Index
All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form
A
- ABOVE_SIDE - Enum constant in enum 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.FieldGradient
-
absolute value.
- abs() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
absolute value.
- abs() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
absolute value.
- abs() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
absolute value.
- abs() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
absolute value.
- abs() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
absolute value.
- abs() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
absolute value.
- abs() - Method in interface org.hipparchus.CalculusFieldElement
-
absolute value.
- abs() - Method in class org.hipparchus.complex.Complex
-
Return the absolute value of this complex number.
- abs() - Method in class org.hipparchus.complex.FieldComplex
-
Return the absolute value of this complex number.
- abs() - Method in class org.hipparchus.dfp.Dfp
-
absolute value.
- abs() - Method in class org.hipparchus.fraction.BigFraction
-
Returns the absolute value of this
BigFraction
. - abs() - Method in class org.hipparchus.fraction.Fraction
-
Returns the absolute value of this fraction.
- abs() - Method in class org.hipparchus.util.Binary64
-
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
-
Empty constructor.
- absExact(int) - Static method in class org.hipparchus.util.FastMath
-
Absolute value.
- absExact(long) - Static method in class org.hipparchus.util.FastMath
-
Absolute value.
- AbstractConvergenceChecker<P> - 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)
, wherex
is the independent variable and thepi
are the parameters. - AbstractCurveFitter() - Constructor for class org.hipparchus.fitting.AbstractCurveFitter
-
Empty constructor.
- AbstractCurveFitter.TheoreticalValuesFunction - Class in org.hipparchus.fitting
-
Vector function for computing function theoretical values.
- AbstractEvaluation - Class in org.hipparchus.optim.nonlinear.vector.leastsquares
-
An implementation of
LeastSquaresProblem.Evaluation
that is designed for extension. - AbstractEvaluation(int) - Constructor for class org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
-
Constructor.
- AbstractFieldIntegrator<T extends CalculusFieldElement<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. - AbstractFieldODEDetector<T extends AbstractFieldODEDetector<T,
E>, E extends CalculusFieldElement<E>> - Class in org.hipparchus.ode.events -
Base class for #@link
FieldODEEventDetector
. - AbstractFieldODEDetector(FieldAdaptableInterval<E>, int, BracketedRealFieldUnivariateSolver<E>, FieldODEEventHandler<E>) - Constructor for class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Build a new instance.
- AbstractFieldODEStateInterpolator<T extends CalculusFieldElement<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
-
Empty constructor.
- 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
-
Empty constructor.
- AbstractMultivariateRealDistribution - Class in org.hipparchus.distribution.multivariate
-
Base class for multivariate probability distributions.
- AbstractMultivariateRealDistribution(RandomGenerator, int) - Constructor for class org.hipparchus.distribution.multivariate.AbstractMultivariateRealDistribution
-
Simple constructor.
- AbstractODEDetector<T extends AbstractODEDetector<T>> - Class in org.hipparchus.ode.events
-
Base class for #@link
ODEEventDetector
. - AbstractODEDetector(AdaptableInterval, int, BracketedUnivariateSolver<UnivariateFunction>, ODEEventHandler) - Constructor for class org.hipparchus.ode.events.AbstractODEDetector
-
Build a new instance.
- 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.
- AbstractOpenIntHashMap - Class in org.hipparchus.util
-
Base class for open addressed map from int.
- AbstractOpenIntHashMap() - Constructor for class org.hipparchus.util.AbstractOpenIntHashMap
-
Build an empty map with default size.
- AbstractOpenIntHashMap(int) - Constructor for class org.hipparchus.util.AbstractOpenIntHashMap
-
Build an empty map with specified size.
- AbstractOpenIntHashMap(AbstractOpenIntHashMap) - Constructor for class org.hipparchus.util.AbstractOpenIntHashMap
-
Copy constructor.
- AbstractOpenIntHashMap.BaseIterator - Class in org.hipparchus.util
-
Iterator class for the map.
- AbstractOpenIntHashMap.InsertionHolder - Class in org.hipparchus.util
-
Holder for handling values insertion.
- AbstractOpenIntHashMap.ValueCopier - Interface in org.hipparchus.util
-
Interface for copying values.
- AbstractOptimizationProblem<P> - Class in org.hipparchus.optim
-
Base class for implementing optimization problems.
- AbstractOptimizationProblem(int, int, ConvergenceChecker<P>) - Constructor for class org.hipparchus.optim.AbstractOptimizationProblem
-
Create an
AbstractOptimizationProblem
from the given data. - 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
-
Simple constructor.
- 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.
- AbstractRuleFactory - Class in org.hipparchus.analysis.integration.gauss
-
Base class for rules that determines the integration nodes and their weights.
- AbstractRuleFactory() - Constructor for class org.hipparchus.analysis.integration.gauss.AbstractRuleFactory
-
Empty constructor.
- 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.
- AbstractSQPOptimizer - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Abstract class for Sequential Quadratic Programming solvers
- AbstractSQPOptimizer() - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.AbstractSQPOptimizer
-
Simple constructor.
- AbstractStorelessUnivariateStatistic - Class in org.hipparchus.stat.descriptive
-
Abstract base class for implementations of the
StorelessUnivariateStatistic
interface. - AbstractStorelessUnivariateStatistic() - Constructor for class org.hipparchus.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Empty constructor.
- 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
-
Abstract base class for implementations of the
UnivariateStatistic
interface. - 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
. - AbstractUnscentedTransform - Class in org.hipparchus.util
-
Base class for unscented transform providers.
- AbstractUnscentedTransform(int) - Constructor for class org.hipparchus.util.AbstractUnscentedTransform
-
Constructor.
- 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 interface org.hipparchus.analysis.differentiation.Derivative
-
Arc cosine operation.
- acos() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Arc cosine operation.
- acos() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Arc cosine operation.
- acos() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Arc cosine operation.
- acos() - Method in interface org.hipparchus.CalculusFieldElement
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.complex.Complex
-
Compute the inverse cosine of this complex number.
- acos() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the inverse cosine of this complex number.
- acos() - Method in class org.hipparchus.dfp.Dfp
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.util.Binary64
-
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
-
Empty constructor.
- acosh() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Inverse hyperbolic cosine operation.
- acosh() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
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.FieldUnivariateDerivative2
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Inverse hyperbolic cosine operation.
- acosh() - Method in interface org.hipparchus.CalculusFieldElement
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.complex.Complex
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.complex.FieldComplex
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.dfp.Dfp
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.util.Binary64
-
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
-
Empty constructor.
- Action - Enum in org.hipparchus.ode.events
-
Enumerate for actions to be performed when an event occurs during ODE integration.
- AdamsBashforthFieldIntegrator<T extends CalculusFieldElement<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 CalculusFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
Base class for
Adams-Bashforth
andAdams-Moulton
integrators. - 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
-
Base class for
Adams-Bashforth
andAdams-Moulton
integrators. - 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 CalculusFieldElement<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 CalculusFieldElement<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.
- AdaptableInterval - Interface in org.hipparchus.ode.events
-
This interface represents an event checking interval that depends on state.
- AdaptiveStepsizeFieldIntegrator<T extends CalculusFieldElement<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 interface org.hipparchus.analysis.differentiation.Derivative
-
'+' operator.
- add(double) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'+' operator.
- add(double) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
'+' operator.
- add(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'+' operator.
- add(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'+' operator.
- add(double) - Method in interface org.hipparchus.CalculusFieldElement
-
'+' operator.
- add(double) - Method in class org.hipparchus.complex.Complex
-
Returns a
Complex
whose value is(this + addend)
, withaddend
interpreted as a real number. - add(double) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value is(this + addend)
, withaddend
interpreted as a real number. - add(double) - Method in class org.hipparchus.util.Binary64
-
'+' 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, FieldVector2D<T>) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Add a scaled vector to the instance.
- add(double, Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Add a scaled vector to the instance.
- add(double, Vector<Euclidean1D, Vector1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Add a scaled vector to the instance.
- add(double, Vector<Euclidean3D, Vector3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Add a scaled vector to the instance.
- add(double, Vector<Euclidean2D, Vector2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Add a scaled vector to the instance.
- add(double, Vector<S, V>) - 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(FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute this + a.
- add(FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute this + a.
- add(FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute this + a.
- add(Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute this + a.
- add(SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute this + a.
- add(UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute this + a.
- add(UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute this + a.
- add(UnivariateDifferentiableFunction...) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Adds functions.
- add(FieldPolynomialFunction<T>) - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Add a polynomial to the instance.
- 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(FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
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(FieldVector2D<T>) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Add a vector to the instance.
- add(Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
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, Vector1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Add a vector to the instance.
- add(Vector<Euclidean3D, Vector3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Add a vector to the instance.
- add(Vector<Euclidean2D, Vector2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Add a vector to the instance.
- add(Vector<S, V>) - 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
andm
. - add(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute the sum of
this
andv
. - add(BlockFieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Compute the sum of
this
andm
. - 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
andm
. - 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
andv
. - add(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Compute the sum of
this
andv
. - add(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Compute the sum of
this
andv
. - 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
andm
. - add(RealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the sum of
this
andm
. - add(RealMatrix) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the sum of
this
andm
. - 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(Binary64) - Method in class org.hipparchus.util.Binary64
-
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(S) - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
'+' operator.
- add(T) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value is(this + addend)
, withaddend
interpreted as a real number. - 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(T, FieldVector2D<T>) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Add a scaled vector to the instance.
- add(T, Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
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
-
Empty constructor.
- ADD_ZERO_VECTOR - Enum constant in enum org.hipparchus.linear.DependentVectorsHandler
-
Replace dependent vectors by vectors with norm 0.
- 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
-
Add a CDF series.
- addCDFSeries(Chart, RealDistribution, String, int, int) - Static method in class org.hipparchus.samples.RealDistributionComparison
-
Add a CDF series.
- 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.
- addEventDetector(FieldODEEventDetector<T>) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Add an event detector to the integrator.
- addEventDetector(FieldODEEventDetector<T>) - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Add an event detector to the integrator.
- addEventDetector(ODEEventDetector) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Add an event detector to the integrator.
- addEventDetector(ODEEventDetector) - Method in interface org.hipparchus.ode.ODEIntegrator
-
Add an event detector 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 - Enum constant in enum 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
-
Add a PDF series.
- addPDFSeries(Chart, RealDistribution, String, int, int) - Static method in class org.hipparchus.samples.RealDistributionComparison
-
Add a PDF series.
- addPoint(T) - Method in class org.hipparchus.clustering.Cluster
-
Add a point to this cluster.
- 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.
- addStepEndHandler(FieldODEStepEndHandler<T>) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Add a handler for step ends to the integrator.
- addStepEndHandler(FieldODEStepEndHandler<T>) - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Add a handler for step ends to the integrator.
- addStepEndHandler(ODEStepEndHandler) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Add a handler for step ends to the integrator.
- addStepEndHandler(ODEStepEndHandler) - Method in interface org.hipparchus.ode.ODEIntegrator
-
Add a handler for step ends to the integrator.
- 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.
- ADMMQPConvergenceChecker - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Convergence Checker for ADMM QP Optimizer.
- ADMMQPKKT - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Alternative Direction Method of Multipliers Solver.
- ADMMQPModifiedRuizEquilibrium - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
TBD.
- ADMMQPModifiedRuizEquilibrium(RealMatrix, RealMatrix, RealVector) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPModifiedRuizEquilibrium
-
Simple constructor
- ADMMQPOptimizer - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Alternating Direction Method of Multipliers Quadratic Programming Optimizer.
- ADMMQPOptimizer() - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOptimizer
-
Simple constructor.
- ADMMQPOption - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Container for
ADMMQPOptimizer
settings. - ADMMQPOption() - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Simple constructor.
- ADMMQPSolution - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Internal Solution for ADMM QP Optimizer.
- ADMMQPSolution(RealVector, RealVector) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPSolution
-
Simple constructor.
- ADMMQPSolution(RealVector, RealVector, Double) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPSolution
-
Simple constructor.
- ADMMQPSolution(RealVector, RealVector, RealVector, RealVector) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPSolution
-
Simple constructor.
- ADMMQPSolution(RealVector, RealVector, RealVector, RealVector, double) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPSolution
-
Simple constructor.
- advance() - Method in class org.hipparchus.util.AbstractOpenIntHashMap.BaseIterator
-
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(FirstMoment) - Method in class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Aggregates the results of the provided instance 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
-
Simple constructor.
- AkimaSplineInterpolator(boolean) - Constructor for class org.hipparchus.analysis.interpolation.AkimaSplineInterpolator
-
Simple constructor.
- 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
-
The kinds of solutions that a
(bracketed univariate real) root-finding algorithm
may accept as solutions. - 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(FieldVector2D<T>, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the angular separation between two vectors.
- angle(FieldVector2D<T>, Vector2D) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the angular separation between two vectors.
- angle(Vector2D, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
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
-
Computes the ANOVA P-value for a collection of
StreamingStatistics
. - 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.FieldPolynomialFunction
-
Returns an anti-derivative of this polynomial, with 0 constant term.
- antiDerivative() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Returns an anti-derivative of this polynomial, with 0 constant term.
- ANY_SIDE - Enum constant in enum 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 insc
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.
- applyExternalButcherWeights(double[], double[][], double, double[]) - Static method in interface org.hipparchus.ode.nonstiff.ExplicitRungeKuttaIntegrator
-
Apply external weights of Butcher array, assuming internal ones have been applied.
- applyExternalButcherWeights(T[], T[][], T, double[]) - Static method in interface org.hipparchus.ode.nonstiff.FieldExplicitRungeKuttaIntegrator
-
Apply external weights of Butcher array, assuming internal ones have been applied.
- applyExternalButcherWeights(T[], T[][], T, T[]) - Static method in interface org.hipparchus.ode.nonstiff.FieldExplicitRungeKuttaIntegrator
-
Apply external weights of Butcher array, assuming internal ones have been applied.
- applyInternalButcherWeights(ExpandableODE, double, double[], double, double[][], double[], double[][]) - Static method in interface org.hipparchus.ode.nonstiff.ExplicitRungeKuttaIntegrator
-
Apply internal weights of Butcher array, with corresponding times.
- applyInternalButcherWeights(FieldExpandableODE<T>, T, T[], T, double[][], double[], T[][]) - Static method in interface org.hipparchus.ode.nonstiff.FieldExplicitRungeKuttaIntegrator
-
Apply internal weights of Butcher array, with corresponding times.
- applyInternalButcherWeights(FieldExpandableODE<T>, T, T[], T, T[][], T[], T[][]) - Static method in interface org.hipparchus.ode.nonstiff.FieldExplicitRungeKuttaIntegrator
-
Apply internal weights of Butcher array, with corresponding times.
- 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
-
Uses the Kolmogorov-Smirnov distribution to approximate \(P(D_{n,m} > d)\) where \(D_{n,m}\) is the 2-sample Kolmogorov-Smirnov statistic.
- 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.
- arccd(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cd.
- arccd(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cd.
- arccd(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cd.
- arccn(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cn.
- arccn(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cn.
- arccn(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cn.
- arccs(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cs.
- arccs(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cs.
- arccs(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cs.
- arcdc(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function dc.
- arcdc(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function dc.
- arcdc(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function dc.
- arcdn(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function dn.
- arcdn(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function dn.
- arcdn(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function dn.
- arcds(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function ds.
- arcds(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function ds.
- arcds(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function ds.
- arcnc(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function nc.
- arcnc(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function nc.
- arcnc(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function nc.
- arcnd(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function nd.
- arcnd(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function nd.
- arcnd(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function nd.
- arcns(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function ns.
- arcns(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function ns.
- arcns(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function ns.
- arcsc(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sc.
- arcsc(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sc.
- arcsc(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sc.
- arcsd(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sd.
- arcsd(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sd.
- arcsd(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sd.
- arcsn(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sn.
- arcsn(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sn.
- arcsn(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sn.
- 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 - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ARGUMENT_OUTSIDE_DOMAIN.
- ARGUMENT_OUTSIDE_DOMAIN - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.ARGUMENT_OUTSIDE_DOMAIN.
- ARITHMETIC_EXCEPTION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ARITHMETIC_EXCEPTION.
- ARITHMETIC_EXCEPTION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ARITHMETIC_EXCEPTION.
- ArithmeticUtils - Class in org.hipparchus.util
-
Some useful, arithmetics related, additions to the built-in functions in
Math
. - ARRAY_ELEMENT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ARRAY_ELEMENT.
- ARRAY_ELEMENT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ARRAY_ELEMENT.
- ARRAY_SIZE_EXCEEDS_MAX_VARIABLES - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ARRAY_SIZE_EXCEEDS_MAX_VARIABLES.
- ARRAY_SIZE_EXCEEDS_MAX_VARIABLES - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ARRAY_SIZE_EXCEEDS_MAX_VARIABLES.
- ARRAY_SIZES_SHOULD_HAVE_DIFFERENCE_1 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ARRAY_SIZES_SHOULD_HAVE_DIFFERENCE_1.
- ARRAY_SIZES_SHOULD_HAVE_DIFFERENCE_1 - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ARRAY_SIZES_SHOULD_HAVE_DIFFERENCE_1.
- ARRAY_SUMS_TO_ZERO - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ARRAY_SUMS_TO_ZERO.
- ARRAY_SUMS_TO_ZERO - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ARRAY_SUMS_TO_ZERO.
- ARRAY_ZERO_LENGTH_OR_NULL_NOT_ALLOWED - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ARRAY_ZERO_LENGTH_OR_NULL_NOT_ALLOWED.
- ARRAY_ZERO_LENGTH_OR_NULL_NOT_ALLOWED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ARRAY_ZERO_LENGTH_OR_NULL_NOT_ALLOWED.
- Array2DRowFieldMatrix<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
Implementation of
FieldMatrix
using aFieldElement
[][] 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>
usingv
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>
usingv
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 adouble[][]
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
-
This class implements the
FieldVector
interface with aFieldElement
array. - 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 interface org.hipparchus.analysis.differentiation.Derivative1
-
Arc sine operation.
- asin() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Arc sine operation.
- asin() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Arc sine operation.
- asin() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Arc sine operation.
- asin() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Arc sine operation.
- asin() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Arc sine operation.
- asin() - Method in interface org.hipparchus.CalculusFieldElement
-
Arc sine operation.
- asin() - Method in class org.hipparchus.complex.Complex
-
Compute the inverse sine of this complex number.
- asin() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the inverse sine of this complex number.
- asin() - Method in class org.hipparchus.dfp.Dfp
-
Arc sine operation.
- asin() - Method in class org.hipparchus.util.Binary64
-
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
-
Empty constructor.
- asinh() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Inverse hyperbolic sine operation.
- asinh() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
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.FieldUnivariateDerivative2
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Inverse hyperbolic sine operation.
- asinh() - Method in interface org.hipparchus.CalculusFieldElement
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.complex.Complex
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.complex.FieldComplex
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.dfp.Dfp
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.util.Binary64
-
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
-
Empty constructor.
- 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 - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ASSYMETRIC_EIGEN_NOT_SUPPORTED.
- ASSYMETRIC_EIGEN_NOT_SUPPORTED - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.ASSYMETRIC_EIGEN_NOT_SUPPORTED.
- AT_LEAST_ONE_COLUMN - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
AT_LEAST_ONE_COLUMN.
- AT_LEAST_ONE_COLUMN - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.AT_LEAST_ONE_COLUMN.
- AT_LEAST_ONE_ROW - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
AT_LEAST_ONE_ROW.
- AT_LEAST_ONE_ROW - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.AT_LEAST_ONE_ROW.
- atan() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Arc tangent operation.
- atan() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Arc tangent operation.
- atan() - Method in interface org.hipparchus.CalculusFieldElement
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.complex.Complex
-
Compute the inverse tangent of this complex number.
- atan() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the inverse tangent of this complex number.
- atan() - Method in class org.hipparchus.dfp.Dfp
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.util.Binary64
-
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
-
Empty constructor.
- 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(FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Two arguments arc tangent operation.
- atan2(FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Two arguments arc tangent operation.
- atan2(FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Two arguments arc tangent operation.
- atan2(Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
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(UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Two arguments arc tangent operation.
- atan2(UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Two arguments arc tangent operation.
- atan2(Complex) - Method in class org.hipparchus.complex.Complex
-
Two arguments arc tangent operation.
- atan2(FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
Two arguments arc tangent operation.
- atan2(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Two arguments arc tangent operation.
- atan2(Binary64) - Method in class org.hipparchus.util.Binary64
-
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.CalculusFieldElement
-
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
-
Empty constructor.
- atanh() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Inverse hyperbolic tangent operation.
- atanh() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
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.FieldUnivariateDerivative2
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Inverse hyperbolic tangent operation.
- atanh() - Method in interface org.hipparchus.CalculusFieldElement
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.complex.Complex
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.complex.FieldComplex
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.dfp.Dfp
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.util.Binary64
-
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
-
Empty constructor.
- atanInternal(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
computes the arc-tangent of the argument.
- AVERAGE - Enum constant in enum org.hipparchus.stat.ranking.TiesStrategy
-
Ties get the average of applicable ranks
B
- ballOnSupport(List<Vector3D>) - Method in class org.hipparchus.geometry.euclidean.threed.SphereGenerator
-
Create a ball whose boundary lies on prescribed support points.
- ballOnSupport(List<Vector2D>) - Method in class org.hipparchus.geometry.euclidean.twod.DiskGenerator
-
Create a ball whose boundary lies on prescribed support points.
- ballOnSupport(List<P>) - Method in interface org.hipparchus.geometry.enclosing.SupportBallGenerator
-
Create a ball whose boundary lies on prescribed support points.
- BANDWIDTH - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
BANDWIDTH.
- BANDWIDTH - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.BANDWIDTH.
- BASE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
BASE.
- BASE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.BASE.
- BaseAbstractFieldUnivariateIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.integration
-
Provide a default implementation for several generic functions.
- BaseAbstractFieldUnivariateIntegrator(Field<T>, double, double) - Constructor for class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Construct an integrator with given accuracies.
- BaseAbstractFieldUnivariateIntegrator(Field<T>, double, double, int, int) - Constructor for class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Construct an integrator with given accuracies and iteration counts.
- BaseAbstractFieldUnivariateIntegrator(Field<T>, int, int) - Constructor for class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Construct an integrator with given iteration counts.
- BaseAbstractUnivariateIntegrator - Class in org.hipparchus.analysis.integration
-
Provide a default implementation for several generic functions.
- BaseAbstractUnivariateIntegrator(double, double) - Constructor for class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Construct an integrator with given accuracies.
- BaseAbstractUnivariateIntegrator(double, double, int, int) - Constructor for class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Construct an integrator with given accuracies and iteration counts.
- BaseAbstractUnivariateIntegrator(int, int) - Constructor for class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Construct an integrator with given iteration counts.
- BaseAbstractUnivariateSolver<F extends UnivariateFunction> - Class in org.hipparchus.analysis.solvers
-
Provide a default implementation for several functions useful to generic solvers.
- BaseAbstractUnivariateSolver(double) - Constructor for class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Construct a solver with given absolute accuracy.
- BaseAbstractUnivariateSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Construct a solver with given accuracies.
- BaseAbstractUnivariateSolver(double, double, double) - Constructor for class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Construct a solver with given accuracies.
- BaseIterator() - Constructor for class org.hipparchus.util.AbstractOpenIntHashMap.BaseIterator
-
Simple constructor.
- BaseMultiStartMultivariateOptimizer<P> - Class in org.hipparchus.optim
-
Base class multi-start optimizer for a multivariate function.
- BaseMultiStartMultivariateOptimizer(BaseMultivariateOptimizer<P>, int, RandomVectorGenerator) - Constructor for class org.hipparchus.optim.BaseMultiStartMultivariateOptimizer
-
Create a multi-start optimizer from a single-start optimizer.
- BaseMultivariateOptimizer<P> - Class in org.hipparchus.optim
-
Base class for implementing optimizers for multivariate functions.
- BaseMultivariateOptimizer(ConvergenceChecker<P>) - Constructor for class org.hipparchus.optim.BaseMultivariateOptimizer
-
Simple constructor.
- BaseOptimizer<P> - Class in org.hipparchus.optim
-
Base class for implementing optimizers.
- BaseOptimizer(ConvergenceChecker<P>) - Constructor for class org.hipparchus.optim.BaseOptimizer
-
Simple constructor.
- BaseOptimizer(ConvergenceChecker<P>, int, int) - Constructor for class org.hipparchus.optim.BaseOptimizer
-
Simple constructor.
- BaseSecantSolver - Class in org.hipparchus.analysis.solvers
-
Base class for all bracketing Secant-based methods for root-finding (approximating a zero of a univariate real function).
- BaseSecantSolver(double, double, double, BaseSecantSolver.Method) - Constructor for class org.hipparchus.analysis.solvers.BaseSecantSolver
-
Construct a solver.
- BaseSecantSolver(double, double, BaseSecantSolver.Method) - Constructor for class org.hipparchus.analysis.solvers.BaseSecantSolver
-
Construct a solver.
- BaseSecantSolver(double, BaseSecantSolver.Method) - Constructor for class org.hipparchus.analysis.solvers.BaseSecantSolver
-
Construct a solver.
- BaseSecantSolver.Method - Enum in org.hipparchus.analysis.solvers
-
Secant-based root-finding methods.
- BaseUnivariateSolver<F extends UnivariateFunction> - Interface in org.hipparchus.analysis.solvers
-
Interface for (univariate real) rootfinding algorithms.
- bellNumber(int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Compute the Bell number (number of partitions of a set).
- BELOW_SIDE - Enum constant in enum org.hipparchus.analysis.solvers.AllowedSolution
-
Only solutions for which values are less than or equal to zero are acceptable as solutions for root-finding.
- BESSEL_FUNCTION_BAD_ARGUMENT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
BESSEL_FUNCTION_BAD_ARGUMENT.
- BESSEL_FUNCTION_BAD_ARGUMENT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.BESSEL_FUNCTION_BAD_ARGUMENT.
- BESSEL_FUNCTION_FAILED_CONVERGENCE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
BESSEL_FUNCTION_FAILED_CONVERGENCE.
- BESSEL_FUNCTION_FAILED_CONVERGENCE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.BESSEL_FUNCTION_FAILED_CONVERGENCE.
- BesselJ - Class in org.hipparchus.special
-
This class provides computation methods related to Bessel functions of the first kind.
- BesselJ(double) - Constructor for class org.hipparchus.special.BesselJ
-
Create a new BesselJ with the given order.
- BesselJ.BesselJResult - Class in org.hipparchus.special
-
Encapsulates the results returned by
BesselJ.rjBesl(double, double, int)
. - BesselJResult(double[], int) - Constructor for class org.hipparchus.special.BesselJ.BesselJResult
-
Create a new BesselJResult with the given values and valid value count.
- Beta - Class in org.hipparchus.special
-
This is a utility class that provides computation methods related to the Beta family of functions.
- BetaDistribution - Class in org.hipparchus.distribution.continuous
-
Implements the Beta distribution.
- BetaDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.BetaDistribution
-
Build a new instance.
- BetaDistribution(double, double, double) - Constructor for class org.hipparchus.distribution.continuous.BetaDistribution
-
Build a new instance.
- BicubicInterpolatingFunction - Class in org.hipparchus.analysis.interpolation
-
Function that implements the bicubic spline interpolation.
- BicubicInterpolatingFunction(double[], double[], double[][], double[][], double[][], double[][]) - Constructor for class org.hipparchus.analysis.interpolation.BicubicInterpolatingFunction
-
Simple constructor.
- BicubicInterpolator - Class in org.hipparchus.analysis.interpolation
-
Generates a
bicubic interpolating function
. - BicubicInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.BicubicInterpolator
-
Empty constructor.
- bigD(double) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral D(m) = [K(m) - E(m)]/m.
- bigD(double, double) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral D(φ, m) = [F(φ, m) - E(φ, m)]/m.
- bigD(Complex) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral D(m) = [K(m) - E(m)]/m.
- bigD(Complex, Complex) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral D(φ, m) = [F(φ, m) - E(φ, m)]/m.
- bigD(FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral D(m) = [K(m) - E(m)]/m.
- bigD(FieldComplex<T>, FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral D(φ, m) = [F(φ, m) - E(φ, m)]/m.
- bigD(T) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral D(m) = [K(m) - E(m)]/m.
- bigD(T, T) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral D(φ, m) = [F(φ, m) - E(φ, m)]/m.
- bigDecimalValue() - Method in class org.hipparchus.fraction.BigFraction
-
Gets the fraction as a
BigDecimal
. - bigDecimalValue() - Method in class org.hipparchus.util.BigReal
-
Get the BigDecimal value corresponding to the instance.
- bigDecimalValue(int, RoundingMode) - Method in class org.hipparchus.fraction.BigFraction
-
Gets the fraction as a
BigDecimal
following the passed scale and rounding mode. - bigDecimalValue(RoundingMode) - Method in class org.hipparchus.fraction.BigFraction
-
Gets the fraction as a
BigDecimal
following the passed rounding mode. - bigE(double) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the second kind E(m).
- bigE(double, double) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the second kind E(φ, m).
- bigE(Complex) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the second kind E(m).
- bigE(Complex, Complex) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the second kind E(φ, m).
- bigE(Complex, Complex, ComplexUnivariateIntegrator, int) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the second kind E(φ, m) using numerical integration.
- bigE(FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the second kind E(m).
- bigE(FieldComplex<T>, FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the second kind E(φ, m).
- bigE(FieldComplex<T>, FieldComplex<T>, FieldComplexUnivariateIntegrator<T>, int) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the second kind E(φ, m).
- bigE(T) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the second kind E(m).
- bigE(T, T) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the second kind E(φ, m).
- bigF(double, double) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the first kind F(φ, m).
- bigF(Complex, Complex) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the first kind F(φ, m).
- bigF(Complex, Complex, ComplexUnivariateIntegrator, int) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the first kind F(φ, m) using numerical integration.
- bigF(FieldComplex<T>, FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the first kind F(φ, m).
- bigF(FieldComplex<T>, FieldComplex<T>, FieldComplexUnivariateIntegrator<T>, int) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the first kind F(φ, m).
- bigF(T, T) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the first kind F(φ, m).
- BigFraction - Class in org.hipparchus.fraction
-
Representation of a rational number without any overflow.
- BigFraction(double) - Constructor for class org.hipparchus.fraction.BigFraction
-
Create a fraction given the double value.
- BigFraction(double, double, int) - Constructor for class org.hipparchus.fraction.BigFraction
-
Create a fraction given the double value and maximum error allowed.
- BigFraction(double, long) - Constructor for class org.hipparchus.fraction.BigFraction
-
Create a fraction given the double value and maximum denominator.
- BigFraction(int) - Constructor for class org.hipparchus.fraction.BigFraction
-
Create a
BigFraction
equivalent to the passedint
, ie "num / 1". - BigFraction(int, int) - Constructor for class org.hipparchus.fraction.BigFraction
-
Create a
BigFraction
given the numerator and denominator as simpleint
. - BigFraction(long) - Constructor for class org.hipparchus.fraction.BigFraction
-
Create a
BigFraction
equivalent to the passed long, ie "num / 1". - BigFraction(long, long) - Constructor for class org.hipparchus.fraction.BigFraction
-
Create a
BigFraction
given the numerator and denominator as simplelong
. - BigFraction(BigInteger) - Constructor for class org.hipparchus.fraction.BigFraction
-
Create a
BigFraction
equivalent to the passedBigInteger
, ie "num / 1". - BigFraction(BigInteger, BigInteger) - Constructor for class org.hipparchus.fraction.BigFraction
-
Create a
BigFraction
given the numerator and denominator asBigInteger
. - BigFraction.ConvergenceTest - Interface in org.hipparchus.fraction
-
A test to determine if a series of fractions has converged.
- BigFractionField - Class in org.hipparchus.fraction
-
Representation of the fractional numbers without any overflow field.
- BigFractionFormat - Class in org.hipparchus.fraction
-
Formats a BigFraction number in proper format or improper format.
- BigFractionFormat() - Constructor for class org.hipparchus.fraction.BigFractionFormat
-
Create an improper formatting instance with the default number format for the numerator and denominator.
- BigFractionFormat(NumberFormat) - Constructor for class org.hipparchus.fraction.BigFractionFormat
-
Create an improper formatting instance with a custom number format for both the numerator and denominator.
- BigFractionFormat(NumberFormat, NumberFormat) - Constructor for class org.hipparchus.fraction.BigFractionFormat
-
Create an improper formatting instance with a custom number format for the numerator and a custom number format for the denominator.
- bigFractionMatrixToRealMatrix(FieldMatrix<BigFraction>) - Static method in class org.hipparchus.linear.MatrixUtils
- bigK(double) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the first kind K(m).
- bigK(Complex) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the first kind K(m).
- bigK(FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the first kind K(m).
- bigK(T) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the first kind K(m).
- bigKPrime(double) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the first kind K'(m).
- bigKPrime(Complex) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the first kind K'(m).
- bigKPrime(FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the first kind K'(m).
- bigKPrime(T) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the first kind K'(m).
- bigPi(double, double) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the third kind Π(n, m).
- bigPi(double, double, double) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the third kind Π(n, φ, m).
- bigPi(Complex, Complex) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the third kind Π(n, m).
- bigPi(Complex, Complex, Complex) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the third kind Π(n, φ, m).
- bigPi(Complex, Complex, Complex, ComplexUnivariateIntegrator, int) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the third kind Π(n, φ, m) using numerical integration.
- bigPi(FieldComplex<T>, FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the third kind Π(n, m).
- bigPi(FieldComplex<T>, FieldComplex<T>, FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the third kind Π(n, φ, m).
- bigPi(FieldComplex<T>, FieldComplex<T>, FieldComplex<T>, FieldComplexUnivariateIntegrator<T>, int) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the third kind Π(n, φ, m).
- bigPi(T, T) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the third kind Π(n, m).
- bigPi(T, T, T) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral of the third kind Π(n, φ, m).
- BigReal - Class in org.hipparchus.util
-
Arbitrary precision decimal number.
- BigReal(char[]) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from a characters representation.
- BigReal(char[], int, int) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from a characters representation.
- BigReal(char[], int, int, MathContext) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from a characters representation.
- BigReal(char[], MathContext) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from a characters representation.
- BigReal(double) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from a double.
- BigReal(double, MathContext) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from a double.
- BigReal(int) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from an int.
- BigReal(int, MathContext) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from an int.
- BigReal(long) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from a long.
- BigReal(long, MathContext) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from a long.
- BigReal(String) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from a String representation.
- BigReal(String, MathContext) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from a String representation.
- BigReal(BigDecimal) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from a BigDecimal.
- BigReal(BigInteger) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from a BigInteger.
- BigReal(BigInteger, int) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from an unscaled BigInteger.
- BigReal(BigInteger, int, MathContext) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from an unscaled BigInteger.
- BigReal(BigInteger, MathContext) - Constructor for class org.hipparchus.util.BigReal
-
Build an instance from a BigInteger.
- BigRealField - Class in org.hipparchus.util
-
Representation of real numbers with arbitrary precision field.
- BilinearInterpolatingFunction - Class in org.hipparchus.analysis.interpolation
-
Interpolate grid data using bi-linear interpolation.
- BilinearInterpolatingFunction(double[], double[], double[][]) - Constructor for class org.hipparchus.analysis.interpolation.BilinearInterpolatingFunction
-
Simple constructor.
- BilinearInterpolator - Class in org.hipparchus.analysis.interpolation
-
Interpolate grid data using bi-linear interpolation.
- BilinearInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.BilinearInterpolator
-
Empty constructor.
- Binary64 - Class in org.hipparchus.util
-
This class wraps a
double
value in an object. - Binary64(double) - Constructor for class org.hipparchus.util.Binary64
-
Creates a new instance of this class.
- Binary64Field - Class in org.hipparchus.util
-
The field of
double precision floating-point numbers
. - BINOMIAL_INVALID_PARAMETERS_ORDER - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
BINOMIAL_INVALID_PARAMETERS_ORDER.
- BINOMIAL_INVALID_PARAMETERS_ORDER - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.BINOMIAL_INVALID_PARAMETERS_ORDER.
- BINOMIAL_NEGATIVE_PARAMETER - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
BINOMIAL_NEGATIVE_PARAMETER.
- BINOMIAL_NEGATIVE_PARAMETER - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.BINOMIAL_NEGATIVE_PARAMETER.
- binomialCoefficient(int, int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Returns an exact representation of the Binomial Coefficient, "
n choose k
", the number ofk
-element subsets that can be selected from ann
-element set. - binomialCoefficientDouble(int, int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Returns a
double
representation of the Binomial Coefficient, "n choose k
", the number ofk
-element subsets that can be selected from ann
-element set. - binomialCoefficientLog(int, int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Returns the natural
log
of the Binomial Coefficient, "n choose k
", the number ofk
-element subsets that can be selected from ann
-element set. - BinomialDistribution - Class in org.hipparchus.distribution.discrete
-
Implementation of the binomial distribution.
- BinomialDistribution(int, double) - Constructor for class org.hipparchus.distribution.discrete.BinomialDistribution
-
Create a binomial distribution with the given number of trials and probability of success.
- BinomialProportion - Class in org.hipparchus.stat.interval
-
Utility methods to generate confidence intervals for a binomial proportion.
- binomialTest(int, int, double, AlternativeHypothesis) - Method in class org.hipparchus.stat.inference.BinomialTest
-
Returns the observed significance level, or p-value, associated with a Binomial test.
- binomialTest(int, int, double, AlternativeHypothesis, double) - Method in class org.hipparchus.stat.inference.BinomialTest
-
Returns whether the null hypothesis can be rejected with the given confidence level.
- BinomialTest - Class in org.hipparchus.stat.inference
-
Implements binomial test statistics.
- BinomialTest() - Constructor for class org.hipparchus.stat.inference.BinomialTest
-
Empty constructor.
- BisectionSolver - Class in org.hipparchus.analysis.solvers
-
Implements the bisection algorithm for finding zeros of univariate real functions.
- BisectionSolver() - Constructor for class org.hipparchus.analysis.solvers.BisectionSolver
-
Construct a solver with default accuracy (1e-6).
- BisectionSolver(double) - Constructor for class org.hipparchus.analysis.solvers.BisectionSolver
-
Construct a solver.
- BisectionSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.BisectionSolver
-
Construct a solver.
- BivariateFunction - Interface in org.hipparchus.analysis
-
An interface representing a bivariate real function.
- BivariateGridInterpolator - Interface in org.hipparchus.analysis.interpolation
-
Interface representing a bivariate real interpolating function where the sample points must be specified on a regular grid.
- BLAND - Enum constant in enum org.hipparchus.optim.linear.PivotSelectionRule
-
The first variable with a negative coefficient in the objective function row will be chosen as entering variable.
- Blendable<B> - Interface in org.hipparchus.util
-
Interface representing classes that can blend with other instances of themselves using a given blending value.
- blendArithmeticallyWith(B, double) - Method in interface org.hipparchus.util.Blendable
-
Blend arithmetically this instance with another one.
- blendArithmeticallyWith(B, T) - Method in interface org.hipparchus.util.FieldBlendable
-
Blend arithmetically this instance with another one.
- blendArithmeticallyWith(FieldVector3D<T>, T) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Blend arithmetically this instance with another one.
- blendArithmeticallyWith(Vector<S, V>, double) - Method in interface org.hipparchus.geometry.Vector
-
Blend arithmetically this instance with another one.
- blendArithmeticallyWith(FieldMatrix<T>, T) - Method in interface org.hipparchus.linear.FieldMatrix
-
Blend arithmetically this instance with another one.
- blendArithmeticallyWith(RealMatrix, double) - Method in interface org.hipparchus.linear.RealMatrix
-
Blend arithmetically this instance with another one.
- BLOCK_SIZE - Static variable in class org.hipparchus.linear.BlockFieldMatrix
-
Block size.
- BLOCK_SIZE - Static variable in class org.hipparchus.linear.BlockRealMatrix
-
Block size.
- BlockFieldMatrix<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
Cache-friendly implementation of FieldMatrix using a flat arrays to store square blocks of the matrix.
- BlockFieldMatrix(int, int, T[][], boolean) - Constructor for class org.hipparchus.linear.BlockFieldMatrix
-
Create a new dense matrix copying entries from block layout data.
- BlockFieldMatrix(Field<T>, int, int) - Constructor for class org.hipparchus.linear.BlockFieldMatrix
-
Create a new matrix with the supplied row and column dimensions.
- BlockFieldMatrix(T[][]) - Constructor for class org.hipparchus.linear.BlockFieldMatrix
-
Create a new dense matrix copying entries from raw layout data.
- blockInverse(RealMatrix, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
Computes the inverse of the given matrix by splitting it into 4 sub-matrices.
- BlockRealMatrix - Class in org.hipparchus.linear
-
Cache-friendly implementation of RealMatrix using a flat arrays to store square blocks of the matrix.
- BlockRealMatrix(double[][]) - Constructor for class org.hipparchus.linear.BlockRealMatrix
-
Create a new dense matrix copying entries from raw layout data.
- BlockRealMatrix(int, int) - Constructor for class org.hipparchus.linear.BlockRealMatrix
-
Create a new matrix with the supplied row and column dimensions.
- BlockRealMatrix(int, int, double[][], boolean) - Constructor for class org.hipparchus.linear.BlockRealMatrix
-
Create a new dense matrix copying entries from block layout data.
- BOBYQA_BOUND_DIFFERENCE_CONDITION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.BOBYQA_BOUND_DIFFERENCE_CONDITION.
- BOBYQA_BOUND_DIFFERENCE_CONDITION - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.BOBYQA_BOUND_DIFFERENCE_CONDITION.
- BOBYQAOptimizer - Class in org.hipparchus.optim.nonlinear.scalar.noderiv
-
Powell's BOBYQA algorithm.
- BOBYQAOptimizer(int) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
-
Simple constructor.
- BOBYQAOptimizer(int, double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
-
Simple constructor.
- bootstrap(double[], double[], int) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Computes
bootstrap(x, y, iterations, true)
. - bootstrap(double[], double[], int, boolean) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Estimates the p-value of a two-sample Kolmogorov-Smirnov test evaluating the null hypothesis that
x
andy
are samples drawn from the same probability distribution. - BOTH - Enum constant in enum org.hipparchus.geometry.partitioning.Side
-
Code for elements crossing the hyperplane from plus to minus side.
- BOTH - Enum constant in enum org.hipparchus.ode.sampling.StepNormalizerBounds
-
Include both the first and last points.
- BOUNDARY - Enum constant in enum org.hipparchus.geometry.partitioning.Region.Location
-
Code for points on the partition boundary.
- BoundaryAttribute<S extends Space> - Class in org.hipparchus.geometry.partitioning
-
Class holding boundary attributes.
- BoundaryProjection<S extends Space> - Class in org.hipparchus.geometry.partitioning
-
Class holding the result of point projection on region boundary.
- BoundaryProjection(Point<S>, Point<S>, double) - Constructor for class org.hipparchus.geometry.partitioning.BoundaryProjection
-
Constructor from raw elements.
- BoundedConstraint - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Constraint with lower and upper bounds: \(l \le f(x) \le u\).
- BoundedConstraint(RealVector, RealVector) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.BoundedConstraint
-
Simple constructor.
- boundedToUnbounded(double[]) - Method in class org.hipparchus.optim.nonlinear.scalar.MultivariateFunctionMappingAdapter
-
Maps an array from bounded to unbounded.
- bracket(CalculusFieldUnivariateFunction<T>, T, T, T) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
This method simply calls
bracket(function, initial, lowerBound, upperBound, q, r, maximumIterations)
withq
andr
set to 1.0 andmaximumIterations
set toInteger.MAX_VALUE
. - bracket(CalculusFieldUnivariateFunction<T>, T, T, T, int) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
This method simply calls
bracket(function, initial, lowerBound, upperBound, q, r, maximumIterations)
withq
andr
set to 1.0. - bracket(CalculusFieldUnivariateFunction<T>, T, T, T, T, T, int) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
This method attempts to find two values a and b satisfying
lowerBound <= a < initial < b <= upperBound
f(a) * f(b) <= 0
Iff
is continuous on[a,b]
, this means thata
andb
bracket a root off
. - bracket(UnivariateFunction, double, double, double) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
This method simply calls
bracket(function, initial, lowerBound, upperBound, q, r, maximumIterations)
withq
andr
set to 1.0 andmaximumIterations
set toInteger.MAX_VALUE
. - bracket(UnivariateFunction, double, double, double, double, double, int) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
This method attempts to find two values a and b satisfying
lowerBound <= a < initial < b <= upperBound
f(a) * f(b) <= 0
Iff
is continuous on[a,b]
, this means thata
andb
bracket a root off
. - bracket(UnivariateFunction, double, double, double, int) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
This method simply calls
bracket(function, initial, lowerBound, upperBound, q, r, maximumIterations)
withq
andr
set to 1.0. - BracketedRealFieldUnivariateSolver<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.analysis.solvers
-
Interface for
(univariate real) root-finding algorithms
that maintain a bracketed solution. - BracketedRealFieldUnivariateSolver.Interval<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.solvers
-
An interval of a function that brackets a root.
- BracketedUnivariateSolver<F extends UnivariateFunction> - Interface in org.hipparchus.analysis.solvers
-
Interface for
(univariate real) root-finding algorithms
that maintain a bracketed solution. - BracketedUnivariateSolver.Interval - Class in org.hipparchus.analysis.solvers
-
An interval of a function that brackets a root.
- BracketFinder - Class in org.hipparchus.optim.univariate
-
Provide an interval that brackets a local optimum of a function.
- BracketFinder() - Constructor for class org.hipparchus.optim.univariate.BracketFinder
-
Constructor with default values
100, 500
(see theother constructor
). - BracketFinder(double, int) - Constructor for class org.hipparchus.optim.univariate.BracketFinder
-
Create a bracketing interval finder.
- BracketingNthOrderBrentSolver - Class in org.hipparchus.analysis.solvers
-
This class implements a modification of the Brent algorithm.
- BracketingNthOrderBrentSolver() - Constructor for class org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolver
-
Construct a solver with default accuracy and maximal order (1e-6 and 5 respectively)
- BracketingNthOrderBrentSolver(double, double, double, int) - Constructor for class org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolver
-
Construct a solver.
- BracketingNthOrderBrentSolver(double, double, int) - Constructor for class org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolver
-
Construct a solver.
- BracketingNthOrderBrentSolver(double, int) - Constructor for class org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolver
-
Construct a solver.
- BrentOptimizer - Class in org.hipparchus.optim.univariate
-
For a function defined on some interval
(lo, hi)
, this class finds an approximationx
to the point at which the function attains its minimum. - BrentOptimizer(double, double) - Constructor for class org.hipparchus.optim.univariate.BrentOptimizer
-
The arguments are used for implementing the original stopping criterion of Brent's algorithm.
- BrentOptimizer(double, double, ConvergenceChecker<UnivariatePointValuePair>) - Constructor for class org.hipparchus.optim.univariate.BrentOptimizer
-
The arguments are used implement the original stopping criterion of Brent's algorithm.
- BrentSolver - Class in org.hipparchus.analysis.solvers
-
This class implements the Brent algorithm for finding zeros of real univariate functions.
- BrentSolver() - Constructor for class org.hipparchus.analysis.solvers.BrentSolver
-
Construct a solver with default absolute accuracy (1e-6).
- BrentSolver(double) - Constructor for class org.hipparchus.analysis.solvers.BrentSolver
-
Construct a solver.
- BrentSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.BrentSolver
-
Construct a solver.
- BrentSolver(double, double, double) - Constructor for class org.hipparchus.analysis.solvers.BrentSolver
-
Construct a solver.
- BRep(List<Vector3D>, List<int[]>) - Constructor for class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet.BRep
-
Simple constructor.
- BSPTree<S extends Space> - Class in org.hipparchus.geometry.partitioning
-
This class represent a Binary Space Partition tree.
- BSPTree() - Constructor for class org.hipparchus.geometry.partitioning.BSPTree
-
Build a tree having only one root cell representing the whole space.
- BSPTree(Object) - Constructor for class org.hipparchus.geometry.partitioning.BSPTree
-
Build a tree having only one root cell representing the whole space.
- BSPTree(SubHyperplane<S>, BSPTree<S>, BSPTree<S>, Object) - Constructor for class org.hipparchus.geometry.partitioning.BSPTree
-
Build a BSPTree from its underlying elements.
- BSPTree.LeafMerger<S extends Space> - Interface in org.hipparchus.geometry.partitioning
-
This interface gather the merging operations between a BSP tree leaf and another BSP tree.
- BSPTree.VanishingCutHandler<S extends Space> - Interface in org.hipparchus.geometry.partitioning
-
This interface handles the corner cases when an internal node cut sub-hyperplane vanishes.
- BSPTreeVisitor<S extends Space> - Interface in org.hipparchus.geometry.partitioning
-
This interface is used to visit
BSP tree
nodes. - BSPTreeVisitor.Order - Enum in org.hipparchus.geometry.partitioning
-
Enumerate for visit order with respect to plus sub-tree, minus sub-tree and cut sub-hyperplane.
- build() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Construct a
LeastSquaresProblem
from the data in this builder. - build() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics.StreamingStatisticsBuilder
-
Builds a StreamingStatistics instance with currently defined properties.
- build(double) - Static method in class org.hipparchus.special.elliptic.jacobi.JacobiEllipticBuilder
-
Build an algorithm for computing Jacobi elliptic functions.
- build(double...) - Method in class org.hipparchus.analysis.differentiation.DSFactory
-
Build a
DerivativeStructure
from all its derivatives. - build(double...) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
Build a
FieldDerivativeStructure
from all its derivatives. - build(double[]) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Build an initial simplex.
- build(Complex) - Static method in class org.hipparchus.special.elliptic.jacobi.JacobiEllipticBuilder
-
Build an algorithm for computing Jacobi elliptic functions.
- build(FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.jacobi.JacobiEllipticBuilder
-
Build an algorithm for computing Jacobi elliptic functions.
- build(T) - Static method in class org.hipparchus.special.elliptic.jacobi.JacobiEllipticBuilder
-
Build an algorithm for computing Jacobi elliptic functions.
- build(T...) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
Build a
FieldDerivativeStructure
from all its derivatives. - buildArray(Field<T>, int) - Static method in class org.hipparchus.util.MathArrays
-
Build an array of elements.
- buildArray(Field<T>, int, int) - Static method in class org.hipparchus.util.MathArrays
-
Build a double dimension array of elements.
- buildArray(Field<T>, int, int, int) - Static method in class org.hipparchus.util.MathArrays
-
Build a triple dimension array of elements.
- buildConvex(Hyperplane<S>...) - Method in class org.hipparchus.geometry.partitioning.RegionFactory
-
Build a convex region from a collection of bounding hyperplanes.
- builder() - Static method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns a
StreamingStatistics.StreamingStatisticsBuilder
to source configuredStreamingStatistics
instances. - buildNew(BSPTree<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.IntervalsSet
-
Build a region using the instance as a prototype.
- buildNew(BSPTree<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Build a region using the instance as a prototype.
- buildNew(BSPTree<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.PolygonsSet
-
Build a region using the instance as a prototype.
- buildNew(BSPTree<Sphere1D>) - Method in class org.hipparchus.geometry.spherical.oned.ArcsSet
-
Build a region using the instance as a prototype.
- buildNew(BSPTree<Sphere2D>) - Method in class org.hipparchus.geometry.spherical.twod.SphericalPolygonsSet
-
Build a region using the instance as a prototype.
- buildNew(BSPTree<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Build a region using the instance as a prototype.
- buildNew(BSPTree<S>) - Method in interface org.hipparchus.geometry.partitioning.Region
-
Build a region using the instance as a prototype.
- buildNew(Hyperplane<Euclidean1D>, Region<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.SubOrientedPoint
-
Build a sub-hyperplane from an hyperplane and a region.
- buildNew(Hyperplane<Euclidean3D>, Region<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.threed.SubPlane
-
Build a sub-hyperplane from an hyperplane and a region.
- buildNew(Hyperplane<Euclidean2D>, Region<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.twod.SubLine
-
Build a sub-hyperplane from an hyperplane and a region.
- buildNew(Hyperplane<Sphere1D>, Region<Sphere1D>) - Method in class org.hipparchus.geometry.spherical.oned.SubLimitAngle
-
Build a sub-hyperplane from an hyperplane and a region.
- buildNew(Hyperplane<Sphere2D>, Region<Sphere1D>) - Method in class org.hipparchus.geometry.spherical.twod.SubCircle
-
Build a sub-hyperplane from an hyperplane and a region.
- buildNew(Hyperplane<S>, Region<T>) - Method in class org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Build a sub-hyperplane from an hyperplane and a region.
- ButcherArrayProvider - Interface in org.hipparchus.ode.nonstiff
-
This interface represents an integrator based on Butcher arrays.
- byteValue() - Method in class org.hipparchus.util.Binary64
-
The current implementation performs casting to a
byte
.
C
- calculateAdjustedRSquared() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Returns the adjusted R-squared statistic, defined by the formula \(R_\mathrm{adj}^2 = 1 - \frac{\mathrm{SSR} (n - 1)}{\mathrm{SSTO} (n - p)}\) where SSR is the
sum of squared residuals
, SSTO is thetotal sum of squares
, n is the number of observations and p is the number of parameters estimated (including the intercept). - 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
-
Used by
ZipfDistribution.getNumericalMean()
. - 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 \(R^2 = 1 - \frac{\mathrm{SSR}}{\mathrm{SSTO}}\) where SSR is the
sum of squared residuals
and SSTO is thetotal sum of squares
- 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.
- CalculusFieldBivariateFunction<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.analysis
-
An interface representing a bivariate field function.
- CalculusFieldElement<T extends FieldElement<T>> - Interface in org.hipparchus
-
Interface representing a field with calculus capabilities (sin, cos, ...).
- CalculusFieldMultivariateFunction<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.analysis
-
An interface representing a scalar multivariate function.
- CalculusFieldMultivariateMatrixFunction<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.analysis
-
An interface representing a matrix multivariate function.
- CalculusFieldMultivariateVectorFunction<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.analysis
-
An interface representing a vector multivariate function.
- CalculusFieldUnivariateFunction<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.analysis
-
An interface representing a univariate real function.
- CalculusFieldUnivariateMatrixFunction<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.analysis
-
An interface representing a univariate matrix function.
- CalculusFieldUnivariateVectorFunction<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.analysis
-
An interface representing a univariate vectorial function for any field type.
- CanberraDistance - Class in org.hipparchus.clustering.distance
-
Calculates the Canberra distance between two points.
- CanberraDistance() - Constructor for class org.hipparchus.clustering.distance.CanberraDistance
-
Empty constructor.
- 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 - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_CLEAR_STATISTIC_CONSTRUCTED_FROM_EXTERNAL_MOMENTS.
- CANNOT_CLEAR_STATISTIC_CONSTRUCTED_FROM_EXTERNAL_MOMENTS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.CANNOT_CLEAR_STATISTIC_CONSTRUCTED_FROM_EXTERNAL_MOMENTS.
- CANNOT_COMPUTE_0TH_ROOT_OF_UNITY - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CANNOT_COMPUTE_0TH_ROOT_OF_UNITY.
- CANNOT_COMPUTE_0TH_ROOT_OF_UNITY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_COMPUTE_0TH_ROOT_OF_UNITY.
- CANNOT_COMPUTE_BETA_DENSITY_AT_0_FOR_SOME_ALPHA - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CANNOT_COMPUTE_BETA_DENSITY_AT_0_FOR_SOME_ALPHA.
- CANNOT_COMPUTE_BETA_DENSITY_AT_0_FOR_SOME_ALPHA - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_COMPUTE_BETA_DENSITY_AT_0_FOR_SOME_ALPHA.
- CANNOT_COMPUTE_BETA_DENSITY_AT_1_FOR_SOME_BETA - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CANNOT_COMPUTE_BETA_DENSITY_AT_1_FOR_SOME_BETA.
- CANNOT_COMPUTE_BETA_DENSITY_AT_1_FOR_SOME_BETA - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_COMPUTE_BETA_DENSITY_AT_1_FOR_SOME_BETA.
- CANNOT_COMPUTE_NTH_ROOT_FOR_NEGATIVE_N - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CANNOT_COMPUTE_NTH_ROOT_FOR_NEGATIVE_N.
- CANNOT_COMPUTE_NTH_ROOT_FOR_NEGATIVE_N - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_COMPUTE_NTH_ROOT_FOR_NEGATIVE_N.
- CANNOT_DISCARD_NEGATIVE_NUMBER_OF_ELEMENTS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CANNOT_DISCARD_NEGATIVE_NUMBER_OF_ELEMENTS.
- CANNOT_DISCARD_NEGATIVE_NUMBER_OF_ELEMENTS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_DISCARD_NEGATIVE_NUMBER_OF_ELEMENTS.
- CANNOT_FORMAT_INSTANCE_AS_3D_VECTOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_FORMAT_INSTANCE_AS_3D_VECTOR.
- CANNOT_FORMAT_INSTANCE_AS_3D_VECTOR - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.CANNOT_FORMAT_INSTANCE_AS_3D_VECTOR.
- CANNOT_FORMAT_INSTANCE_AS_COMPLEX - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CANNOT_FORMAT_INSTANCE_AS_COMPLEX.
- CANNOT_FORMAT_INSTANCE_AS_COMPLEX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_FORMAT_INSTANCE_AS_COMPLEX.
- CANNOT_FORMAT_INSTANCE_AS_REAL_VECTOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_FORMAT_INSTANCE_AS_REAL_VECTOR.
- CANNOT_FORMAT_INSTANCE_AS_REAL_VECTOR - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.CANNOT_FORMAT_INSTANCE_AS_REAL_VECTOR.
- CANNOT_FORMAT_OBJECT_TO_FRACTION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CANNOT_FORMAT_OBJECT_TO_FRACTION.
- CANNOT_FORMAT_OBJECT_TO_FRACTION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_FORMAT_OBJECT_TO_FRACTION.
- CANNOT_INCREMENT_STATISTIC_CONSTRUCTED_FROM_EXTERNAL_MOMENTS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_INCREMENT_STATISTIC_CONSTRUCTED_FROM_EXTERNAL_MOMENTS.
- CANNOT_INCREMENT_STATISTIC_CONSTRUCTED_FROM_EXTERNAL_MOMENTS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.CANNOT_INCREMENT_STATISTIC_CONSTRUCTED_FROM_EXTERNAL_MOMENTS.
- CANNOT_NORMALIZE_A_ZERO_NORM_VECTOR - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
CANNOT_NORMALIZE_A_ZERO_NORM_VECTOR.
- CANNOT_NORMALIZE_A_ZERO_NORM_VECTOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_NORMALIZE_A_ZERO_NORM_VECTOR.
- CANNOT_PARSE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CANNOT_PARSE.
- CANNOT_PARSE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_PARSE.
- CANNOT_PARSE_AS_TYPE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CANNOT_PARSE_AS_TYPE.
- CANNOT_PARSE_AS_TYPE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_PARSE_AS_TYPE.
- CANNOT_RETRIEVE_AT_NEGATIVE_INDEX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_RETRIEVE_AT_NEGATIVE_INDEX.
- CANNOT_RETRIEVE_AT_NEGATIVE_INDEX - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.CANNOT_RETRIEVE_AT_NEGATIVE_INDEX.
- CANNOT_SET_AT_NEGATIVE_INDEX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_SET_AT_NEGATIVE_INDEX.
- CANNOT_SET_AT_NEGATIVE_INDEX - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.CANNOT_SET_AT_NEGATIVE_INDEX.
- CANNOT_SUBSTITUTE_ELEMENT_FROM_EMPTY_ARRAY - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CANNOT_SUBSTITUTE_ELEMENT_FROM_EMPTY_ARRAY.
- CANNOT_SUBSTITUTE_ELEMENT_FROM_EMPTY_ARRAY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_SUBSTITUTE_ELEMENT_FROM_EMPTY_ARRAY.
- CANNOT_TRANSFORM_TO_DOUBLE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CANNOT_TRANSFORM_TO_DOUBLE.
- CANNOT_TRANSFORM_TO_DOUBLE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.CANNOT_TRANSFORM_TO_DOUBLE.
- CARDAN_ANGLES_SINGULARITY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CARDAN_ANGLES_SINGULARITY.
- CARDAN_ANGLES_SINGULARITY - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.CARDAN_ANGLES_SINGULARITY.
- CardanEulerSingularityException - Exception in org.hipparchus.migration.geometry.euclidean
-
Deprecated.
- CardanEulerSingularityException(boolean) - Constructor for exception org.hipparchus.migration.geometry.euclidean.CardanEulerSingularityException
-
Deprecated.Simple constructor.
- CarlsonEllipticIntegral - Class in org.hipparchus.special.elliptic.carlson
-
Elliptic integrals in Carlson symmetric form.
- 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 interface org.hipparchus.analysis.differentiation.Derivative1
-
Cubic root.
- cbrt() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Cubic root.
- cbrt() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Cubic root.
- cbrt() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Cubic root.
- cbrt() - Method in interface org.hipparchus.CalculusFieldElement
-
Cubic root.
- cbrt() - Method in class org.hipparchus.complex.Complex
-
Cubic root.
- cbrt() - Method in class org.hipparchus.complex.FieldComplex
-
Cubic root.
- cbrt() - Method in class org.hipparchus.util.Binary64
-
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
-
Empty constructor.
- cd() - Method in class org.hipparchus.special.elliptic.jacobi.CopolarD
-
Get the value of the cd function.
- cd() - Method in class org.hipparchus.special.elliptic.jacobi.FieldCopolarD
-
Get the value of the cd function.
- 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 interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Get the smallest whole number larger than instance.
- ceil() - Method in interface org.hipparchus.CalculusFieldElement
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.complex.Complex
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.complex.FieldComplex
-
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 class org.hipparchus.util.Binary64
-
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
-
Empty constructor.
- ceilDiv(int, int) - Static method in class org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
withb < r <= 0
ifb > 0
and0 <= r < b
ifb < 0
. - ceilDiv(long, int) - Static method in class org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
withb < r <= 0
ifb > 0
and0 <= r < b
ifb < 0
. - ceilDiv(long, long) - Static method in class org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
withb < r <= 0
ifb > 0
and0 <= r < b
ifb < 0
. - ceilDivExact(int, int) - Static method in class org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
withb < r <= 0
ifb > 0
and0 <= r < b
ifb < 0
. - ceilDivExact(long, long) - Static method in class org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
withb < r <= 0
ifb > 0
and0 <= r < b
ifb < 0
. - ceilMod(int, int) - Static method in class org.hipparchus.util.FastMath
-
Finds r such that
a = q b + r
withb < r <= 0
ifb > 0
and0 <= r < b
ifb < 0
. - ceilMod(long, int) - Static method in class org.hipparchus.util.FastMath
-
Finds r such that
a = q b + r
withb < r <= 0
ifb > 0
and0 <= r < b
ifb < 0
. - ceilMod(long, long) - Static method in class org.hipparchus.util.FastMath
-
Finds r such that
a = q b + r
withb < r <= 0
ifb > 0
and0 <= r < b
ifb < 0
. - CENTRAL - Enum constant in enum 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
-
Empty constructor.
- 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.
- checkBetweenZeroAndOneIncluded(double) - Static method in class org.hipparchus.analysis.polynomials.SmoothStepFactory
-
Check that input is between [0: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.
- checkEqualLength(T[], T[]) - Static method in class org.hipparchus.util.MathArrays
-
Check that both arrays have the same length.
- checkEqualLength(T[], T[], 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.
- checkInputEdges(double, double) - Method in class org.hipparchus.analysis.polynomials.SmoothStepFactory.FieldSmoothStepFunction
-
Check that left edge is lower than right edge.
- checkInputEdges(double, double) - Method in class org.hipparchus.analysis.polynomials.SmoothStepFactory.SmoothStepFunction
-
Check that left edge is lower than right edge.
- 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.
- checkOrder(T[]) - Static method in class org.hipparchus.util.MathArrays
-
Check that the given array is sorted in strictly increasing order.
- checkOrder(T[], MathArrays.OrderDirection, boolean) - Static method in class org.hipparchus.util.MathArrays
-
Check that the given array is sorted.
- checkOrder(T[], 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
andsolveInPlace
, 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
andsolveInPlace
, 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, V>) - 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, V>) - 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.
- checkTolerance(double) - Static method in class org.hipparchus.geometry.spherical.oned.Sphere1D
-
Check tolerance against
Sphere1D.SMALLEST_TOLERANCE
. - checkTolerance(double) - Static method in class org.hipparchus.geometry.spherical.twod.Sphere2D
-
Check tolerance against
Sphere2D.SMALLEST_TOLERANCE
. - 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
-
Computes the Chi-Square statistic associated with a chi-square test of independence based on the input
counts
array, viewed as a two-way table. - chiSquare(long[][]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes the Chi-Square statistic associated with a chi-square test of independence based on the input
counts
array, viewed as a two-way table. - chiSquareDataSetsComparison(long[], long[]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
Computes a Chi-Square two sample test statistic comparing bin frequency counts in
observed1
andobserved2
. - chiSquareDataSetsComparison(long[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes a Chi-Square two sample test statistic comparing bin frequency counts in
observed1
andobserved2
. - 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
-
Returns the observed significance level, or p-value, associated with a Chi-square goodness of fit test comparing the
observed
frequency counts to those in theexpected
array. - chiSquareTest(double[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Returns the observed significance level, or p-value, associated with a Chi-square goodness of fit test comparing the
observed
frequency counts to those in theexpected
array. - 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
-
Performs a Chi-square goodness of fit test evaluating the null hypothesis that the observed counts conform to the frequency distribution described by the expected counts, with significance level
alpha
. - chiSquareTest(long[][]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
Returns the observed significance level, or p-value, associated with a chi-square test of independence based on the input
counts
array, viewed as a two-way table. - chiSquareTest(long[][]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Returns the observed significance level, or p-value, associated with a chi-square test of independence based on the input
counts
array, viewed as a two-way table. - chiSquareTest(long[][], double) - Method in class org.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
-
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 - Class in org.hipparchus.stat.inference
-
Implements Chi-Square test statistics.
- ChiSquareTest() - Constructor for class org.hipparchus.stat.inference.ChiSquareTest
-
Empty constructor.
- 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
andobserved2
. - chiSquareTestDataSetsComparison(long[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Returns the observed significance level, or p-value, associated with a Chi-Square two sample test comparing bin frequency counts in
observed1
andobserved2
. - 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
-
Performs a Chi-Square two sample test comparing two binned data sets.
- 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.
- clamp(double, double, double) - Static method in class org.hipparchus.util.FastMath
-
Clamp a value within an interval.
- clamp(float, float, float) - Static method in class org.hipparchus.util.FastMath
-
Clamp a value within an interval.
- clamp(int, int, int) - Static method in class org.hipparchus.util.FastMath
-
Clamp a value within an interval.
- clamp(long, int, int) - Static method in class org.hipparchus.util.FastMath
-
Clamp a value within an interval.
- clamp(long, long, long) - Static method in class org.hipparchus.util.FastMath
-
Clamp a value within an interval.
- clampInput(double, double, double) - Method in class org.hipparchus.analysis.polynomials.SmoothStepFactory.SmoothStepFunction
-
Clamp input between edges.
- clampInput(double, double, T) - Method in class org.hipparchus.analysis.polynomials.SmoothStepFactory.FieldSmoothStepFunction
-
Clamp input between edges.
- CLASS_DOESNT_IMPLEMENT_COMPARABLE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CLASS_DOESNT_IMPLEMENT_COMPARABLE.
- CLASS_DOESNT_IMPLEMENT_COMPARABLE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.CLASS_DOESNT_IMPLEMENT_COMPARABLE.
- ClassicalRungeKuttaFieldIntegrator<T extends CalculusFieldElement<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.
- clearCache() - Method in class org.hipparchus.random.JDKRandomGenerator
-
Clears the cache used by the default implementation of
RandomGenerator.nextGaussian()
. - clearEventDetectors() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearEventDetectors() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearEventDetectors() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearEventDetectors() - 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.
- clearStepEndHandlers() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Remove all the handlers for step ends that have been added to the integrator.
- clearStepEndHandlers() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Remove all the handlers for step ends that have been added to the integrator.
- clearStepEndHandlers() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Remove all the handlers for step ends that have been added to the integrator.
- clearStepEndHandlers() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Remove all the handlers for step ends that have been added to the integrator.
- 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.
- CLOSE_VERTICES - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
CLOSE_VERTICES.
- CLOSE_VERTICES - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CLOSE_VERTICES.
- CLOSEST_ORTHOGONAL_MATRIX_HAS_NEGATIVE_DETERMINANT - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
CLOSEST_ORTHOGONAL_MATRIX_HAS_NEGATIVE_DETERMINANT.
- CLOSEST_ORTHOGONAL_MATRIX_HAS_NEGATIVE_DETERMINANT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CLOSEST_ORTHOGONAL_MATRIX_HAS_NEGATIVE_DETERMINANT.
- 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 holding a set of
Clusterable
points. - 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
-
Empty constructor.
- ClusterAlgorithmComparison.ClusterPlot - Class in org.hipparchus.samples
-
Plot component.
- ClusterAlgorithmComparison.Display - Class in org.hipparchus.samples
-
Display frame.
- Clusterer<T extends Clusterable> - Class in org.hipparchus.clustering
-
Base class for clustering algorithms.
- Clusterer(DistanceMeasure) - Constructor for class org.hipparchus.clustering.Clusterer
-
Build a new clusterer with the given
DistanceMeasure
. - 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
-
Creates a new cluster evaluator with an
EuclideanDistance
as distance measure. - 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
-
Simple constructor.
- 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
-
Simple constructor.
- 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.
- cn() - Method in class org.hipparchus.special.elliptic.jacobi.CopolarN
-
Get the value of the cn function.
- cn() - Method in class org.hipparchus.special.elliptic.jacobi.FieldCopolarN
-
Get the value of the cn function.
- 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 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
COLUMN_INDEX.
- COLUMN_INDEX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.COLUMN_INDEX.
- COLUMN_INDEX_OUT_OF_RANGE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.COLUMN_INDEX_OUT_OF_RANGE.
- COLUMN_INDEX_OUT_OF_RANGE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.COLUMN_INDEX_OUT_OF_RANGE.
- Combinations - Class in org.hipparchus.util
-
Utility to create combinations
(n, k)
ofk
elements in a set ofn
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 ofthis
andy
. - combine(double, double, RealVector) - Method in class org.hipparchus.linear.RealVector
-
Returns a new vector representing
a * this + b * y
, the linear combination ofthis
andy
. - 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 ofthis
andy
. - combineToSelf(double, double, RealVector) - Method in class org.hipparchus.linear.RealVector
-
Updates
this
with the linear combination ofthis
andy
. - 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(UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
- compareTo(UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
- compareTo(Complex) - Method in class org.hipparchus.complex.Complex
- 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(Binary64) - Method in class org.hipparchus.util.Binary64
-
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 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
COMPLEX_CANNOT_BE_CONSIDERED_A_REAL_NUMBER.
- ComplexComparator - Class in org.hipparchus.complex
-
Comparator for Complex Numbers.
- ComplexComparator() - Constructor for class org.hipparchus.complex.ComplexComparator
-
Empty constructor.
- ComplexEigenDecomposition - Class in org.hipparchus.linear
-
Given a matrix A, it computes a complex eigen decomposition AV = VD.
- ComplexEigenDecomposition(RealMatrix) - Constructor for class org.hipparchus.linear.ComplexEigenDecomposition
-
Constructor for decomposition.
- ComplexEigenDecomposition(RealMatrix, double, double, double) - 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.
- ComplexODEConverter - Class in org.hipparchus.ode
-
This class converts
complex Ordinary Differential Equations
intoreal ones
. - ComplexODEConverter() - Constructor for class org.hipparchus.ode.ComplexODEConverter
-
Empty constructor.
- ComplexODEState - Class in org.hipparchus.ode
-
Container for time, main and secondary state vectors.
- ComplexODEState(double, Complex[]) - Constructor for class org.hipparchus.ode.ComplexODEState
-
Simple constructor.
- ComplexODEState(double, Complex[], Complex[][]) - Constructor for class org.hipparchus.ode.ComplexODEState
-
Simple constructor.
- ComplexODEStateAndDerivative - Class in org.hipparchus.ode
-
Container for time, main and secondary state vectors as well as their derivatives.
- ComplexODEStateAndDerivative(double, Complex[], Complex[]) - Constructor for class org.hipparchus.ode.ComplexODEStateAndDerivative
-
Simple constructor.
- ComplexODEStateAndDerivative(double, Complex[], Complex[], Complex[][], Complex[][]) - Constructor for class org.hipparchus.ode.ComplexODEStateAndDerivative
-
Simple constructor.
- ComplexOrdinaryDifferentialEquation - Interface in org.hipparchus.ode
-
This interface represents a first order differential equations set for
complex state
. - ComplexSecondaryODE - Interface in org.hipparchus.ode
-
This interface allows users to add secondary differential equations to a primary set of differential equations.
- ComplexUnivariateIntegrator - Class in org.hipparchus.complex
-
Wrapper to perform univariate complex integration using an underlying real integration algorithms.
- ComplexUnivariateIntegrator(UnivariateIntegrator) - Constructor for class org.hipparchus.complex.ComplexUnivariateIntegrator
-
Crate a complex integrator from a real integrator.
- ComplexUtils - Class in org.hipparchus.complex
-
Static implementations of common
Complex
utilities functions. - compose(double...) - Method in interface org.hipparchus.analysis.differentiation.Derivative
-
Compute composition of the instance by a univariate function.
- 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...) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute composition of the instance by a univariate function.
- compose(double...) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute composition of the instance by a univariate function.
- compose(double...) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute composition of the instance by a univariate function.
- compose(double...) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
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 interface org.hipparchus.analysis.differentiation.Derivative1
-
Compute composition of the instance by a univariate function differentiable at order 1.
- compose(double, double) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute composition of the instance by a univariate function differentiable at order 1.
- compose(double, double) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute composition of the instance by a univariate function differentiable at order 1.
- compose(double, double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute composition of the instance by a univariate function differentiable at order 1.
- compose(FieldTaylorMap<T>) - Method in class org.hipparchus.analysis.differentiation.FieldTaylorMap
-
Compose the instance with another Taylor map as \(\mathrm{this} \circ \mathrm{other}\).
- compose(TaylorMap) - Method in class org.hipparchus.analysis.differentiation.TaylorMap
-
Compose the instance with another Taylor map as \(\mathrm{this} \circ \mathrm{other}\).
- 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(S, S) - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Compute composition of the instance by a univariate function differentiable at order 1.
- 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.
- compose(T, T) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute composition of the instance by a function.
- compose(T, T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute composition of the instance by a function.
- compose(T, T, T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute composition of the instance 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
-
Computes the correlation matrix for the columns of the input matrix, using
PearsonsCorrelation.correlation(double[], double[])
. - 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(double, Complex[]) - Method in interface org.hipparchus.ode.ComplexOrdinaryDifferentialEquation
-
Get the current time derivative of the state vector.
- computeDerivatives(double, Complex[], Complex[], Complex[]) - Method in interface org.hipparchus.ode.ComplexSecondaryODE
-
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.
- computeObjectiveValue(T) - Method in class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Compute 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.AbstractRuleFactory
-
Computes the rule for the given order.
- computeRule(int) - Method in class org.hipparchus.analysis.integration.gauss.ConvertingRuleFactory
-
Computes the rule for the given order.
- computeRule(int) - Method in class org.hipparchus.analysis.integration.gauss.FieldAbstractRuleFactory
-
Computes the rule for the given order.
- computeRule(int) - Method in class org.hipparchus.analysis.integration.gauss.FieldHermiteRuleFactory
-
Computes the rule for the given order.
- computeRule(int) - Method in class org.hipparchus.analysis.integration.gauss.FieldLaguerreRuleFactory
-
Computes the rule for the given order.
- computeRule(int) - Method in class org.hipparchus.analysis.integration.gauss.FieldLegendreRuleFactory
-
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.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.MultistepFieldIntegrator
-
Compute step grow/shrink factor according to normalized error.
- computeStepGrowShrinkFactor(double) - Method in class org.hipparchus.ode.MultistepIntegrator
-
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.
- conjugate() - Method in class org.hipparchus.complex.FieldComplex
-
Returns the conjugate of this complex number.
- ConjugateGradient - Class in org.hipparchus.linear
-
This is an implementation of the conjugate gradient method for
RealLinearOperator
. - ConjugateGradient(int, double, boolean) - Constructor for class org.hipparchus.linear.ConjugateGradient
-
Creates a new instance of this class, with default stopping criterion.
- ConjugateGradient(IterationManager, double, boolean) - Constructor for class org.hipparchus.linear.ConjugateGradient
-
Creates a new instance of this class, with default stopping criterion and custom iteration manager.
- constant(double) - Method in class org.hipparchus.analysis.differentiation.DSFactory
-
Build a
DerivativeStructure
representing a constant value. - constant(double) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
Build a
FieldDerivativeStructure
representing a constant value. - constant(int, double) - Static method in class org.hipparchus.analysis.differentiation.Gradient
-
Build an instance corresponding to a constant value.
- constant(int, T) - Static method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Build an instance corresponding to a constant value.
- constant(T) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
Build a
FieldDerivativeStructure
representing a constant value. - Constant - Class in org.hipparchus.analysis.function
-
Constant function.
- Constant(double) - Constructor for class org.hipparchus.analysis.function.Constant
-
Simple constructor.
- 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 - Interface in org.hipparchus.optim.nonlinear.vector.constrained
-
Generic constraint.
- CONSTRAINT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CONSTRAINT.
- CONSTRAINT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CONSTRAINT.
- ConstraintOptimizer - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Abstract Constraint Optimizer.
- ConstraintOptimizer() - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.ConstraintOptimizer
-
Simple constructor.
- CONSTRAINTS_RANK - Enum constant in enum org.hipparchus.optim.LocalizedOptimFormats
-
CONSTRAINTS_RANK.
- 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.AbstractOpenIntHashMap
-
Check if a value is associated with a key.
- containsKey(int, int) - Method in class org.hipparchus.util.AbstractOpenIntHashMap
-
Check if the tables contain an element associated with specified key at specified index.
- CONTINUE - Enum constant in enum org.hipparchus.migration.ode.events.EventHandler.Action
-
Deprecated.Continue indicator.
- CONTINUE - Enum constant in enum org.hipparchus.ode.events.Action
-
Continue indicator.
- CONTINUED_FRACTION_INFINITY_DIVERGENCE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CONTINUED_FRACTION_INFINITY_DIVERGENCE.
- CONTINUED_FRACTION_INFINITY_DIVERGENCE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CONTINUED_FRACTION_INFINITY_DIVERGENCE.
- CONTINUED_FRACTION_NAN_DIVERGENCE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CONTINUED_FRACTION_NAN_DIVERGENCE.
- CONTINUED_FRACTION_NAN_DIVERGENCE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CONTINUED_FRACTION_NAN_DIVERGENCE.
- ContinuedFraction - Class in org.hipparchus.util
-
Provides a generic means to evaluate continued fractions.
- ContinuedFraction() - Constructor for class org.hipparchus.util.ContinuedFraction
-
Default constructor.
- ContinuousModuleValue - Class in org.hipparchus.samples.complex
-
Classical method for domain coloring.
- ContinuousModuleValue(double) - Constructor for class org.hipparchus.samples.complex.ContinuousModuleValue
-
Simple constructor.
- ContinuousOutputModel - Class in org.hipparchus.migration.ode
-
Deprecated.as of 1.0, replaced with
DenseOutputModel
- ContinuousOutputModel() - Constructor for class org.hipparchus.migration.ode.ContinuousOutputModel
-
Deprecated.Empty constructor.
- 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 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CONTRACTION_CRITERIA_SMALLER_THAN_EXPANSION_FACTOR.
- CONTRACTION_CRITERIA_SMALLER_THAN_EXPANSION_FACTOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CONTRACTION_CRITERIA_SMALLER_THAN_EXPANSION_FACTOR.
- CONTRACTION_CRITERIA_SMALLER_THAN_ONE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CONTRACTION_CRITERIA_SMALLER_THAN_ONE.
- CONTRACTION_CRITERIA_SMALLER_THAN_ONE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CONTRACTION_CRITERIA_SMALLER_THAN_ONE.
- converged(double, double, double, double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPConvergenceChecker
-
Evaluate convergence.
- converged(int, LagrangeSolution, LagrangeSolution) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPConvergenceChecker
-
Check if the optimization algorithm has converged.
- 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, P, P) - Method in class org.hipparchus.optim.AbstractConvergenceChecker
-
Check if the optimization algorithm has converged.
- converged(int, P, P) - Method in interface org.hipparchus.optim.ConvergenceChecker
-
Check if the optimization algorithm has converged.
- converged(int, P, P) - Method in class org.hipparchus.optim.ConvergenceCheckerAndMultiplexer
-
Check if the optimization algorithm has converged.
- converged(int, P, P) - Method in class org.hipparchus.optim.ConvergenceCheckerOrMultiplexer
-
Check if the optimization algorithm has converged.
- converged(int, P, P) - Method in class org.hipparchus.optim.SimplePointChecker
-
Check if the optimization algorithm has converged considering the last two points.
- CONVERGENCE_FAILED - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CONVERGENCE_FAILED.
- CONVERGENCE_FAILED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CONVERGENCE_FAILED.
- ConvergenceChecker<P> - Interface in org.hipparchus.optim
-
This interface specifies how to check if an optimization algorithm has converged.
- ConvergenceCheckerAndMultiplexer<P> - Class in org.hipparchus.optim
-
Multiplexer for
ConvergenceChecker
, checking all the checkers converged. - ConvergenceCheckerAndMultiplexer(List<ConvergenceChecker<P>>) - Constructor for class org.hipparchus.optim.ConvergenceCheckerAndMultiplexer
-
Simple constructor.
- ConvergenceCheckerOrMultiplexer<P> - Class in org.hipparchus.optim
-
Multiplexer for
ConvergenceChecker
, checking one of the checkers converged. - ConvergenceCheckerOrMultiplexer(List<ConvergenceChecker<P>>) - Constructor for class org.hipparchus.optim.ConvergenceCheckerOrMultiplexer
-
Simple constructor.
- ConvergenceException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalStateException
- 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.
- convergent(double, int, BigFraction.ConvergenceTest) - Static method in class org.hipparchus.fraction.BigFraction
-
Returns the last element of the series of convergent-steps to approximate the given value.
- convergent(double, int, Fraction.ConvergenceTest) - Static method in class org.hipparchus.fraction.Fraction
-
Returns the last element of the series of convergent-steps to approximate the given value.
- convergents(double, int) - Static method in class org.hipparchus.fraction.BigFraction
-
Generate a
stream
of convergents from a real number. - convergents(double, int) - Static method in class org.hipparchus.fraction.Fraction
-
Generate a
stream
of convergents from a real number. - convertEquations(ComplexOrdinaryDifferentialEquation) - Method in class org.hipparchus.ode.ComplexODEConverter
-
Convert an equations set.
- ConvertingRuleFactory<T extends FieldElement<T>> - Class in org.hipparchus.analysis.integration.gauss
- ConvertingRuleFactory(FieldRuleFactory<T>) - Constructor for class org.hipparchus.analysis.integration.gauss.ConvertingRuleFactory
-
Simple constructor.
- convertSecondaryEquations(ComplexSecondaryODE) - Method in class org.hipparchus.ode.ComplexODEConverter
-
Convert a secondary equations set.
- convertState(ComplexODEState) - Method in class org.hipparchus.ode.ComplexODEConverter
-
Convert a complex state (typically the initial state).
- convertState(ODEStateAndDerivative) - Method in class org.hipparchus.ode.ComplexODEConverter
-
Convert a real state and derivatives (typically the final state or some intermediate state for step handling or event handling).
- 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
-
Calculates the convolution between two sequences.
- CopolarC - Class in org.hipparchus.special.elliptic.jacobi
-
Copolar trio with pole at point c in Glaisher’s Notation.
- CopolarD - Class in org.hipparchus.special.elliptic.jacobi
-
Copolar trio with pole at point d in Glaisher’s Notation.
- CopolarN - Class in org.hipparchus.special.elliptic.jacobi
-
Copolar trio with pole at point n in Glaisher’s Notation.
- CopolarS - Class in org.hipparchus.special.elliptic.jacobi
-
Copolar trio with pole at point s in Glaisher’s Notation.
- 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(Complex[][]) - Method in class org.hipparchus.ode.ComplexODEState
-
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.
- copySelf() - Method in interface org.hipparchus.stat.descriptive.rank.PSquarePercentile.PSquareMarkers
-
A deep copy function to clone the current 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.FieldGradient
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
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.analysis.differentiation.UnivariateDerivative1
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in interface org.hipparchus.CalculusFieldElement
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class org.hipparchus.complex.Complex
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class org.hipparchus.complex.FieldComplex
-
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 class org.hipparchus.util.Binary64
-
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(FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Returns the instance with the sign of the argument.
- copySign(FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Returns the instance with the sign of the argument.
- copySign(FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Returns the instance with the sign of the argument.
- copySign(Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
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(UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Returns the instance with the sign of the argument.
- copySign(UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Returns the instance with the sign of the argument.
- copySign(Complex) - Method in class org.hipparchus.complex.Complex
-
Returns the instance with the sign of the argument.
- copySign(FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
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(Binary64) - Method in class org.hipparchus.util.Binary64
-
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 class org.hipparchus.analysis.differentiation.FieldGradient
-
Returns the instance with the sign of the argument.
- copySign(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Returns the instance with the sign of the argument.
- copySign(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Returns the instance with the sign of the argument.
- copySign(T) - Method in interface org.hipparchus.CalculusFieldElement
-
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.
- copyValue(int, int) - Method in interface org.hipparchus.util.AbstractOpenIntHashMap.ValueCopier
-
Copy a value.
- correct(T, RealMatrix, RealVector, RealMatrix, RealMatrix) - Method in class org.hipparchus.filtering.kalman.AbstractKalmanFilter
-
Perform correction step.
- CorrelatedRandomVectorGenerator - Class in org.hipparchus.random
-
A
RandomVectorGenerator
that generates vectors with with correlated components. - 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 interface org.hipparchus.analysis.differentiation.Derivative1
-
Cosine operation.
- cos() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Cosine operation.
- cos() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Cosine operation.
- cos() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Cosine operation.
- cos() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Cosine operation.
- cos() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Cosine operation.
- cos() - Method in interface org.hipparchus.CalculusFieldElement
-
Cosine operation.
- cos() - Method in class org.hipparchus.complex.Complex
-
Compute the cosine of this complex number.
- cos() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the cosine of this complex number.
- cos() - Method in class org.hipparchus.dfp.Dfp
-
Cosine operation.
- cos() - Method in class org.hipparchus.util.Binary64
-
Cosine operation.
- cos() - Method in class org.hipparchus.util.FieldSinCos
-
Get the value of the cosine.
- 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
-
Empty constructor.
- cosAngle(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Calculates the cosine of the angle between two vectors.
- cosh() - Method in interface org.hipparchus.analysis.differentiation.Derivative
-
Hyperbolic cosine operation.
- cosh() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Hyperbolic cosine operation.
- cosh() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Hyperbolic cosine operation.
- cosh() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Hyperbolic cosine operation.
- cosh() - Method in interface org.hipparchus.CalculusFieldElement
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.complex.Complex
-
Compute the hyperbolic cosine of this complex number.
- cosh() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the hyperbolic cosine of this complex number.
- cosh() - Method in class org.hipparchus.dfp.Dfp
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.util.Binary64
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.util.FieldSinhCosh
-
Get the value of the hyperbolic cosine.
- cosh() - Method in class org.hipparchus.util.FieldTuple
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.util.SinhCosh
-
Get the value of the hyperbolic cosine.
- 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
-
Empty constructor.
- 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 - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.COVARIANCE_MATRIX.
- COVARIANCE_MATRIX - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
COVARIANCE_MATRIX.
- 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
-
Convenience factory method that calls the
constructor
. - create(MultivariateVectorFunction, MultivariateMatrixFunction, double[], double[], RealMatrix, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
Create a
LeastSquaresProblem
from the given elements. - 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(AdaptableInterval, int, BracketedUnivariateSolver<UnivariateFunction>, ODEEventHandler) - Method in class org.hipparchus.ode.events.AbstractODEDetector
-
Build a new instance.
- create(AdaptableInterval, int, BracketedUnivariateSolver<UnivariateFunction>, ODEEventHandler) - Method in class org.hipparchus.ode.events.EventSlopeFilter
-
Build a new instance.
- create(FieldAdaptableInterval<E>, int, BracketedRealFieldUnivariateSolver<E>, FieldODEEventHandler<E>) - Method in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Build a new instance.
- create(FieldAdaptableInterval<E>, int, BracketedRealFieldUnivariateSolver<E>, FieldODEEventHandler<E>) - Method in class org.hipparchus.ode.events.FieldEventSlopeFilter
-
Build a new instance.
- create(MultivariateJacobianFunction, RealVector, RealVector, RealMatrix, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
Create a
LeastSquaresProblem
from the given elements. - create(MultivariateJacobianFunction, RealVector, RealVector, RealMatrix, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int, boolean, ParameterValidator) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
Create a
LeastSquaresProblem
from the given elements. - create(MultivariateJacobianFunction, RealVector, RealVector, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
Create a
LeastSquaresProblem
from the given elements. - 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
-
Create a canvas
- createChart(String, int, int, StyleManager.LegendPosition) - Static method in class org.hipparchus.samples.IntegerDistributionComparison
-
Create a chart.
- createChart(String, int, int, StyleManager.LegendPosition) - Static method in class org.hipparchus.samples.RealDistributionComparison
-
Create a chart.
- 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
-
Create a circle sprite.
- 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.
- createComplex(T, T) - Method in class org.hipparchus.complex.FieldComplex
-
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
-
Create a component.
- createComponent(String, int, int, String[], RealDistribution...) - Static method in class org.hipparchus.samples.RealDistributionComparison
-
Create a component.
- 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
-
Create a cross sprite.
- 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
-
Returns a
FieldMatrix
with specified dimensions. - 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
-
Creates a
FieldVector
with specified dimensions. - 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
-
Create a list of random points.
- 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 specifiedComplex
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
-
Returns a
RealMatrix
with specified dimensions. - 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
-
Creates a
RealVector
with specified dimensions. - 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 - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
CROSSING_BOUNDARY_LOOPS.
- CROSSING_BOUNDARY_LOOPS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CROSSING_BOUNDARY_LOOPS.
- 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(FieldVector2D<T>, FieldVector2D<T>) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the cross-product of the instance and the given points.
- crossProduct(Vector2D, Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the cross-product of the instance and the given points.
- 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, Vector3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the cross-product of the instance with another vector.
- cs() - Method in class org.hipparchus.special.elliptic.jacobi.CopolarS
-
Get the value of the cs function.
- cs() - Method in class org.hipparchus.special.elliptic.jacobi.FieldCopolarS
-
Get the value of the cs function.
- CUMULATIVE_PROBABILITY_RETURNED_NAN - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
CUMULATIVE_PROBABILITY_RETURNED_NAN.
- CUMULATIVE_PROBABILITY_RETURNED_NAN - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.CUMULATIVE_PROBABILITY_RETURNED_NAN.
- 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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(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 returnsP(X <= x)
. - currentInterval(FieldODEStateAndDerivative<T>) - Method in interface org.hipparchus.ode.events.FieldAdaptableInterval
-
Get the current value of maximal time interval between events handler checks.
- currentInterval(ODEStateAndDerivative) - Method in interface org.hipparchus.ode.events.AdaptableInterval
-
Get the current value of maximal time interval between events handler checks.
D
- DANTZIG - Enum constant in enum org.hipparchus.optim.linear.PivotSelectionRule
-
The classical rule, the variable with the most negative coefficient in the objective function row will be chosen as entering variable.
- DBSCANClusterer<T extends Clusterable> - Class in org.hipparchus.clustering
-
DBSCAN (density-based spatial clustering of applications with noise) algorithm.
- DBSCANClusterer(double, int) - Constructor for class org.hipparchus.clustering.DBSCANClusterer
-
Creates a new instance of a DBSCANClusterer.
- DBSCANClusterer(double, int, DistanceMeasure) - Constructor for class org.hipparchus.clustering.DBSCANClusterer
-
Creates a new instance of a DBSCANClusterer.
- dc() - Method in class org.hipparchus.special.elliptic.jacobi.CopolarC
-
Get the value of the dc function.
- dc() - Method in class org.hipparchus.special.elliptic.jacobi.FieldCopolarC
-
Get the value of the dc function.
- DctNormalization - Enum in org.hipparchus.transform
-
This enumeration defines the various types of normalizations that can be applied to discrete cosine transforms (DCT).
- decompose(double[][]) - Method in class org.hipparchus.linear.QRDecomposition
-
Decompose matrix.
- decompose(double[][]) - Method in class org.hipparchus.linear.RRQRDecomposition
-
Decompose matrix.
- decompose(FieldMatrix<T>) - Method in class org.hipparchus.linear.FieldLUDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(FieldMatrix<T>) - Method in interface org.hipparchus.linear.FieldMatrixDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(FieldMatrix<T>) - Method in class org.hipparchus.linear.FieldQRDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(RealMatrix) - Method in class org.hipparchus.linear.CholeskyDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(RealMatrix) - Method in class org.hipparchus.linear.LUDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(RealMatrix) - Method in interface org.hipparchus.linear.MatrixDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(RealMatrix) - Method in class org.hipparchus.linear.QRDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(RealMatrix) - Method in class org.hipparchus.linear.SingularValueDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(T[][]) - Method in class org.hipparchus.linear.FieldQRDecomposition
-
Decompose matrix.
- DecompositionSolver - Interface in org.hipparchus.linear
-
Interface handling decomposition algorithms that can solve A × X = B.
- DECREASING - Enum constant in enum org.hipparchus.util.MathArrays.OrderDirection
-
Constant for decreasing direction.
- decrementExact(int) - Static method in class org.hipparchus.util.FastMath
-
Decrement a number, detecting overflows.
- decrementExact(long) - Static method in class org.hipparchus.util.FastMath
-
Decrement a number, detecting overflows.
- DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Default absolute accuracy.
- DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Default absolute accuracy.
- DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.hipparchus.analysis.solvers.BaseSecantSolver
-
Default absolute accuracy.
- DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.hipparchus.analysis.solvers.SecantSolver
-
Default absolute accuracy.
- DEFAULT_ABSOLUTE_POSITIVITY_THRESHOLD - Static variable in class org.hipparchus.linear.CholeskyDecomposition
-
Default threshold below which diagonal elements are considered null and matrix not positive definite.
- DEFAULT_ACCURACY - Static variable in class org.hipparchus.analysis.interpolation.LoessInterpolator
-
Default value for accuracy.
- DEFAULT_ALPHA - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Default Value of Alpha filter for ADMM iteration.
- DEFAULT_ALPHA - Static variable in class org.hipparchus.util.MerweUnscentedTransform
-
Default value for alpha (0.5, see reference).
- DEFAULT_B - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Default parameter for quadratic line search.
- DEFAULT_BANDWIDTH - Static variable in class org.hipparchus.analysis.interpolation.LoessInterpolator
-
Default value of the bandwidth parameter.
- DEFAULT_BETA - Static variable in class org.hipparchus.util.MerweUnscentedTransform
-
Default value for beta (2.0, see reference).
- DEFAULT_BIN_COUNT - Static variable in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Default bin count
- DEFAULT_CONV_CRITERIA - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Default convergence criteria.
- DEFAULT_DECIMAL_DIGITS - Static variable in class org.hipparchus.analysis.integration.gauss.GaussIntegratorFactory
-
Number of digits for Legendre high precision.
- DEFAULT_EIGENVECTORS_EQUALITY - Static variable in class org.hipparchus.linear.ComplexEigenDecomposition
-
Default threshold below which eigenvectors are considered equal.
- DEFAULT_EPS - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Default Absolute and Relative Tolerance for convergence.
- DEFAULT_EPS_INFEASIBLE - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Default Absolute and Relative Tolerance for Infeasible Criteria.
- DEFAULT_EPSILON - Static variable in class org.hipparchus.distribution.discrete.PoissonDistribution
-
Default convergence criterion.
- DEFAULT_EPSILON - Static variable in class org.hipparchus.linear.ComplexEigenDecomposition
-
Default value to use for internal epsilon.
- DEFAULT_EPSILON - Static variable in class org.hipparchus.linear.EigenDecompositionNonSymmetric
-
Default epsilon value to use for internal epsilon
- DEFAULT_EPSILON - Static variable in class org.hipparchus.linear.EigenDecompositionSymmetric
-
Default epsilon value to use for internal epsilon
- DEFAULT_EPSILON - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Default tolerance for convergence and active constraint.
- DEFAULT_EPSILON - Static variable in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Default quantile estimation error setting
- DEFAULT_EPSILON_AV_VD_CHECK - Static variable in class org.hipparchus.linear.ComplexEigenDecomposition
-
Internally used epsilon criteria for final AV=VD check.
- DEFAULT_EXPECTED_SIZE - Static variable in class org.hipparchus.util.AbstractOpenIntHashMap
-
Default starting size.
- DEFAULT_EXTEND - Static variable in class org.hipparchus.analysis.interpolation.UnivariatePeriodicInterpolator
-
Default number of extension points of the samples array.
- DEFAULT_FORMAT - Static variable in class org.hipparchus.linear.MatrixUtils
-
The default format for
RealMatrix
objects. - DEFAULT_HIGH_EXP - Static variable in class org.hipparchus.util.RyuDouble
-
Default high switch level to scientific notation.
- DEFAULT_INITIAL_RADIUS - Static variable in class org.hipparchus.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
-
Default value for
BOBYQAOptimizer.initialTrustRegionRadius
: 10.0 . - DEFAULT_KAPPA - Static variable in class org.hipparchus.util.JulierUnscentedTransform
-
Default value for kappa, (0.0, see reference).
- DEFAULT_KAPPA - Static variable in class org.hipparchus.util.MerweUnscentedTransform
-
Default value for kappa, (0.0, see reference).
- DEFAULT_LOW_EXP - Static variable in class org.hipparchus.util.RyuDouble
-
Default low switch level to scientific notation.
- DEFAULT_MAX_ITER - Static variable in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Default maximum number of iterations in the event time search.
- DEFAULT_MAX_ITER - Static variable in class org.hipparchus.ode.events.AbstractODEDetector
-
Default maximum number of iterations in the event time search.
- DEFAULT_MAX_ITERATIONS - Static variable in class org.hipparchus.distribution.discrete.PoissonDistribution
-
Default maximum number of iterations for cumulative probability calculations.
- DEFAULT_MAX_ITERATIONS_COUNT - Static variable in class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Default maximal iteration count.
- DEFAULT_MAX_ITERATIONS_COUNT - Static variable in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Default maximal iteration count.
- DEFAULT_MAX_LINE_SEARCH_ITERATION - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Default max iteration before reset hessian.
- DEFAULT_MAX_RHO_ITERATION - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Default Max number of weight changes.
- DEFAULT_MAXCHECK - Static variable in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Default maximum checking interval (s).
- DEFAULT_MAXCHECK - Static variable in class org.hipparchus.ode.events.AbstractODEDetector
-
Default maximum checking interval (s).
- DEFAULT_MIN_ITERATIONS_COUNT - Static variable in class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Default minimal iteration count.
- DEFAULT_MIN_ITERATIONS_COUNT - Static variable in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Default minimal iteration count.
- DEFAULT_MU - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Default parameter for evaluation of Armijo condition for descend direction.
- DEFAULT_NAN_STRATEGY - Static variable in class org.hipparchus.stat.ranking.NaturalRanking
-
default NaN strategy
- DEFAULT_POLISHING - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Default Value for enabling polishing the solution.
- DEFAULT_POLISHING_ITERATION - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Default Value for Iteration of polishing Algorithm.
- DEFAULT_PREFIX - Static variable in class org.hipparchus.geometry.VectorFormat
-
The default prefix: "{".
- DEFAULT_QP_MAX_LOOP - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Default max iteration admitted for QP subproblem.
- DEFAULT_RELATIVE_ACCURACY - Static variable in class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Default relative accuracy.
- DEFAULT_RELATIVE_ACCURACY - Static variable in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Default relative accuracy.
- DEFAULT_RELATIVE_SYMMETRY_THRESHOLD - Static variable in class org.hipparchus.linear.CholeskyDecomposition
-
Default threshold above which off-diagonal elements are considered too different and matrix not symmetric.
- DEFAULT_RHO - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Default weight for augmented QP subproblem.
- DEFAULT_RHO_MAX - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Default Max Value for the Weight for ADMM iteration.
- DEFAULT_RHO_MIN - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Default Min Value for the Weight for ADMM iteration.
- DEFAULT_RHO_UPDATE - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Default Value for adapting the weight during iterations.
- DEFAULT_ROBUSTNESS_ITERS - Static variable in class org.hipparchus.analysis.interpolation.LoessInterpolator
-
Default value of the number of robustness iterations.
- DEFAULT_SCALING - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Default Value for Enabling Problem Scaling.
- DEFAULT_SCALING_MAX_ITERATION - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Default Value for the Max Iteration for the scaling.
- DEFAULT_SEPARATOR - Static variable in class org.hipparchus.geometry.VectorFormat
-
The default separator: ", ".
- DEFAULT_SIGMA - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Default Value of regularization term sigma for Karush–Kuhn–Tucker solver.
- DEFAULT_SIGMA_MAX - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Default max value admitted for additional variable in QP subproblem.
- DEFAULT_SOLVER_ABSOLUTE_ACCURACY - Static variable in class org.hipparchus.distribution.continuous.AbstractRealDistribution
-
Default absolute accuracy for inverse cumulative computation.
- DEFAULT_STOPPING_RADIUS - Static variable in class org.hipparchus.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
-
Default value for
BOBYQAOptimizer.stoppingTrustRegionRadius
: 1.0E-8 . - DEFAULT_SUFFIX - Static variable in class org.hipparchus.geometry.VectorFormat
-
The default suffix: "}".
- DEFAULT_THRESHOLD - Static variable in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Default convergence threshold (s).
- DEFAULT_THRESHOLD - Static variable in class org.hipparchus.ode.events.AbstractODEDetector
-
Default convergence threshold (s).
- DEFAULT_TIES_STRATEGY - Static variable in class org.hipparchus.stat.ranking.NaturalRanking
-
default ties strategy
- DEFAULT_USE_FUNCTION_HESSIAN - Static variable in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Default flag for using BFGS update formula.
- DEFAULT_ZERO_TOLERANCE - Static variable in class org.hipparchus.linear.OpenMapRealVector
-
Default Tolerance for having a value considered zero.
- DefaultFieldMatrixChangingVisitor<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
Default implementation of the
FieldMatrixChangingVisitor
interface. - DefaultFieldMatrixChangingVisitor(T) - Constructor for class org.hipparchus.linear.DefaultFieldMatrixChangingVisitor
-
Build a new instance.
- DefaultFieldMatrixPreservingVisitor<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
Default implementation of the
FieldMatrixPreservingVisitor
interface. - DefaultFieldMatrixPreservingVisitor(T) - Constructor for class org.hipparchus.linear.DefaultFieldMatrixPreservingVisitor
-
Build a new instance.
- DefaultIterativeLinearSolverEvent - Class in org.hipparchus.linear
-
A default concrete implementation of the abstract class
IterativeLinearSolverEvent
. - DefaultIterativeLinearSolverEvent(Object, int, RealVector, RealVector, double) - Constructor for class org.hipparchus.linear.DefaultIterativeLinearSolverEvent
-
Creates a new instance of this class.
- DefaultIterativeLinearSolverEvent(Object, int, RealVector, RealVector, RealVector, double) - Constructor for class org.hipparchus.linear.DefaultIterativeLinearSolverEvent
-
Creates a new instance of this class.
- DefaultRealMatrixChangingVisitor - Class in org.hipparchus.linear
-
Default implementation of the
RealMatrixChangingVisitor
interface. - DefaultRealMatrixChangingVisitor() - Constructor for class org.hipparchus.linear.DefaultRealMatrixChangingVisitor
-
Empty constructor.
- DefaultRealMatrixPreservingVisitor - Class in org.hipparchus.linear
-
Default implementation of the
RealMatrixPreservingVisitor
interface. - DefaultRealMatrixPreservingVisitor() - Constructor for class org.hipparchus.linear.DefaultRealMatrixPreservingVisitor
-
Empty constructor.
- degree() - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Returns the degree of the polynomial.
- degree() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Returns the degree of the polynomial.
- degree() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Returns the degree of the polynomial.
- degree() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Returns the degree of the polynomial.
- DEGREES_OF_FREEDOM - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
DEGREES_OF_FREEDOM.
- DEGREES_OF_FREEDOM - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.DEGREES_OF_FREEDOM.
- delegate() - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns the backing delegate instance that methods are forwarded to.
- DENOMINATOR - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
DENOMINATOR.
- DENOMINATOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.DENOMINATOR.
- DENOMINATOR_FORMAT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
DENOMINATOR_FORMAT.
- DENOMINATOR_FORMAT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.DENOMINATOR_FORMAT.
- DenseOutputModel - Class in org.hipparchus.ode
-
This class stores all information provided by an ODE integrator during the integration process and build a continuous model of the solution from this.
- DenseOutputModel() - Constructor for class org.hipparchus.ode.DenseOutputModel
-
Simple constructor.
- density(double) - Method in class org.hipparchus.distribution.continuous.BetaDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.CauchyDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.ConstantRealDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(X = x)
. - density(double) - Method in class org.hipparchus.distribution.continuous.ExponentialDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.FDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.GammaDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.GumbelDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.LaplaceDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.LevyDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.LogisticDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.LogNormalDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.NakagamiDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.NormalDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.ParetoDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.TDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.TriangularDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.UniformRealDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.distribution.continuous.WeibullDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in interface org.hipparchus.distribution.RealDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double[]) - Method in class org.hipparchus.distribution.multivariate.MixtureMultivariateRealDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double[]) - Method in class org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double[]) - Method in interface org.hipparchus.distribution.MultivariateRealDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - DependentVectorsHandler - Enum in org.hipparchus.linear
-
Enumerate to specify how dependent vectors should be handled in
MatrixUtils.orthonormalize(List, double, DependentVectorsHandler)
andMatrixUtils.orthonormalize(Field, List, CalculusFieldElement, DependentVectorsHandler)
. - DERIVATION_ORDER_NOT_ALLOWED - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
DERIVATION_ORDER_NOT_ALLOWED.
- derivative(MultivariateDifferentiableFunction, int[]) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Convert an
MultivariateDifferentiableFunction
to anMultivariateFunction
computing nth order derivative. - derivative(UnivariateDifferentiableFunction, int) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Convert an
UnivariateDifferentiableFunction
to anUnivariateFunction
computing nth order derivative. - Derivative<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.analysis.differentiation
-
Interface representing both the value and the differentials of a function.
- Derivative1<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.analysis.differentiation
-
Interface representing an object holding partial derivatives up to first order.
- derivatives(double, int) - Method in class org.hipparchus.analysis.interpolation.HermiteInterpolator
-
Interpolate value and first derivatives at a specified abscissa.
- derivatives(T, int) - Method in class org.hipparchus.analysis.interpolation.FieldHermiteInterpolator
-
Interpolate value and first derivatives at a specified abscissa.
- DerivativeStructure - Class in org.hipparchus.analysis.differentiation
-
Class representing both the value and the differentials of a function.
- DescriptiveStatistics - Class in org.hipparchus.stat.descriptive
-
Maintains a dataset of values of a single variable and computes descriptive statistics based on stored data.
- DescriptiveStatistics() - Constructor for class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Construct a DescriptiveStatistics instance with an infinite window.
- DescriptiveStatistics(double[]) - Constructor for class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Construct a DescriptiveStatistics instance with an infinite window and the initial data values in double[] initialDoubleArray.
- DescriptiveStatistics(int) - Constructor for class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Construct a DescriptiveStatistics instance with the specified window.
- DescriptiveStatistics(DescriptiveStatistics) - Constructor for class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Copy constructor.
- DetectorBasedEventState - Class in org.hipparchus.ode.events
-
This class handles the state for one
event handler
during integration steps. - DetectorBasedEventState(ODEEventDetector) - Constructor for class org.hipparchus.ode.events.DetectorBasedEventState
-
Simple constructor.
- dev - Variable in class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Deviation of most recently added value from previous first moment.
- df(double, double, double, double) - Method in class org.hipparchus.stat.inference.TTest
-
Computes approximate degrees of freedom for 2-sample t-test.
- Dfp - Class in org.hipparchus.dfp
-
Decimal floating point library for Java
- Dfp(Dfp) - Constructor for class org.hipparchus.dfp.Dfp
-
Copy constructor.
- Dfp(DfpField) - Constructor for class org.hipparchus.dfp.Dfp
-
Makes an instance with a value of zero.
- Dfp(DfpField, byte) - Constructor for class org.hipparchus.dfp.Dfp
-
Create an instance from a byte value.
- Dfp(DfpField, byte, byte) - Constructor for class org.hipparchus.dfp.Dfp
-
Creates an instance with a non-finite value.
- Dfp(DfpField, double) - Constructor for class org.hipparchus.dfp.Dfp
-
Create an instance from a double value.
- Dfp(DfpField, int) - Constructor for class org.hipparchus.dfp.Dfp
-
Create an instance from an int value.
- Dfp(DfpField, long) - Constructor for class org.hipparchus.dfp.Dfp
-
Create an instance from a long value.
- Dfp(DfpField, String) - Constructor for class org.hipparchus.dfp.Dfp
-
Create an instance from a String representation.
- dfp2sci() - Method in class org.hipparchus.dfp.Dfp
-
Convert an instance to a string using scientific notation.
- dfp2string() - Method in class org.hipparchus.dfp.Dfp
-
Convert an instance to a string using normal notation.
- DfpDec - Class in org.hipparchus.dfp
-
Subclass of
Dfp
which hides the radix-10000 artifacts of the superclass. - DfpDec(Dfp) - Constructor for class org.hipparchus.dfp.DfpDec
-
Copy constructor.
- DfpDec(DfpField) - Constructor for class org.hipparchus.dfp.DfpDec
-
Makes an instance with a value of zero.
- DfpDec(DfpField, byte) - Constructor for class org.hipparchus.dfp.DfpDec
-
Create an instance from a byte value.
- DfpDec(DfpField, byte, byte) - Constructor for class org.hipparchus.dfp.DfpDec
-
Creates an instance with a non-finite value.
- DfpDec(DfpField, double) - Constructor for class org.hipparchus.dfp.DfpDec
-
Create an instance from a double value.
- DfpDec(DfpField, int) - Constructor for class org.hipparchus.dfp.DfpDec
-
Create an instance from an int value.
- DfpDec(DfpField, long) - Constructor for class org.hipparchus.dfp.DfpDec
-
Create an instance from a long value.
- DfpDec(DfpField, String) - Constructor for class org.hipparchus.dfp.DfpDec
-
Create an instance from a String representation.
- DfpField - Class in org.hipparchus.dfp
-
Field for Decimal floating point instances.
- DfpField(int) - Constructor for class org.hipparchus.dfp.DfpField
-
Create a factory for the specified number of radix digits.
- DfpField.RoundingMode - Enum in org.hipparchus.dfp
-
Enumerate for rounding modes.
- DfpMath - Class in org.hipparchus.dfp
-
Mathematical routines for use with
Dfp
. - DftNormalization - Enum in org.hipparchus.transform
-
This enumeration defines the various types of normalizations that can be applied to discrete Fourier transforms (DFT).
- DiagonalMatrix - Class in org.hipparchus.linear
-
Implementation of a diagonal matrix.
- DiagonalMatrix(double[]) - Constructor for class org.hipparchus.linear.DiagonalMatrix
-
Creates a matrix using the input array as the underlying data.
- DiagonalMatrix(double[], boolean) - Constructor for class org.hipparchus.linear.DiagonalMatrix
-
Creates a matrix using the input array as the underlying data.
- DiagonalMatrix(int) - Constructor for class org.hipparchus.linear.DiagonalMatrix
-
Creates a matrix with the supplied dimension.
- difference(Region<S>, Region<S>) - Method in class org.hipparchus.geometry.partitioning.RegionFactory
-
Compute the difference of two regions.
- difference(FieldSinCos<S>, FieldSinCos<S>) - Static method in class org.hipparchus.util.FieldSinCos
-
Compute sine and cosine of angles difference.
- difference(FieldSinhCosh<S>, FieldSinhCosh<S>) - Static method in class org.hipparchus.util.FieldSinhCosh
-
Compute hyperbolic sine and hyperbolic cosine of angles difference.
- difference(SinCos, SinCos) - Static method in class org.hipparchus.util.SinCos
-
Compute sine and cosine of angles difference.
- difference(SinhCosh, SinhCosh) - Static method in class org.hipparchus.util.SinhCosh
-
Compute hyperbolic sine and hyperbolic cosine of angles difference.
- DIFFERENT_ROWS_LENGTHS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
DIFFERENT_ROWS_LENGTHS.
- DIFFERENT_ROWS_LENGTHS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.DIFFERENT_ROWS_LENGTHS.
- DifferentialAlgebra - Interface in org.hipparchus.analysis.differentiation
-
Interface representing an object holding partial derivatives.
- differentiate(double[]) - Static method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Returns the coefficients of the derivative of the polynomial with the given coefficients.
- differentiate(int, int) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Differentiate w.r.t.
- differentiate(int, int) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Differentiate w.r.t.
- differentiate(UnivariateFunction) - Method in class org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
Create an implementation of a
differential
from a regularfunction
. - differentiate(UnivariateFunction) - Method in interface org.hipparchus.analysis.differentiation.UnivariateFunctionDifferentiator
-
Create an implementation of a
differential
from a regularfunction
. - differentiate(UnivariateMatrixFunction) - Method in class org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
Create an implementation of a
differential
from a regularmatrix function
. - differentiate(UnivariateMatrixFunction) - Method in interface org.hipparchus.analysis.differentiation.UnivariateMatrixFunctionDifferentiator
-
Create an implementation of a
differential
from a regularmatrix function
. - differentiate(UnivariateVectorFunction) - Method in class org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
Create an implementation of a
differential
from a regularvector function
. - differentiate(UnivariateVectorFunction) - Method in interface org.hipparchus.analysis.differentiation.UnivariateVectorFunctionDifferentiator
-
Create an implementation of a
differential
from a regularvector function
. - differentiate(T[]) - Static method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Returns the coefficients of the derivative of the polynomial with the given coefficients.
- digamma(double) - Static method in class org.hipparchus.special.Gamma
-
Computes the digamma function of x.
- digamma(T) - Static method in class org.hipparchus.special.Gamma
-
Computes the digamma function of x.
- DIGEST_NOT_INITIALIZED - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
DIGEST_NOT_INITIALIZED.
- DIGEST_NOT_INITIALIZED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.DIGEST_NOT_INITIALIZED.
- dim() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.LinearBoundedConstraint
-
Returns the dimensionality of the function domain.
- dim() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.LinearEqualityConstraint
- dim() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.LinearInequalityConstraint
- dim() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.QuadraticFunction
-
Returns the dimensionality of the function domain.
- dim() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.TwiceDifferentiableFunction
-
Returns the dimensionality of the function domain.
- dim() - Method in interface org.hipparchus.optim.nonlinear.vector.constrained.VectorDifferentiableFunction
-
Returns the dimensionality of the function domain.
- DIMENSION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
DIMENSION.
- DIMENSION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.DIMENSION.
- DimensionMismatchException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- DimensionMismatchException(int, int) - Constructor for exception org.hipparchus.migration.exception.DimensionMismatchException
-
Deprecated.Construct an exception from the mismatched dimensions.
- DimensionMismatchException(Localizable, int, int) - Constructor for exception org.hipparchus.migration.exception.DimensionMismatchException
-
Deprecated.Construct an exception from the mismatched dimensions.
- DIMENSIONS_MISMATCH - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
DIMENSIONS_MISMATCH.
- DIMENSIONS_MISMATCH - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.DIMENSIONS_MISMATCH.
- DIMENSIONS_MISMATCH_2x2 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
DIMENSIONS_MISMATCH_2x2.
- DIMENSIONS_MISMATCH_2x2 - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.DIMENSIONS_MISMATCH_2x2.
- DIMENSIONS_MISMATCH_SIMPLE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.DIMENSIONS_MISMATCH_SIMPLE.
- DIMENSIONS_MISMATCH_SIMPLE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.DIMENSIONS_MISMATCH_SIMPLE.
- dimY() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.BoundedConstraint
-
Returns the dimensionality of the function eval.
- dimY() - Method in interface org.hipparchus.optim.nonlinear.vector.constrained.VectorDifferentiableFunction
-
Returns the dimensionality of the function eval.
- discardFrontElements(int) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Discards the
i
initial elements of the array. - discardMostRecentElements(int) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Discards the
i
last elements of the array. - DISCRETE_CUMULATIVE_PROBABILITY_RETURNED_NAN - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
DISCRETE_CUMULATIVE_PROBABILITY_RETURNED_NAN.
- DISCRETE_CUMULATIVE_PROBABILITY_RETURNED_NAN - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.DISCRETE_CUMULATIVE_PROBABILITY_RETURNED_NAN.
- DiskGenerator - Class in org.hipparchus.geometry.euclidean.twod
-
Class generating an enclosing ball from its support points.
- DiskGenerator() - Constructor for class org.hipparchus.geometry.euclidean.twod.DiskGenerator
-
Empty constructor.
- Display() - Constructor for class org.hipparchus.samples.ClusterAlgorithmComparison.Display
-
Simple consructor.
- Display() - Constructor for class org.hipparchus.samples.clustering.ImageClusteringExample.Display
-
Simple constructor.
- Display() - Constructor for class org.hipparchus.samples.geometry.GeometryExample.Display
-
Simple constructor.
- Display() - Constructor for class org.hipparchus.samples.IntegerDistributionComparison.Display
-
Simple constructor.
- Display() - Constructor for class org.hipparchus.samples.LowDiscrepancyGeneratorComparison.Display
-
Simple constructor.
- Display() - Constructor for class org.hipparchus.samples.RealDistributionComparison.Display
-
Simple constructor.
- distance(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Calculates the L2 (Euclidean) distance between two points.
- distance(int[], int[]) - Static method in class org.hipparchus.util.MathArrays
-
Calculates the L2 (Euclidean) distance between two points.
- distance(Clusterable, Clusterable) - Method in class org.hipparchus.clustering.Clusterer
-
Calculates the distance between two
Clusterable
instances with the configuredDistanceMeasure
. - distance(Clusterable, Clusterable) - Method in class org.hipparchus.clustering.evaluation.ClusterEvaluator
-
Calculates the distance between two
Clusterable
instances with the configuredDistanceMeasure
. - distance(Vector1D, Vector1D) - Static method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the distance between two vectors according to the L2 norm.
- distance(FieldLine<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Compute the shortest distance between the instance and another line.
- distance(FieldRotation<T>, FieldRotation<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Compute the distance between two rotations.
- distance(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Compute the distance between the instance and a point.
- distance(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between the instance and another vector according to the L2 norm.
- distance(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L2 norm.
- distance(FieldVector3D<T>, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L2 norm.
- distance(Line) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Compute the shortest distance between the instance and another line.
- distance(Rotation, Rotation) - Static method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Compute the distance between two rotations.
- distance(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Compute the distance between the instance and a point.
- distance(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between the instance and another vector according to the L2 norm.
- distance(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Compute the distance between the instance and a point.
- distance(Vector3D, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L2 norm.
- distance(Vector3D, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between two vectors according to the L2 norm.
- distance(FieldVector2D<T>) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between the instance and another vector according to the L2 norm.
- distance(FieldVector2D<T>, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance(FieldVector2D<T>, Vector2D) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance(Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between the instance and another vector according to the L2 norm.
- distance(Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Compute the distance between the instance and a point.
- distance(Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.Segment
-
Calculates the shortest distance from a point to this line segment.
- distance(Vector2D, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance(Vector2D, Vector2D) - Static method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance(Point<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the distance between the instance and another point.
- distance(Point<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between the instance and another point.
- distance(Point<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between the instance and another point.
- distance(Point<Sphere1D>) - Method in class org.hipparchus.geometry.spherical.oned.S1Point
-
Compute the distance between the instance and another point.
- distance(Point<Sphere2D>) - Method in class org.hipparchus.geometry.spherical.twod.S2Point
-
Compute the distance between the instance and another point.
- distance(Point<S>) - Method in interface org.hipparchus.geometry.Point
-
Compute the distance between the instance and another point.
- distance(S1Point, S1Point) - Static method in class org.hipparchus.geometry.spherical.oned.S1Point
-
Compute the distance (angular separation) between two points.
- distance(S2Point, S2Point) - Static method in class org.hipparchus.geometry.spherical.twod.S2Point
-
Compute the distance (angular separation) between two points.
- distance1(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Calculates the L1 (sum of abs) distance between two points.
- distance1(int[], int[]) - Static method in class org.hipparchus.util.MathArrays
-
Calculates the L1 (sum of abs) distance between two points.
- distance1(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L1 norm.
- distance1(FieldVector3D<T>, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L1 norm.
- distance1(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(Vector3D, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L1 norm.
- distance1(Vector3D, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between two vectors according to the L1 norm.
- distance1(FieldVector2D<T>) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(FieldVector2D<T>, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance1(FieldVector2D<T>, Vector2D) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance1(Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(Vector2D, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance1(Vector2D, Vector2D) - Static method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between two vectors according to the L1 norm.
- distance1(Vector<Euclidean1D, Vector1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(Vector<Euclidean3D, Vector3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(Vector<Euclidean2D, Vector2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(Vector<S, V>) - Method in interface org.hipparchus.geometry.Vector
-
Compute the distance between the instance and another vector according to the L1 norm.
- distanceInf(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Calculates the L∞ (max of abs) distance between two points.
- distanceInf(int[], int[]) - Static method in class org.hipparchus.util.MathArrays
-
Calculates the L∞ (max of abs) distance between two points.
- distanceInf(Vector1D, Vector1D) - Static method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(FieldVector3D<T>, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(Vector3D, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector3D, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(FieldVector2D<T>) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(FieldVector2D<T>, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(FieldVector2D<T>, Vector2D) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(Vector2D, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector2D, Vector2D) - Static method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector<Euclidean1D, Vector1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(Vector<Euclidean3D, Vector3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(Vector<Euclidean2D, Vector2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(Vector<S, V>) - Method in interface org.hipparchus.geometry.Vector
-
Compute the distance between the instance and another vector according to the L∞ norm.
- DistanceMeasure - Interface in org.hipparchus.clustering.distance
-
Interface for distance measures of n-dimensional vectors.
- distanceSq(Vector1D, Vector1D) - Static method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the square of the distance between two vectors.
- distanceSq(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the square of the distance between two vectors.
- distanceSq(FieldVector3D<T>, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector3D, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector3D, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the square of the distance between two vectors.
- distanceSq(FieldVector2D<T>) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(FieldVector2D<T>, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the square of the distance between two vectors.
- distanceSq(FieldVector2D<T>, Vector2D) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector2D, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector2D, Vector2D) - Static method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector<Euclidean1D, Vector1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector<Euclidean3D, Vector3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector<Euclidean2D, Vector2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector<S, V>) - Method in interface org.hipparchus.geometry.Vector
-
Compute the square of the distance between the instance and another vector.
- DISTRIBUTION_NOT_LOADED - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
DISTRIBUTION_NOT_LOADED.
- DISTRIBUTION_NOT_LOADED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.DISTRIBUTION_NOT_LOADED.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
'÷' operator.
- divide(double) - Method in interface org.hipparchus.CalculusFieldElement
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.complex.Complex
-
Returns a
Complex
whose value is(this / divisor)
, withdivisor
interpreted as a real number. - divide(double) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value is(this / divisor)
, withdivisor
interpreted as a real number. - divide(double) - Method in class org.hipparchus.util.Binary64
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.util.FieldTuple
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.util.Tuple
-
'÷' operator.
- divide(double[], int, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform division of two derivative structures.
- divide(int) - Method in class org.hipparchus.dfp.Dfp
-
Divide by a single digit less than radix.
- divide(int) - Method in class org.hipparchus.fraction.BigFraction
-
Divide the value of this fraction by the passed
int
, iethis * 1 / i
, returning the result in reduced form. - divide(int) - Method in class org.hipparchus.fraction.Fraction
-
Divide the fraction by an integer.
- divide(long) - Method in class org.hipparchus.fraction.BigFraction
-
Divide the value of this fraction by the passed
long
, iethis * 1 / l
, returning the result in reduced form. - divide(BigInteger) - Method in class org.hipparchus.fraction.BigFraction
-
Divide the value of this fraction by the passed
BigInteger
, iethis * 1 / bg
, returning the result in reduced form. - divide(DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute this ÷ a.
- divide(FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute this ÷ a.
- divide(FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute this ÷ a.
- divide(FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute this ÷ a.
- divide(FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute this ÷ a.
- divide(Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute this ÷ a.
- divide(SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute this ÷ a.
- divide(UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute this ÷ a.
- divide(UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute this ÷ a.
- divide(Complex) - Method in class org.hipparchus.complex.Complex
-
Returns a
Complex
whose value is(this / divisor)
. - divide(FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value is(this / divisor)
. - divide(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Divide this by divisor.
- divide(BigFraction) - Method in class org.hipparchus.fraction.BigFraction
-
Divide the value of this fraction by another, returning the result in reduced form.
- divide(Fraction) - Method in class org.hipparchus.fraction.Fraction
-
Divide the value of this fraction by another.
- divide(BigReal) - Method in class org.hipparchus.util.BigReal
-
Compute this ÷ a.
- divide(Binary64) - Method in class org.hipparchus.util.Binary64
-
Compute this ÷ a.
- divide(FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Compute this ÷ a.
- divide(Tuple) - Method in class org.hipparchus.util.Tuple
-
Compute this ÷ a.
- divide(T) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'÷' operator.
- divide(T) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
'÷' operator.
- divide(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'÷' operator.
- divide(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'÷' operator.
- divide(T) - Method in interface org.hipparchus.CalculusFieldElement
-
Compute this ÷ a.
- divide(T) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value is(this / divisor)
, withdivisor
interpreted as a real number. - divide(T) - Method in interface org.hipparchus.FieldElement
-
Compute this ÷ a.
- divide(T[], int, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform division of two derivative structures.
- Divide - Class in org.hipparchus.analysis.function
-
Divide the first operand by the second.
- Divide() - Constructor for class org.hipparchus.analysis.function.Divide
-
Empty constructor.
- DividedDifferenceInterpolator - Class in org.hipparchus.analysis.interpolation
-
Implements the Divided Difference Algorithm for interpolation of real univariate functions.
- DividedDifferenceInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.DividedDifferenceInterpolator
-
Empty constructor.
- divideExact(int, int) - Static method in class org.hipparchus.util.FastMath
-
Divide two integers, checking for overflow.
- divideExact(long, long) - Static method in class org.hipparchus.util.FastMath
-
Divide two long integers, checking for overflow.
- divideUnsigned(int, int) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Returns the unsigned quotient of dividing the first argument by the second where each argument and the result is interpreted as an unsigned value.
- divideUnsigned(long, long) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Returns the unsigned quotient of dividing the first argument by the second where each argument and the result is interpreted as an unsigned value.
- dn() - Method in class org.hipparchus.special.elliptic.jacobi.CopolarN
-
Get the value of the dn function.
- dn() - Method in class org.hipparchus.special.elliptic.jacobi.FieldCopolarN
-
Get the value of the dn function.
- doEvent(FieldODEStateAndDerivative<T>) - Method in class org.hipparchus.ode.events.FieldDetectorBasedEventState
-
Notify the user's listener of the event.
- doEvent(FieldODEStateAndDerivative<T>) - Method in interface org.hipparchus.ode.events.FieldEventState
-
Notify the user's listener of the event.
- doEvent(FieldODEStateAndDerivative<T>) - Method in class org.hipparchus.ode.events.FieldStepEndEventState
-
Notify the user's listener of the event.
- doEvent(ODEStateAndDerivative) - Method in class org.hipparchus.ode.events.DetectorBasedEventState
-
Notify the user's listener of the event.
- doEvent(ODEStateAndDerivative) - Method in interface org.hipparchus.ode.events.EventState
-
Notify the user's listener of the event.
- doEvent(ODEStateAndDerivative) - Method in class org.hipparchus.ode.events.StepEndEventState
-
Notify the user's listener of the event.
- doGrowTable(int, AbstractOpenIntHashMap.ValueCopier) - Method in class org.hipparchus.util.AbstractOpenIntHashMap
-
Grow the tables.
- doIntegrate() - Method in class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - Method in class org.hipparchus.analysis.integration.FieldMidPointIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - Method in class org.hipparchus.analysis.integration.FieldRombergIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - Method in class org.hipparchus.analysis.integration.FieldSimpsonIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - Method in class org.hipparchus.analysis.integration.FieldTrapezoidIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - Method in class org.hipparchus.analysis.integration.IterativeLegendreFieldGaussIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - Method in class org.hipparchus.analysis.integration.IterativeLegendreGaussIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - Method in class org.hipparchus.analysis.integration.MidPointIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - Method in class org.hipparchus.analysis.integration.RombergIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - Method in class org.hipparchus.analysis.integration.SimpsonIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - Method in class org.hipparchus.analysis.integration.TrapezoidIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIteration(SimplexTableau) - Method in class org.hipparchus.optim.linear.SimplexSolver
-
Runs one iteration of the Simplex method on the given model.
- DomainColoring - Class in org.hipparchus.samples.complex
-
Base class for domain coloring.
- DomainColoring(double) - Constructor for class org.hipparchus.samples.complex.DomainColoring
-
Simple constructor.
- doOptimize() - Method in class org.hipparchus.optim.BaseMultiStartMultivariateOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - Method in class org.hipparchus.optim.BaseOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - Method in class org.hipparchus.optim.linear.SimplexSolver
-
Performs the bulk of the optimization algorithm.
- doOptimize() - Method in class org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.PowellOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.SimplexOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.QPOptimizer
- doOptimize() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOptimizerGM
-
Performs the bulk of the optimization algorithm.
- doOptimize() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOptimizerS
-
Performs the bulk of the optimization algorithm.
- doOptimize() - Method in class org.hipparchus.optim.univariate.BrentOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - Method in class org.hipparchus.optim.univariate.MultiStartUnivariateOptimizer
-
Performs the bulk of the optimization algorithm.
- doRemove(int) - Method in class org.hipparchus.util.AbstractOpenIntHashMap
-
Remove an element at specified index.
- DormandPrince54FieldIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This class implements the 5(4) Dormand-Prince integrator for Ordinary Differential Equations.
- DormandPrince54FieldIntegrator(Field<T>, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
-
Simple constructor.
- DormandPrince54FieldIntegrator(Field<T>, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
-
Simple constructor.
- DormandPrince54Integrator - Class in org.hipparchus.ode.nonstiff
-
This class implements the 5(4) Dormand-Prince integrator for Ordinary Differential Equations.
- DormandPrince54Integrator(double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
Simple constructor.
- DormandPrince54Integrator(double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
Simple constructor.
- DormandPrince853FieldIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This class implements the 8(5,3) Dormand-Prince integrator for Ordinary Differential Equations.
- DormandPrince853FieldIntegrator(Field<T>, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
-
Simple constructor.
- DormandPrince853FieldIntegrator(Field<T>, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
-
Simple constructor.
- DormandPrince853Integrator - Class in org.hipparchus.ode.nonstiff
-
This class implements the 8(5,3) Dormand-Prince integrator for Ordinary Differential Equations.
- DormandPrince853Integrator(double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
Simple constructor.
- DormandPrince853Integrator(double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
Simple constructor.
- doSolve() - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - Method in class org.hipparchus.analysis.solvers.BaseSecantSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - Method in class org.hipparchus.analysis.solvers.BisectionSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - Method in class org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - Method in class org.hipparchus.analysis.solvers.BrentSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - Method in class org.hipparchus.analysis.solvers.LaguerreSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - Method in class org.hipparchus.analysis.solvers.MullerSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - Method in class org.hipparchus.analysis.solvers.MullerSolver2
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - Method in class org.hipparchus.analysis.solvers.NewtonRaphsonSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - Method in class org.hipparchus.analysis.solvers.RiddersSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - Method in class org.hipparchus.analysis.solvers.SecantSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolveInterval() - Method in class org.hipparchus.analysis.solvers.BaseSecantSolver
-
Find a root and return the containing interval.
- doSolveInterval() - Method in class org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolver
-
Find a root and return the containing interval.
- dotProduct(Quaternion) - Method in class org.hipparchus.complex.Quaternion
-
Computes the dot-product of the instance by a quaternion.
- dotProduct(Quaternion, Quaternion) - Static method in class org.hipparchus.complex.Quaternion
-
Computes the dot-product of two quaternions.
- dotProduct(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the dot-product of the instance and another vector.
- dotProduct(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the dot-product of two vectors.
- dotProduct(FieldVector3D<T>, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the dot-product of two vectors.
- dotProduct(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector3D, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the dot-product of two vectors.
- dotProduct(Vector3D, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the dot-product of two vectors.
- dotProduct(FieldVector2D<T>) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector<Euclidean1D, Vector1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector<Euclidean3D, Vector3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector<Euclidean2D, Vector2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector<S, V>) - Method in interface org.hipparchus.geometry.Vector
-
Compute the dot-product of the instance and another vector.
- dotProduct(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute the dot product.
- dotProduct(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute the dot product.
- dotProduct(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Compute the dot product.
- dotProduct(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Compute the dot product.
- dotProduct(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Compute the dot product of this vector with
v
. - dotProduct(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Compute the dot product of this vector with
v
. - dotrap(int, String, Dfp, Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Raises a trap.
- DoublePoint - Class in org.hipparchus.clustering
-
A simple implementation of
Clusterable
for points with double coordinates. - DoublePoint(double[]) - Constructor for class org.hipparchus.clustering.DoublePoint
-
Build an instance wrapping an double array.
- DoublePoint(int[]) - Constructor for class org.hipparchus.clustering.DoublePoint
-
Build an instance wrapping an integer array.
- doubleToString(double) - Static method in class org.hipparchus.util.RyuDouble
-
Convert a double to shortest string representation, preserving full accuracy.
- doubleToString(double, int, int) - Static method in class org.hipparchus.util.RyuDouble
-
Convert a double to shortest string representation, preserving full accuracy.
- doubleValue() - Method in class org.hipparchus.fraction.BigFraction
-
Gets the fraction as a
double
. - doubleValue() - Method in class org.hipparchus.fraction.Fraction
-
Gets the fraction as a
double
. - doubleValue() - Method in class org.hipparchus.util.BigReal
-
Get the double value corresponding to the instance.
- doubleValue() - Method in class org.hipparchus.util.Binary64
- DOWNSIDE - Enum constant in enum org.hipparchus.stat.descriptive.moment.SemiVariance.Direction
-
The DOWNSIDE Direction is used to specify that the observations below the cutoff point will be used to calculate SemiVariance
- DOWNSIDE_VARIANCE - Static variable in class org.hipparchus.stat.descriptive.moment.SemiVariance
-
The DOWNSIDE Direction is used to specify that the observations below the cutoff point will be used to calculate SemiVariance
- ds() - Method in class org.hipparchus.special.elliptic.jacobi.CopolarS
-
Get the value of the ds function.
- ds() - Method in class org.hipparchus.special.elliptic.jacobi.FieldCopolarS
-
Get the value of the ds function.
- DSCompiler - Class in org.hipparchus.analysis.differentiation
-
Class holding "compiled" computation rules for derivative structures.
- DSFactory - Class in org.hipparchus.analysis.differentiation
-
Factory for
DerivativeStructure
. - DSFactory(int, int) - Constructor for class org.hipparchus.analysis.differentiation.DSFactory
-
Simple constructor.
- DSFactory.DSField - Class in org.hipparchus.analysis.differentiation
-
Field for {link DerivativeStructure} instances.
- DstNormalization - Enum in org.hipparchus.transform
-
This enumeration defines the various types of normalizations that can be applied to discrete sine transforms (DST).
- DummyLocalizable - Class in org.hipparchus.exception
-
Dummy implementation of the
Localizable
interface, without localization. - DummyLocalizable(String) - Constructor for class org.hipparchus.exception.DummyLocalizable
-
Simple constructor.
- DummyStepHandler - Class in org.hipparchus.migration.ode.sampling
-
Deprecated.as of 1.0, this class is not used anymore
- DUPLICATED_ABSCISSA_DIVISION_BY_ZERO - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
DUPLICATED_ABSCISSA_DIVISION_BY_ZERO.
- DUPLICATED_ABSCISSA_DIVISION_BY_ZERO - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.DUPLICATED_ABSCISSA_DIVISION_BY_ZERO.
E
- E - Static variable in class org.hipparchus.util.FastMath
-
Napier's constant e, base of the natural logarithm.
- EarthMoversDistance - Class in org.hipparchus.clustering.distance
-
Calculates the Earh Mover's distance (also known as Wasserstein metric) between two distributions.
- EarthMoversDistance() - Constructor for class org.hipparchus.clustering.distance.EarthMoversDistance
-
Empty constructor.
- ebeAdd(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Creates an array whose contents will be the element-by-element addition of the arguments.
- ebeDivide(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Creates an array whose contents will be the element-by-element division of the first argument by the second.
- ebeDivide(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Element-by-element division.
- ebeDivide(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Element-by-element division.
- ebeDivide(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Element-by-element division.
- ebeDivide(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Element-by-element division.
- ebeDivide(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Element-by-element division.
- ebeDivide(RealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Element-by-element division.
- ebeDivide(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Element-by-element division.
- ebeMultiply(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Creates an array whose contents will be the element-by-element multiplication of the arguments.
- ebeMultiply(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Element-by-element multiplication.
- ebeMultiply(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Element-by-element multiplication.
- ebeMultiply(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Element-by-element multiplication.
- ebeMultiply(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Element-by-element multiplication.
- ebeMultiply(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Element-by-element multiplication.
- ebeMultiply(RealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Element-by-element multiplication.
- ebeMultiply(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Element-by-element multiplication.
- ebeSubtract(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Creates an array whose contents will be the element-by-element subtraction of the second argument from the first.
- Edge - Class in org.hipparchus.geometry.spherical.twod
-
Spherical polygons boundary edge.
- EDGE_CONNECTED_TO_ONE_FACET - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
EDGE_CONNECTED_TO_ONE_FACET.
- EDGE_CONNECTED_TO_ONE_FACET - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.EDGE_CONNECTED_TO_ONE_FACET.
- EigenDecompositionNonSymmetric - Class in org.hipparchus.linear
-
Calculates the eigen decomposition of a non-symmetric real matrix.
- EigenDecompositionNonSymmetric(RealMatrix) - Constructor for class org.hipparchus.linear.EigenDecompositionNonSymmetric
-
Calculates the eigen decomposition of the given real matrix.
- EigenDecompositionNonSymmetric(RealMatrix, double) - Constructor for class org.hipparchus.linear.EigenDecompositionNonSymmetric
-
Calculates the eigen decomposition of the given real matrix.
- EigenDecompositionSymmetric - Class in org.hipparchus.linear
-
Calculates the eigen decomposition of a symmetric real matrix.
- EigenDecompositionSymmetric(double[], double[]) - Constructor for class org.hipparchus.linear.EigenDecompositionSymmetric
-
Calculates the eigen decomposition of the symmetric tridiagonal matrix.
- EigenDecompositionSymmetric(double[], double[], double, boolean) - Constructor for class org.hipparchus.linear.EigenDecompositionSymmetric
-
Calculates the eigen decomposition of the symmetric tridiagonal matrix.
- EigenDecompositionSymmetric(RealMatrix) - Constructor for class org.hipparchus.linear.EigenDecompositionSymmetric
-
Calculates the eigen decomposition of the given symmetric real matrix.
- EigenDecompositionSymmetric(RealMatrix, double, boolean) - Constructor for class org.hipparchus.linear.EigenDecompositionSymmetric
-
Calculates the eigen decomposition of the given real matrix.
- EmbeddedRungeKuttaFieldIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This class implements the common part of all embedded Runge-Kutta integrators for Ordinary Differential Equations.
- EmbeddedRungeKuttaFieldIntegrator(Field<T>, String, int, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Build a Runge-Kutta integrator with the given Butcher array.
- EmbeddedRungeKuttaFieldIntegrator(Field<T>, String, int, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Build a Runge-Kutta integrator with the given Butcher array.
- EmbeddedRungeKuttaIntegrator - Class in org.hipparchus.ode.nonstiff
-
This class implements the common part of all embedded Runge-Kutta integrators for Ordinary Differential Equations.
- EmbeddedRungeKuttaIntegrator(String, int, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Build a Runge-Kutta integrator with the given Butcher array.
- EmbeddedRungeKuttaIntegrator(String, int, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Build a Runge-Kutta integrator with the given Butcher array.
- Embedding<S extends Space,
T extends Space> - Interface in org.hipparchus.geometry.partitioning -
This interface defines mappers between a space and one of its sub-spaces.
- EmpiricalDistribution - Class in org.hipparchus.stat.fitting
-
Represents an empirical probability distribution -- a probability distribution derived from observed data without making any assumptions about the functional form of the population distribution that the data come from.
- EmpiricalDistribution() - Constructor for class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Creates a new EmpiricalDistribution with the default bin count.
- EmpiricalDistribution(int) - Constructor for class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Creates a new EmpiricalDistribution with the specified bin count.
- EmpiricalDistribution(int, RandomGenerator) - Constructor for class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Creates a new EmpiricalDistribution with the specified bin count using the provided
RandomGenerator
as the source of random data. - EmpiricalDistribution(RandomGenerator) - Constructor for class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Creates a new EmpiricalDistribution with default bin count using the provided
RandomGenerator
as the source of random data. - EMPTY_CLUSTER_IN_K_MEANS - Enum constant in enum org.hipparchus.clustering.LocalizedClusteringFormats
-
EMPTY_CLUSTER_IN_K_MEANS.
- EMPTY_CLUSTER_IN_K_MEANS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.EMPTY_CLUSTER_IN_K_MEANS.
- EMPTY_INTERPOLATION_SAMPLE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
EMPTY_INTERPOLATION_SAMPLE.
- EMPTY_INTERPOLATION_SAMPLE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.EMPTY_INTERPOLATION_SAMPLE.
- EMPTY_POLYNOMIALS_COEFFICIENTS_ARRAY - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
EMPTY_POLYNOMIALS_COEFFICIENTS_ARRAY.
- EMPTY_POLYNOMIALS_COEFFICIENTS_ARRAY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.EMPTY_POLYNOMIALS_COEFFICIENTS_ARRAY.
- EMPTY_SELECTED_COLUMN_INDEX_ARRAY - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
EMPTY_SELECTED_COLUMN_INDEX_ARRAY.
- EMPTY_SELECTED_COLUMN_INDEX_ARRAY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.EMPTY_SELECTED_COLUMN_INDEX_ARRAY.
- EMPTY_SELECTED_ROW_INDEX_ARRAY - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
EMPTY_SELECTED_ROW_INDEX_ARRAY.
- EMPTY_SELECTED_ROW_INDEX_ARRAY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.EMPTY_SELECTED_ROW_INDEX_ARRAY.
- EMPTY_STRING_FOR_IMAGINARY_CHARACTER - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.EMPTY_STRING_FOR_IMAGINARY_CHARACTER.
- EMPTY_STRING_FOR_IMAGINARY_CHARACTER - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.EMPTY_STRING_FOR_IMAGINARY_CHARACTER.
- emptyHyperplane() - Method in class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Build a sub-hyperplane covering nothing.
- emptyHyperplane() - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Build a sub-hyperplane covering nothing.
- emptyHyperplane() - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Build a sub-hyperplane covering nothing.
- emptyHyperplane() - Method in interface org.hipparchus.geometry.partitioning.Hyperplane
-
Build a sub-hyperplane covering nothing.
- emptyHyperplane() - Method in class org.hipparchus.geometry.spherical.oned.LimitAngle
-
Build a sub-hyperplane covering nothing.
- emptyHyperplane() - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Build a sub-hyperplane covering nothing.
- enclose(Iterable<P>) - Method in interface org.hipparchus.geometry.enclosing.Encloser
-
Find a ball enclosing a list of points.
- enclose(Iterable<P>) - Method in class org.hipparchus.geometry.enclosing.WelzlEncloser
-
Find a ball enclosing a list of points.
- Encloser<S extends Space,
P extends Point<S>> - Interface in org.hipparchus.geometry.enclosing -
Interface for algorithms computing enclosing balls.
- EnclosingBall<S extends Space,
P extends Point<S>> - Class in org.hipparchus.geometry.enclosing -
This class represents a ball enclosing some points.
- EnclosingBall(P, double, P...) - Constructor for class org.hipparchus.geometry.enclosing.EnclosingBall
-
Simple constructor.
- end() - Method in class org.hipparchus.linear.DefaultFieldMatrixChangingVisitor
-
End visiting a matrix.
- end() - Method in class org.hipparchus.linear.DefaultFieldMatrixPreservingVisitor
-
End visiting a matrix.
- end() - Method in class org.hipparchus.linear.DefaultRealMatrixChangingVisitor
-
End visiting a matrix.
- end() - Method in class org.hipparchus.linear.DefaultRealMatrixPreservingVisitor
-
End visiting a matrix.
- end() - Method in interface org.hipparchus.linear.FieldMatrixChangingVisitor
-
End visiting a matrix.
- end() - Method in interface org.hipparchus.linear.FieldMatrixPreservingVisitor
-
End visiting a matrix.
- end() - Method in interface org.hipparchus.linear.FieldVectorChangingVisitor
-
End visiting a vector.
- end() - Method in interface org.hipparchus.linear.FieldVectorPreservingVisitor
-
End visiting a vector.
- end() - Method in interface org.hipparchus.linear.RealMatrixChangingVisitor
-
End visiting a matrix.
- end() - Method in interface org.hipparchus.linear.RealMatrixPreservingVisitor
-
End visiting a matrix.
- end() - Method in interface org.hipparchus.linear.RealVectorChangingVisitor
-
End visiting a vector.
- end() - Method in interface org.hipparchus.linear.RealVectorPreservingVisitor
-
End visiting a vector.
- ENDPOINTS_NOT_AN_INTERVAL - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ENDPOINTS_NOT_AN_INTERVAL.
- ENDPOINTS_NOT_AN_INTERVAL - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ENDPOINTS_NOT_AN_INTERVAL.
- enforceSymmetry(double[]) - Method in class org.hipparchus.analysis.integration.gauss.AbstractRuleFactory
-
Enforce symmetry of roots.
- enforceSymmetry(T[]) - Method in class org.hipparchus.analysis.integration.gauss.FieldAbstractRuleFactory
-
Enforce symmetry of roots.
- Entry() - Constructor for class org.hipparchus.linear.RealVector.Entry
-
Simple constructor.
- entrySetIterator() - Method in class org.hipparchus.stat.Frequency
-
Return an Iterator over the set of keys and values that have been added.
- EnumeratedDistribution<T> - Class in org.hipparchus.distribution
-
A generic implementation of a discrete probability distribution (Wikipedia) over a finite sample space, based on an enumerated list of <value, probability> pairs.
- EnumeratedDistribution(List<Pair<T, Double>>) - Constructor for class org.hipparchus.distribution.EnumeratedDistribution
-
Create an enumerated distribution using the given probability mass function enumeration.
- EnumeratedIntegerDistribution - Class in org.hipparchus.distribution.discrete
-
Implementation of an integer-valued
EnumeratedDistribution
. - EnumeratedIntegerDistribution(int[]) - Constructor for class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
Create a discrete integer-valued distribution from the input data.
- EnumeratedIntegerDistribution(int[], double[]) - Constructor for class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
Create a discrete distribution using the given probability mass function definition.
- EnumeratedRealDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of a real-valued
EnumeratedDistribution
. - EnumeratedRealDistribution(double[]) - Constructor for class org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
Create a discrete real-valued distribution from the input data.
- EnumeratedRealDistribution(double[], double[]) - Constructor for class org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
Create a discrete real-valued distribution using the given probability mass function enumeration.
- EPSILON - Static variable in class org.hipparchus.util.Precision
-
Largest double-precision floating-point number such that
1 + EPSILON
is numerically equal to 1. - EQ - Enum constant in enum org.hipparchus.optim.linear.Relationship
-
Equality relationship.
- EQUAL_VERTICES_IN_SIMPLEX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.EQUAL_VERTICES_IN_SIMPLEX.
- EQUAL_VERTICES_IN_SIMPLEX - Enum constant in enum org.hipparchus.optim.LocalizedOptimFormats
-
EQUAL_VERTICES_IN_SIMPLEX.
- EqualityConstraint - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Equality Constraint.
- EqualityConstraint(RealVector) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.EqualityConstraint
-
Simple constructor.
- equalKeys(AbstractOpenIntHashMap) - Method in class org.hipparchus.util.AbstractOpenIntHashMap
-
Check if keys are equals.
- equals(byte[], byte[]) - Static method in class org.hipparchus.util.MathArrays
-
Returns
true
if both arguments arenull
or have same dimensions and all their elements are equals. - equals(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Returns
true
iff both arguments arenull
or have same dimensions and all their elements are equal as defined byPrecision.equals(double,double)
. - equals(double, double) - Static method in class org.hipparchus.util.MathUtils
-
Returns
true
if the values are equal according to semantics ofDouble.equals(Object)
. - equals(double, double) - Static method in class org.hipparchus.util.Precision
-
Returns true iff they are equal as defined by
equals(x, y, 1)
. - equals(double, double, double) - Static method in class org.hipparchus.util.Precision
-
Returns
true
if there is no double value strictly between the arguments or the difference between them is within the range of allowed error (inclusive). - equals(double, double, int) - Static method in class org.hipparchus.util.Precision
-
Returns true if the arguments are equal or within the range of allowed error (inclusive).
- equals(float[], float[]) - Static method in class org.hipparchus.util.MathArrays
-
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by
Precision.equals(float,float)
. - equals(float, float) - Static method in class org.hipparchus.util.Precision
-
Returns true iff they are equal as defined by
equals(x, y, 1)
. - equals(float, float, float) - Static method in class org.hipparchus.util.Precision
-
Returns true if the arguments are equal or within the range of allowed error (inclusive).
- equals(float, float, int) - Static method in class org.hipparchus.util.Precision
-
Returns true if the arguments are equal or within the range of allowed error (inclusive).
- equals(int[], int[]) - Static method in class org.hipparchus.util.MathArrays
-
Returns
true
if both arguments arenull
or have same dimensions and all their elements are equals. - equals(long[], long[]) - Static method in class org.hipparchus.util.MathArrays
-
Returns
true
if both arguments arenull
or have same dimensions and all their elements are equals. - equals(short[], short[]) - Static method in class org.hipparchus.util.MathArrays
-
Returns
true
if both arguments arenull
or have same dimensions and all their elements are equals. - equals(Object) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Test for the equality of two derivative structures.
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.DSFactory.DSField
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.FDSFactory.DerivativeField
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Test for the equality of two univariate derivatives.
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.FieldGradientField
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Test for the equality of two univariate derivatives.
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1Field
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Test for the equality of two univariate derivatives.
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2Field
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Test for the equality of two univariate derivatives.
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.GradientField
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Test for the equality of two sparse gradients.
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Test for the equality of two univariate derivatives.
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1Field
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Test for the equality of two univariate derivatives.
- equals(Object) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2Field
- equals(Object) - Method in class org.hipparchus.analysis.polynomials.JacobiKey
-
Check if the instance represent the same key as another instance.
- equals(Object) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
- equals(Object) - Method in class org.hipparchus.clustering.DoublePoint
- equals(Object) - Method in class org.hipparchus.complex.Complex
-
Test for equality with another object.
- equals(Object) - Method in class org.hipparchus.complex.ComplexField
- equals(Object) - Method in class org.hipparchus.complex.FieldComplex
-
Test for equality with another object.
- equals(Object) - Method in class org.hipparchus.complex.FieldComplexField
- equals(Object) - Method in class org.hipparchus.complex.Quaternion
- equals(Object) - Method in class org.hipparchus.dfp.Dfp
-
Check if instance is equal to x.
- equals(Object) - Method in class org.hipparchus.dfp.DfpField
- equals(Object) - Method in class org.hipparchus.fraction.BigFraction
-
Test for the equality of two fractions.
- equals(Object) - Method in class org.hipparchus.fraction.BigFractionField
- equals(Object) - Method in class org.hipparchus.fraction.Fraction
-
Test for the equality of two fractions.
- equals(Object) - Method in class org.hipparchus.fraction.FractionField
- equals(Object) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Test for the equality of two 1D vectors.
- equals(Object) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Test for the equality of two 3D vectors.
- equals(Object) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Test for the equality of two 3D vectors.
- equals(Object) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Test for the equality of two 2D vectors.
- equals(Object) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Test for the equality of two 2D vectors.
- equals(Object) - Method in class org.hipparchus.geometry.spherical.oned.S1Point
-
Test for the equality of two points on the 1-sphere.
- equals(Object) - Method in class org.hipparchus.geometry.spherical.twod.S2Point
-
Test for the equality of two points on the 2-sphere.
- equals(Object) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Returns true iff
object
is aFieldMatrix
instance with the same dimensions as this and all corresponding matrix entries are equal. - equals(Object) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns true iff
object
is aRealMatrix
instance with the same dimensions as this and all corresponding matrix entries are equal. - equals(Object) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Test for the equality of two vectors.
- equals(Object) - Method in class org.hipparchus.linear.ArrayRealVector
-
Test for the equality of two real vectors.
- equals(Object) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Test for the equality of two real vectors.
- equals(Object) - Method in class org.hipparchus.linear.RealVector
-
Test for the equality of two real vectors.
- equals(Object) - Method in class org.hipparchus.linear.SparseFieldVector
- equals(Object) - Method in class org.hipparchus.optim.linear.LinearConstraint
- equals(Object) - Method in class org.hipparchus.optim.linear.LinearObjectiveFunction
- equals(Object) - Method in class org.hipparchus.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Returns true iff
object
is the same type ofStorelessUnivariateStatistic
(the object's class equals this instance) returning the same values as this forgetResult()
andgetN()
. - equals(Object) - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns true iff
object
is aMultivariateSummaryStatistics
instance and all statistics have the same values as this. - equals(Object) - Method in class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
Returns true iff
o
is aPSquarePercentile
returning the same values as this forgetResult()
andgetN()
and also having equal markers - equals(Object) - Method in class org.hipparchus.stat.descriptive.StatisticalSummaryValues
-
Returns true iff
object
is aStatisticalSummary
instance and all statistics have the same values as this. - equals(Object) - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns true iff
object
is aStreamingStatistics
instance and all statistics have the same values as this. - equals(Object) - Method in class org.hipparchus.stat.descriptive.vector.VectorialCovariance
- equals(Object) - Method in class org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic
- equals(Object) - Method in class org.hipparchus.stat.Frequency
- equals(Object) - Method in class org.hipparchus.util.BigReal
- equals(Object) - Method in class org.hipparchus.util.BigRealField
- equals(Object) - Method in class org.hipparchus.util.Binary64
- equals(Object) - Method in class org.hipparchus.util.Binary64Field
- equals(Object) - Method in class org.hipparchus.util.FieldTuple
- equals(Object) - Method in class org.hipparchus.util.OpenIntToDoubleHashMap
- equals(Object) - Method in class org.hipparchus.util.OpenIntToFieldHashMap
- equals(Object) - Method in class org.hipparchus.util.Pair
-
Compare the specified object with this entry for equality.
- equals(Object) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Returns true iff object is a ResizableDoubleArray with the same properties as this and an identical internal storage array.
- equals(Object) - Method in class org.hipparchus.util.Tuple
- equals(Complex, Complex) - Static method in class org.hipparchus.complex.Complex
-
Returns
true
iff the values are equal as defined byequals(x, y, 1)
. - equals(Complex, Complex, double) - Static method in class org.hipparchus.complex.Complex
-
Returns
true
if, both for the real part and for the imaginary part, there is no double value strictly between the arguments or the difference between them is within the range of allowed error (inclusive). - equals(Complex, Complex, int) - Static method in class org.hipparchus.complex.Complex
-
Test for the floating-point equality between Complex objects.
- equals(FieldComplex<T>, FieldComplex<T>) - Static method in class org.hipparchus.complex.FieldComplex
-
Returns
true
iff the values are equal as defined byequals(x, y, 1)
. - equals(FieldComplex<T>, FieldComplex<T>, double) - Static method in class org.hipparchus.complex.FieldComplex
-
Returns
true
if, both for the real part and for the imaginary part, there is no T value strictly between the arguments or the difference between them is within the range of allowed error (inclusive). - equals(FieldComplex<T>, FieldComplex<T>, int) - Static method in class org.hipparchus.complex.FieldComplex
-
Test for the floating-point equality between Complex objects.
- equals(Quaternion, double) - Method in class org.hipparchus.complex.Quaternion
-
Checks whether this instance is equal to another quaternion within a given tolerance.
- equalsIeee754(Object) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Test for the equality of two 1D vectors.
- equalsIeee754(Object) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Test for the equality of two 3D vectors.
- equalsIeee754(Object) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Test for the equality of two 2D vectors.
- equalsIeee754(Object) - Method in class org.hipparchus.geometry.spherical.oned.S1Point
-
Test for the equality of two points on the 1-sphere.
- equalsIeee754(Object) - Method in class org.hipparchus.geometry.spherical.twod.S2Point
-
Test for the equality of two points on the 2-sphere.
- equalsIncludingNaN(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Returns
true
iff both arguments arenull
or have same dimensions and all their elements are equal as defined bythis method
. - equalsIncludingNaN(double, double) - Static method in class org.hipparchus.util.Precision
-
Returns true if the arguments are both NaN or they are equal as defined by
equals(x, y, 1)
. - equalsIncludingNaN(double, double, double) - Static method in class org.hipparchus.util.Precision
-
Returns true if the arguments are both NaN, are equal or are within the range of allowed error (inclusive).
- equalsIncludingNaN(double, double, int) - Static method in class org.hipparchus.util.Precision
-
Returns true if both arguments are NaN or if they are equal as defined by
equals(x, y, maxUlps)
. - equalsIncludingNaN(float[], float[]) - Static method in class org.hipparchus.util.MathArrays
-
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by
this method
. - equalsIncludingNaN(float, float) - Static method in class org.hipparchus.util.Precision
-
Returns true if both arguments are NaN or they are equal as defined by
equals(x, y, 1)
. - equalsIncludingNaN(float, float, float) - Static method in class org.hipparchus.util.Precision
-
Returns true if the arguments are both NaN, are equal, or are within the range of allowed error (inclusive).
- equalsIncludingNaN(float, float, int) - Static method in class org.hipparchus.util.Precision
-
Returns true if the arguments are both NaN or if they are equal as defined by
equals(x, y, maxUlps)
. - equalStates(AbstractOpenIntHashMap) - Method in class org.hipparchus.util.AbstractOpenIntHashMap
-
Check if states are equals.
- equalsWithRelativeTolerance(double, double, double) - Static method in class org.hipparchus.util.Precision
-
Returns
true
if there is no double value strictly between the arguments or the relative difference between them is less than or equal to the given tolerance. - equalsWithRelativeTolerance(Complex, Complex, double) - Static method in class org.hipparchus.complex.Complex
-
Returns
true
if, both for the real part and for the imaginary part, there is no double value strictly between the arguments or the relative difference between them is smaller or equal to the given tolerance. - equalsWithRelativeTolerance(FieldComplex<T>, FieldComplex<T>, double) - Static method in class org.hipparchus.complex.FieldComplex
-
Returns
true
if, both for the real part and for the imaginary part, there is no T value strictly between the arguments or the relative difference between them is smaller or equal to the given tolerance. - EquationsMapper - Class in org.hipparchus.ode
-
Class mapping the part of a complete state or derivative that pertains to a specific differential equation.
- erf(double) - Static method in class org.hipparchus.special.Erf
-
Returns the error function.
- erf(double, double) - Static method in class org.hipparchus.special.Erf
-
Returns the difference between erf(x1) and erf(x2).
- erf(T) - Static method in class org.hipparchus.special.Erf
-
Returns the error function.
- erf(T, T) - Static method in class org.hipparchus.special.Erf
-
Returns the difference between erf(x1) and erf(x2).
- Erf - Class in org.hipparchus.special
-
This is a utility class that provides computation methods related to the error functions.
- erfc(double) - Static method in class org.hipparchus.special.Erf
-
Returns the complementary error function.
- erfc(T) - Static method in class org.hipparchus.special.Erf
-
Returns the complementary error function.
- erfcInv(double) - Static method in class org.hipparchus.special.Erf
-
Returns the inverse erfc.
- erfcInv(T) - Static method in class org.hipparchus.special.Erf
-
Returns the inverse erfc.
- erfInv(double) - Static method in class org.hipparchus.special.Erf
-
Returns the inverse erf.
- erfInv(T) - Static method in class org.hipparchus.special.Erf
-
Returns the inverse erf.
- ERR_SCALE - Static variable in class org.hipparchus.dfp.Dfp
-
The amount under/overflows are scaled by before going to trap handler
- ERROR - Enum constant in enum org.hipparchus.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
-
Generate an error.
- errorEstimation(double[], double, double[], double[], RealMatrix) - Method in class org.hipparchus.ode.nonstiff.AdamsBashforthIntegrator
-
Estimate error.
- errorEstimation(double[], double, double[], double[], RealMatrix) - Method in class org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Estimate error.
- errorEstimation(double[], double, double[], double[], RealMatrix) - Method in class org.hipparchus.ode.nonstiff.AdamsMoultonIntegrator
-
Estimate error.
- errorEstimation(T[], T, T[], T[], FieldMatrix<T>) - Method in class org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegrator
-
Estimate error.
- errorEstimation(T[], T, T[], T[], FieldMatrix<T>) - Method in class org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Estimate error.
- errorEstimation(T[], T, T[], T[], FieldMatrix<T>) - Method in class org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegrator
-
Estimate error.
- estimate(double[][], int) - Static method in class org.hipparchus.stat.fitting.MultivariateNormalMixtureExpectationMaximization
-
Helper method to create a multivariate normal mixture model which can be used to initialize
MultivariateNormalMixtureExpectationMaximization.fit(MixtureMultivariateNormalDistribution)
. - estimate(double[], int[], double, int, KthSelector) - Method in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
Estimation based on Kth selection.
- estimate(int) - Method in interface org.hipparchus.stat.descriptive.rank.PSquarePercentile.PSquareMarkers
-
An Estimate of the percentile value of a given Marker
- estimateError(double[][], double[], double[], double) - Method in class org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
Compute the error ratio.
- estimateError(double[][], double[], double[], double) - Method in class org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
Compute the error ratio.
- estimateError(double[][], double[], double[], double) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Compute the error ratio.
- estimateError(double[][], double[], double[], double) - Method in class org.hipparchus.ode.nonstiff.HighamHall54Integrator
-
Compute the error ratio.
- estimateError(T[][], T[], T[], T) - Method in class org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
-
Compute the error ratio.
- estimateError(T[][], T[], T[], T) - Method in class org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
-
Compute the error ratio.
- estimateError(T[][], T[], T[], T) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Compute the error ratio.
- estimateError(T[][], T[], T[], T) - Method in class org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
-
Compute the error ratio.
- estimateErrorVariance() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Estimates the variance of the error.
- estimateRegressandVariance() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Returns the variance of the regressand, ie Var(y).
- estimateRegressandVariance() - Method in interface org.hipparchus.stat.regression.MultipleLinearRegression
-
Returns the variance of the regressand, ie Var(y).
- estimateRegressionParameters() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Estimates the regression parameters b.
- estimateRegressionParameters() - Method in interface org.hipparchus.stat.regression.MultipleLinearRegression
-
Estimates the regression parameters b.
- estimateRegressionParametersStandardErrors() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Returns the standard errors of the regression parameters.
- estimateRegressionParametersStandardErrors() - Method in interface org.hipparchus.stat.regression.MultipleLinearRegression
-
Returns the standard errors of the regression parameters.
- estimateRegressionParametersVariance() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Estimates the variance of the regression parameters, ie Var(b).
- estimateRegressionParametersVariance() - Method in interface org.hipparchus.stat.regression.MultipleLinearRegression
-
Estimates the variance of the regression parameters, ie Var(b).
- estimateRegressionStandardError() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Estimates the standard error of the regression.
- estimateResiduals() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Estimates the residuals, ie u = y - X*b.
- estimateResiduals() - Method in interface org.hipparchus.stat.regression.MultipleLinearRegression
-
Estimates the residuals, ie u = y - X*b.
- estimationStep(T) - Method in class org.hipparchus.filtering.kalman.extended.ExtendedKalmanFilter
-
Perform one estimation step.
- estimationStep(T) - Method in interface org.hipparchus.filtering.kalman.KalmanFilter
-
Perform one estimation step.
- estimationStep(T) - Method in class org.hipparchus.filtering.kalman.linear.LinearKalmanFilter
-
Perform one estimation step.
- estimationStep(T) - Method in class org.hipparchus.filtering.kalman.unscented.UnscentedKalmanFilter
-
Perform one estimation step.
- Euclidean1D - Class in org.hipparchus.geometry.euclidean.oned
-
This class implements a one-dimensional space.
- Euclidean1D.NoSubSpaceException - Exception in org.hipparchus.geometry.euclidean.oned
-
Specialized exception for inexistent sub-space.
- Euclidean2D - Class in org.hipparchus.geometry.euclidean.twod
-
This class implements a two-dimensional space.
- Euclidean3D - Class in org.hipparchus.geometry.euclidean.threed
-
This class implements a three-dimensional space.
- EuclideanDistance - Class in org.hipparchus.clustering.distance
-
Calculates the L2 (Euclidean) distance between two points.
- EuclideanDistance() - Constructor for class org.hipparchus.clustering.distance.EuclideanDistance
-
Empty constructor.
- EULER_ANGLES_SINGULARITY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.EULER_ANGLES_SINGULARITY.
- EULER_ANGLES_SINGULARITY - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.EULER_ANGLES_SINGULARITY.
- EulerFieldIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This class implements a simple Euler integrator for Ordinary Differential Equations.
- EulerFieldIntegrator(Field<T>, T) - Constructor for class org.hipparchus.ode.nonstiff.EulerFieldIntegrator
-
Simple constructor.
- EulerIntegrator - Class in org.hipparchus.ode.nonstiff
-
This class implements a simple Euler integrator for Ordinary Differential Equations.
- EulerIntegrator(double) - Constructor for class org.hipparchus.ode.nonstiff.EulerIntegrator
-
Simple constructor.
- evaluate() - Method in class org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Returns the result of evaluating the statistic over the stored data.
- evaluate(double) - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Returns the result of evaluating the statistic over the stored data.
- evaluate(double) - Method in class org.hipparchus.util.ContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(double[]) - Method in interface org.hipparchus.stat.descriptive.UnivariateStatistic
-
Returns the result of evaluating the statistic over the input array.
- evaluate(double[]) - Method in interface org.hipparchus.util.MathArrays.Function
-
Operates on an entire array.
- evaluate(double[], double) - Static method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Uses Horner's Method to evaluate the polynomial with the given coefficients at the argument.
- evaluate(double[], double) - Method in class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Returns the
SemiVariance
of the designated values against the cutoff, using instance properties variancDirection and biasCorrection. - evaluate(double[], double) - Method in class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Returns the Standard Deviation of the entries in the input array, using the precomputed mean value.
- evaluate(double[], double) - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Returns the variance of the entries in the input array, using the precomputed mean value.
- evaluate(double[], double) - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Returns an estimate of the
p
th percentile of the values in thevalues
array. - evaluate(double[], double[]) - Method in interface org.hipparchus.stat.descriptive.WeightedEvaluation
-
Returns the result of evaluating the statistic over the input array, using the supplied weights.
- evaluate(double[], double[], double) - Static method in class org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Evaluate the Lagrange polynomial using Neville's Algorithm.
- evaluate(double[], double[], double) - Static method in class org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Evaluate the Newton polynomial using nested multiplication.
- evaluate(double[], double[], double) - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Returns the weighted variance of the values in the input array, using the precomputed weighted mean value.
- evaluate(double[], double[], double, int, int) - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Returns the weighted variance of the entries in the specified portion of the input array, using the precomputed weighted mean value.
- evaluate(double[], double[], int, int) - Method in class org.hipparchus.stat.descriptive.moment.Mean
-
Returns the weighted arithmetic mean of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], double[], int, int) - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Returns the weighted variance of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], double[], int, int) - Method in class org.hipparchus.stat.descriptive.summary.Product
-
Returns the weighted product of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], double[], int, int) - Method in class org.hipparchus.stat.descriptive.summary.Sum
-
The weighted sum of the entries in the specified portion of the input array, or 0 if the designated subarray is empty.
- evaluate(double[], double[], int, int) - Method in interface org.hipparchus.stat.descriptive.WeightedEvaluation
-
Returns the result of evaluating the statistic over the specified entries in the input array, using corresponding entries in the supplied weights array.
- evaluate(double[], double, int, int) - Method in class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Returns the Standard Deviation of the entries in the specified portion of the input array, using the precomputed mean value.
- evaluate(double[], double, int, int) - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Returns the variance of the entries in the specified portion of the input array, using the precomputed mean value.
- evaluate(double[], double, SemiVariance.Direction) - Method in class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Returns the
SemiVariance
of the designated values against the cutoff in the given direction, using the current value of the biasCorrection instance property. - evaluate(double[], double, SemiVariance.Direction, boolean, int, int) - Method in class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Returns the
SemiVariance
of the designated values against the cutoff in the given direction with the provided bias correction. - evaluate(double[], double, KthSelector) - Method in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
Evaluate method to compute the percentile for a given bounded array.
- evaluate(double[], int[], double, KthSelector) - Method in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
- evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Returns the result of evaluating the statistic over the specified entries in the input array.
- evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.moment.GeometricMean
-
Returns the geometric mean of the entries in the specified portion of the input array.
- evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.moment.Kurtosis
-
Returns the kurtosis of the entries in the specified portion of the input array.
- evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.moment.Mean
-
Returns the arithmetic mean of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Returns the
SemiVariance
of the designated values against the mean, using instance properties varianceDirection and biasCorrection. - evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.moment.Skewness
-
Returns the Skewness of the entries in the specified portion of the input array.
- evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Returns the Standard Deviation of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Returns the variance of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.rank.Max
-
Returns the maximum of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.rank.Median
-
Returns the result of evaluating the statistic over the specified entries in the input array.
- evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.rank.Min
-
Returns the minimum of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Returns an estimate of the
quantile
th percentile of the designated values in thevalues
array. - evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Returns an estimate of the median, computed using the designated array segment as input data.
- evaluate(double[], int, int) - Method in interface org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
-
Returns the result of evaluating the statistic over the specified entries in the input array.
- evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.summary.Product
-
Returns the product of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.summary.Sum
-
The sum of the entries in the specified portion of the input array, or 0 if the designated subarray is empty.
- evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.summary.SumOfLogs
-
Returns the sum of the natural logs of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - Method in class org.hipparchus.stat.descriptive.summary.SumOfSquares
-
Returns the sum of the squares of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - Method in interface org.hipparchus.stat.descriptive.UnivariateStatistic
-
Returns the result of evaluating the statistic over the specified entries in the input array.
- evaluate(double[], int, int) - Method in interface org.hipparchus.util.MathArrays.Function
-
Operates on a sub-array.
- evaluate(double[], int, int, double) - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Returns an estimate of the
p
th percentile of the values in thevalues
array, starting with the element in (0-based) positionbegin
in the array and includinglength
values. - evaluate(double[], SemiVariance.Direction) - Method in class org.hipparchus.stat.descriptive.moment.SemiVariance
-
This method calculates
SemiVariance
for the entire array against the mean, using the current value of the biasCorrection instance property. - evaluate(double, double) - Method in class org.hipparchus.util.ContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(double, double[]) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Returns an estimate of percentile over the given array.
- evaluate(double, double[], int, int) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Returns an estimate of the given percentile, computed using the designated array segment as input data.
- evaluate(double, double, int) - Method in class org.hipparchus.util.ContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(double, int) - Method in class org.hipparchus.util.ContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Evaluate all the non-evaluated points of the simplex.
- evaluate(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
-
Evaluate the model at the specified point.
- evaluate(RealVector) - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem
-
Evaluate the model at the specified point.
- evaluate(T) - Method in class org.hipparchus.util.FieldContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(T[], T) - Static method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Uses Horner's Method to evaluate the polynomial with the given coefficients at the argument.
- evaluate(T, double) - Method in class org.hipparchus.util.FieldContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(T, double, int) - Method in class org.hipparchus.util.FieldContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(T, int) - Method in class org.hipparchus.util.FieldContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluateStep(FieldODEStateInterpolator<T>) - Method in class org.hipparchus.ode.events.FieldDetectorBasedEventState
-
Evaluate the impact of the proposed step on the event handler.
- evaluateStep(FieldODEStateInterpolator<T>) - Method in interface org.hipparchus.ode.events.FieldEventState
-
Evaluate the impact of the proposed step on the event handler.
- evaluateStep(FieldODEStateInterpolator<T>) - Method in class org.hipparchus.ode.events.FieldStepEndEventState
-
Evaluate the impact of the proposed step on the event handler.
- evaluateStep(ODEStateInterpolator) - Method in class org.hipparchus.ode.events.DetectorBasedEventState
-
Evaluate the impact of the proposed step on the handler.
- evaluateStep(ODEStateInterpolator) - Method in interface org.hipparchus.ode.events.EventState
-
Evaluate the impact of the proposed step on the handler.
- evaluateStep(ODEStateInterpolator) - Method in class org.hipparchus.ode.events.StepEndEventState
-
Evaluate the impact of the proposed step on the handler.
- EVALUATION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
EVALUATION.
- EVALUATION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.EVALUATION.
- evaluationChecker(ConvergenceChecker<PointVectorValuePair>) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
View a convergence checker specified for a
PointVectorValuePair
as one specified for anLeastSquaresProblem.Evaluation
. - EvaluationRmsChecker - Class in org.hipparchus.optim.nonlinear.vector.leastsquares
-
Check if an optimization has converged based on the change in computed RMS.
- EvaluationRmsChecker(double) - Constructor for class org.hipparchus.optim.nonlinear.vector.leastsquares.EvaluationRmsChecker
-
Create a convergence checker for the RMS with the same relative and absolute tolerance.
- EvaluationRmsChecker(double, double) - Constructor for class org.hipparchus.optim.nonlinear.vector.leastsquares.EvaluationRmsChecker
-
Create a convergence checker for the RMS with a relative and absolute tolerance.
- evaluations - Variable in class org.hipparchus.optim.BaseOptimizer
-
Evaluations counter.
- EVALUATIONS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
EVALUATIONS.
- EVALUATIONS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.EVALUATIONS.
- EventHandler - Interface in org.hipparchus.migration.ode.events
-
Deprecated.as of 1.0, replaced with
ODEEventDetector
- EventHandler.Action - Enum in org.hipparchus.migration.ode.events
-
Deprecated.as of 1.0, replaced with
Action
- eventOccurred(double, double[], boolean) - Method in interface org.hipparchus.migration.ode.events.EventHandler
-
Deprecated.Handle an event and choose what to do next.
- eventOccurred(FieldODEStateAndDerivative<T>, FieldODEEventDetector<T>, boolean) - Method in interface org.hipparchus.ode.events.FieldODEEventHandler
-
Handle an event and choose what to do next.
- eventOccurred(ODEStateAndDerivative, ODEEventDetector, boolean) - Method in interface org.hipparchus.ode.events.ODEEventHandler
-
Handle an event and choose what to do next.
- EventOccurrence - Class in org.hipparchus.ode.events
-
Class to hold the data related to an event occurrence that is needed to decide how to modify integration.
- EventOccurrence(Action, ODEState, double) - Constructor for class org.hipparchus.ode.events.EventOccurrence
-
Create a new occurrence of an event.
- EventSlopeFilter<T extends ODEEventDetector> - Class in org.hipparchus.ode.events
-
Wrapper used to detect only increasing or decreasing events.
- EventSlopeFilter(T, FilterType) - Constructor for class org.hipparchus.ode.events.EventSlopeFilter
-
Wrap an
event detector
. - EventState - Interface in org.hipparchus.ode.events
-
This interface handles the state for either one
event handler
or onestep end handler
during integration steps. - exactLog2(int) - Static method in class org.hipparchus.transform.TransformUtils
-
Returns the base-2 logarithm of the specified
int
. - exactP(double, int, int, boolean) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes \(P(D_{n,m} > d)\) if
strict
istrue
; otherwise \(P(D_{n,m} \ge d)\), where \(D_{n,m}\) is the 2-sample Kolmogorov-Smirnov statistic. - exactP(double, int, int, boolean) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Computes \(P(D_{n,m} > d)\) if
strict
istrue
; otherwise \(P(D_{n,m} \ge d)\), where \(D_{n,m}\) is the 2-sample Kolmogorov-Smirnov statistic. - ExampleFrame() - Constructor for class org.hipparchus.samples.ExampleUtils.ExampleFrame
-
Empty constructor.
- ExampleUtils - Class in org.hipparchus.samples
-
Graphics utilities for examples.
- ExampleUtils() - Constructor for class org.hipparchus.samples.ExampleUtils
-
Empty constructor.
- ExampleUtils.ExampleFrame - Class in org.hipparchus.samples
-
Display frame.
- exp - Variable in class org.hipparchus.dfp.Dfp
-
Exponent.
- exp() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Exponential.
- exp() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Exponential.
- exp() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Exponential.
- exp() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Exponential.
- exp() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Exponential.
- exp() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Exponential.
- exp() - Method in interface org.hipparchus.CalculusFieldElement
-
Exponential.
- exp() - Method in class org.hipparchus.complex.Complex
-
Compute the exponential function of this complex number.
- exp() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the exponential function of this complex number.
- exp() - Method in class org.hipparchus.dfp.Dfp
-
Exponential.
- exp() - Method in class org.hipparchus.util.Binary64
-
Exponential.
- exp() - Method in class org.hipparchus.util.FieldTuple
-
Exponential.
- exp() - Method in class org.hipparchus.util.Tuple
-
Exponential.
- exp(double) - Static method in class org.hipparchus.util.FastMath
-
Exponential function.
- exp(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute exponential of a derivative structure.
- exp(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
Computes e to the given power.
- exp(T) - Static method in class org.hipparchus.util.FastMath
-
Exponential function.
- exp(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute exponential of a derivative structure.
- Exp - Class in org.hipparchus.analysis.function
-
Exponential function.
- Exp() - Constructor for class org.hipparchus.analysis.function.Exp
-
Empty constructor.
- expand() - Method in class org.hipparchus.util.ResizableDoubleArray
-
Expands the internal storage array using the expansion factor.
- ExpandableODE - Class in org.hipparchus.ode
-
This class represents a combined set of first order differential equations, with at least a primary set of equations expandable by some sets of secondary equations.
- ExpandableODE(OrdinaryDifferentialEquation) - Constructor for class org.hipparchus.ode.ExpandableODE
-
Build an expandable set from its primary ODE set.
- EXPANSION_FACTOR_SMALLER_THAN_ONE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
EXPANSION_FACTOR_SMALLER_THAN_ONE.
- EXPANSION_FACTOR_SMALLER_THAN_ONE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.EXPANSION_FACTOR_SMALLER_THAN_ONE.
- expInternal(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
Computes e to the given power.
- ExplicitRungeKuttaIntegrator - Interface in org.hipparchus.ode.nonstiff
-
This interface implements the part of Runge-Kutta integrators for Ordinary Differential Equations common to fixed- and adaptive steps.
- expm1() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Exponential minus 1.
- expm1() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Exponential minus 1.
- expm1() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Exponential minus 1.
- expm1() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Exponential minus 1.
- expm1() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Exponential minus 1.
- expm1() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Exponential minus 1.
- expm1() - Method in interface org.hipparchus.CalculusFieldElement
-
Exponential minus 1.
- expm1() - Method in class org.hipparchus.complex.Complex
-
Exponential minus 1.
- expm1() - Method in class org.hipparchus.complex.FieldComplex
-
Exponential minus 1.
- expm1() - Method in class org.hipparchus.dfp.Dfp
-
Exponential minus 1.
- expm1() - Method in class org.hipparchus.util.Binary64
-
Exponential minus 1.
- expm1() - Method in class org.hipparchus.util.FieldTuple
-
Exponential minus 1.
- expm1() - Method in class org.hipparchus.util.Tuple
-
Exponential minus 1.
- expm1(double) - Static method in class org.hipparchus.util.FastMath
-
Compute exp(x) - 1
- expm1(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute exp(x) - 1 of a derivative structure.
- expm1(T) - Static method in class org.hipparchus.util.FastMath
-
Compute exp(x) - 1
- expm1(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute exp(x) - 1 of a derivative structure.
- Expm1 - Class in org.hipparchus.analysis.function
-
ex-1
function. - Expm1() - Constructor for class org.hipparchus.analysis.function.Expm1
-
Empty constructor.
- EXPONENT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
EXPONENT.
- EXPONENT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.EXPONENT.
- ExponentialDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the exponential distribution.
- ExponentialDistribution(double) - Constructor for class org.hipparchus.distribution.continuous.ExponentialDistribution
-
Create an exponential distribution with the given mean.
- ExtendedKalmanFilter<T extends Measurement> - Class in org.hipparchus.filtering.kalman.extended
-
Kalman filter for
non-linear process
. - ExtendedKalmanFilter(MatrixDecomposer, NonLinearProcess<T>, ProcessEstimate) - Constructor for class org.hipparchus.filtering.kalman.extended.ExtendedKalmanFilter
-
Simple constructor.
- extractEquationData(int, double[]) - Method in class org.hipparchus.ode.EquationsMapper
-
Extract equation data from a complete state or derivative array.
- extractEquationData(int, T[]) - Method in class org.hipparchus.ode.FieldEquationsMapper
-
Extract equation data from a complete state or derivative array.
- extractField(T[]) - Static method in class org.hipparchus.linear.AbstractFieldMatrix
-
Get the elements type from an array.
- extractField(T[][]) - Static method in class org.hipparchus.linear.AbstractFieldMatrix
-
Get the elements type from an array.
- extractMainSetJacobian(ODEState) - Method in class org.hipparchus.migration.ode.JacobianMatrices
-
Deprecated.Extract the Jacobian matrix with respect to state.
- extractMainSetJacobian(ODEState) - Method in class org.hipparchus.ode.VariationalEquation
-
Extract the Jacobian matrix with respect to state.
- extractParameterJacobian(ODEState, String) - Method in class org.hipparchus.migration.ode.JacobianMatrices
-
Deprecated.Extract the Jacobian matrix with respect to one parameter.
- extractParameterJacobian(ODEState, String) - Method in class org.hipparchus.ode.VariationalEquation
-
Extract the Jacobian matrix with respect to one parameter.
- extrema(boolean) - Method in class org.hipparchus.stat.descriptive.StreamingStatistics.StreamingStatisticsBuilder
-
Sets the computeExtrema setting of the factory.
F
- FACET_ORIENTATION_MISMATCH - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
FACET_ORIENTATION_MISMATCH.
- FACET_ORIENTATION_MISMATCH - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.FACET_ORIENTATION_MISMATCH.
- FACET_WITH_SEVERAL_BOUNDARY_LOOPS - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
FACET_WITH_SEVERAL_BOUNDARY_LOOPS.
- factorial(int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Returns n!.
- FACTORIAL_NEGATIVE_PARAMETER - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
FACTORIAL_NEGATIVE_PARAMETER.
- FACTORIAL_NEGATIVE_PARAMETER - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.FACTORIAL_NEGATIVE_PARAMETER.
- factorialDouble(int) - Static method in class org.hipparchus.util.CombinatoricsUtils
- factorialLog(int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Compute the natural logarithm of the factorial of
n
. - FAILED - Enum constant in enum org.hipparchus.stat.ranking.NaNStrategy
-
NaNs result in an exception
- FAILED_BRACKETING - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
FAILED_BRACKETING.
- FAILED_BRACKETING - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.FAILED_BRACKETING.
- FAILED_DECOMPOSITION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
FAILED_DECOMPOSITION.
- FAILED_FRACTION_CONVERSION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
FAILED_FRACTION_CONVERSION.
- FAILED_FRACTION_CONVERSION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.FAILED_FRACTION_CONVERSION.
- FARTHEST_POINT - Enum constant in enum org.hipparchus.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
-
Create a cluster around the point farthest from its centroid.
- FastCosineTransformer - Class in org.hipparchus.transform
-
Implements the Fast Cosine Transform for transformation of one-dimensional real data sets.
- FastCosineTransformer(DctNormalization) - Constructor for class org.hipparchus.transform.FastCosineTransformer
-
Creates a new instance of this class, with various normalization conventions.
- FastFourierTransformer - Class in org.hipparchus.transform
-
Implements the Fast Fourier Transform for transformation of one-dimensional real or complex data sets.
- FastFourierTransformer(DftNormalization) - Constructor for class org.hipparchus.transform.FastFourierTransformer
-
Creates a new instance of this class, with various normalization conventions.
- FastHadamardTransformer - Class in org.hipparchus.transform
-
Implements the Fast Hadamard Transform (FHT).
- FastHadamardTransformer() - Constructor for class org.hipparchus.transform.FastHadamardTransformer
-
Empty constructor.
- FastMath - Class in org.hipparchus.util
-
Faster, more accurate, portable alternative to
Math
andStrictMath
for large scale computation. - FastSineTransformer - Class in org.hipparchus.transform
-
Implements the Fast Sine Transform for transformation of one-dimensional real data sets.
- FastSineTransformer(DstNormalization) - Constructor for class org.hipparchus.transform.FastSineTransformer
-
Creates a new instance of this class, with various normalization conventions.
- fct(double[]) - Method in class org.hipparchus.transform.FastCosineTransformer
-
Perform the FCT algorithm (including inverse).
- FDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the F-distribution.
- FDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.FDistribution
-
Creates an F distribution using the given degrees of freedom.
- FDistribution(double, double, double) - Constructor for class org.hipparchus.distribution.continuous.FDistribution
-
Creates an F distribution.
- FDSFactory<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.differentiation
-
Factory for
FieldDerivativeStructure
. - FDSFactory(Field<T>, int, int) - Constructor for class org.hipparchus.analysis.differentiation.FDSFactory
-
Simple constructor.
- FDSFactory.DerivativeField<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.differentiation
-
Field for {link FieldDerivativeStructure} instances.
- fht(double[]) - Method in class org.hipparchus.transform.FastHadamardTransformer
-
The FHT (Fast Hadamard Transformation) which uses only subtraction and addition.
- fht(int[]) - Method in class org.hipparchus.transform.FastHadamardTransformer
-
Returns the forward transform of the specified integer data set.
- Field<T extends FieldElement<T>> - Interface in org.hipparchus
-
Interface representing a field.
- FieldAbstractRuleFactory<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.integration.gauss
-
Base class for rules that determines the integration nodes and their weights.
- FieldAbstractRuleFactory(Field<T>) - Constructor for class org.hipparchus.analysis.integration.gauss.FieldAbstractRuleFactory
-
Simple constructor
- FieldAdaptableInterval<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.ode.events
-
This interface represents an event checking interval that depends on state.
- FieldBivariateFunction - Interface in org.hipparchus.analysis
-
An interface representing a bivariate field function.
- FieldBlendable<B,
T extends FieldElement<T>> - Interface in org.hipparchus.util -
Interface representing classes that can blend with other instances of themselves using a given blending value.
- FieldBracketingNthOrderBrentSolver<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.solvers
-
This class implements a modification of the Brent algorithm.
- FieldBracketingNthOrderBrentSolver(T, T, T, int) - Constructor for class org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
-
Construct a solver.
- FieldButcherArrayProvider<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.ode.nonstiff
-
This interface represents an integrator based on Butcher arrays.
- FieldComplex<T extends CalculusFieldElement<T>> - Class in org.hipparchus.complex
-
Representation of a Complex number, i.e.
- FieldComplex(T) - Constructor for class org.hipparchus.complex.FieldComplex
-
Create a complex number given only the real part.
- FieldComplex(T, T) - Constructor for class org.hipparchus.complex.FieldComplex
-
Create a complex number given the real and imaginary parts.
- FieldComplexField<T extends CalculusFieldElement<T>> - Class in org.hipparchus.complex
-
Representation of the complex numbers field.
- FieldComplexUnivariateIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.complex
-
Wrapper to perform univariate complex integration using an underlying real integration algorithms.
- FieldComplexUnivariateIntegrator(FieldUnivariateIntegrator<T>) - Constructor for class org.hipparchus.complex.FieldComplexUnivariateIntegrator
-
Crate a complex integrator from a real integrator.
- FieldContinuedFraction - Class in org.hipparchus.util
-
Provides a generic means to evaluate continued fractions.
- FieldContinuedFraction() - Constructor for class org.hipparchus.util.FieldContinuedFraction
-
Default constructor.
- FieldCopolarC<T extends CalculusFieldElement<T>> - Class in org.hipparchus.special.elliptic.jacobi
-
Copolar trio with pole at point c in Glaisher’s Notation.
- FieldCopolarD<T extends CalculusFieldElement<T>> - Class in org.hipparchus.special.elliptic.jacobi
-
Copolar trio with pole at point d in Glaisher’s Notation.
- FieldCopolarN<T extends CalculusFieldElement<T>> - Class in org.hipparchus.special.elliptic.jacobi
-
Copolar trio with pole at point n in Glaisher’s Notation.
- FieldCopolarS<T extends CalculusFieldElement<T>> - Class in org.hipparchus.special.elliptic.jacobi
-
Copolar trio with pole at point s in Glaisher’s Notation.
- FieldDecompositionSolver<T extends FieldElement<T>> - Interface in org.hipparchus.linear
-
Interface handling decomposition algorithms that can solve A × X = B.
- FieldDenseOutputModel<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode
-
This class stores all information provided by an ODE integrator during the integration process and build a continuous model of the solution from this.
- FieldDenseOutputModel() - Constructor for class org.hipparchus.ode.FieldDenseOutputModel
-
Simple constructor.
- FieldDerivative<S extends CalculusFieldElement<S>,
T extends FieldDerivative<S, T>> - Interface in org.hipparchus.analysis.differentiation -
Interface representing both the value and the differentials of a function.
- FieldDerivative1<S extends CalculusFieldElement<S>,
T extends FieldDerivative<S, T>> - Interface in org.hipparchus.analysis.differentiation -
Interface representing a Field object holding partial derivatives up to first order.
- FieldDerivativeStructure<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.differentiation
-
Class representing both the value and the differentials of a function.
- FieldDetectorBasedEventState<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode.events
-
This class handles the state for one
event handler
during integration steps. - FieldDetectorBasedEventState(FieldODEEventDetector<T>) - Constructor for class org.hipparchus.ode.events.FieldDetectorBasedEventState
-
Simple constructor.
- FieldElement<T extends FieldElement<T>> - Interface in org.hipparchus
-
Interface representing field elements.
- FieldEquationsMapper<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode
-
Class mapping the part of a complete state or derivative that pertains to a set of differential equations.
- FieldEventOccurrence<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode.events
-
Class to hold the data related to an event occurrence that is needed to decide how to modify integration.
- FieldEventOccurrence(Action, FieldODEState<T>, T) - Constructor for class org.hipparchus.ode.events.FieldEventOccurrence
-
Create a new occurrence of an event.
- FieldEventSlopeFilter<T extends FieldODEEventDetector<E>,
E extends CalculusFieldElement<E>> - Class in org.hipparchus.ode.events -
Wrapper used to detect only increasing or decreasing events.
- FieldEventSlopeFilter(Field<E>, T, FilterType) - Constructor for class org.hipparchus.ode.events.FieldEventSlopeFilter
-
Wrap a
eve,t detector
. - FieldEventState<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.ode.events
-
This interface handles the state for either one
event handler
or onestep end handler
during integration steps. - FieldExpandableODE<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode
-
This class represents a combined set of first order differential equations, with at least a primary set of equations expandable by some sets of secondary equations.
- FieldExpandableODE(FieldOrdinaryDifferentialEquation<T>) - Constructor for class org.hipparchus.ode.FieldExpandableODE
-
Build an expandable set from its primary ODE set.
- FieldExplicitRungeKuttaIntegrator<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.ode.nonstiff
-
This interface implements the part of Runge-Kutta Field integrators for Ordinary Differential Equations common to fixed- and adaptive steps.
- FieldGaussIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.integration.gauss
-
Class that implements the Gaussian rule for
integrating
a weighted function. - FieldGaussIntegrator(Pair<T[], T[]>) - Constructor for class org.hipparchus.analysis.integration.gauss.FieldGaussIntegrator
-
Creates an integrator from the given pair of points (first element of the pair) and weights (second element of the pair.
- FieldGaussIntegrator(T[], T[]) - Constructor for class org.hipparchus.analysis.integration.gauss.FieldGaussIntegrator
-
Creates an integrator from the given
points
andweights
. - FieldGaussIntegratorFactory<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.integration.gauss
-
Class that provides different ways to compute the nodes and weights to be used by the
Gaussian integration rule
. - FieldGaussIntegratorFactory(Field<T>) - Constructor for class org.hipparchus.analysis.integration.gauss.FieldGaussIntegratorFactory
-
Simple constructor.
- FieldGradient<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.differentiation
-
Class representing both the value and the differentials of a function.
- FieldGradient(FieldDerivativeStructure<T>) - Constructor for class org.hipparchus.analysis.differentiation.FieldGradient
-
Build an instance from a
DerivativeStructure
. - FieldGradient(T, T...) - Constructor for class org.hipparchus.analysis.differentiation.FieldGradient
-
Build an instance with values and derivative.
- FieldGradientField<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.differentiation
-
Field for
Gradient
instances. - FieldHermiteInterpolator<T extends FieldElement<T>> - Class in org.hipparchus.analysis.interpolation
-
Polynomial interpolator using both sample values and sample derivatives.
- FieldHermiteInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.FieldHermiteInterpolator
-
Create an empty interpolator.
- FieldHermiteRuleFactory<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.integration.gauss
-
Factory that creates a Gauss-type quadrature rule using Hermite polynomials of the first kind.
- FieldHermiteRuleFactory(Field<T>) - Constructor for class org.hipparchus.analysis.integration.gauss.FieldHermiteRuleFactory
-
Simple constructor
- FieldJacobiElliptic<T extends CalculusFieldElement<T>> - Class in org.hipparchus.special.elliptic.jacobi
-
Computation of Jacobi elliptic functions.
- FieldJacobiElliptic(T) - Constructor for class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Simple constructor.
- FieldJacobiTheta<T extends CalculusFieldElement<T>> - Class in org.hipparchus.special.elliptic.jacobi
-
Algorithm computing Jacobi theta functions.
- FieldJacobiTheta(T) - Constructor for class org.hipparchus.special.elliptic.jacobi.FieldJacobiTheta
-
Simple constructor.
- FieldLaguerreRuleFactory<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.integration.gauss
-
Factory that creates Gauss-type quadrature rule using Laguerre polynomials.
- FieldLaguerreRuleFactory(Field<T>) - Constructor for class org.hipparchus.analysis.integration.gauss.FieldLaguerreRuleFactory
-
Simple constructor
- FieldLegendreRuleFactory<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.integration.gauss
-
Factory that creates Gauss-type quadrature rule using Legendre polynomials.
- FieldLegendreRuleFactory(Field<T>) - Constructor for class org.hipparchus.analysis.integration.gauss.FieldLegendreRuleFactory
-
Simple constructor
- FieldLine<T extends CalculusFieldElement<T>> - Class in org.hipparchus.geometry.euclidean.threed
-
The class represent lines in a three dimensional space.
- FieldLine(FieldLine<T>) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Copy constructor.
- FieldLine(FieldVector3D<T>, FieldVector3D<T>, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Build a line from two points.
- FieldLUDecomposer<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
Matrix decomposer using LU-decomposition.
- FieldLUDecomposer(Predicate<T>) - Constructor for class org.hipparchus.linear.FieldLUDecomposer
-
Creates a LU decomposer with specific zero checker for several matrices.
- FieldLUDecomposition<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
Calculates the LUP-decomposition of a square matrix.
- FieldLUDecomposition(FieldMatrix<T>) - Constructor for class org.hipparchus.linear.FieldLUDecomposition
-
Calculates the LU-decomposition of the given matrix.
- FieldLUDecomposition(FieldMatrix<T>, Predicate<T>) - Constructor for class org.hipparchus.linear.FieldLUDecomposition
-
Calculates the LU-decomposition of the given matrix.
- FieldLUDecomposition(FieldMatrix<T>, Predicate<T>, boolean) - Constructor for class org.hipparchus.linear.FieldLUDecomposition
-
Calculates the LU-decomposition of the given matrix.
- FieldMatrix<T extends FieldElement<T>> - Interface in org.hipparchus.linear
-
Interface defining field-valued matrix with basic algebraic operations.
- FieldMatrixChangingVisitor<T extends FieldElement<?>> - Interface in org.hipparchus.linear
-
Interface defining a visitor for matrix entries.
- FieldMatrixDecomposer<T extends FieldElement<T>> - Interface in org.hipparchus.linear
-
Interface for all algorithms providing matrix decomposition.
- FieldMatrixPreservingVisitor<T extends FieldElement<?>> - Interface in org.hipparchus.linear
-
Interface defining a visitor for matrix entries.
- FieldMidPointIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.integration
-
Implements the Midpoint Rule for integration of real univariate functions.
- FieldMidPointIntegrator(Field<T>) - Constructor for class org.hipparchus.analysis.integration.FieldMidPointIntegrator
-
Construct a midpoint integrator with default settings.
- FieldMidPointIntegrator(Field<T>, double, double, int, int) - Constructor for class org.hipparchus.analysis.integration.FieldMidPointIntegrator
-
Build a midpoint integrator with given accuracies and iterations counts.
- FieldMidPointIntegrator(Field<T>, int, int) - Constructor for class org.hipparchus.analysis.integration.FieldMidPointIntegrator
-
Build a midpoint integrator with given iteration counts.
- FieldMultivariateFunction - Interface in org.hipparchus.analysis
-
An interface representing a scalar multivariate function for any field type.
- FieldMultivariateMatrixFunction - Interface in org.hipparchus.analysis
-
An interface representing a matrix multivariate function for any field type.
- FieldMultivariateVectorFunction - Interface in org.hipparchus.analysis
-
An interface representing a vector multivariate function for any field type.
- FieldODEEventDetector<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.ode.events
-
This interface represents a handler for discrete events triggered during ODE integration.
- FieldODEEventHandler<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.ode.events
-
This interface represents a handler for discrete events triggered during ODE integration.
- FieldODEFixedStepHandler<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.ode.sampling
-
This interface represents a handler that should be called after each successful fixed step.
- FieldODEIntegrator<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.ode
-
This interface represents a first order integrator for differential equations.
- FieldODEState<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode
-
Container for time, main and secondary state vectors.
- FieldODEState(T, T[]) - Constructor for class org.hipparchus.ode.FieldODEState
-
Simple constructor.
- FieldODEState(T, T[], T[][]) - Constructor for class org.hipparchus.ode.FieldODEState
-
Simple constructor.
- FieldODEStateAndDerivative<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode
-
Container for time, main and secondary state vectors as well as their derivatives.
- FieldODEStateAndDerivative(T, T[], T[]) - Constructor for class org.hipparchus.ode.FieldODEStateAndDerivative
-
Simple constructor.
- FieldODEStateAndDerivative(T, T[], T[], T[][], T[][]) - Constructor for class org.hipparchus.ode.FieldODEStateAndDerivative
-
Simple constructor.
- FieldODEStateInterpolator<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.ode.sampling
-
This interface represents an interpolator over the last step during an ODE integration.
- FieldODEStepEndHandler<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.ode.events
-
This interface represents a handler for discrete events triggered during ODE integration at each step end.
- FieldODEStepHandler<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.ode.sampling
-
This interface represents a handler that should be called after each successful step.
- FieldOrdinaryDifferentialEquation<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.ode
-
This interface represents a first order differential equations set.
- FieldPolynomialFunction<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.polynomials
-
Immutable representation of a real polynomial function with real coefficients.
- FieldPolynomialFunction(T[]) - Constructor for class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Construct a polynomial with the given coefficients.
- FieldPolynomialSplineFunction<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.polynomials
-
Represents a polynomial spline function.
- FieldPolynomialSplineFunction(T[], FieldPolynomialFunction<T>[]) - Constructor for class org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
-
Construct a polynomial spline function with the given segment delimiters and interpolating polynomials.
- FieldQRDecomposer<T extends CalculusFieldElement<T>> - Class in org.hipparchus.linear
-
Matrix decomposer using QR-decomposition.
- FieldQRDecomposer(T) - Constructor for class org.hipparchus.linear.FieldQRDecomposer
-
Creates a QR decomposer with specify threshold for several matrices.
- FieldQRDecomposition<T extends CalculusFieldElement<T>> - Class in org.hipparchus.linear
-
Calculates the QR-decomposition of a field matrix.
- FieldQRDecomposition(FieldMatrix<T>) - Constructor for class org.hipparchus.linear.FieldQRDecomposition
-
Calculates the QR-decomposition of the given matrix.
- FieldQRDecomposition(FieldMatrix<T>, T) - Constructor for class org.hipparchus.linear.FieldQRDecomposition
-
Calculates the QR-decomposition of the given matrix.
- FieldQRDecomposition(FieldMatrix<T>, T, Predicate<T>) - Constructor for class org.hipparchus.linear.FieldQRDecomposition
-
Calculates the QR-decomposition of the given matrix.
- FieldRombergIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.integration
-
Implements the Romberg Algorithm for integration of real univariate functions.
- FieldRombergIntegrator(Field<T>) - Constructor for class org.hipparchus.analysis.integration.FieldRombergIntegrator
-
Construct a Romberg integrator with default settings
- FieldRombergIntegrator(Field<T>, double, double, int, int) - Constructor for class org.hipparchus.analysis.integration.FieldRombergIntegrator
-
Build a Romberg integrator with given accuracies and iterations counts.
- FieldRombergIntegrator(Field<T>, int, int) - Constructor for class org.hipparchus.analysis.integration.FieldRombergIntegrator
-
Build a Romberg integrator with given iteration counts.
- FieldRotation<T extends CalculusFieldElement<T>> - Class in org.hipparchus.geometry.euclidean.threed
-
This class is a re-implementation of
Rotation
usingCalculusFieldElement
. - FieldRotation(Field<T>, Rotation) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build a
FieldRotation
from aRotation
. - FieldRotation(FieldVector3D<T>, FieldVector3D<T>) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build one of the rotations that transform one vector into another one.
- FieldRotation(FieldVector3D<T>, FieldVector3D<T>, FieldVector3D<T>, FieldVector3D<T>) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build the rotation that transforms a pair of vectors into another pair.
- FieldRotation(FieldVector3D<T>, T, RotationConvention) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build a rotation from an axis and an angle.
- FieldRotation(RotationOrder, RotationConvention, T, T, T) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build a rotation from three Cardan or Euler elementary rotations.
- FieldRotation(T[][], double) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build a rotation from a 3X3 matrix.
- FieldRotation(T, T, T, T, boolean) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build a rotation from the quaternion coordinates.
- FieldRuleFactory<T extends FieldElement<T>> - Interface in org.hipparchus.analysis.integration.gauss
-
Interface for rules that determines the integration nodes and their weights.
- FieldSecondaryODE<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.ode
-
This interface allows users to add secondary differential equations to a primary set of differential equations.
- FieldSimpsonIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.integration
-
Implements Simpson's Rule for integration of real univariate functions.
- FieldSimpsonIntegrator(Field<T>) - Constructor for class org.hipparchus.analysis.integration.FieldSimpsonIntegrator
-
Construct an integrator with default settings.
- FieldSimpsonIntegrator(Field<T>, double, double, int, int) - Constructor for class org.hipparchus.analysis.integration.FieldSimpsonIntegrator
-
Build a Simpson integrator with given accuracies and iterations counts.
- FieldSimpsonIntegrator(Field<T>, int, int) - Constructor for class org.hipparchus.analysis.integration.FieldSimpsonIntegrator
-
Build a Simpson integrator with given iteration counts.
- FieldSinCos<T> - Class in org.hipparchus.util
-
Holder for both sine and cosine values.
- FieldSinCos(T, T) - Constructor for class org.hipparchus.util.FieldSinCos
-
Simple constructor.
- FieldSinhCosh<T> - Class in org.hipparchus.util
-
Holder for both hyperbolic sine and hyperbolic cosine values.
- FieldSinhCosh(T, T) - Constructor for class org.hipparchus.util.FieldSinhCosh
-
Simple constructor.
- FieldStepEndEventState<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode.events
-
This class handles the state for one
event handler
that triggers at step end. - FieldStepEndEventState(FieldODEStepEndHandler<T>) - Constructor for class org.hipparchus.ode.events.FieldStepEndEventState
-
Simple constructor.
- FieldStepNormalizer<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode.sampling
-
This class wraps an object implementing
FieldODEFixedStepHandler
into aFieldODEStepHandler
. - FieldStepNormalizer(double, FieldODEFixedStepHandler<T>) - Constructor for class org.hipparchus.ode.sampling.FieldStepNormalizer
-
Simple constructor.
- FieldStepNormalizer(double, FieldODEFixedStepHandler<T>, StepNormalizerBounds) - Constructor for class org.hipparchus.ode.sampling.FieldStepNormalizer
-
Simple constructor.
- FieldStepNormalizer(double, FieldODEFixedStepHandler<T>, StepNormalizerMode) - Constructor for class org.hipparchus.ode.sampling.FieldStepNormalizer
-
Simple constructor.
- FieldStepNormalizer(double, FieldODEFixedStepHandler<T>, StepNormalizerMode, StepNormalizerBounds) - Constructor for class org.hipparchus.ode.sampling.FieldStepNormalizer
-
Simple constructor.
- FieldTaylorMap<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.differentiation
-
Container for a Taylor map.
- FieldTaylorMap(Field<T>, int, int, int) - Constructor for class org.hipparchus.analysis.differentiation.FieldTaylorMap
-
Constructor for identity map.
- FieldTaylorMap(T[], FieldDerivativeStructure<T>[]) - Constructor for class org.hipparchus.analysis.differentiation.FieldTaylorMap
-
Simple constructor.
- FieldTheta<T extends CalculusFieldElement<T>> - Class in org.hipparchus.special.elliptic.jacobi
-
Values of
Jacobi theta
functions. - FieldTrapezoidIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.integration
-
Implements the Trapezoid Rule for integration of real univariate functions.
- FieldTrapezoidIntegrator(Field<T>) - Constructor for class org.hipparchus.analysis.integration.FieldTrapezoidIntegrator
-
Construct a trapezoid integrator with default settings.
- FieldTrapezoidIntegrator(Field<T>, double, double, int, int) - Constructor for class org.hipparchus.analysis.integration.FieldTrapezoidIntegrator
-
Build a trapezoid integrator with given accuracies and iterations counts.
- FieldTrapezoidIntegrator(Field<T>, int, int) - Constructor for class org.hipparchus.analysis.integration.FieldTrapezoidIntegrator
-
Build a trapezoid integrator with given iteration counts.
- FieldTuple<T extends CalculusFieldElement<T>> - Class in org.hipparchus.util
-
This class allows to perform the same computation of all components of a Tuple at once.
- FieldTuple(T...) - Constructor for class org.hipparchus.util.FieldTuple
-
Creates a new instance from its components.
- FieldUnivariateDerivative<S extends CalculusFieldElement<S>,
T extends FieldUnivariateDerivative<S, T>> - Class in org.hipparchus.analysis.differentiation -
Abstract class representing both the value and the differentials of a function.
- FieldUnivariateDerivative() - Constructor for class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative
-
Empty constructor.
- FieldUnivariateDerivative1<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.differentiation
-
Class representing both the value and the differentials of a function.
- FieldUnivariateDerivative1(FieldDerivativeStructure<T>) - Constructor for class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Build an instance from a
DerivativeStructure
. - FieldUnivariateDerivative1(T, T) - Constructor for class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Build an instance with values and derivative.
- FieldUnivariateDerivative1Field<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.differentiation
-
Field for
FieldUnivariateDerivative1
instances. - FieldUnivariateDerivative2<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.differentiation
-
Class representing both the value and the differentials of a function.
- FieldUnivariateDerivative2(FieldDerivativeStructure<T>) - Constructor for class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Build an instance from a
DerivativeStructure
. - FieldUnivariateDerivative2(T, T, T) - Constructor for class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Build an instance with values and derivative.
- FieldUnivariateDerivative2Field<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.differentiation
-
Field for
FieldUnivariateDerivative2
instances. - FieldUnivariateFunction - Interface in org.hipparchus.analysis
-
An interface representing a univariate real function for any field type.
- FieldUnivariateIntegrator<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.analysis.integration
-
Interface for univariate real integration algorithms.
- FieldUnivariateInterpolator - Interface in org.hipparchus.analysis.interpolation
-
Interface representing a univariate field interpolating function.
- FieldUnivariateMatrixFunction - Interface in org.hipparchus.analysis
-
An interface representing a univariate matrix function for any field type.
- FieldUnivariateVectorFunction - Interface in org.hipparchus.analysis
-
An interface representing a univariate vectorial function for any field type.
- FieldVector<T extends FieldElement<T>> - Interface in org.hipparchus.linear
-
Interface defining a field-valued vector with basic algebraic operations.
- FieldVector2D<T extends CalculusFieldElement<T>> - Class in org.hipparchus.geometry.euclidean.twod
-
This class is a re-implementation of
Vector2D
usingCalculusFieldElement
. - FieldVector2D(double, FieldVector2D<T>) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Multiplicative constructor Build a vector from another one and a scale factor.
- FieldVector2D(double, FieldVector2D<T>, double, FieldVector2D<T>) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(double, FieldVector2D<T>, double, FieldVector2D<T>, double, FieldVector2D<T>) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(double, FieldVector2D<T>, double, FieldVector2D<T>, double, FieldVector2D<T>, double, FieldVector2D<T>) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(Field<T>, Vector2D) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Build a
FieldVector2D
from aVector2D
. - FieldVector2D(T[]) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Simple constructor.
- FieldVector2D(T, FieldVector2D<T>) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Multiplicative constructor Build a vector from another one and a scale factor.
- FieldVector2D(T, FieldVector2D<T>, T, FieldVector2D<T>) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor Build a vector from two other ones and corresponding scale factors.
- FieldVector2D(T, FieldVector2D<T>, T, FieldVector2D<T>, T, FieldVector2D<T>) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(T, FieldVector2D<T>, T, FieldVector2D<T>, T, FieldVector2D<T>, T, FieldVector2D<T>) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(T, Vector2D) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Multiplicative constructor Build a vector from another one and a scale factor.
- FieldVector2D(T, Vector2D, T, Vector2D) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(T, Vector2D, T, Vector2D, T, Vector2D) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(T, Vector2D, T, Vector2D, T, Vector2D, T, Vector2D) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(T, T) - Constructor for class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Simple constructor.
- FieldVector3D<T extends CalculusFieldElement<T>> - Class in org.hipparchus.geometry.euclidean.threed
-
This class is a re-implementation of
Vector3D
usingCalculusFieldElement
. - FieldVector3D(double, FieldVector3D<T>) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Multiplicative constructor.
- FieldVector3D(double, FieldVector3D<T>, double, FieldVector3D<T>) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(double, FieldVector3D<T>, double, FieldVector3D<T>, double, FieldVector3D<T>) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(double, FieldVector3D<T>, double, FieldVector3D<T>, double, FieldVector3D<T>, double, FieldVector3D<T>) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(Field<T>, Vector3D) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Build a
FieldVector3D
from aVector3D
. - FieldVector3D(T[]) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Simple constructor.
- FieldVector3D(T, FieldVector3D<T>) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Multiplicative constructor.
- FieldVector3D(T, FieldVector3D<T>, T, FieldVector3D<T>) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(T, FieldVector3D<T>, T, FieldVector3D<T>, T, FieldVector3D<T>) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(T, FieldVector3D<T>, T, FieldVector3D<T>, T, FieldVector3D<T>, T, FieldVector3D<T>) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(T, Vector3D) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Multiplicative constructor.
- FieldVector3D(T, Vector3D, T, Vector3D) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(T, Vector3D, T, Vector3D, T, Vector3D) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(T, Vector3D, T, Vector3D, T, Vector3D, T, Vector3D) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(T, T) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Simple constructor.
- FieldVector3D(T, T, T) - Constructor for class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Simple constructor.
- FieldVectorChangingVisitor<T extends FieldElement<?>> - Interface in org.hipparchus.linear
-
This interface defines a visitor for the entries of a vector.
- FieldVectorPreservingVisitor<T extends FieldElement<?>> - Interface in org.hipparchus.linear
-
This interface defines a visitor for the entries of a vector.
- filterStep(double, boolean, boolean) - Method in class org.hipparchus.ode.nonstiff.StepsizeHelper
-
Filter the integration step.
- filterStep(T, boolean, boolean) - Method in class org.hipparchus.ode.nonstiff.StepsizeHelper
-
Filter the integration step.
- FilterType - Enum in org.hipparchus.ode.events
-
Enumerate for
filtering events
. - finalizeStep(double, double[], double[], Array2DRowRealMatrix, boolean, ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.AdamsBashforthIntegrator
-
Finalize the step.
- finalizeStep(double, double[], double[], Array2DRowRealMatrix, boolean, ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Finalize the step.
- finalizeStep(double, double[], double[], Array2DRowRealMatrix, boolean, ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.AdamsMoultonIntegrator
-
Finalize the step.
- finalizeStep(T, T[], T[], Array2DRowFieldMatrix<T>, boolean, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegrator
-
Finalize the step.
- finalizeStep(T, T[], T[], Array2DRowFieldMatrix<T>, boolean, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Finalize the step.
- finalizeStep(T, T[], T[], Array2DRowFieldMatrix<T>, boolean, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegrator
-
Finalize the step.
- FIND_ROOT - Enum constant in enum org.hipparchus.ode.LocalizedODEFormats
-
FIND_ROOT.
- findEigenValues(RealMatrix) - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Compute eigen values using the Schur transform.
- findEigenVectors(FieldMatrix<Complex>) - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Compute the eigen vectors using the inverse power method.
- findHullVertices(Collection<Vector2D>) - Method in class org.hipparchus.geometry.euclidean.twod.hull.MonotoneChain
-
Find the convex hull vertices from the set of input points.
- findRoots(int, CalculusFieldUnivariateFunction<T>) - Method in class org.hipparchus.analysis.integration.gauss.FieldAbstractRuleFactory
-
Computes roots of the associated orthogonal polynomials.
- findRoots(int, UnivariateFunction) - Method in class org.hipparchus.analysis.integration.gauss.AbstractRuleFactory
-
Computes roots of the associated orthogonal polynomials.
- finish(FieldODEStateAndDerivative<T>) - Method in class org.hipparchus.ode.FieldDenseOutputModel
-
Finalize integration.
- finish(FieldODEStateAndDerivative<T>) - Method in interface org.hipparchus.ode.sampling.FieldODEStepHandler
-
Finalize integration.
- finish(FieldODEStateAndDerivative<T>) - Method in class org.hipparchus.ode.sampling.FieldStepNormalizer
-
Finalize integration.
- finish(ODEStateAndDerivative) - Method in class org.hipparchus.ode.DenseOutputModel
-
Finalize integration.
- finish(ODEStateAndDerivative) - Method in interface org.hipparchus.ode.sampling.ODEStepHandler
-
Finalize integration.
- finish(ODEStateAndDerivative) - Method in class org.hipparchus.ode.sampling.StepNormalizer
-
Finalize integration.
- FINITE - Static variable in class org.hipparchus.dfp.Dfp
-
Indicator value for normal finite numbers.
- FiniteDifferencesDifferentiator - Class in org.hipparchus.analysis.differentiation
-
Univariate functions differentiator using finite differences.
- FiniteDifferencesDifferentiator(int, double) - Constructor for class org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
Build a differentiator with number of points and step size when independent variable is unbounded.
- FiniteDifferencesDifferentiator(int, double, double, double) - Constructor for class org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
Build a differentiator with number of points and step size when independent variable is bounded.
- fireInitializationEvent(IterationEvent) - Method in class org.hipparchus.util.IterationManager
-
Informs all registered listeners that the initial phase (prior to the main iteration loop) has been completed.
- fireIterationPerformedEvent(IterationEvent) - Method in class org.hipparchus.util.IterationManager
-
Informs all registered listeners that a new iteration (in the main iteration loop) has been performed.
- fireIterationStartedEvent(IterationEvent) - Method in class org.hipparchus.util.IterationManager
-
Informs all registered listeners that a new iteration (in the main iteration loop) has been started.
- fireTerminationEvent(IterationEvent) - Method in class org.hipparchus.util.IterationManager
-
Informs all registered listeners that the final phase (post-iterations) has been completed.
- FIRST - Enum constant in enum org.hipparchus.ode.sampling.StepNormalizerBounds
-
Include the first point, but not the last point.
- FIRST_COLUMNS_NOT_INITIALIZED_YET - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
FIRST_COLUMNS_NOT_INITIALIZED_YET.
- FIRST_COLUMNS_NOT_INITIALIZED_YET - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.FIRST_COLUMNS_NOT_INITIALIZED_YET.
- FIRST_ELEMENT_NOT_ZERO - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.FIRST_ELEMENT_NOT_ZERO.
- FIRST_ELEMENT_NOT_ZERO - Enum constant in enum org.hipparchus.transform.LocalizedFFTFormats
-
FIRST_ELEMENT_NOT_ZERO.
- FIRST_ROWS_NOT_INITIALIZED_YET - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
FIRST_ROWS_NOT_INITIALIZED_YET.
- FIRST_ROWS_NOT_INITIALIZED_YET - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.FIRST_ROWS_NOT_INITIALIZED_YET.
- firstIncluded() - Method in enum org.hipparchus.ode.sampling.StepNormalizerBounds
-
Returns a value indicating whether the first point should be passed to the underlying fixed step size step handler.
- firstIntersection(Vector3D, Line) - Method in class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Get the first sub-hyperplane crossed by a semi-infinite line.
- FirstOrderConverter - Class in org.hipparchus.ode
-
This class converts second order differential equations to first order ones.
- FirstOrderConverter(SecondOrderODE) - Constructor for class org.hipparchus.ode.FirstOrderConverter
-
Simple constructor.
- FirstOrderDifferentialEquations - Interface in org.hipparchus.migration.ode
-
Deprecated.as of 1.0, replaced with
OrdinaryDifferentialEquation
- fit(double[][]) - Method in class org.hipparchus.stat.projection.PCA
-
Fit our model to the data, ready for subsequence transforms.
- fit(Collection<WeightedObservedPoint>) - Method in class org.hipparchus.fitting.AbstractCurveFitter
-
Fits a curve.
- fit(MixtureMultivariateNormalDistribution) - Method in class org.hipparchus.stat.fitting.MultivariateNormalMixtureExpectationMaximization
-
Fit a mixture model to the data supplied to the constructor.
- fit(MixtureMultivariateNormalDistribution, int, double) - Method in class org.hipparchus.stat.fitting.MultivariateNormalMixtureExpectationMaximization
-
Fit a mixture model to the data supplied to the constructor.
- fitAndTransform(double[][]) - Method in class org.hipparchus.stat.projection.PCA
-
Fit our model to the data and then transform it to the reduced dimensions.
- fix1stArgument(BivariateFunction, double) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Creates a unary function by fixing the first argument of a binary function.
- fix2ndArgument(BivariateFunction, double) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Creates a unary function by fixing the second argument of a binary function.
- FIXED - Enum constant in enum org.hipparchus.stat.ranking.NaNStrategy
-
NaNs are left in place
- FixedStepHandler - Interface in org.hipparchus.migration.ode.sampling
-
Deprecated.as of 1.0, replaced with
ODEFixedStepHandler
- fixNode(BSPTree<S>) - Method in interface org.hipparchus.geometry.partitioning.BSPTree.VanishingCutHandler
-
Fix a node with both vanished cut and children.
- FLAG_DIV_ZERO - Static variable in class org.hipparchus.dfp.DfpField
-
IEEE 854-1987 flag for division by zero.
- FLAG_INEXACT - Static variable in class org.hipparchus.dfp.DfpField
-
IEEE 854-1987 flag for inexact result.
- FLAG_INVALID - Static variable in class org.hipparchus.dfp.DfpField
-
IEEE 854-1987 flag for invalid operation.
- FLAG_OVERFLOW - Static variable in class org.hipparchus.dfp.DfpField
-
IEEE 854-1987 flag for overflow.
- FLAG_UNDERFLOW - Static variable in class org.hipparchus.dfp.DfpField
-
IEEE 854-1987 flag for underflow.
- FLETCHER_REEVES - Enum constant in enum org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.Formula
-
Fletcher-Reeves formula.
- floatValue() - Method in class org.hipparchus.fraction.BigFraction
-
Gets the fraction as a
float
. - floatValue() - Method in class org.hipparchus.fraction.Fraction
-
Gets the fraction as a
float
. - floatValue() - Method in class org.hipparchus.util.Binary64
-
The current implementation performs casting to a
float
. - floor() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Get the largest whole number smaller than instance.
- floor() - Method in interface org.hipparchus.CalculusFieldElement
-
Get the largest whole number smaller than instance.
- floor() - Method in class org.hipparchus.complex.Complex
-
Get the largest whole number smaller than instance.
- floor() - Method in class org.hipparchus.complex.FieldComplex
-
Get the largest whole number smaller than instance.
- floor() - Method in class org.hipparchus.dfp.Dfp
-
Round to an integer using the round floor mode.
- floor() - Method in class org.hipparchus.util.Binary64
-
Get the largest whole number smaller than instance.
- floor() - Method in class org.hipparchus.util.FieldTuple
-
Get the largest whole number smaller than instance.
- floor() - Method in class org.hipparchus.util.Tuple
-
Get the largest whole number smaller than instance.
- floor(double) - Static method in class org.hipparchus.util.FastMath
-
Get the largest whole number smaller than x.
- floor(T) - Static method in class org.hipparchus.util.FastMath
-
Get the largest whole number smaller than x.
- Floor - Class in org.hipparchus.analysis.function
-
floor
function. - Floor() - Constructor for class org.hipparchus.analysis.function.Floor
-
Empty constructor.
- floorDiv(int, int) - Static method in class org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorDiv(long, int) - Static method in class org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorDiv(long, long) - Static method in class org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorDivExact(int, int) - Static method in class org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorDivExact(long, long) - Static method in class org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorMod(int, int) - Static method in class org.hipparchus.util.FastMath
-
Finds r such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorMod(long, int) - Static method in class org.hipparchus.util.FastMath
-
Finds r such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorMod(long, long) - Static method in class org.hipparchus.util.FastMath
-
Finds r such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - fma(double, double, double) - Static method in class org.hipparchus.util.FastMath
-
Compute Fused-multiply-add operation a * b + c.
- fma(float, float, float) - Static method in class org.hipparchus.util.FastMath
-
Compute Fused-multiply-add operation a * b + c.
- forceSide(int, UnivariateFunction, BracketedUnivariateSolver<UnivariateFunction>, double, double, double, AllowedSolution) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
Force a root found by a non-bracketing solver to lie on a specified side, as if the solver were a bracketing one.
- format(double, StringBuffer, FieldPosition) - Method in class org.hipparchus.fraction.ProperBigFractionFormat
-
Formats a double value as a fraction and appends the result to a StringBuffer.
- format(long, StringBuffer, FieldPosition) - Method in class org.hipparchus.fraction.ProperBigFractionFormat
-
Formats a long value as a fraction and appends the result to a StringBuffer.
- format(Double) - Method in class org.hipparchus.complex.ComplexFormat
-
This method calls
ComplexFormat.format(Object,StringBuffer,FieldPosition)
. - format(Object, StringBuffer, FieldPosition) - Method in class org.hipparchus.complex.ComplexFormat
-
Formats a object to produce a string.
- format(Object, StringBuffer, FieldPosition) - Method in class org.hipparchus.fraction.BigFractionFormat
-
Formats an object and appends the result to a StringBuffer.
- format(Object, StringBuffer, FieldPosition) - Method in class org.hipparchus.fraction.FractionFormat
-
Formats an object and appends the result to a StringBuffer.
- format(StringBuffer, FieldPosition, double...) - Method in class org.hipparchus.geometry.VectorFormat
-
Formats the coordinates of a
Vector
to produce a string. - format(Complex) - Method in class org.hipparchus.complex.ComplexFormat
-
This method calls
ComplexFormat.format(Object,StringBuffer,FieldPosition)
. - format(Complex, StringBuffer, FieldPosition) - Method in class org.hipparchus.complex.ComplexFormat
-
Formats a
Complex
object to produce a string. - format(BigFraction, StringBuffer, FieldPosition) - Method in class org.hipparchus.fraction.BigFractionFormat
-
Formats a
BigFraction
object to produce a string. - format(BigFraction, StringBuffer, FieldPosition) - Method in class org.hipparchus.fraction.ProperBigFractionFormat
-
Formats a
BigFraction
object to produce a string. - format(Fraction, StringBuffer, FieldPosition) - Method in class org.hipparchus.fraction.FractionFormat
-
Formats a
Fraction
object to produce a string. - format(Fraction, StringBuffer, FieldPosition) - Method in class org.hipparchus.fraction.ProperFractionFormat
-
Formats a
Fraction
object to produce a string. - format(Vector<Euclidean1D, Vector1D>, StringBuffer, FieldPosition) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1DFormat
-
Formats a
Vector
object to produce a string. - format(Vector<Euclidean3D, Vector3D>, StringBuffer, FieldPosition) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3DFormat
-
Formats a
Vector3D
object to produce a string. - format(Vector<Euclidean2D, Vector2D>, StringBuffer, FieldPosition) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2DFormat
-
Formats a
Vector
object to produce a string. - format(Vector<S, V>) - Method in class org.hipparchus.geometry.VectorFormat
-
Formats a
Vector
object to produce a string. - format(Vector<S, V>, StringBuffer, FieldPosition) - Method in class org.hipparchus.geometry.VectorFormat
-
Formats a
Vector
object to produce a string. - format(RealMatrix) - Method in class org.hipparchus.linear.RealMatrixFormat
-
This method calls
RealMatrixFormat.format(RealMatrix,StringBuffer,FieldPosition)
. - format(RealMatrix, StringBuffer, FieldPosition) - Method in class org.hipparchus.linear.RealMatrixFormat
-
Formats a
RealMatrix
object to produce a string. - format(RealVector) - Method in class org.hipparchus.linear.RealVectorFormat
-
This method calls
RealVectorFormat.format(RealVector,StringBuffer,FieldPosition)
. - format(RealVector, StringBuffer, FieldPosition) - Method in class org.hipparchus.linear.RealVectorFormat
-
Formats a
RealVector
object to produce a string. - formatBigFraction(BigFraction) - Static method in class org.hipparchus.fraction.BigFractionFormat
-
This static method calls formatBigFraction() on a default instance of BigFractionFormat.
- formatDouble(double, NumberFormat, StringBuffer, FieldPosition) - Static method in class org.hipparchus.util.CompositeFormat
-
Formats a double value to produce a string.
- formatFraction(Fraction) - Static method in class org.hipparchus.fraction.FractionFormat
-
This static method calls formatFraction() on a default instance of FractionFormat.
- FORWARD - Enum constant in enum org.hipparchus.transform.TransformType
-
The type to be specified for forward transforms.
- FOUR_FIFTHS - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "4/5".
- FOUR_FIFTHS - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "4/5".
- fraction(Field<T>, double, double) - Static method in interface org.hipparchus.ode.nonstiff.FieldExplicitRungeKuttaIntegrator
-
Create a fraction from doubles.
- fraction(Field<T>, int, int) - Static method in interface org.hipparchus.ode.nonstiff.FieldExplicitRungeKuttaIntegrator
-
Create a fraction from integers.
- Fraction - Class in org.hipparchus.fraction
-
Representation of a rational number.
- Fraction(double) - Constructor for class org.hipparchus.fraction.Fraction
-
Create a fraction given the double value.
- Fraction(double, double, int) - Constructor for class org.hipparchus.fraction.Fraction
-
Create a fraction given the double value and maximum error allowed.
- Fraction(double, int) - Constructor for class org.hipparchus.fraction.Fraction
-
Create a fraction given the double value and maximum denominator.
- Fraction(int) - Constructor for class org.hipparchus.fraction.Fraction
-
Create a fraction from an int.
- Fraction(int, int) - Constructor for class org.hipparchus.fraction.Fraction
-
Create a fraction given the numerator and denominator.
- FRACTION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
FRACTION.
- FRACTION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.FRACTION.
- FRACTION_CONVERSION_OVERFLOW - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
FRACTION_CONVERSION_OVERFLOW.
- FRACTION_CONVERSION_OVERFLOW - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.FRACTION_CONVERSION_OVERFLOW.
- Fraction.ConvergenceTest - Interface in org.hipparchus.fraction
-
A test to determine if a series of fractions has converged.
- FractionField - Class in org.hipparchus.fraction
-
Representation of the fractional numbers field.
- FractionFormat - Class in org.hipparchus.fraction
-
Formats a Fraction number in proper format or improper format.
- FractionFormat() - Constructor for class org.hipparchus.fraction.FractionFormat
-
Create an improper formatting instance with the default number format for the numerator and denominator.
- FractionFormat(NumberFormat) - Constructor for class org.hipparchus.fraction.FractionFormat
-
Create an improper formatting instance with a custom number format for both the numerator and denominator.
- FractionFormat(NumberFormat, NumberFormat) - Constructor for class org.hipparchus.fraction.FractionFormat
-
Create an improper formatting instance with a custom number format for the numerator and a custom number format for the denominator.
- fractionMatrixToRealMatrix(FieldMatrix<Fraction>) - Static method in class org.hipparchus.linear.MatrixUtils
- FRAME_TRANSFORM - Enum constant in enum org.hipparchus.geometry.euclidean.threed.RotationConvention
-
Constant for rotation that have the semantics of a frame conversion.
- Frequency<T extends Comparable<T>> - Class in org.hipparchus.stat
-
Maintains a frequency distribution of Comparable values.
- Frequency() - Constructor for class org.hipparchus.stat.Frequency
-
Default constructor.
- Frequency(Comparator<? super T>) - Constructor for class org.hipparchus.stat.Frequency
-
Constructor allowing values Comparator to be specified.
- fromDirection(Vector3D, Vector3D, double) - Static method in class org.hipparchus.geometry.euclidean.threed.Line
-
Create a line from a point and a direction.
- fst(double[]) - Method in class org.hipparchus.transform.FastSineTransformer
-
Perform the FST algorithm (including inverse).
- FUNCTION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
FUNCTION.
- FUNCTION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.FUNCTION.
- FUNCTION_NOT_DIFFERENTIABLE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.FUNCTION_NOT_DIFFERENTIABLE.
- FUNCTION_NOT_DIFFERENTIABLE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.FUNCTION_NOT_DIFFERENTIABLE.
- FUNCTION_NOT_POLYNOMIAL - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.FUNCTION_NOT_POLYNOMIAL.
- FUNCTION_NOT_POLYNOMIAL - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.FUNCTION_NOT_POLYNOMIAL.
- FunctionUtils - Class in org.hipparchus.analysis
-
Utilities for manipulating function objects.
- FuzzyKMeansClusterer<T extends Clusterable> - Class in org.hipparchus.clustering
-
Fuzzy K-Means clustering algorithm.
- FuzzyKMeansClusterer(int, double) - Constructor for class org.hipparchus.clustering.FuzzyKMeansClusterer
-
Creates a new instance of a FuzzyKMeansClusterer.
- FuzzyKMeansClusterer(int, double, int, DistanceMeasure) - Constructor for class org.hipparchus.clustering.FuzzyKMeansClusterer
-
Creates a new instance of a FuzzyKMeansClusterer.
- FuzzyKMeansClusterer(int, double, int, DistanceMeasure, double, RandomGenerator) - Constructor for class org.hipparchus.clustering.FuzzyKMeansClusterer
-
Creates a new instance of a FuzzyKMeansClusterer.
G
- 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<E>) - Method in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Compute the value of the switching function.
- g(FieldODEStateAndDerivative<E>) - Method in class org.hipparchus.ode.events.FieldEventSlopeFilter
-
Compute the value of the switching function.
- g(FieldODEStateAndDerivative<T>) - Method in interface org.hipparchus.ode.events.FieldODEEventDetector
-
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.AbstractODEDetector
-
Compute the value of the switching function.
- g(ODEStateAndDerivative) - Method in class org.hipparchus.ode.events.EventSlopeFilter
-
Compute the value of the switching function.
- g(ODEStateAndDerivative) - Method in interface org.hipparchus.ode.events.ODEEventDetector
-
Compute the value of the switching function.
- gamma(double) - Static method in class org.hipparchus.special.Gamma
-
Returns the value of Γ(x).
- gamma(T) - 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 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
-
Fits points to a
Gaussian
function. - GaussianCurveFitter.ParameterGuesser - Class in org.hipparchus.fitting
-
Guesses the parameters
norm
,mean
, andsigma
of aGaussian.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
andweights
. - 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
-
Class that provides different ways to compute the nodes and weights to be used by the
Gaussian integration rule
. - GaussIntegratorFactory() - Constructor for class org.hipparchus.analysis.integration.gauss.GaussIntegratorFactory
-
Simple constructor.
- GaussIntegratorFactory(int) - Constructor for class org.hipparchus.analysis.integration.gauss.GaussIntegratorFactory
-
Simple constructor.
- GaussMarkovGenerator - Class in org.hipparchus.random
-
This class is a Gauss-Markov order 1 autoregressive process generator for scalars.
- GaussMarkovGenerator(double, double, RandomGenerator) - Constructor for class org.hipparchus.random.GaussMarkovGenerator
-
Create a new generator.
- 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.
- 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(BigFraction) - Method in class org.hipparchus.fraction.BigFraction
-
Rational number greatest common divisor.
- gcd(Fraction) - Method in class org.hipparchus.fraction.Fraction
-
Rational number greatest common divisor.
- GCD_OVERFLOW_32_BITS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
GCD_OVERFLOW_32_BITS.
- GCD_OVERFLOW_32_BITS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.GCD_OVERFLOW_32_BITS.
- GCD_OVERFLOW_64_BITS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
GCD_OVERFLOW_64_BITS.
- GCD_OVERFLOW_64_BITS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.GCD_OVERFLOW_64_BITS.
- 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
andobserved2
. - gDataSetsComparison(long[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes a G (Log-Likelihood Ratio) two sample test statistic for independence comparing frequency counts in
observed1
andobserved2
. - generate(Collection<Vector2D>) - Method in class org.hipparchus.geometry.euclidean.twod.hull.MonotoneChain
-
Builds the convex hull from the set of input points.
- 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.
- GENERATE_EXCEPTION - Enum constant in enum org.hipparchus.linear.DependentVectorsHandler
-
Generate a
MathIllegalArgumentException
if dependent vectors are found. - generateNoiseVector(RandomGenerator, double) - Static method in class org.hipparchus.samples.ClusterAlgorithmComparison
-
Generate a random vector.
- 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
-
Returns the geometric mean of the available values.
- 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 theoriginal
. - 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
-
Empty constructor.
- GeometryExample.Display - Class in org.hipparchus.samples.geometry
-
Main frame for geometry examples.
- GEQ - Enum constant in enum 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() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.LinearEqualityConstraint
-
Get the matrix of linear weights.
- getA(int, double) - Method in class org.hipparchus.util.ContinuedFraction
-
Access the n-th a coefficient of the continued fraction.
- getA(int, T) - Method in class org.hipparchus.util.FieldContinuedFraction
-
Access the n-th a coefficient of the continued fraction.
- getA1() - Method in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Get the axis of the first rotation.
- getA2() - Method in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Get the axis of the second rotation.
- getA3() - Method in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Get the axis of the third 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.BaseAbstractFieldUnivariateIntegrator
-
Get the absolute accuracy.
- getAbsoluteAccuracy() - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the absolute accuracy.
- getAbsoluteAccuracy() - Method in interface org.hipparchus.analysis.integration.FieldUnivariateIntegrator
-
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
-
Get absolute threshold.
- getAction() - Method in class org.hipparchus.ode.events.EventOccurrence
-
Get the user requested action.
- getAction() - Method in class org.hipparchus.ode.events.FieldEventOccurrence
-
Get the user requested action.
- getAdjustedRSquared() - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns the adjusted R-squared statistic, defined by the formula \( R_\mathrm{adj}^2 = 1 - \frac{\mathrm{SSR} (n - 1)}{\mathrm{SSTO} (n - p)} \) where SSR is the sum of squared residuals}, SSTO is the total sum of squares}, n is the number of observations and p is the number of parameters estimated (including the intercept).
- 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 \).
- getAlpha() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Get value of alpha filter for ADMM iteration.
- 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(FieldRotation<T>, RotationConvention) - Method in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Get the Cardan or Euler angles corresponding to the instance.
- 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.
- getAngles(Rotation, RotationConvention) - Method in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Get the Cardan or Euler angles corresponding to the instance.
- getArc(S2Point, S2Point) - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Get the arc on this circle between two defining points.
- getArgument() - Method in class org.hipparchus.complex.Complex
-
Compute the argument of this complex number.
- getArgument() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the argument of this complex number.
- getArgument() - Method in exception org.hipparchus.migration.exception.MathIllegalNumberException
-
Deprecated.Get argument.
- 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(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() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Get parameter for quadratic line search.
- getB(int, double) - Method in class org.hipparchus.util.ContinuedFraction
-
Access the n-th b coefficient of the continued fraction.
- getB(int, T) - Method in class org.hipparchus.util.FieldContinuedFraction
-
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.Check if the maximum is included in the allowed range.
- getBoundIsAllowed() - Method in exception org.hipparchus.migration.exception.NumberIsTooSmallException
-
Deprecated.Check if the minimum is included in the allowed range.
- 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.AbstractOpenIntHashMap
-
Get capacity.
- 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.
- getCenter() - Method in class org.hipparchus.stat.projection.PCA
-
Get by column center (or mean) of the fitted data.
- getCenters() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Returns a copy of the centers array.
- 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.
- getClamp() - Static method in class org.hipparchus.analysis.polynomials.SmoothStepFactory
-
Get the
clamping smoothstep function
. - getClamp(Field<T>) - Static method in class org.hipparchus.analysis.polynomials.SmoothStepFactory
-
Get the
clamping smoothstep function
. - 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
-
Returns the
ClusterEvaluator
used to determine the "best" clustering. - getClusters() - Method in class org.hipparchus.clustering.FuzzyKMeansClusterer
-
Returns the list of clusters resulting from the last call to
FuzzyKMeansClusterer.cluster(Collection)
. - getCoefficients() - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Returns a copy of the coefficients array.
- 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
-
Get the coefficients of the polynomial function.
- 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.Get column index.
- getColumn() - Method in exception org.hipparchus.migration.linear.NonSymmetricMatrixException
-
Deprecated.Get column index of the entry.
- 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 interface org.hipparchus.linear.DecompositionSolver
-
Returns the number of columns in the matrix.
- getColumnDimension() - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns the number of columns of this matrix.
- getColumnDimension() - Method in interface org.hipparchus.linear.FieldDecompositionSolver
-
Returns the number of columns in the 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.ComplexODEStateAndDerivative
-
Get complete derivative at time.
- 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.ComplexODEState
-
Get complete state 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.ComplexODEState
-
Return the dimension of the complete set of equations.
- 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.
- getComplexFormat() - Static method in class org.hipparchus.complex.ComplexFormat
-
Returns the default complex format for the current locale.
- getComplexFormat(String, Locale) - Static method in class org.hipparchus.complex.ComplexFormat
-
Returns the default complex format for the given locale.
- getComplexFormat(Locale) - Static method in class org.hipparchus.complex.ComplexFormat
-
Returns the default complex format for the given locale.
- 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.stat.projection.PCA
-
Returns the principal components of our projection 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
-
Get asserted probability that the interval contains the population parameter.
- 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
-
Get constraints.
- 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.
- getConvCriteria() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Get convergence criteria.
- 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.constrained.ADMMQPOptimizer
-
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.
- getCorrected() - Method in class org.hipparchus.filtering.kalman.unscented.UnscentedKalmanFilter
-
Get the 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 withgetCorrelationMatrix.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.
- getCubic() - Static method in class org.hipparchus.analysis.polynomials.SmoothStepFactory
-
Get the
cubic smoothstep function
. - getCubic(Field<T>) - Static method in class org.hipparchus.analysis.polynomials.SmoothStepFactory
-
Get the
cubic smoothstep function
. - 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).
- getCurrent() - Method in class org.hipparchus.util.AbstractOpenIntHashMap.BaseIterator
-
Get index of current entry.
- 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.
- getCurrentStates() - Method in class org.hipparchus.filtering.kalman.unscented.UnscentedEvolution
-
Get current states.
- getCurrentTime() - Method in class org.hipparchus.filtering.kalman.extended.NonLinearEvolution
-
Get current time.
- getCurrentTime() - Method in class org.hipparchus.filtering.kalman.unscented.UnscentedEvolution
-
Get current time.
- getCurrentTime() - Method in interface org.hipparchus.migration.ode.sampling.StepInterpolator
-
Deprecated.as of 1.0, replaced with
ODEStateInterpolator.getCurrentState()
/ODEState.getTime()
- 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.EigenDecompositionNonSymmetric
-
Gets the block diagonal matrix D of the decomposition.
- getD() - Method in class org.hipparchus.linear.EigenDecompositionSymmetric
-
Gets the diagonal matrix D of the decomposition.
- getD() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.QuadraticFunction
-
Get constant term.
- 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
-
Returns an unmodifiable list of the data points used in the last call to
FuzzyKMeansClusterer.cluster(Collection)
. - 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 class org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
-
Get the matrix decomposition algorithm.
- getDecomposer() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
-
Get the matrix decomposition algorithm.
- getDefaultNumberFormat() - Static method in class org.hipparchus.fraction.ProperBigFractionFormat
-
Create a default number format.
- 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.fraction.ProperBigFractionFormat
-
Create a default number format.
- getDefaultNumberFormat(Locale) - Static method in class org.hipparchus.util.CompositeFormat
-
Create a default number format.
- getDefaultStep() - Method in class org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegrator
-
Getter for the default, positive step-size assigned at constructor level.
- getDefaultStep() - Method in class org.hipparchus.ode.nonstiff.RungeKuttaIntegrator
-
Getter for the default, positive step-size assigned at constructor level.
- 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.
- getDegToRad() - Method in class org.hipparchus.dfp.DfpField
-
Get the degrees to radians conversion factor.
- 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.
- getDenominatorFormat() - Method in class org.hipparchus.fraction.ProperBigFractionFormat
-
Access the denominator format.
- getDerivative(int) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative
-
Get a derivative from the univariate derivative.
- getDerivative(int) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Get a derivative from the univariate derivative.
- getDerivative(int) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Get a derivative from the univariate derivative.
- getDerivative(int) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Get the derivative with respect to a particular index variable.
- getDerivative(int) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative
-
Get a derivative from the univariate derivative.
- getDerivative(int) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Get a derivative from the univariate derivative.
- getDerivative(int) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Get a derivative from the univariate derivative.
- getDerivativeField() - Method in class org.hipparchus.analysis.differentiation.DSFactory
-
Get the
Field
theDerivativeStructure
instances belong to. - getDerivativeField() - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
Get the
Field
theFieldDerivativeStructure
instances belong to. - getDetector() - Method in class org.hipparchus.ode.events.EventSlopeFilter
-
Get the wrapped raw detector.
- getDetector() - Method in class org.hipparchus.ode.events.FieldEventSlopeFilter
-
Get the wrapped raw detector.
- 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.EigenDecompositionNonSymmetric
-
Computes the determinant of the matrix.
- getDeterminant() - Method in class org.hipparchus.linear.EigenDecompositionSymmetric
-
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.Get expected dimension.
- getDimension() - Method in interface org.hipparchus.ode.ComplexOrdinaryDifferentialEquation
-
Get the dimension of the problem.
- getDimension() - Method in interface org.hipparchus.ode.ComplexSecondaryODE
-
Get the dimension of the secondary state parameters.
- 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.Get order direction.
- 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
-
Returns the
DistanceMeasure
instance used by this clusterer. - getDummyStepsize() - Method in class org.hipparchus.ode.nonstiff.StepsizeHelper
-
Get a dummy step size.
- getE() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant e.
- getEigenvalue(int) - Method in class org.hipparchus.linear.EigenDecompositionNonSymmetric
-
Returns the ith eigenvalue of the original matrix.
- getEigenvalue(int) - Method in class org.hipparchus.linear.EigenDecompositionSymmetric
-
Returns the ith eigenvalue of the original matrix.
- getEigenvalues() - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Getter of the eigen values.
- getEigenvalues() - Method in class org.hipparchus.linear.EigenDecompositionNonSymmetric
-
Gets a copy of the eigenvalues of the original matrix.
- getEigenvalues() - Method in class org.hipparchus.linear.EigenDecompositionSymmetric
-
Gets a copy of the eigenvalues of the original matrix.
- getEigenvector(int) - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Getter of the eigen vectors.
- getEigenvector(int) - Method in class org.hipparchus.linear.EigenDecompositionNonSymmetric
-
Gets a copy of the ith eigenvector of the original matrix.
- getEigenvector(int) - Method in class org.hipparchus.linear.EigenDecompositionSymmetric
-
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
-
Returns the
KMeansPlusPlusClusterer.EmptyClusterStrategy
used by this instance. - 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.
- getEps() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Get absolute and Relative Tolerance for convergence.
- getEps() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Get tolerance for convergence and active constraint evaluation.
- getEpsilon() - Method in class org.hipparchus.clustering.FuzzyKMeansClusterer
-
Returns the convergence criteria used by this instance.
- getEpsilon() - Method in class org.hipparchus.linear.EigenDecompositionNonSymmetric
-
Get's the value for epsilon which is used for internal tests (e.g.
- getEpsilon() - Method in class org.hipparchus.linear.EigenDecompositionSymmetric
-
Get's the value for epsilon which is used for internal tests (e.g.
- getEpsInfeasible() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Get absolute and Relative Tolerance for infeasible criteria.
- getEqConstraint() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.AbstractSQPOptimizer
-
Getter for equality constraint.
- 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
-
Returns the sum of squared errors (SSE) associated with the regression model.
- 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.BaseAbstractFieldUnivariateIntegrator
-
Get the number of function evaluations of the last run of the integrator.
- 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.FieldUnivariateIntegrator
-
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
-
Get number of evaluations.
- 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.
- getEventDetector() - Method in class org.hipparchus.ode.events.DetectorBasedEventState
-
Get the underlying event detector.
- getEventDetector() - Method in class org.hipparchus.ode.events.FieldDetectorBasedEventState
-
Get the underlying event detector.
- getEventDetectors() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Get all the event detectors that have been added to the integrator.
- getEventDetectors() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Get all the event detectors that have been added to the integrator.
- getEventDetectors() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Get all the event detectors that have been added to the integrator.
- getEventDetectors() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Get all the event detectors that have been added to the integrator.
- getEventTime() - Method in class org.hipparchus.ode.events.DetectorBasedEventState
-
Get the occurrence time of the event triggered in the current step.
- getEventTime() - Method in interface 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.FieldDetectorBasedEventState
-
Get the occurrence time of the event triggered in the current step.
- getEventTime() - Method in interface org.hipparchus.ode.events.FieldEventState
-
Get the occurrence time of the event triggered in the current step.
- getEventTime() - Method in class org.hipparchus.ode.events.FieldStepEndEventState
-
Get the occurrence time of the event triggered in the current step.
- getEventTime() - Method in class org.hipparchus.ode.events.StepEndEventState
-
Get the occurrence time of the event triggered in the current step.
- getEvolution(double, RealVector[], T) - Method in interface org.hipparchus.filtering.kalman.unscented.UnscentedProcess
-
Get the state evolution between two times.
- 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.Get expected column dimension.
- getExpectedDimension(int) - Method in exception org.hipparchus.migration.exception.MultiDimensionMismatchException
-
Deprecated.Get expected dimension at index.
- getExpectedDimensions() - Method in exception org.hipparchus.migration.exception.MultiDimensionMismatchException
-
Deprecated.Get array containing the expected dimensions.
- getExpectedRowDimension() - Method in exception org.hipparchus.migration.linear.MatrixDimensionMismatchException
-
Deprecated.Get expected row dimension.
- getExponent() - Method in interface org.hipparchus.analysis.differentiation.Derivative
-
Return the exponent of the instance, removing the bias.
- getExponent() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Return the exponent of the instance, removing the bias.
- getExponent() - Method in interface org.hipparchus.CalculusFieldElement
-
Return the exponent of the instance, removing the bias.
- getExponent() - Method in class org.hipparchus.dfp.Dfp
-
Return the exponent of the instance, 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.
- getExtendedField(int, boolean) - Method in class org.hipparchus.dfp.DfpField
-
Get extended field for accuracy conversion.
- 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
-
Get function value at
BracketFinder.getHi()
. - 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.FieldGradient
-
Get the
Field
to which the instance belongs. - getField() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Get the
Field
to which the instance belongs. - getField() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Get the
Field
to which the instance belongs. - getField() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
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.analysis.differentiation.UnivariateDerivative1
-
Get the
Field
to which the instance belongs. - getField() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Get the
Field
to which the instance belongs. - getField() - Method in class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Get the field to which function argument and value belong.
- getField() - Method in class org.hipparchus.analysis.integration.gauss.FieldAbstractRuleFactory
-
Get the field to which rule coefficients belong.
- getField() - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Get the
Field
to which the instance belongs. - getField() - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
-
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.complex.FieldComplex
-
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.Binary64
-
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. - getField(int) - Static method in class org.hipparchus.analysis.differentiation.GradientField
-
Get the field for number of free parameters.
- getField(Field<T>) - Static method in class org.hipparchus.complex.FieldComplexField
-
Get the field for complex numbers.
- getField(Field<T>, int) - Static method in class org.hipparchus.analysis.differentiation.FieldGradientField
-
Get the field for number of free parameters.
- getFieldGeneralOrder(Field<T>, int) - Static method in class org.hipparchus.analysis.polynomials.SmoothStepFactory
-
Create a
smoothstep function
of order 2N + 1. - 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.
- getFirstDerivative() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Get the first derivative.
- getFirstDerivative() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Get the first derivative.
- getFirstDerivative() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Get the first derivative.
- getFirstDerivative() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Get the first derivative.
- 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
-
Get function value at
BracketFinder.getLo()
. - getFMid() - Method in class org.hipparchus.optim.univariate.BracketFinder
-
Get function value at
BracketFinder.getMid()
. - 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 interface org.hipparchus.analysis.differentiation.DifferentialAlgebra
-
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
- getFreeParameters() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Get the number of free parameters.
- getFreeParameters() - Method in class org.hipparchus.analysis.differentiation.FieldTaylorMap
-
Get the number of free parameters.
- getFreeParameters() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative
-
Get the number of free parameters.
- getFreeParameters() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Get the number of free parameters.
- getFreeParameters() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Get the number of free parameters.
- getFreeParameters() - Method in class org.hipparchus.analysis.differentiation.TaylorMap
-
Get the number of free parameters.
- getFreeParameters() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative
-
Get the number of free parameters.
- getFrobeniusNorm() - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the Frobenius norm of the matrix.
- getFrobeniusNorm() - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the Frobenius norm of the matrix.
- getFrobeniusNorm() - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the Frobenius norm of the matrix.
- getFunction() - Method in class org.hipparchus.optim.linear.LinearOptimizer
-
Get optimization type.
- getFunction(int) - Method in class org.hipparchus.analysis.differentiation.FieldTaylorMap
-
Get a function from the map.
- getFunction(int) - Method in class org.hipparchus.analysis.differentiation.TaylorMap
-
Get a function from the map.
- 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.
- getGeneralOrder(int) - Static method in class org.hipparchus.analysis.polynomials.SmoothStepFactory
-
Create a
smoothstep function
of order 2N + 1. - 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
-
Get optimization type.
- getGoalType() - Method in class org.hipparchus.optim.univariate.UnivariateOptimizer
-
Get optimization type.
- getGradient() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Get the gradient part of the function.
- getGradient() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Get the gradient part of the function.
- getH() - Method in class org.hipparchus.linear.FieldQRDecomposition
-
Returns the Householder reflector vectors.
- getH() - Method in class org.hipparchus.linear.HessenbergTransformer
-
Returns the Hessenberg matrix H of the transform.
- getH() - Method in class org.hipparchus.linear.QRDecomposition
-
Returns the Householder reflector vectors.
- getHandler() - Method in interface org.hipparchus.migration.ode.events.EventHandler
-
Deprecated.Get the underlying event handler.
- getHandler() - Method in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Get the underlying event handler.
- getHandler() - Method in class org.hipparchus.ode.events.AbstractODEDetector
-
Get the underlying event handler.
- getHandler() - Method in interface org.hipparchus.ode.events.FieldODEEventDetector
-
Get the underlying event handler.
- getHandler() - Method in class org.hipparchus.ode.events.FieldStepEndEventState
-
Get the underlying step end handler.
- getHandler() - Method in interface org.hipparchus.ode.events.ODEEventDetector
-
Get the underlying event handler.
- getHandler() - Method in class org.hipparchus.ode.events.StepEndEventState
-
Get the underlying step end handler.
- 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.Get higher bound.
- getHi() - Method in class org.hipparchus.optim.univariate.BracketFinder
-
Get higher bound of the bracket.
- 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.
- getI(Field<T>) - Static method in class org.hipparchus.complex.FieldComplex
-
Get the square root of -1.
- 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.
- getImaginary() - Method in class org.hipparchus.complex.Complex
-
Access the imaginary part.
- getImaginary() - Method in class org.hipparchus.complex.FieldComplex
-
Access the imaginary part.
- getImaginary(int) - Method in class org.hipparchus.complex.RootsOfUnity
-
Get the imaginary part of the
k
-thn
-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.
- getImaginaryPart() - Method in class org.hipparchus.complex.Complex
-
Access the imaginary part.
- getImaginaryPart() - Method in class org.hipparchus.complex.FieldComplex
-
Access the imaginary part.
- 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.
- getIndex() - Method in class org.hipparchus.util.AbstractOpenIntHashMap.InsertionHolder
-
Get index at which new value should be put.
- 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.
- getInf(Field<T>) - Static method in class org.hipparchus.complex.FieldComplex
-
Get a complex number representing "+INF + INFi".
- getInitialGuess() - Method in class org.hipparchus.optim.InitialGuess
-
Gets the initial guess.
- getInitialStep() - Method in class org.hipparchus.ode.nonstiff.StepsizeHelper
-
Get the initial step.
- 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.
- getInnovation(T, RealVector, RealVector, RealMatrix) - Method in interface org.hipparchus.filtering.kalman.unscented.UnscentedProcess
-
Get the innovation brought by a measurement.
- getInnovationCovariance() - Method in class org.hipparchus.filtering.kalman.ProcessEstimate
-
Get the innovation covariance matrix.
- 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.analysis.differentiation.UnivariateDerivative1Field
-
Get the unique instance.
- getInstance() - Static method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2Field
-
Get the unique instance.
- getInstance() - Static method in class org.hipparchus.complex.ComplexField
-
Get the unique instance.
- 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.threed.Euclidean3D
-
Get the unique instance.
- getInstance() - Static method in class org.hipparchus.geometry.euclidean.twod.Euclidean2D
-
Get the unique instance.
- 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.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.Binary64Field
-
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(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
-
Returns the intercept of the estimated regression line, if
SimpleRegression.hasIntercept()
is true; otherwise 0. - getInterceptStdErr() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the standard error of the intercept estimate, usually denoted s(b0).
- 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
-
Deprecated.as of 1.0, replaced with
ODEStateInterpolator.getInterpolatedState(double)
.ODEStateAndDerivative.getPrimaryDerivative()
- 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
-
Deprecated.as of 1.0, replaced with
ODEStateInterpolator.getInterpolatedState(double)
.ODEStateAndDerivative.getSecondaryDerivative(int)
- 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
-
Deprecated.as of 1.0, replaced with
ODEStateInterpolator.getInterpolatedState(double)
.ODEState.getSecondaryState(int)
- 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
-
Deprecated.as of 1.0, replaced with
ODEStateInterpolator.getInterpolatedState(double)
.ODEState.getPrimaryState()
- 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
-
Deprecated.as of 1.0, replaced with
ODEStateInterpolator.getInterpolatedState(double)
/ODEState.getTime()
- 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
-
Get the pseudo-inverse of the decomposed matrix.
- 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.
- getIqConstraint() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.AbstractSQPOptimizer
-
Getter for inequality constraint.
- 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.BaseAbstractFieldUnivariateIntegrator
-
Get the number of iterations of the last run of the integrator.
- 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.FieldUnivariateIntegrator
-
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.
- getKalmanGain() - Method in class org.hipparchus.filtering.kalman.ProcessEstimate
-
Get the Kalman gain matrix.
- 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.FieldPolynomialSplineFunction
-
Get an array copy of the knot points.
- 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
-
Get the
kthSelector
used for computation. - getKthSelector() - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Get the
kthSelector
used for computation. - 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.
- getL() - Method in class org.hipparchus.linear.SemiDefinitePositiveCholeskyDecomposition
-
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.
- getLambda() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.LagrangeSolution
-
Returns Lambda Multiplier
- 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
-
Get the function value at
BracketedRealFieldUnivariateSolver.Interval.getLeftAbscissa()
. - getLeftValue() - Method in class org.hipparchus.analysis.solvers.BracketedUnivariateSolver.Interval
-
Get the function value at
BracketedUnivariateSolver.Interval.getLeftAbscissa()
. - getLength() - Method in class org.hipparchus.geometry.euclidean.twod.Segment
-
Get the length of the line segment.
- 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.Get lower bound.
- getLo() - Method in class org.hipparchus.optim.univariate.BracketFinder
-
Get lower bound of the bracket.
- 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.distribution.continuous.LogNormalDistribution
-
Returns the location parameter of this distribution.
- 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
-
Get lower bounds.
- getLowerBound() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.BoundedConstraint
-
Get Lower Bound for
value(x)
. - getLowerBound() - Method in interface org.hipparchus.optim.nonlinear.vector.constrained.Constraint
-
Get Lower Bound for
value(x)
. - getLowerBound() - Method in class org.hipparchus.stat.interval.ConfidenceInterval
-
Get lower endpoint of the interval.
- getLT() - Method in class org.hipparchus.linear.CholeskyDecomposition
-
Returns the transpose of the matrix L of the decomposition.
- getLT() - Method in class org.hipparchus.linear.SemiDefinitePositiveCholeskyDecomposition
-
Returns the transpose of the matrix L of the decomposition.
- getM() - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Get the parameter of the function.
- getM() - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Get the parameter of the function.
- 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
-
Returns the main panel which should be printed by the screenshot action.
- getMainPanel() - Method in class org.hipparchus.samples.IntegerDistributionComparison.Display
-
Returns the main panel which should be printed by the screenshot action.
- getMainPanel() - Method in class org.hipparchus.samples.RealDistributionComparison.Display
-
Returns the main panel which should be printed by the screenshot action.
- getMainSetDimension() - Method in class org.hipparchus.ode.nonstiff.StepsizeHelper
-
Get the main set dimension.
- 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.BaseAbstractFieldUnivariateIntegrator
-
Get the upper bound.
- getMax() - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the upper bound.
- getMax() - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Get higher end of the search interval.
- getMax() - Method in exception org.hipparchus.migration.exception.MaxCountExceededException
-
Deprecated.Get maximum number of evaluations.
- getMax() - Method in exception org.hipparchus.migration.exception.NumberIsTooLargeException
-
Deprecated.Get the maximum.
- getMax() - Method in class org.hipparchus.optim.univariate.SearchInterval
-
Gets the upper bound.
- getMax() - Method in class org.hipparchus.optim.univariate.UnivariateOptimizer
-
Get upper bounds.
- 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.AbstractFieldODEDetector
-
Get the maximal time interval between events handler checks.
- getMaxCheckInterval() - Method in class org.hipparchus.ode.events.AbstractODEDetector
-
Get the maximal time interval between events handler checks.
- getMaxCheckInterval() - Method in interface org.hipparchus.ode.events.FieldODEEventDetector
-
Get the maximal time interval between events handler checks.
- getMaxCheckInterval() - Method in interface org.hipparchus.ode.events.ODEEventDetector
-
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 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
-
Get maximum number of evaluations.
- 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.BaseAbstractFieldUnivariateIntegrator
-
Get the upper limit for the number of iterations.
- 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.FieldUnivariateIntegrator
-
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.AbstractFieldODEDetector
-
Get the upper limit in the iteration count for event localization.
- getMaxIterationCount() - Method in class org.hipparchus.ode.events.AbstractODEDetector
-
Get the upper limit in the iteration count for event localization.
- getMaxIterationCount() - Method in interface org.hipparchus.ode.events.FieldODEEventDetector
-
Get the upper limit in the iteration count for event localization.
- getMaxIterationCount() - Method in interface org.hipparchus.ode.events.ODEEventDetector
-
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.
- getMaxLineSearchIteration() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Get max Iteration for the line search
- getMaxRhoIteration() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Get max number of weight changes.
- 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.
- getMaxStep() - Method in class org.hipparchus.ode.nonstiff.StepsizeHelper
-
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
-
Returns the arithmetic mean of the available values
- 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
-
Returns the arithmetic mean of the available values
- getMean() - Method in class org.hipparchus.stat.descriptive.StatisticalSummaryValues
- getMean() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns the arithmetic mean of the available values
- 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.
- getMeasurementJacobian() - Method in class org.hipparchus.filtering.kalman.ProcessEstimate
-
Get the Jacobian of the measurement with respect to the state (H matrix).
- 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, wheren
is the number of data points andk
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
-
Get a point in the middle of the bracket.
- getMin() - Method in class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Get the lower bound.
- getMin() - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the lower bound.
- getMin() - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Get lower end of the search interval.
- getMin() - Method in exception org.hipparchus.migration.exception.NumberIsTooSmallException
-
Deprecated.Get minimum.
- getMin() - Method in class org.hipparchus.optim.univariate.SearchInterval
-
Gets the lower bound.
- getMin() - Method in class org.hipparchus.optim.univariate.UnivariateOptimizer
-
Get lower bounds.
- 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.BaseAbstractFieldUnivariateIntegrator
-
Get the min limit for the number of iterations.
- 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.FieldUnivariateIntegrator
-
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.
- getMinStep() - Method in class org.hipparchus.ode.nonstiff.StepsizeHelper
-
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.complex.FieldComplex
-
Get the square root of -1.
- getMinusI(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get opposite of the first canonical vector (coordinates: -1, 0, 0).
- getMinusI(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Get opposite of the first canonical vector (coordinates: -1).
- getMinusJ(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get opposite of the second canonical vector (coordinates: 0, -1, 0).
- getMinusJ(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Get opposite of the second canonical vector (coordinates: 0, -1).
- getMinusK(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get opposite of the third canonical vector (coordinates: 0, 0, -1).
- getMinusOne(Field<T>) - Static method in class org.hipparchus.complex.FieldComplex
-
Get a complex number representing "-1.0 + 0.0i".
- 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
-
Get model function value.
- getModelFunctionJacobian() - Method in class org.hipparchus.fitting.AbstractCurveFitter.TheoreticalValuesFunction
-
Get model function Jacobian.
- getMu() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Get parameter for evaluation of Armijo condition for descend direction.
- getMultiplicationFactor() - Method in class org.hipparchus.util.AbstractUnscentedTransform
-
Get the factor applied to the covariance matrix during the unscented transform.
- getMultiplicationFactor() - Method in class org.hipparchus.util.JulierUnscentedTransform
-
Get the factor applied to the covariance matrix during the unscented transform.
- getMultiplicationFactor() - Method in class org.hipparchus.util.MerweUnscentedTransform
-
Get the factor applied to the covariance matrix during the unscented transform.
- getN() - Method in class org.hipparchus.analysis.interpolation.GridAxis
-
Get the number of points required for interpolation.
- getN() - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
-
Get the number of spline segments.
- 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
-
This
Covariance
method is not supported by aStorelessCovariance
, since the number of bivariate observations does not have to be the same for different pairs of covariates - i.e., N as defined inCovariance.getN()
is undefined. - getN() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the number of available values
- getN() - Method in class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Returns the number of values that have been added.
- 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.Get name of the unknown parameter.
- 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.complex.FieldComplex
-
Get a complex number representing "NaN + NaNi".
- getNaN(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get a vector with all coordinates set to NaN.
- getNaN(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
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
-
Get the
NaN Handling
strategy used for computation. - getNaNStrategy() - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Get the
NaN Handling
strategy used for computation. - getNbFunctions() - Method in class org.hipparchus.analysis.differentiation.FieldTaylorMap
-
Get the number of functions of the map.
- getNbFunctions() - Method in class org.hipparchus.analysis.differentiation.TaylorMap
-
Get the number of functions of the map.
- getNbParameters() - Method in class org.hipparchus.analysis.differentiation.FieldTaylorMap
-
Deprecated.
- getNbParameters() - Method in class org.hipparchus.analysis.differentiation.TaylorMap
-
Deprecated.
- 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.
- getNegativeInfinity(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Get a vector with all coordinates set to negative infinity.
- getNewState() - Method in class org.hipparchus.ode.events.EventOccurrence
-
Get the new state for a reset action.
- getNewState() - Method in class org.hipparchus.ode.events.FieldEventOccurrence
-
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
-
Returns the index i of the next point in the Halton sequence that will be returned by calling
HaltonSequenceGenerator.nextVector()
. - getNextIndex() - Method in class org.hipparchus.random.SobolSequenceGenerator
-
Returns the index i of the next point in the Sobol sequence that will be returned by calling
SobolSequenceGenerator.nextVector()
. - 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.FieldVector2D
-
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.ArrayRealVector
-
Returns the L2 norm of the vector.
- 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.FieldVector2D
-
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.
- getNorm1() - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the maximum absolute column sum norm (L1) of the matrix.
- getNorm1() - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the maximum absolute column sum norm (L1) of the matrix.
- 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.FieldVector2D
-
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.
- getNormInfty() - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the maximum absolute row sum norm (L∞) of the matrix.
- getNormInfty() - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the maximum absolute row sum norm (L∞) of the matrix.
- 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.FieldVector2D
-
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).
- 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.FieldGaussIntegrator
-
Get order of the integration rule.
- getNumberOfPoints() - Method in class org.hipparchus.analysis.integration.gauss.GaussIntegrator
-
Get the order of the integration rule.
- getNumberOfRoots() - Method in class org.hipparchus.complex.RootsOfUnity
-
Returns the number of roots of unity currently stored.
- getNumberOfSecondaryStates() - Method in class org.hipparchus.ode.ComplexODEState
-
Get the number of secondary states.
- 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.
- getNumberOfStages() - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Getter for the number of stages corresponding to the Butcher array.
- getNumberOfStages() - Method in interface org.hipparchus.ode.nonstiff.ExplicitRungeKuttaIntegrator
-
Getter for the number of stages corresponding to the Butcher array.
- getNumberOfStages() - Method in interface org.hipparchus.ode.nonstiff.FieldExplicitRungeKuttaIntegrator
-
Getter for the number of stages corresponding to the Butcher array.
- getNumberOfStages() - Method in class org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegrator
-
Getter for the number of stages corresponding to the Butcher array.
- 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.
- getNumComponents() - Method in class org.hipparchus.stat.projection.PCA
-
GEt number of components.
- 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.
- getNumeratorFormat() - Method in class org.hipparchus.fraction.ProperBigFractionFormat
-
Access the numerator format.
- 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
-
Get number of valid function values.
- getObj() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.AbstractSQPOptimizer
-
Getter for objective function.
- 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(double) - Method in class org.hipparchus.geometry.spherical.oned.Arc
-
Get the distance (arc length) from a point to the edge of the arc.
- 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(S1Point) - Method in class org.hipparchus.geometry.spherical.oned.Arc
-
Get the distance (arc length) from a point to the edge of the arc.
- getOffset(Vector<Euclidean1D, Vector1D>) - Method in class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Get the offset (oriented distance) of a vector.
- getOffset(Vector<Euclidean3D, Vector3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Get the offset (oriented distance) of a vector.
- getOffset(Vector<Euclidean2D, Vector2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Get the offset (oriented distance) of a vector.
- getOldEvaluation() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
-
Get the previous evaluation used by the optimizer.
- getOmegaInverse() - Method in class org.hipparchus.stat.regression.GLSMultipleLinearRegression
-
Get the inverse of the covariance.
- getOne() - Method in class org.hipparchus.analysis.differentiation.DSFactory.DSField
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.analysis.differentiation.FDSFactory.DerivativeField
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.analysis.differentiation.FieldGradientField
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1Field
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2Field
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.analysis.differentiation.GradientField
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1Field
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2Field
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.complex.ComplexField
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.complex.FieldComplexField
-
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.Binary64Field
-
Get the multiplicative identity of the field.
- getOne(Field<T>) - Static method in class org.hipparchus.complex.FieldComplex
-
Get a complex number representing "1.0 + 0.0i".
- 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 interface org.hipparchus.analysis.differentiation.Derivative1
-
Get the maximum derivation order.
- getOrder() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get the maximum derivation order.
- getOrder() - Method in interface org.hipparchus.analysis.differentiation.DifferentialAlgebra
-
Get the maximum derivation order.
- getOrder() - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Get the derivation order.
- getOrder() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Get the maximum derivation order.
- getOrder() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
- getOrder() - Method in class org.hipparchus.analysis.differentiation.FieldTaylorMap
-
Get the maximum derivation order.
- getOrder() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Get the derivation order.
- getOrder() - Method in class org.hipparchus.analysis.differentiation.TaylorMap
-
Get the maximum derivation order.
- getOrder() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Get the maximum 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.HessenbergTransformer
-
Returns the matrix P of the transform.
- 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.
- getP() - Method in class org.hipparchus.linear.SchurTransformer
-
Returns the matrix P of the transform.
- getP() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.QuadraticFunction
-
Get square matrix of weights for quadratic terms.
- 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.FieldGradient
-
Get the partial derivative with respect to one parameter.
- getPartialDerivative(int) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Get the partial derivative with respect to one parameter.
- getPartialDerivative(int...) - Method in interface org.hipparchus.analysis.differentiation.Derivative
-
Get a partial derivative.
- getPartialDerivative(int...) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get a partial derivative.
- getPartialDerivative(int...) - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Get a partial derivative.
- getPartialDerivative(int...) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Get a partial derivative.
- getPartialDerivative(int...) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Get a partial derivative.
- getPartialDerivative(int...) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative
-
Get a partial derivative.
- getPartialDerivative(int...) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Get a partial derivative.
- getPartialDerivative(int...) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Get a partial derivative.
- getPartialDerivative(int...) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative
-
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.
- getPartialDerivativeOrdersSum(int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Get the sum of 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.
- getPartsField() - Method in class org.hipparchus.complex.FieldComplex
-
Get the
Field
the real and imaginary parts belong to. - 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.analysis.differentiation.DerivativeStructure
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.analysis.differentiation.DSFactory.DSField
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.analysis.differentiation.FDSFactory.DerivativeField
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Get the Archimedes constant π.
- getPi() - Method in interface org.hipparchus.CalculusFieldElement
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.complex.Complex
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.complex.FieldComplex
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.dfp.Dfp
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant π.
- getPi() - Method in class org.hipparchus.util.Binary64
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.util.FieldTuple
-
Get the Archimedes constant π.
- getPi() - Method in class org.hipparchus.util.Tuple
-
Get the Archimedes constant π.
- getPi(Field<T>) - Static method in class org.hipparchus.complex.FieldComplex
-
Get a complex number representing "π + 0.0i".
- 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
-
Get the
PivotingStrategy
used in KthSelector for computation. - 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).
- getPlusI(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Get first canonical vector (coordinates: 1, 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).
- getPlusJ(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Get second canonical vector (coordinates: 0, 1).
- 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 class org.hipparchus.analysis.differentiation.FieldTaylorMap
-
Get the point at which map is evaluated.
- getPoint() - Method in class org.hipparchus.analysis.differentiation.TaylorMap
-
Get the point at which map is evaluated.
- 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.FieldGaussIntegrator
-
Gets the integration point at the given index.
- 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.
- getPolishIteration() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Get number of iterations of polishing algorithm.
- getPolynomials() - Method in class org.hipparchus.analysis.interpolation.HermiteInterpolator
-
Compute the interpolation polynomials.
- getPolynomials() - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
-
Get a copy of the interpolating polynomials array.
- 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
-
Get population size.
- 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
-
Returns the population variance of the values that have been added.
- getPositiveInfinity(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get a vector with all coordinates set to positive infinity.
- getPositiveInfinity(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
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.
- getPredicted() - Method in class org.hipparchus.filtering.kalman.unscented.UnscentedKalmanFilter
-
Get the predicted state.
- getPredictedMeasurements(RealVector[], T) - Method in interface org.hipparchus.filtering.kalman.unscented.UnscentedProcess
-
Get the state evolution between two times.
- 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.Get previous value.
- 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
-
Deprecated.as of 1.0, replaced with
ODEStateInterpolator.getPreviousState()
/ODEState.getTime()
- getPrimary() - Method in class org.hipparchus.ode.ExpandableODE
-
Get the primary set of differential equations to be integrated.
- getPrimary() - Method in class org.hipparchus.ode.FieldExpandableODE
-
Get the primary set of differential equations to be integrated.
- getPrimaryDerivative() - Method in class org.hipparchus.ode.ComplexODEStateAndDerivative
-
Get derivative of the primary state at time.
- 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.ComplexODEState
-
Get 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.ComplexODEState
-
Get primary state dimension.
- 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.
- getProcessNoiseMatrix() - Method in class org.hipparchus.filtering.kalman.unscented.UnscentedEvolution
-
Get process noise.
- 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.
- getPT() - Method in class org.hipparchus.linear.HessenbergTransformer
-
Returns the transpose of the matrix P of the transform.
- getPT() - Method in class org.hipparchus.linear.SchurTransformer
-
Returns the transpose of the matrix P of the transform.
- 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.
- getQ() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.QuadraticFunction
-
Get vector of weights for linear terms.
- getQ() - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiTheta
-
Get the nome.
- getQ() - Method in class org.hipparchus.special.elliptic.jacobi.JacobiTheta
-
Get the nome.
- 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.
- getQpMaxLoop() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Get max iteration admitted for QP subproblem evaluation.
- 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.
- getQuadratic() - Static method in class org.hipparchus.analysis.polynomials.SmoothStepFactory
-
Get the
quadratic smoothstep function
. - getQuadratic(Field<T>) - Static method in class org.hipparchus.analysis.polynomials.SmoothStepFactory
-
Get the
quadratic smoothstep function
. - 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
-
Get quantile estimated by this statistic.
- getQuantileRank(double) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Returns the estimated quantile position of value in the dataset.
- getQuintic() - Static method in class org.hipparchus.analysis.polynomials.SmoothStepFactory
-
Get the
quintic smoothstep function
. - getQuintic(Field<T>) - Static method in class org.hipparchus.analysis.polynomials.SmoothStepFactory
-
Get the
quintic smoothstep function
. - 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
-
Returns Pearson's product moment correlation coefficient, usually denoted r.
- 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. - getRadToDeg() - Method in class org.hipparchus.dfp.DfpField
-
Get the radians to degrees conversion factor.
- 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
-
Returns a
PearsonsCorrelation
instance constructed from the ranked input data. - getRankingThreshold() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Gets the value of a tuning parameter.
- getReal() - Method in interface org.hipparchus.analysis.differentiation.Derivative
-
Get the real value of the number.
- getReal() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
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.complex.FieldComplex
-
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.FieldElement
-
Get the real value of the number.
- getReal() - Method in class org.hipparchus.fraction.BigFraction
-
Get the real value of the number.
- getReal() - Method in class org.hipparchus.fraction.Fraction
-
Get the real value of the number.
- getReal() - Method in class org.hipparchus.util.BigReal
-
Get the real value of the number.
- getReal() - Method in class org.hipparchus.util.Binary64
-
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
-thn
-th root of unity. - getRealA() - Method in interface org.hipparchus.ode.nonstiff.FieldExplicitRungeKuttaIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getRealB() - Method in interface org.hipparchus.ode.nonstiff.FieldExplicitRungeKuttaIntegrator
-
Get the external weights for the high order method from Butcher array.
- getRealC() - Method in interface org.hipparchus.ode.nonstiff.FieldExplicitRungeKuttaIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getRealFormat() - Method in class org.hipparchus.complex.ComplexFormat
-
Access the realFormat.
- getRealMatrixFormat() - Static method in class org.hipparchus.linear.RealMatrixFormat
-
Returns the default real vector format for the current locale.
- getRealMatrixFormat(Locale) - Static method in class org.hipparchus.linear.RealMatrixFormat
-
Returns the default real vector format for the given locale.
- getRealPart() - Method in class org.hipparchus.complex.Complex
-
Access the real part.
- getRealPart() - Method in class org.hipparchus.complex.FieldComplex
-
Access the real part.
- getRealVectorFormat() - Static method in class org.hipparchus.linear.RealVectorFormat
-
Returns the default real vector format for the current locale.
- getRealVectorFormat(Locale) - Static method in class org.hipparchus.linear.RealVectorFormat
-
Returns the default real vector format for the given locale.
- 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.BaseAbstractFieldUnivariateIntegrator
-
Get the relative accuracy.
- getRelativeAccuracy() - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the relative accuracy.
- getRelativeAccuracy() - Method in interface org.hipparchus.analysis.integration.FieldUnivariateIntegrator
-
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
-
Get relative threshold.
- getRelativeTolerance(int) - Method in class org.hipparchus.ode.nonstiff.StepsizeHelper
-
Get the relative tolerance for one component.
- 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.
- getResidual() - Method in class org.hipparchus.util.MathUtils.FieldSumAndResidual
-
Returns the residual error in the sum.
- getResidual() - Method in class org.hipparchus.util.MathUtils.SumAndResidual
-
Returns the residual error in the sum.
- 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.
- getRhoCons() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Get weight for augmented QP subproblem.
- getRhoMax() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Get max Value for the Weight for ADMM iteration.
- getRhoMin() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Get min Value for the Weight for ADMM iteration.
- 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
-
Get the function value at
BracketedRealFieldUnivariateSolver.Interval.getRightAbscissa()
. - getRightValue() - Method in class org.hipparchus.analysis.solvers.BracketedUnivariateSolver.Interval
-
Get the function value at
BracketedUnivariateSolver.Interval.getRightAbscissa()
. - 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.
- getRotationOrder(String) - Static method in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Get the rotation order corresponding to a string representation.
- 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.Get row index.
- getRow() - Method in exception org.hipparchus.migration.linear.NonSymmetricMatrixException
-
Deprecated.Get row index of the entry.
- 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 interface org.hipparchus.linear.DecompositionSolver
-
Returns the number of rows in the matrix.
- getRowDimension() - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns the number of rows of this matrix.
- getRowDimension() - Method in interface org.hipparchus.linear.FieldDecompositionSolver
-
Returns the number of rows in the 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
-
Returns the coefficient of determination, usually denoted r-square.
- getRSquared() - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns the coefficient of multiple determination, usually denoted r-square.
- getRule(int) - Method in class org.hipparchus.analysis.integration.gauss.AbstractRuleFactory
-
Gets a copy of the quadrature rule with the given number of integration points.
- getRule(int) - Method in class org.hipparchus.analysis.integration.gauss.FieldAbstractRuleFactory
-
Gets a copy of the quadrature rule with the given number of integration points.
- getRule(int) - Method in interface org.hipparchus.analysis.integration.gauss.FieldRuleFactory
-
Gets a copy of the quadrature rule with the given number of integration points.
- getRule(int) - Method in interface org.hipparchus.analysis.integration.gauss.RuleFactory
-
Gets a copy of the quadrature rule with the given number of integration points.
- getRuntimeClass() - Method in class org.hipparchus.analysis.differentiation.DSFactory.DSField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.analysis.differentiation.FDSFactory.DerivativeField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.analysis.differentiation.FieldGradientField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1Field
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2Field
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.analysis.differentiation.GradientField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1Field
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2Field
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.complex.ComplexField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.complex.FieldComplexField
-
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.Binary64Field
-
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
-
Returns a
StatisticalSummary
describing this distribution. - 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.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.
- getScaledA() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPModifiedRuizEquilibrium
-
Get scaled constraints coefficients matrix.
- getScaledH() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPModifiedRuizEquilibrium
-
Get scaled square matrix of weights for quadratic terms.
- getScaledLUb(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPModifiedRuizEquilibrium
-
Get scaled upper bound
- getScaledQ() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPModifiedRuizEquilibrium
-
Get scaled vector of weights for linear terms.
- getScaleMaxIteration() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Get max iteration for the scaling.
- getSecond() - Method in class org.hipparchus.util.Pair
-
Get the second element of the pair.
- getSecondaryDerivative(int) - Method in class org.hipparchus.ode.ComplexODEStateAndDerivative
-
Get derivative of the secondary state at time.
- 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.ComplexODEState
-
Get 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.ComplexODEState
-
Get secondary state dimension.
- 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.
- getSecondDerivative() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Get the second derivative.
- getSecondDerivative() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Get the second derivative.
- 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.
- getSettings() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.AbstractSQPOptimizer
-
Getter for settings.
- 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
-
Get sigma values.
- getSigma() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Get value of regularization term sigma for Karush–Kuhn–Tucker solver.
- 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.
- getSigmaMax() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Get max value admitted for the solution of the additional variable in QP subproblem.
- getSignificance() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the significance level of the slope (equiv) correlation.
- getSingularMatrixCheckTolerance() - Method in class org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
-
Gets the current setting for the tolerance check used during singular checks before inversion
- 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.AbstractOpenIntHashMap
-
Get the number of elements stored in the map.
- 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
-
Returns the standard error of the slope estimate, usually denoted s(b1).
- 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.EigenDecompositionSymmetric
-
Gets a solver for finding the \(A \times 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.
- getSolver() - Method in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Get the root-finding algorithm to use to detect state events.
- getSolver() - Method in class org.hipparchus.ode.events.AbstractODEDetector
-
Get the root-finding algorithm to use to detect state events.
- getSolver() - Method in interface org.hipparchus.ode.events.FieldODEEventDetector
-
Get the root-finding algorithm to use to detect state events.
- getSolver() - Method in interface org.hipparchus.ode.events.ODEEventDetector
-
Get the root-finding algorithm to use to detect state events.
- 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
-
Get percentage of none zero elements as a decimal percent.
- 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.EigenDecompositionSymmetric
-
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
-
Returns an array whose ith entry is the standard deviation of the ith entries of the arrays that have been added using
MultivariateSummaryStatistics.addValue(double[])
- getStandardDeviation() - Method in interface org.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
-
Get initial guess.
- getStartValue() - Method in class org.hipparchus.optim.univariate.SearchInterval
-
Gets the start value.
- getStartValue() - Method in class org.hipparchus.optim.univariate.UnivariateOptimizer
-
Get initial guess.
- getState() - Method in class org.hipparchus.filtering.kalman.ProcessEstimate
-
Get the state vector.
- 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.
- getStateTransitionMatrix() - Method in class org.hipparchus.filtering.kalman.ProcessEstimate
-
Get state transition matrix between previous state and estimated (but not yet corrected) state.
- getStationarySigma() - Method in class org.hipparchus.random.GaussMarkovGenerator
-
Get the standard deviation of the stationary process.
- getStatisticsDHistory() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
Get history of D matrix.
- getStatisticsFitnessHistory() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
Get history of fitness values.
- getStatisticsMeanHistory() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
Get history of mean matrix.
- getStatisticsSigmaHistory() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
Get history of sigma values.
- getStdErrorOfEstimate(int) - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns the standard error of the parameter estimate at index, usually denoted s(bindex).
- getStdErrorOfEstimates() - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns the standard error of the parameter estimates, usually denoted s(bi).
- getStepEndHandlers() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Get all the handlers for step ends that have been added to the integrator.
- getStepEndHandlers() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Get all the handlers for step ends that have been added to the integrator.
- getStepEndHandlers() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Get all the handlers for step ends that have been added to the integrator.
- getStepEndHandlers() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Get all the handlers for step ends that have been added to the integrator.
- 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.
- getStepSizeHelper() - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Get the stepsize helper.
- getStepSizeHelper() - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Get the stepsize helper.
- 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.EventOccurrence
-
Get the new time for a stop action.
- getStopTime() - Method in class org.hipparchus.ode.events.FieldEventOccurrence
-
Get the new time for a stop action.
- getStrict() - Method in exception org.hipparchus.migration.exception.NonMonotonicSequenceException
-
Deprecated.Check if sequence should be strictly monotonic.
- 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.
- getSum() - Method in class org.hipparchus.util.MathUtils.FieldSumAndResidual
-
Returns the sum.
- getSum() - Method in class org.hipparchus.util.MathUtils.SumAndResidual
-
Returns the sum.
- 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
-
Return a
StatisticalSummaryValues
instance reporting current statistics. - 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
-
Returns the sum of squared errors (SSE) associated with the regression model.
- 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.
- getT() - Method in class org.hipparchus.linear.SchurTransformer
-
Returns the quasi-triangular Schur matrix T of the transform.
- getTau() - Method in class org.hipparchus.random.GaussMarkovGenerator
-
Get the correlation time.
- 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.Get absolute positivity threshold.
- getThreshold() - Method in exception org.hipparchus.migration.linear.NonSymmetricMatrixException
-
Deprecated.Get relative symmetry threshold.
- 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.ComplexODEState
-
Get 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.hull.MonotoneChain
-
Get the tolerance below which points are considered identical.
- 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.
- getTolerance(int, double) - Method in class org.hipparchus.ode.nonstiff.StepsizeHelper
-
Get the tolerance for one component.
- getTolerance(int, T) - Method in class org.hipparchus.ode.nonstiff.StepsizeHelper
-
Get the tolerance for one component.
- 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
-
Get a
Transform
embedding a 3D rotation. - 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.
- 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.
- getUnivariateDerivative1Field(Field<T>) - Static method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1Field
-
Get the univariate derivative field corresponding to a value field.
- getUnivariateDerivative2Field(Field<T>) - Static method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2Field
-
Get the univariate derivative field corresponding to a value field.
- getUnscentedCovariance(RealVector[], RealVector) - Method in interface org.hipparchus.util.UnscentedTransformProvider
-
Computes the unscented covariance matrix from a weighted mean state and a set of sigma points.
- getUnscentedMeanState(RealVector[]) - Method in interface org.hipparchus.util.UnscentedTransformProvider
-
Computes a weighted mean state from a given set of sigma points.
- getUnscentedTransformProvider() - Method in class org.hipparchus.filtering.kalman.unscented.UnscentedKalmanFilter
-
Get the unscented transform provider.
- getUpper() - Method in class org.hipparchus.optim.SimpleBounds
-
Gets the upper bounds.
- getUpperBound() - Method in class org.hipparchus.optim.BaseMultivariateOptimizer
-
Get upper bounds.
- getUpperBound() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.BoundedConstraint
-
Get Upper Bound for
value(x)
. - getUpperBound() - Method in interface org.hipparchus.optim.nonlinear.vector.constrained.Constraint
-
Get Upper Bound for
value(x)
. - getUpperBound() - Method in class org.hipparchus.stat.interval.ConfidenceInterval
-
Get upper endpoint of the interval.
- 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.EigenDecompositionNonSymmetric
-
Gets the matrix V of the decomposition.
- getV() - Method in class org.hipparchus.linear.EigenDecompositionSymmetric
-
Gets the matrix V of the decomposition.
- getV() - Method in class org.hipparchus.linear.SingularValueDecomposition
-
Returns the matrix V of the decomposition.
- getV() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPSolution
-
Returns V tilde auxiliary Variable
- getVals() - Method in class org.hipparchus.special.BesselJ.BesselJResult
-
Get computed function values.
- getValue() - Method in interface org.hipparchus.analysis.differentiation.Derivative
-
Get the value part of the function.
- getValue() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get the value part of the derivative structure.
- getValue() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Get the value part of the function.
- 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.FieldGradient
-
Get the value part of the function.
- getValue() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Get the value part of the univariate derivative.
- getValue() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Get the value part of the univariate derivative.
- getValue() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Get the value part of the function.
- getValue() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Get the value of the function.
- getValue() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Get the value part of the function.
- getValue() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Get the value part 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.nonlinear.vector.constrained.LagrangeSolution
-
Returns min(max) evaluated function at x
- 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. - getValueField() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Get the
Field
the value and parameters of the function belongs to. - getValueField() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Get the
Field
the value and parameters of the function belongs to. - getValueField() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
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.
- getVariance() - Method in class org.hipparchus.stat.projection.PCA
-
Get principal component variances.
- 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.
- getVector1DFormat() - Static method in class org.hipparchus.geometry.euclidean.oned.Vector1DFormat
-
Returns the default 1D vector format for the current locale.
- getVector1DFormat(Locale) - Static method in class org.hipparchus.geometry.euclidean.oned.Vector1DFormat
-
Returns the default 1D vector format for the given locale.
- getVector2DFormat() - Static method in class org.hipparchus.geometry.euclidean.twod.Vector2DFormat
-
Returns the default 2D vector format for the current locale.
- getVector2DFormat(Locale) - Static method in class org.hipparchus.geometry.euclidean.twod.Vector2DFormat
-
Returns the default 2D vector format for the given locale.
- getVector3DFormat() - Static method in class org.hipparchus.geometry.euclidean.threed.Vector3DFormat
-
Returns the default 3D vector format for the current locale.
- getVector3DFormat(Locale) - Static method in class org.hipparchus.geometry.euclidean.threed.Vector3DFormat
-
Returns the default 3D vector format for the given locale.
- 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.
- getVInv() - Method in class org.hipparchus.linear.EigenDecompositionNonSymmetric
-
Gets the inverse of the matrix V of the decomposition.
- getVT() - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Getter VT.
- getVT() - Method in class org.hipparchus.linear.EigenDecompositionSymmetric
-
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.SingularValueDecomposition
-
Returns the transpose of the matrix V of the decomposition.
- getWc() - Method in class org.hipparchus.util.JulierUnscentedTransform
-
Get the covariance weights.
- getWc() - Method in class org.hipparchus.util.MerweUnscentedTransform
-
Get the covariance weights.
- getWc() - Method in interface org.hipparchus.util.UnscentedTransformProvider
-
Get the covariance weights.
- 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.FieldGaussIntegrator
-
Gets the weight of the integration point at the given index.
- 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.
- getWm() - Method in class org.hipparchus.util.JulierUnscentedTransform
-
Get the mean weights.
- getWm() - Method in class org.hipparchus.util.MerweUnscentedTransform
-
Get the mean weights.
- getWm() - Method in interface org.hipparchus.util.UnscentedTransformProvider
-
Get the mean weights.
- 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.Get wrong column dimension.
- getWrongDimension(int) - Method in exception org.hipparchus.migration.exception.MultiDimensionMismatchException
-
Deprecated.Get wrong dimension at index.
- getWrongDimensions() - Method in exception org.hipparchus.migration.exception.MultiDimensionMismatchException
-
Deprecated.Get array containing the wrong dimensions.
- getWrongRowDimension() - Method in exception org.hipparchus.migration.linear.MatrixDimensionMismatchException
-
Deprecated.Get wrong row dimension.
- 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.FieldVector2D
-
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.optim.nonlinear.vector.constrained.LagrangeSolution
-
Returns X solution
- getX() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Get the X sample data.
- getXAxis() - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Get the X axis of the circle.
- getXInf() - Method in class org.hipparchus.analysis.interpolation.BilinearInterpolatingFunction
-
Get the lowest grid x coordinate.
- getXSumSquares() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the sum of squared deviations of the x values about their mean.
- getXSup() - Method in class org.hipparchus.analysis.interpolation.BilinearInterpolatingFunction
-
Get the highest grid x coordinate.
- 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.FieldVector2D
-
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
-
Get the Y sample data.
- getYAxis() - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Get the Y axis of the circle.
- getYInf() - Method in class org.hipparchus.analysis.interpolation.BilinearInterpolatingFunction
-
Get the lowest grid y coordinate.
- getYSup() - Method in class org.hipparchus.analysis.interpolation.BilinearInterpolatingFunction
-
Get the highest grid y coordinate.
- 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.
- getZ() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPSolution
-
Returns Z auxiliary Variable
- getZero() - Method in class org.hipparchus.analysis.differentiation.DSFactory.DSField
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.analysis.differentiation.FDSFactory.DerivativeField
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.analysis.differentiation.FieldGradientField
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1Field
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2Field
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.analysis.differentiation.GradientField
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1Field
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2Field
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.complex.ComplexField
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.complex.FieldComplexField
-
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.Binary64Field
-
Get the additive identity of the field.
- getZero(Field<T>) - Static method in class org.hipparchus.complex.FieldComplex
-
Get a complex number representing "0.0 + 0.0i".
- getZero(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get null vector (coordinates: 0, 0, 0).
- getZero(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Get null vector (coordinates: 0, 0).
- GillFieldIntegrator<T extends CalculusFieldElement<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
-
Empty constructor.
- GnuplotComplexPlotter - Class in org.hipparchus.samples.complex
-
Program plotting complex functions with domain coloring.
- GoalType - Enum in org.hipparchus.optim.nonlinear.scalar
-
Goal type for an optimization problem (minimization or maximization of a scalar function.
- gradient(double[]) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.TwiceDifferentiableFunction
-
Returns the gradient of this function at (x)
- gradient(double[]) - Method in interface org.hipparchus.optim.nonlinear.vector.constrained.VectorDifferentiableFunction
-
Returns the gradient of this function at (x)
- 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.
- gradient(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.QuadraticFunction
-
Returns the gradient of this function at (x)
- gradient(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.TwiceDifferentiableFunction
-
Returns the gradient of this function at (x)
- Gradient - Class in org.hipparchus.analysis.differentiation
-
Class representing both the value and the differentials of a function.
- Gradient(double, double...) - Constructor for class org.hipparchus.analysis.differentiation.Gradient
-
Build an instance with values and derivative.
- Gradient(DerivativeStructure) - Constructor for class org.hipparchus.analysis.differentiation.Gradient
-
Build an instance from a
DerivativeStructure
. - GradientField - Class in org.hipparchus.analysis.differentiation
-
Field for
Gradient
instances. - 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
-
Simple constructor.
- 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 - Enum constant in enum 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.
- GridAxis - Class in org.hipparchus.analysis.interpolation
-
Helper for finding interpolation nodes along one axis of grid data.
- GridAxis(double[], int) - Constructor for class org.hipparchus.analysis.interpolation.GridAxis
-
Simple constructor.
- growTable(int) - Method in class org.hipparchus.util.AbstractOpenIntHashMap
-
Grow the tables.
- growTable(int) - Method in class org.hipparchus.util.OpenIntToDoubleHashMap
-
Grow the tables.
- growTable(int) - Method in class org.hipparchus.util.OpenIntToFieldHashMap
-
Grow the tables.
- 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 theexpected
array. - gTest(double[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
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 theexpected
array. - 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
-
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 - Class in org.hipparchus.stat.inference
-
Implements G Test statistics.
- GTest() - Constructor for class org.hipparchus.stat.inference.GTest
-
Empty constructor.
- 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
andobserved2
. - gTestDataSetsComparison(long[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
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
andobserved2
. - 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
-
Performs a G-Test (Log-Likelihood Ratio Test) comparing two binned data sets.
- 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
-
Returns the intrinsic (Hardy-Weinberg proportions) p-Value, as described in p64-69 of McDonald, J.H.
- 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.
H
- HaltonSequenceGenerator - Class in org.hipparchus.random
-
Implementation of a Halton sequence.
- HaltonSequenceGenerator(int) - Constructor for class org.hipparchus.random.HaltonSequenceGenerator
-
Construct a new Halton sequence generator for the given space dimension.
- HaltonSequenceGenerator(int, int[], int[]) - Constructor for class org.hipparchus.random.HaltonSequenceGenerator
-
Construct a new Halton sequence generator with the given base numbers and weights for each dimension.
- handleStep(double, double[], double[], boolean) - Method in interface org.hipparchus.migration.ode.sampling.FixedStepHandler
-
Deprecated.Handle the last accepted step
- handleStep(MigrationStepInterpolator, boolean) - Method in interface org.hipparchus.migration.ode.sampling.StepHandler
-
Deprecated.Handle the last accepted step
- handleStep(FieldODEStateAndDerivative<T>, boolean) - Method in interface org.hipparchus.ode.sampling.FieldODEFixedStepHandler
-
Handle the last accepted step
- handleStep(ODEStateAndDerivative, boolean) - Method in interface org.hipparchus.migration.ode.sampling.FixedStepHandler
-
Deprecated.Handle the last accepted step
- handleStep(ODEStateAndDerivative, boolean) - Method in interface org.hipparchus.ode.sampling.ODEFixedStepHandler
-
Handle the last accepted step
- handleStep(FieldODEStateInterpolator<T>) - Method in class org.hipparchus.ode.FieldDenseOutputModel
-
Handle the last accepted step.
- handleStep(FieldODEStateInterpolator<T>) - Method in interface org.hipparchus.ode.sampling.FieldODEStepHandler
-
Handle the last accepted step.
- handleStep(FieldODEStateInterpolator<T>) - Method in class org.hipparchus.ode.sampling.FieldStepNormalizer
-
Handle the last accepted step.
- handleStep(ODEStateInterpolator) - Method in class org.hipparchus.migration.ode.sampling.DummyStepHandler
-
Deprecated.Handle the last accepted step.
- handleStep(ODEStateInterpolator) - Method in interface org.hipparchus.migration.ode.sampling.StepHandler
-
Deprecated.Handle the last accepted step.
- handleStep(ODEStateInterpolator) - Method in class org.hipparchus.ode.DenseOutputModel
-
Handle the last accepted step.
- handleStep(ODEStateInterpolator) - Method in interface org.hipparchus.ode.sampling.ODEStepHandler
-
Handle the last accepted step.
- handleStep(ODEStateInterpolator) - Method in class org.hipparchus.ode.sampling.StepNormalizer
-
Handle the last accepted step.
- HarmonicCurveFitter - Class in org.hipparchus.fitting
-
Fits points to a
harmonic oscillator
function. - HarmonicCurveFitter.ParameterGuesser - Class in org.hipparchus.fitting
-
This class guesses harmonic coefficients from a sample.
- HarmonicOscillator - Class in org.hipparchus.analysis.function
-
simple harmonic oscillator function.
- HarmonicOscillator(double, double, double) - Constructor for class org.hipparchus.analysis.function.HarmonicOscillator
-
Harmonic oscillator function.
- HarmonicOscillator.Parametric - Class in org.hipparchus.analysis.function
-
Parametric function where the input array contains the parameters of the harmonic oscillator function, ordered as follows: Amplitude Angular frequency Phase
- hasComplexEigenvalues() - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Confirm if there are complex eigen values.
- hash(double) - Static method in class org.hipparchus.util.MathUtils
-
Returns an integer hash code representing the given double value.
- hash(double[]) - Static method in class org.hipparchus.util.MathUtils
-
Returns an integer hash code representing the given double array.
- hashCode() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get a hashCode for the derivative structure.
- hashCode() - Method in class org.hipparchus.analysis.differentiation.DSFactory.DSField
- hashCode() - Method in class org.hipparchus.analysis.differentiation.FDSFactory.DerivativeField
- hashCode() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Get a hashCode for the univariate derivative.
- hashCode() - Method in class org.hipparchus.analysis.differentiation.FieldGradientField
- hashCode() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Get a hashCode for the univariate derivative.
- hashCode() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1Field
- hashCode() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Get a hashCode for the univariate derivative.
- hashCode() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2Field
- hashCode() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Get a hashCode for the univariate derivative.
- hashCode() - Method in class org.hipparchus.analysis.differentiation.GradientField
- hashCode() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Get a hashCode for the derivative structure.
- hashCode() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Get a hashCode for the univariate derivative.
- hashCode() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1Field
- hashCode() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Get a hashCode for the univariate derivative.
- hashCode() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2Field
- hashCode() - Method in class org.hipparchus.analysis.polynomials.JacobiKey
-
Get hash code.
- hashCode() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
- hashCode() - Method in class org.hipparchus.clustering.DoublePoint
- hashCode() - Method in class org.hipparchus.complex.Complex
-
Get a hashCode for the complex number.
- hashCode() - Method in class org.hipparchus.complex.ComplexField
- hashCode() - Method in class org.hipparchus.complex.FieldComplex
-
Get a hashCode for the complex number.
- hashCode() - Method in class org.hipparchus.complex.FieldComplexField
- hashCode() - Method in class org.hipparchus.complex.Quaternion
- hashCode() - Method in class org.hipparchus.dfp.Dfp
-
Gets a hashCode for the instance.
- hashCode() - Method in class org.hipparchus.dfp.DfpField
- hashCode() - Method in class org.hipparchus.fraction.BigFraction
-
Gets a hashCode for the fraction.
- hashCode() - Method in class org.hipparchus.fraction.BigFractionField
- hashCode() - Method in class org.hipparchus.fraction.Fraction
-
Gets a hashCode for the fraction.
- hashCode() - Method in class org.hipparchus.fraction.FractionField
- hashCode() - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Get a hashCode for the 1D vector.
- hashCode() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get a hashCode for the 3D vector.
- hashCode() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get a hashCode for the 3D vector.
- hashCode() - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Get a hashCode for the 3D vector.
- hashCode() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Get a hashCode for the 2D vector.
- hashCode() - Method in class org.hipparchus.geometry.spherical.oned.S1Point
-
Get a hashCode for the point.
- hashCode() - Method in class org.hipparchus.geometry.spherical.twod.S2Point
-
Get a hashCode for the point.
- hashCode() - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Computes a hashcode for the matrix.
- hashCode() - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Computes a hashcode for the matrix.
- hashCode() - Method in class org.hipparchus.linear.ArrayFieldVector
-
Get a hashCode for the real vector.
- hashCode() - Method in class org.hipparchus.linear.ArrayRealVector
-
.
- hashCode() - Method in class org.hipparchus.linear.OpenMapRealVector
-
.
- hashCode() - Method in class org.hipparchus.linear.RealVector
-
.
- hashCode() - Method in class org.hipparchus.linear.SparseFieldVector
- hashCode() - Method in class org.hipparchus.optim.linear.LinearConstraint
- hashCode() - Method in class org.hipparchus.optim.linear.LinearObjectiveFunction
- hashCode() - Method in class org.hipparchus.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Returns hash code based on getResult() and getN().
- hashCode() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns hash code based on values of statistics
- hashCode() - Method in class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
Returns hash code based on getResult() and getN().
- hashCode() - Method in class org.hipparchus.stat.descriptive.StatisticalSummaryValues
-
Returns hash code based on values of statistics
- hashCode() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns hash code based on values of statistics.
- hashCode() - Method in class org.hipparchus.stat.descriptive.vector.VectorialCovariance
- hashCode() - Method in class org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic
- hashCode() - Method in class org.hipparchus.stat.Frequency
- hashCode() - Method in class org.hipparchus.util.BigReal
- hashCode() - Method in class org.hipparchus.util.BigRealField
- hashCode() - Method in class org.hipparchus.util.Binary64
-
The current implementation returns the same value as
new Double(this.doubleValue()).hashCode()
- hashCode() - Method in class org.hipparchus.util.Binary64Field
- hashCode() - Method in class org.hipparchus.util.FieldTuple
- hashCode() - Method in class org.hipparchus.util.OpenIntToDoubleHashMap
- hashCode() - Method in class org.hipparchus.util.OpenIntToFieldHashMap
- hashCode() - Method in class org.hipparchus.util.Pair
-
Compute a hash code.
- hashCode() - Method in class org.hipparchus.util.ResizableDoubleArray
-
Returns a hash code consistent with equals.
- hashCode() - Method in class org.hipparchus.util.Tuple
- hasIntercept() - Method in class org.hipparchus.stat.regression.MillerUpdatingRegression
-
A getter method which determines whether a constant is included.
- hasIntercept() - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns true if the regression model has been computed including an intercept.
- hasIntercept() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns true if the model includes an intercept term.
- hasIntercept() - Method in interface org.hipparchus.stat.regression.UpdatingMultipleLinearRegression
-
Returns true if a constant has been included false otherwise.
- hasNext() - Method in class org.hipparchus.linear.OpenMapRealVector.OpenMapSparseIterator
- hasNext() - Method in class org.hipparchus.linear.RealVector.SparseEntryIterator
- hasNext() - Method in class org.hipparchus.util.AbstractOpenIntHashMap.BaseIterator
-
Check if there is a next element in the map.
- hasNext() - Method in class org.hipparchus.util.MultidimensionalCounter.Iterator
- hasNext() - Method in class org.hipparchus.util.RosenNumberPartitionIterator
- HEAD - Enum constant in enum org.hipparchus.util.MathArrays.Position
-
Designates the beginning of the array (near index 0).
- height(int) - Method in interface org.hipparchus.stat.descriptive.rank.PSquarePercentile.PSquareMarkers
-
Returns the marker height (or percentile) of a given marker index.
- hermite(int) - Method in class org.hipparchus.analysis.integration.gauss.FieldGaussIntegratorFactory
-
Creates a Gauss-Hermite integrator of the given order.
- hermite(int) - Method in class org.hipparchus.analysis.integration.gauss.GaussIntegratorFactory
-
Creates a Gauss-Hermite integrator of the given order.
- HermiteInterpolator - Class in org.hipparchus.analysis.interpolation
-
Polynomial interpolator using both sample values and sample derivatives.
- HermiteInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.HermiteInterpolator
-
Create an empty interpolator.
- HermiteRuleFactory - Class in org.hipparchus.analysis.integration.gauss
-
Factory that creates a Gauss-type quadrature rule using Hermite polynomials of the first kind.
- HermiteRuleFactory() - Constructor for class org.hipparchus.analysis.integration.gauss.HermiteRuleFactory
-
Empty constructor.
- HessenbergTransformer - Class in org.hipparchus.linear
-
Class transforming a general real matrix to Hessenberg form.
- HessenbergTransformer(RealMatrix) - Constructor for class org.hipparchus.linear.HessenbergTransformer
-
Build the transformation to Hessenberg form of a general matrix.
- hessian(double[]) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.TwiceDifferentiableFunction
-
The Hessian of this function at (x)
- hessian(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.QuadraticFunction
-
The Hessian of this function at (x)
- hessian(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.TwiceDifferentiableFunction
-
The Hessian of this function at (x)
- HighamHall54FieldIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This class implements the 5(4) Higham and Hall integrator for Ordinary Differential Equations.
- HighamHall54FieldIntegrator(Field<T>, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
-
Simple constructor.
- HighamHall54FieldIntegrator(Field<T>, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
-
Simple constructor.
- HighamHall54Integrator - Class in org.hipparchus.ode.nonstiff
-
This class implements the 5(4) Higham and Hall integrator for Ordinary Differential Equations.
- HighamHall54Integrator(double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.HighamHall54Integrator
-
Simple constructor.
- HighamHall54Integrator(double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.HighamHall54Integrator
-
Simple constructor.
- HOLE_BETWEEN_MODELS_TIME_RANGES - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.HOLE_BETWEEN_MODELS_TIME_RANGES.
- HOLE_BETWEEN_MODELS_TIME_RANGES - Enum constant in enum org.hipparchus.ode.LocalizedODEFormats
-
HOLE_BETWEEN_MODELS_TIME_RANGES.
- homoscedasticT(double[], double[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes a 2-sample t statistic, under the hypothesis of equal subpopulation variances.
- homoscedasticT(double[], double[]) - Method in class org.hipparchus.stat.inference.TTest
-
Computes a 2-sample t statistic, under the hypothesis of equal subpopulation variances.
- homoscedasticT(double, double, double, double, double, double) - Method in class org.hipparchus.stat.inference.TTest
-
Computes t test statistic for 2-sample t-test under the hypothesis of equal subpopulation variances.
- homoscedasticT(StatisticalSummary, StatisticalSummary) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes a 2-sample t statistic, comparing the means of the datasets described by two
StatisticalSummary
instances, under the assumption of equal subpopulation variances. - homoscedasticT(StatisticalSummary, StatisticalSummary) - Method in class org.hipparchus.stat.inference.TTest
-
Computes a 2-sample t statistic, comparing the means of the datasets described by two
StatisticalSummary
instances, under the assumption of equal subpopulation variances. - homoscedasticTTest(double[], double[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays, under the assumption that the two samples are drawn from subpopulations with equal variances.
- homoscedasticTTest(double[], double[]) - Method in class org.hipparchus.stat.inference.TTest
-
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays, under the assumption that the two samples are drawn from subpopulations with equal variances.
- homoscedasticTTest(double[], double[], double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Performs a two-sided t-test evaluating the null hypothesis that
sample1
andsample2
are drawn from populations with the same mean, with significance levelalpha
, assuming that the subpopulation variances are equal. - homoscedasticTTest(double[], double[], double) - Method in class org.hipparchus.stat.inference.TTest
-
Performs a two-sided t-test evaluating the null hypothesis that
sample1
andsample2
are drawn from populations with the same mean, with significance levelalpha
, assuming that the subpopulation variances are equal. - homoscedasticTTest(double, double, double, double, double, double) - Method in class org.hipparchus.stat.inference.TTest
-
Computes p-value for 2-sided, 2-sample t-test, under the assumption of equal subpopulation variances.
- homoscedasticTTest(StatisticalSummary, StatisticalSummary) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances, under the hypothesis of equal subpopulation variances.
- homoscedasticTTest(StatisticalSummary, StatisticalSummary) - Method in class org.hipparchus.stat.inference.TTest
-
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances, under the hypothesis of equal subpopulation variances.
- hue(Complex) - Method in class org.hipparchus.samples.complex.DomainColoring
-
Continuous hue.
- HYPER - Enum constant in enum org.hipparchus.geometry.partitioning.Side
-
Code for the hyperplane itself.
- HypergeometricDistribution - Class in org.hipparchus.distribution.discrete
-
Implementation of the hypergeometric distribution.
- HypergeometricDistribution(int, int, int) - Constructor for class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
Construct a new hypergeometric distribution with the specified population size, number of successes in the population, and sample size.
- Hyperplane<S extends Space> - Interface in org.hipparchus.geometry.partitioning
-
This interface represents an hyperplane of a space.
- hypot(double, double) - Static method in class org.hipparchus.util.FastMath
-
Returns the hypotenuse of a triangle with sides
x
andy
- sqrt(x2 +y2)
avoiding intermediate overflow or underflow. - hypot(DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(DerivativeStructure, DerivativeStructure) - Static method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Returns the hypotenuse of a triangle with sides
x
andy
- sqrt(x2 +y2) avoiding intermediate overflow or underflow. - hypot(FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(FieldDerivativeStructure<T>, FieldDerivativeStructure<T>) - Static method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Returns the hypotenuse of a triangle with sides
x
andy
- sqrt(x2 +y2) avoiding intermediate overflow or underflow. - hypot(FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(SparseGradient, SparseGradient) - Static method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Returns the hypotenuse of a triangle with sides
x
andy
- sqrt(x2 +y2) avoiding intermediate overflow or underflow. - hypot(UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(Complex) - Method in class org.hipparchus.complex.Complex
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(Binary64) - Method in class org.hipparchus.util.Binary64
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(Tuple) - Method in class org.hipparchus.util.Tuple
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(T) - Method in interface org.hipparchus.CalculusFieldElement
-
Returns the hypotenuse of a triangle with sides
this
andy
- sqrt(this2 +y2) avoiding intermediate overflow or underflow. - hypot(T, T) - Static method in class org.hipparchus.util.FastMath
-
Returns the hypotenuse of a triangle with sides
x
andy
- sqrt(x2 +y2)
avoiding intermediate overflow or underflow.
I
- 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
-
Empty constructor.
- 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
-
Empty constructor.
- 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 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ILL_CONDITIONED_OPERATOR.
- ILL_CONDITIONED_OPERATOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ILL_CONDITIONED_OPERATOR.
- IllConditionedOperatorException - Exception in org.hipparchus.migration.linear
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- IllConditionedOperatorException(double) - Constructor for exception org.hipparchus.migration.linear.IllConditionedOperatorException
-
Deprecated.Creates a new instance of this class.
- ILLEGAL_STATE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ILLEGAL_STATE.
- ILLEGAL_STATE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ILLEGAL_STATE.
- ILLEGAL_STATE_PCA - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
ILLEGAL_STATE_PCA.
- ILLINOIS - Enum constant in enum org.hipparchus.analysis.solvers.BaseSecantSolver.Method
-
The
Illinois
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
-
Empty constructor.
- ImageClusteringExample.Display - Class in org.hipparchus.samples.clustering
-
Main frame for displaying clusters.
- IMAGINARY_FORMAT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
IMAGINARY_FORMAT.
- IMAGINARY_FORMAT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.IMAGINARY_FORMAT.
- 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
-
Whether or not
Variance.increment(double)
should increment the internal second moment. - INCONSISTENT_STATE_AT_2_PI_WRAPPING - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
INCONSISTENT_STATE_AT_2_PI_WRAPPING.
- INCONSISTENT_STATE_AT_2_PI_WRAPPING - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INCONSISTENT_STATE_AT_2_PI_WRAPPING.
- InconsistentStateAt2PiWrapping() - Constructor for exception org.hipparchus.geometry.spherical.oned.ArcsSet.InconsistentStateAt2PiWrapping
-
Simple constructor.
- INCREASING - Enum constant in enum 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 - Enum constant in enum 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.
- incrementEvaluations(int) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Increment evaluations of derivatives.
- incrementEvaluations(int) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Increment evaluations of derivatives.
- 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 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INDEX.
- INDEX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INDEX.
- INDEX_LARGER_THAN_MAX - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INDEX_LARGER_THAN_MAX.
- INDEX_LARGER_THAN_MAX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INDEX_LARGER_THAN_MAX.
- INDEX_NOT_POSITIVE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INDEX_NOT_POSITIVE.
- INDEX_NOT_POSITIVE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INDEX_NOT_POSITIVE.
- INDEX_OUT_OF_RANGE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INDEX_OUT_OF_RANGE.
- INDEX_OUT_OF_RANGE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.INDEX_OUT_OF_RANGE.
- IndexTable(int, int, int, int) - Constructor for class org.hipparchus.random.AbstractWell.IndexTable
-
Creates a new pre-calculated indirection index table.
- InequalityConstraint - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Inequality Constraint with lower bound only: \(l \le f(x)\).
- InequalityConstraint(RealVector) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.InequalityConstraint
-
Simple constructor.
- 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 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INFINITE_ARRAY_ELEMENT.
- INFINITE_ARRAY_ELEMENT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INFINITE_ARRAY_ELEMENT.
- INFINITE_BOUND - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INFINITE_BOUND.
- INFINITE_BOUND - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INFINITE_BOUND.
- INFINITE_VALUE_CONVERSION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INFINITE_VALUE_CONVERSION.
- INFINITE_VALUE_CONVERSION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INFINITE_VALUE_CONVERSION.
- 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(double, Complex[], double) - Method in interface org.hipparchus.ode.ComplexOrdinaryDifferentialEquation
-
Initialize equations at the start of an ODE integration.
- init(double, Complex[], Complex[], double) - Method in interface org.hipparchus.ode.ComplexSecondaryODE
-
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<E>, E) - Method in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Initialize event handler at the start of an ODE integration.
- init(FieldODEStateAndDerivative<E>, E) - Method in class org.hipparchus.ode.events.FieldEventSlopeFilter
-
Initialize event handler at the start of an ODE integration.
- init(FieldODEStateAndDerivative<T>, T) - Method in class org.hipparchus.ode.events.FieldDetectorBasedEventState
-
Initialize event handler at the start of an integration.
- init(FieldODEStateAndDerivative<T>, T) - Method in interface org.hipparchus.ode.events.FieldEventState
-
Initialize handler at the start of an integration.
- init(FieldODEStateAndDerivative<T>, T) - Method in interface org.hipparchus.ode.events.FieldODEEventDetector
-
Initialize event handler at the start of an ODE integration.
- init(FieldODEStateAndDerivative<T>, T) - Method in interface org.hipparchus.ode.events.FieldODEStepEndHandler
-
Initialize step end handler at the start of an ODE integration.
- init(FieldODEStateAndDerivative<T>, T) - Method in class org.hipparchus.ode.events.FieldStepEndEventState
-
Initialize handler at the start of an 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(FieldODEStateAndDerivative<T>, T, FieldODEEventDetector<T>) - Method in interface org.hipparchus.ode.events.FieldODEEventHandler
-
Initialize event 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.AbstractODEDetector
-
Initialize event handler at the start of an ODE integration.
- init(ODEStateAndDerivative, double) - Method in class org.hipparchus.ode.events.DetectorBasedEventState
-
Initialize handler at the start of an integration.
- init(ODEStateAndDerivative, double) - Method in class org.hipparchus.ode.events.EventSlopeFilter
-
Initialize event handler at the start of an ODE integration.
- init(ODEStateAndDerivative, double) - Method in interface org.hipparchus.ode.events.EventState
-
Initialize handler at the start of an integration.
- init(ODEStateAndDerivative, double) - Method in interface org.hipparchus.ode.events.ODEEventDetector
-
Initialize event handler at the start of an ODE integration.
- init(ODEStateAndDerivative, double) - Method in interface org.hipparchus.ode.events.ODEStepEndHandler
-
Initialize step end handler at the start of an ODE integration.
- init(ODEStateAndDerivative, double) - Method in class org.hipparchus.ode.events.StepEndEventState
-
Initialize handler at the start of an 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(ODEStateAndDerivative, double, ODEEventDetector) - Method in interface org.hipparchus.ode.events.ODEEventHandler
-
Initialize event 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 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INITIAL_CAPACITY_NOT_POSITIVE.
- INITIAL_CAPACITY_NOT_POSITIVE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INITIAL_CAPACITY_NOT_POSITIVE.
- INITIAL_COLUMN_AFTER_FINAL_COLUMN - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INITIAL_COLUMN_AFTER_FINAL_COLUMN.
- INITIAL_COLUMN_AFTER_FINAL_COLUMN - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INITIAL_COLUMN_AFTER_FINAL_COLUMN.
- INITIAL_ROW_AFTER_FINAL_ROW - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INITIAL_ROW_AFTER_FINAL_ROW.
- INITIAL_ROW_AFTER_FINAL_ROW - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INITIAL_ROW_AFTER_FINAL_ROW.
- InitialGuess - Class in org.hipparchus.optim
-
Starting point (first guess) of the optimization procedure.
- InitialGuess(double[]) - Constructor for class org.hipparchus.optim.InitialGuess
-
Simple constructor.
- 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).
- initialize(RealMatrix, RealMatrix, RealVector, int, RealVector, RealVector, double, double, double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPKKT
-
Initialize problem
- 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) - 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.
- initIntegration(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Prepare the start of an integration.
- initIntegration(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegrator
-
Prepare the start of an integration.
- INPUT_ARRAY - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INPUT_ARRAY.
- INPUT_ARRAY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INPUT_ARRAY.
- INPUT_EXPECTED_BETWEEN_ZERO_AND_ONE_INCLUDED - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INPUT_EXPECTED_BETWEEN_ZERO_AND_ONE_INCLUDED.
- 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 - Enum constant in enum org.hipparchus.geometry.partitioning.Region.Location
-
Code for points inside the partition.
- INSUFFICIENT_DATA - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INSUFFICIENT_DATA.
- INSUFFICIENT_DATA - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INSUFFICIENT_DATA.
- INSUFFICIENT_DATA_FOR_T_STATISTIC - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INSUFFICIENT_DATA_FOR_T_STATISTIC.
- INSUFFICIENT_DATA_FOR_T_STATISTIC - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
INSUFFICIENT_DATA_FOR_T_STATISTIC.
- INSUFFICIENT_DIMENSION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INSUFFICIENT_DIMENSION.
- INSUFFICIENT_DIMENSION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INSUFFICIENT_DIMENSION.
- INSUFFICIENT_OBSERVED_POINTS_IN_SAMPLE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INSUFFICIENT_OBSERVED_POINTS_IN_SAMPLE.
- INSUFFICIENT_OBSERVED_POINTS_IN_SAMPLE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INSUFFICIENT_OBSERVED_POINTS_IN_SAMPLE.
- INSUFFICIENT_ROWS_AND_COLUMNS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INSUFFICIENT_ROWS_AND_COLUMNS.
- INSUFFICIENT_ROWS_AND_COLUMNS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INSUFFICIENT_ROWS_AND_COLUMNS.
- InsufficientDataException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- 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
-
Empty constructor.
- IntegerDistributionComparison.Display - Class in org.hipparchus.samples
-
Main frame for displaying distributions.
- integrate(double, double) - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Returns the definite integral of this polymomial over the given interval.
- integrate(double, double) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Returns the definite integral of this polymomial over the given interval.
- integrate(int, int) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Integrate w.r.t.
- integrate(int, int) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Integrate w.r.t.
- integrate(int, CalculusFieldUnivariateFunction<Complex>, Complex, Complex) - Method in class org.hipparchus.complex.ComplexUnivariateIntegrator
-
Integrate a function along a straight path between points.
- integrate(int, CalculusFieldUnivariateFunction<Complex>, Complex, Complex...) - Method in class org.hipparchus.complex.ComplexUnivariateIntegrator
-
Integrate a function along a polyline path between any number of points.
- integrate(int, CalculusFieldUnivariateFunction<FieldComplex<T>>, FieldComplex<T>, FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplexUnivariateIntegrator
-
Integrate a function along a straight path between points.
- integrate(int, CalculusFieldUnivariateFunction<FieldComplex<T>>, FieldComplex<T>, FieldComplex<T>...) - Method in class org.hipparchus.complex.FieldComplexUnivariateIntegrator
-
Integrate a function along a polyline path between any number of points.
- integrate(int, CalculusFieldUnivariateFunction<T>, T, T) - Method in class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Integrate the function in the given interval.
- integrate(int, CalculusFieldUnivariateFunction<T>, T, T) - Method in interface org.hipparchus.analysis.integration.FieldUnivariateIntegrator
-
Integrate the function in 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(CalculusFieldUnivariateFunction<T>) - Method in class org.hipparchus.analysis.integration.gauss.FieldGaussIntegrator
-
Returns an estimate of the integral of
f(x) * w(x)
, wherew
is a weight function that depends on the actual flavor of the Gauss integration scheme. - integrate(CalculusFieldUnivariateFunction<T>) - Method in class org.hipparchus.analysis.integration.gauss.SymmetricFieldGaussIntegrator
-
Returns an estimate of the integral of
f(x) * w(x)
, wherew
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.GaussIntegrator
-
Returns an estimate of the integral of
f(x) * w(x)
, wherew
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)
, wherew
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.AdamsIntegrator
-
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.AdamsFieldIntegrator
-
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, ODEState, double) - Method in interface org.hipparchus.ode.ODEIntegrator
-
Integrate the differential equations up to the given time.
- integrate(T, T) - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Returns the definite integral of this polymomial over the given interval.
- INTEGRATION_METHOD_NEEDS_AT_LEAST_TWO_PREVIOUS_POINTS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INTEGRATION_METHOD_NEEDS_AT_LEAST_TWO_PREVIOUS_POINTS.
- INTEGRATION_METHOD_NEEDS_AT_LEAST_TWO_PREVIOUS_POINTS - Enum constant in enum org.hipparchus.ode.LocalizedODEFormats
-
INTEGRATION_METHOD_NEEDS_AT_LEAST_TWO_PREVIOUS_POINTS.
- INTERNAL_ERROR - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INTERNAL_ERROR.
- INTERNAL_ERROR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INTERNAL_ERROR.
- 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 class org.hipparchus.analysis.interpolation.BilinearInterpolator
-
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.
- interpolate(T[], T[]) - Method in class org.hipparchus.analysis.interpolation.AkimaSplineInterpolator
-
Computes an interpolating function for the data set.
- interpolate(T[], T[]) - Method in interface org.hipparchus.analysis.interpolation.FieldUnivariateInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(T[], T[]) - Method in class org.hipparchus.analysis.interpolation.LinearInterpolator
-
Computes a linear interpolating function for the data set.
- interpolate(T[], T[]) - Method in class org.hipparchus.analysis.interpolation.SplineInterpolator
-
Computes an interpolating function for the data set.
- InterpolatingMicrosphere - Class in org.hipparchus.analysis.interpolation
-
Utility class for the
MicrosphereProjectionInterpolator
algorithm. - 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
-
Utility class for the
MicrosphereProjectionInterpolator
algorithm. - 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.
- interpolationIndex(double) - Method in class org.hipparchus.analysis.interpolation.GridAxis
-
Get the index of the first interpolation node for some coordinate along the grid.
- 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.Binary64
-
The current implementation performs casting to a
int
. - INVALID_BRACKETING_PARAMETERS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INVALID_BRACKETING_PARAMETERS.
- INVALID_BRACKETING_PARAMETERS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.INVALID_BRACKETING_PARAMETERS.
- INVALID_IMPLEMENTATION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INVALID_IMPLEMENTATION.
- INVALID_IMPLEMENTATION - Enum constant in enum org.hipparchus.optim.LocalizedOptimFormats
-
INVALID_IMPLEMENTATION.
- INVALID_INTERVAL_INITIAL_VALUE_PARAMETERS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INVALID_INTERVAL_INITIAL_VALUE_PARAMETERS.
- INVALID_INTERVAL_INITIAL_VALUE_PARAMETERS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.INVALID_INTERVAL_INITIAL_VALUE_PARAMETERS.
- INVALID_ITERATIONS_LIMITS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INVALID_ITERATIONS_LIMITS.
- INVALID_ITERATIONS_LIMITS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.INVALID_ITERATIONS_LIMITS.
- INVALID_MAX_ITERATIONS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
INVALID_MAX_ITERATIONS.
- INVALID_MAX_ITERATIONS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INVALID_MAX_ITERATIONS.
- INVALID_REGRESSION_ARRAY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INVALID_REGRESSION_ARRAY.
- INVALID_REGRESSION_ARRAY - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.INVALID_REGRESSION_ARRAY.
- INVALID_REGRESSION_OBSERVATION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.INVALID_REGRESSION_OBSERVATION.
- INVALID_REGRESSION_OBSERVATION - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
INVALID_REGRESSION_OBSERVATION.
- INVALID_ROTATION_ORDER_NAME - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
INVALID_ROTATION_ORDER_NAME.
- InvalidRepresentationException - Exception in org.hipparchus.migration.genetics
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalStateException
- 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
-
Empty constructor.
- INVERSE - Enum constant in enum 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.
- inverseUnscentedTransform(RealVector[]) - Method in interface org.hipparchus.util.UnscentedTransformProvider
-
Perform the inverse unscented transform from an array of sigma points.
- invert(FieldMatrixDecomposer<T>) - Method in class org.hipparchus.analysis.differentiation.FieldTaylorMap
-
Invert the instance.
- invert(MatrixDecomposer) - Method in class org.hipparchus.analysis.differentiation.TaylorMap
-
Invert the instance.
- invGamma1pm1(double) - Static method in class org.hipparchus.special.Gamma
-
Returns the value of 1 / Γ(1 + x) - 1 for -0.5 ≤ x ≤ 1.5.
- invGamma1pm1(T) - 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
-
Check if bias is corrected.
- isBiasCorrected() - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Check if bias is corrected.
- isBiasCorrection() - Method in class org.hipparchus.stat.projection.PCA
-
Check whether scaling (correlation), if in use, adjusts for bias.
- 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.
- isConverged() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOptimizer
-
Check if convergence has been reached.
- isCounterClockWise() - Method in class org.hipparchus.complex.RootsOfUnity
- isCurrentStateInterpolated() - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Determines if the
current state
is computed directly by the integrator, or if it is calculated usinginterpolation
. - isCurrentStateInterpolated() - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Determines if the
current state
is computed directly by the integrator, or if it is calculated usinginterpolation
. - isCurrentStateInterpolated() - Method in interface org.hipparchus.ode.sampling.FieldODEStateInterpolator
-
Determines if the
current state
is computed directly by the integrator, or if it is calculated usinginterpolation
. - isCurrentStateInterpolated() - Method in interface org.hipparchus.ode.sampling.ODEStateInterpolator
-
Determines if the
current state
is computed directly by the integrator, or if it is calculated usinginterpolation
. - 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.
- isExisting() - Method in class org.hipparchus.util.AbstractOpenIntHashMap.InsertionHolder
-
Get indicator for value already present before insertion.
- isFinite() - Method in interface org.hipparchus.CalculusFieldElement
-
Check if the instance is finite (neither infinite nor NaN).
- isFormNormalEquations() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
-
Get if the normal equations are explicitly formed.
- isFormNormalEquations() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
-
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.events.AbstractFieldODEDetector
-
Check if the current propagation is forward or backward.
- isForward() - Method in class org.hipparchus.ode.events.AbstractODEDetector
-
Check if the current propagation is forward or backward.
- 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.
- isIncludeCollinearPoints() - Method in class org.hipparchus.geometry.euclidean.twod.hull.MonotoneChain
-
Returns if collinear points on the hull will be added as hull vertices.
- isInfinite() - Method in interface org.hipparchus.CalculusFieldElement
-
Check if the instance is infinite.
- 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
orDouble.NEGATIVE_INFINITY
) and neither part isNaN
. - isInfinite() - Method in class org.hipparchus.complex.FieldComplex
-
Checks whether either the real or imaginary part of this complex number takes an infinite value (either
Double.POSITIVE_INFINITY
orDouble.NEGATIVE_INFINITY
) and neither part isNaN
. - isInfinite() - Method in class org.hipparchus.dfp.Dfp
-
Check if the 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.FieldVector2D
-
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.Binary64
-
Returns
true
ifthis
double precision number is infinite (Double.POSITIVE_INFINITY
orDouble.NEGATIVE_INFINITY
). - isInteger() - Method in class org.hipparchus.fraction.BigFraction
-
Check if a fraction is an integer.
- isInteger() - Method in class org.hipparchus.fraction.Fraction
-
Check if a fraction is an integer.
- 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.
- isMathematicalInteger() - Method in class org.hipparchus.complex.Complex
-
Check whether the instance is an integer (i.e.
- isMathematicalInteger() - Method in class org.hipparchus.complex.FieldComplex
-
Check whether the instance is an integer (i.e.
- isMathematicalInteger(double) - Static method in class org.hipparchus.util.Precision
-
Check is x is a mathematical integer.
- isMathematicalInteger(float) - Static method in class org.hipparchus.util.Precision
-
Check is x is a mathematical integer.
- 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 interface org.hipparchus.CalculusFieldElement
-
Check if the instance is Not a Number.
- 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.complex.FieldComplex
-
Checks whether either or both parts of this complex number is
NaN
. - isNaN() - Method in class org.hipparchus.dfp.Dfp
-
Check if the 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.FieldVector2D
-
Returns true if any coordinate of this vector 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.Binary64
-
Returns
true
ifthis
double precision number is Not-a-Number (NaN
), false otherwise. - isNoIntercept() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Chekc if the model has no intercept term.
- 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.
- isPolishing() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Check if polishing is enabled.
- 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
-
Determines if the
previous state
is computed directly by the integrator, or if it is calculated usinginterpolation
. - isPreviousStateInterpolated() - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Determines if the
previous state
is computed directly by the integrator, or if it is calculated usinginterpolation
. - isPreviousStateInterpolated() - Method in interface org.hipparchus.ode.sampling.FieldODEStateInterpolator
-
Determines if the
previous state
is computed directly by the integrator, or if it is calculated usinginterpolation
. - isPreviousStateInterpolated() - Method in interface org.hipparchus.ode.sampling.ODEStateInterpolator
-
Determines if the
previous state
is computed directly by the integrator, or if it is calculated usinginterpolation
. - isPureQuaternion(double) - Method in class org.hipparchus.complex.Quaternion
-
Checks whether the instance is a pure quaternion within a given tolerance.
- isReal() - Method in class org.hipparchus.complex.Complex
-
Check whether the instance is real (i.e.
- isReal() - Method in class org.hipparchus.complex.FieldComplex
-
Check whether the instance is real (i.e.
- isRestrictedToNonNegative() - Method in class org.hipparchus.optim.linear.LinearOptimizer
-
Check if variables are restricted to non-negative values.
- isRestrictedToNonNegative() - Method in class org.hipparchus.optim.linear.NonNegativeConstraint
-
Indicates whether all the variables must be restricted to non-negative values.
- isScale() - Method in class org.hipparchus.stat.projection.PCA
-
Check whether scaling (correlation) or no scaling (covariance) is used.
- isScaling() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Check if scaling is enabled.
- 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
-
Returns
true
if this operator supportsRealLinearOperator.operateTranspose(RealVector)
. - isTriggeredOnIncreasing() - Method in enum org.hipparchus.ode.events.FilterType
-
Check if triggered events are increasing events.
- isUnitQuaternion(double) - Method in class org.hipparchus.complex.Quaternion
-
Checks whether the instance is a unit quaternion within a given tolerance.
- isUsingFieldCoefficients() - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Getter for the flag between real or Field coefficients in the Butcher array.
- isUsingFieldCoefficients() - Method in interface org.hipparchus.ode.nonstiff.FieldExplicitRungeKuttaIntegrator
-
Getter for the flag between real or Field coefficients in the Butcher array.
- isUsingFieldCoefficients() - Method in class org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegrator
-
Getter for the flag between real or Field coefficients in the Butcher array.
- 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.
- isValidPoint(T) - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
-
Indicates whether a point is within the interpolation range.
- isZero() - Method in class org.hipparchus.complex.Complex
-
Check if an element is semantically equal to zero.
- isZero() - Method in class org.hipparchus.complex.FieldComplex
-
Check if an element is semantically equal to zero.
- isZero() - Method in class org.hipparchus.dfp.Dfp
-
Check if instance is equal to zero.
- isZero() - Method in interface org.hipparchus.FieldElement
-
Check if an element is semantically equal to zero.
- isZero() - Method in class org.hipparchus.util.Binary64
-
Check if an element is semantically 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.
- iterate(RealVector...) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPKKT
-
Iterate Karush–Kuhn–Tucker equation from given list of Vector
- iterate(RealVector...) - Method in interface org.hipparchus.optim.nonlinear.vector.constrained.KarushKuhnTuckerSolver
-
Iterate Karush–Kuhn–Tucker equation from given list of Vector
- 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.BaseAbstractFieldUnivariateIntegrator
-
The iteration count.
- iterations - Variable in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
The iteration count.
- iterations - Variable in class org.hipparchus.optim.BaseOptimizer
-
Iterations counter.
- ITERATIONS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ITERATIONS.
- ITERATIONS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ITERATIONS.
- iterationStarted(IterationEvent) - Method in interface org.hipparchus.util.IterationListener
-
Invoked each time a new iteration is completed (in the main iteration loop).
- IterativeLegendreFieldGaussIntegrator<T extends CalculusFieldElement<T>> - 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.
- IterativeLegendreFieldGaussIntegrator(Field<T>, int, double, double) - Constructor for class org.hipparchus.analysis.integration.IterativeLegendreFieldGaussIntegrator
-
Builds an integrator with given accuracies.
- IterativeLegendreFieldGaussIntegrator(Field<T>, int, double, double, int, int) - Constructor for class org.hipparchus.analysis.integration.IterativeLegendreFieldGaussIntegrator
-
Builds an integrator with given accuracies and iterations counts.
- IterativeLegendreFieldGaussIntegrator(Field<T>, int, int, int) - Constructor for class org.hipparchus.analysis.integration.IterativeLegendreFieldGaussIntegrator
-
Builds an integrator with given iteration counts.
- 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
-
This is the base class for all events occurring during the iterations of a
IterativeLinearSolver
. - 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() - Constructor for class org.hipparchus.util.OpenIntToDoubleHashMap.Iterator
- Iterator() - Constructor for class org.hipparchus.util.OpenIntToFieldHashMap.Iterator
- ITERATOR_EXHAUSTED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ITERATOR_EXHAUSTED.
- ITERATOR_EXHAUSTED - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.ITERATOR_EXHAUSTED.
J
- J - Static variable in class org.hipparchus.complex.Quaternion
-
j
- jacobian(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.LinearBoundedConstraint
-
Returns the gradient of this function at (x)
- jacobian(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.LinearEqualityConstraint
- jacobian(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.LinearInequalityConstraint
- jacobian(RealVector) - Method in interface org.hipparchus.optim.nonlinear.vector.constrained.VectorDifferentiableFunction
-
Returns the gradient of this function at (x)
- JacobianFunction - Class in org.hipparchus.analysis.differentiation
-
Class representing the Jacobian of a multivariate vector function.
- JacobianFunction(MultivariateDifferentiableVectorFunction) - Constructor for class org.hipparchus.analysis.differentiation.JacobianFunction
-
Simple constructor.
- JacobianMatrices - Class in org.hipparchus.migration.ode
-
Deprecated.as of 1.0, replaced with
VariationalEquation
- JacobianMatrices(MainStateJacobianProvider, String...) - Constructor for class org.hipparchus.migration.ode.JacobianMatrices
-
Deprecated.Simple constructor for a secondary equations set computing Jacobian matrices.
- JacobianMatrices(OrdinaryDifferentialEquation, double[], String...) - Constructor for class org.hipparchus.migration.ode.JacobianMatrices
-
Deprecated.Simple constructor for a secondary equations set computing Jacobian matrices.
- JacobianMatrices.MismatchedEquations - Exception in org.hipparchus.migration.ode
-
Deprecated.Special exception for equations mismatch.
- JacobiElliptic - Class in org.hipparchus.special.elliptic.jacobi
-
Algorithm computing Jacobi elliptic functions.
- JacobiElliptic(double) - Constructor for class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Simple constructor.
- JacobiEllipticBuilder - Class in org.hipparchus.special.elliptic.jacobi
-
Builder for algorithms compmuting Jacobi elliptic functions.
- JacobiKey - Class in org.hipparchus.analysis.polynomials
-
Class for handling Jacobi polynomials keys.
- JacobiKey(int, int) - Constructor for class org.hipparchus.analysis.polynomials.JacobiKey
-
Simple constructor.
- JacobiPreconditioner - Class in org.hipparchus.linear
-
This class implements the standard Jacobi (diagonal) preconditioner.
- JacobiPreconditioner(double[], boolean) - Constructor for class org.hipparchus.linear.JacobiPreconditioner
-
Creates a new instance of this class.
- JacobiTheta - Class in org.hipparchus.special.elliptic.jacobi
-
Algorithm computing Jacobi theta functions.
- JacobiTheta(double) - Constructor for class org.hipparchus.special.elliptic.jacobi.JacobiTheta
-
Simple constructor.
- JDKRandomGenerator - Class in org.hipparchus.random
-
A
RandomGenerator
adapter that delegates the random number generation to the standardRandom
class. - JDKRandomGenerator() - Constructor for class org.hipparchus.random.JDKRandomGenerator
-
Creates an instance with an arbitrary seed.
- JDKRandomGenerator(long) - Constructor for class org.hipparchus.random.JDKRandomGenerator
-
Creates an instance with the given seed.
- JDKRandomGenerator(Random) - Constructor for class org.hipparchus.random.JDKRandomGenerator
-
Creates an instance that wraps the given
Random
instance. - JulierUnscentedTransform - Class in org.hipparchus.util
-
Unscented transform as defined by Julier and Uhlmann.
- JulierUnscentedTransform(int) - Constructor for class org.hipparchus.util.JulierUnscentedTransform
-
Default constructor.
- JulierUnscentedTransform(int, double) - Constructor for class org.hipparchus.util.JulierUnscentedTransform
-
Simple constructor.
K
- K - Static variable in class org.hipparchus.complex.Quaternion
-
k
- KalmanFilter<T extends Measurement> - Interface in org.hipparchus.filtering.kalman
-
Interface representing a Kalman filter.
- KarushKuhnTuckerSolver<T> - Interface in org.hipparchus.optim.nonlinear.vector.constrained
-
Karush–Kuhn–Tucker Solver.
- KendallsCorrelation - Class in org.hipparchus.stat.correlation
-
Implementation of Kendall's Tau-b rank correlation.
- KendallsCorrelation() - Constructor for class org.hipparchus.stat.correlation.KendallsCorrelation
-
Create a KendallsCorrelation instance without data.
- KendallsCorrelation(double[][]) - Constructor for class org.hipparchus.stat.correlation.KendallsCorrelation
-
Create a KendallsCorrelation from a rectangular array whose columns represent values of variables to be correlated.
- KendallsCorrelation(RealMatrix) - Constructor for class org.hipparchus.stat.correlation.KendallsCorrelation
-
Create a KendallsCorrelation from a RealMatrix whose columns represent variables to be correlated.
- key() - Method in class org.hipparchus.util.AbstractOpenIntHashMap.BaseIterator
-
Get the key of current entry.
- keysStatesHashCode() - Method in class org.hipparchus.util.AbstractOpenIntHashMap
-
Compute partial hashcode on keys and states.
- KMeansPlusPlusClusterer<T extends Clusterable> - Class in org.hipparchus.clustering
-
Clustering algorithm based on David Arthur and Sergei Vassilvitski k-means++ algorithm.
- KMeansPlusPlusClusterer(int) - Constructor for class org.hipparchus.clustering.KMeansPlusPlusClusterer
-
Build a clusterer.
- KMeansPlusPlusClusterer(int, int) - Constructor for class org.hipparchus.clustering.KMeansPlusPlusClusterer
-
Build a clusterer.
- KMeansPlusPlusClusterer(int, int, DistanceMeasure) - Constructor for class org.hipparchus.clustering.KMeansPlusPlusClusterer
-
Build a clusterer.
- KMeansPlusPlusClusterer(int, int, DistanceMeasure, RandomGenerator) - Constructor for class org.hipparchus.clustering.KMeansPlusPlusClusterer
-
Build a clusterer.
- KMeansPlusPlusClusterer(int, int, DistanceMeasure, RandomGenerator, KMeansPlusPlusClusterer.EmptyClusterStrategy) - Constructor for class org.hipparchus.clustering.KMeansPlusPlusClusterer
-
Build a clusterer.
- KMeansPlusPlusClusterer.EmptyClusterStrategy - Enum in org.hipparchus.clustering
-
Strategies to use for replacing an empty cluster.
- kolmogorovSmirnovStatistic(double[], double[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes the two-sample Kolmogorov-Smirnov test statistic, \(D_{n,m}=\sup_x |F_n(x)-F_m(x)|\) where \(n\) is the length of
x
, \(m\) is the length ofy
, \(F_n\) is the empirical distribution that puts mass \(1/n\) at each of the values inx
and \(F_m\) is the empirical distribution of they
values. - kolmogorovSmirnovStatistic(double[], double[]) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Computes the two-sample Kolmogorov-Smirnov test statistic, \(D_{n,m}=\sup_x |F_n(x)-F_m(x)|\) where \(n\) is the length of
x
, \(m\) is the length ofy
, \(F_n\) is the empirical distribution that puts mass \(1/n\) at each of the values inx
and \(F_m\) is the empirical distribution of they
values. - kolmogorovSmirnovStatistic(RealDistribution, double[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes the one-sample Kolmogorov-Smirnov test statistic, \(D_n=\sup_x |F_n(x)-F(x)|\) where \(F\) is the distribution (cdf) function associated with
distribution
, \(n\) is the length ofdata
and \(F_n\) is the empirical distribution that puts mass \(1/n\) at each of the values indata
. - kolmogorovSmirnovStatistic(RealDistribution, double[]) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Computes the one-sample Kolmogorov-Smirnov test statistic, \(D_n=\sup_x |F_n(x)-F(x)|\) where \(F\) is the distribution (cdf) function associated with
distribution
, \(n\) is the length ofdata
and \(F_n\) is the empirical distribution that puts mass \(1/n\) at each of the values indata
. - kolmogorovSmirnovTest(double[], double[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes the p-value, or observed significance level, of a two-sample Kolmogorov-Smirnov test evaluating the null hypothesis that
x
andy
are samples drawn from the same probability distribution. - kolmogorovSmirnovTest(double[], double[]) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Computes the p-value, or observed significance level, of a two-sample Kolmogorov-Smirnov test evaluating the null hypothesis that
x
andy
are samples drawn from the same probability distribution. - kolmogorovSmirnovTest(double[], double[], boolean) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes the p-value, or observed significance level, of a two-sample Kolmogorov-Smirnov test evaluating the null hypothesis that
x
andy
are samples drawn from the same probability distribution. - kolmogorovSmirnovTest(double[], double[], boolean) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Computes the p-value, or observed significance level, of a two-sample Kolmogorov-Smirnov test evaluating the null hypothesis that
x
andy
are samples drawn from the same probability distribution. - kolmogorovSmirnovTest(RealDistribution, double[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes the p-value, or observed significance level, of a one-sample Kolmogorov-Smirnov test evaluating the null hypothesis that
data
conforms todistribution
. - kolmogorovSmirnovTest(RealDistribution, double[]) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Computes the p-value, or observed significance level, of a one-sample Kolmogorov-Smirnov test evaluating the null hypothesis that
data
conforms todistribution
. - kolmogorovSmirnovTest(RealDistribution, double[], boolean) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes the p-value, or observed significance level, of a one-sample Kolmogorov-Smirnov test evaluating the null hypothesis that
data
conforms todistribution
. - kolmogorovSmirnovTest(RealDistribution, double[], boolean) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Computes the p-value, or observed significance level, of a one-sample Kolmogorov-Smirnov test evaluating the null hypothesis that
data
conforms todistribution
. - kolmogorovSmirnovTest(RealDistribution, double[], double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Performs a Kolmogorov-Smirnov test evaluating the null hypothesis that
data
conforms todistribution
. - kolmogorovSmirnovTest(RealDistribution, double[], double) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Performs a Kolmogorov-Smirnov test evaluating the null hypothesis that
data
conforms todistribution
. - KolmogorovSmirnovTest - Class in org.hipparchus.stat.inference
-
Implementation of the Kolmogorov-Smirnov (K-S) test for equality of continuous distributions.
- KolmogorovSmirnovTest() - Constructor for class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Construct a KolmogorovSmirnovTest instance.
- KolmogorovSmirnovTest(long) - Constructor for class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Construct a KolmogorovSmirnovTest instance providing a seed for the PRNG used by the
KolmogorovSmirnovTest.bootstrap(double[], double[], int)
method. - kroneckerProduct(RealMatrix) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Kronecker product of the current matrix and the parameter matrix.
- KS_SUM_CAUCHY_CRITERION - Static variable in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Convergence criterion for
KolmogorovSmirnovTest.ksSum(double, double, int)
- ksSum(double, double, int) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Computes \( 1 + 2 \sum_{i=1}^\infty (-1)^i e^{-2 i^2 t^2} \) stopping when successive partial sums are within
tolerance
of one another, or whenmaxIterations
partial sums have been computed. - KthSelector - Class in org.hipparchus.util
-
A Simple Kth selector implementation to pick up the Kth ordered element from a work array containing the input numbers.
- KthSelector() - Constructor for class org.hipparchus.util.KthSelector
-
Constructor with default
median of 3
pivoting strategy. - KthSelector(PivotingStrategy) - Constructor for class org.hipparchus.util.KthSelector
-
Constructor with specified pivoting strategy
- Kurtosis - Class in org.hipparchus.stat.descriptive.moment
-
Computes the Kurtosis of the available values.
- Kurtosis() - Constructor for class org.hipparchus.stat.descriptive.moment.Kurtosis
-
Construct a Kurtosis.
- Kurtosis(FourthMoment) - Constructor for class org.hipparchus.stat.descriptive.moment.Kurtosis
-
Construct a Kurtosis from an external moment.
- Kurtosis(Kurtosis) - Constructor for class org.hipparchus.stat.descriptive.moment.Kurtosis
-
Copy constructor, creates a new
Kurtosis
identical to theoriginal
.
L
- LagrangeSolution - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Container for Lagrange t-uple.
- LagrangeSolution(RealVector, RealVector, double) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.LagrangeSolution
-
Simple constructor.
- lagrangianGradX(RealVector, RealMatrix, RealVector, RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.AbstractSQPOptimizer
-
Compute Lagrangian gradient for variable X
- laguerre(int) - Method in class org.hipparchus.analysis.integration.gauss.FieldGaussIntegratorFactory
-
Creates a Gauss-Laguerre integrator of the given order.
- laguerre(int) - Method in class org.hipparchus.analysis.integration.gauss.GaussIntegratorFactory
-
Creates a Gauss-Laguerre integrator of the given order.
- LaguerreRuleFactory - Class in org.hipparchus.analysis.integration.gauss
-
Factory that creates Gauss-type quadrature rule using Laguerre polynomials.
- LaguerreRuleFactory() - Constructor for class org.hipparchus.analysis.integration.gauss.LaguerreRuleFactory
-
Empty constructor.
- LaguerreSolver - Class in org.hipparchus.analysis.solvers
-
Implements the Laguerre's Method for root finding of real coefficient polynomials.
- LaguerreSolver() - Constructor for class org.hipparchus.analysis.solvers.LaguerreSolver
-
Construct a solver with default accuracy (1e-6).
- LaguerreSolver(double) - Constructor for class org.hipparchus.analysis.solvers.LaguerreSolver
-
Construct a solver.
- LaguerreSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.LaguerreSolver
-
Construct a solver.
- LaguerreSolver(double, double, double) - Constructor for class org.hipparchus.analysis.solvers.LaguerreSolver
-
Construct a solver.
- lanczos(double) - Static method in class org.hipparchus.special.Gamma
-
Returns the Lanczos approximation used to compute the gamma function.
- lanczos(T) - Static method in class org.hipparchus.special.Gamma
-
Returns the Lanczos approximation used to compute the gamma function.
- LANCZOS_G - Static variable in class org.hipparchus.special.Gamma
-
The value of the
g
constant in the Lanczos approximation, seeGamma.lanczos(double)
. - LaplaceDistribution - Class in org.hipparchus.distribution.continuous
-
This class implements the Laplace distribution.
- LaplaceDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.LaplaceDistribution
-
Build a new instance.
- LARGE_SAMPLE_PRODUCT - Static variable in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
When product of sample sizes exceeds this value, 2-sample K-S test uses asymptotic distribution to compute the p-value.
- LARGEST_POINTS_NUMBER - Enum constant in enum org.hipparchus.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
-
Split the cluster with largest number of points.
- LARGEST_VARIANCE - Enum constant in enum org.hipparchus.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
-
Split the cluster with largest distance variance.
- LAST - Enum constant in enum org.hipparchus.ode.sampling.StepNormalizerBounds
-
Include the last point, but not the first point.
- lastIncluded() - Method in enum org.hipparchus.ode.sampling.StepNormalizerBounds
-
Returns a value indicating whether the last point should be passed to the underlying fixed step size step handler.
- lazyEvaluation(boolean) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure whether evaluation will be lazy or not.
- lcm(int, int) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Returns the least common multiple of the absolute value of two numbers, using the formula
lcm(a,b) = (a / gcd(a,b)) * b
. - lcm(long, long) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Returns the least common multiple of the absolute value of two numbers, using the formula
lcm(a,b) = (a / gcd(a,b)) * b
. - lcm(BigFraction) - Method in class org.hipparchus.fraction.BigFraction
-
Rational number least common multiple.
- lcm(Fraction) - Method in class org.hipparchus.fraction.Fraction
-
Rational number least common multiple.
- LCM_OVERFLOW_32_BITS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
LCM_OVERFLOW_32_BITS.
- LCM_OVERFLOW_32_BITS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.LCM_OVERFLOW_32_BITS.
- LCM_OVERFLOW_64_BITS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
LCM_OVERFLOW_64_BITS.
- LCM_OVERFLOW_64_BITS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.LCM_OVERFLOW_64_BITS.
- LeastSquaresAdapter - Class in org.hipparchus.optim.nonlinear.vector.leastsquares
-
An adapter that delegates to another implementation of
LeastSquaresProblem
. - LeastSquaresAdapter(LeastSquaresProblem) - Constructor for class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
-
Delegate the
LeastSquaresProblem
interface to the given implementation. - LeastSquaresBuilder - Class in org.hipparchus.optim.nonlinear.vector.leastsquares
-
A mutable builder for
LeastSquaresProblem
s. - LeastSquaresBuilder() - Constructor for class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Empty constructor.
- LeastSquaresConverter - Class in org.hipparchus.optim.nonlinear.scalar
-
This class converts
vectorial objective functions
toscalar objective functions
when the goal is to minimize them. - LeastSquaresConverter(MultivariateVectorFunction, double[]) - Constructor for class org.hipparchus.optim.nonlinear.scalar.LeastSquaresConverter
-
Builds a simple converter for uncorrelated residuals with identical weights.
- LeastSquaresConverter(MultivariateVectorFunction, double[], double[]) - Constructor for class org.hipparchus.optim.nonlinear.scalar.LeastSquaresConverter
-
Builds a simple converter for uncorrelated residuals with the specified weights.
- LeastSquaresConverter(MultivariateVectorFunction, double[], RealMatrix) - Constructor for class org.hipparchus.optim.nonlinear.scalar.LeastSquaresConverter
-
Builds a simple converter for correlated residuals with the specified weights.
- LeastSquaresFactory - Class in org.hipparchus.optim.nonlinear.vector.leastsquares
-
A Factory for creating
LeastSquaresProblem
s. - LeastSquaresOptimizer - Interface in org.hipparchus.optim.nonlinear.vector.leastsquares
-
An algorithm that can be applied to a non-linear least squares problem.
- LeastSquaresOptimizer.Optimum - Interface in org.hipparchus.optim.nonlinear.vector.leastsquares
-
The optimum found by the optimizer.
- LeastSquaresProblem - Interface in org.hipparchus.optim.nonlinear.vector.leastsquares
-
The data necessary to define a non-linear least squares problem.
- LeastSquaresProblem.Evaluation - Interface in org.hipparchus.optim.nonlinear.vector.leastsquares
-
An evaluation of a
LeastSquaresProblem
at a particular point. - LEFT_SIDE - Enum constant in enum org.hipparchus.analysis.solvers.AllowedSolution
-
Only solutions that are less than or equal to the actual root are acceptable as solutions for root-finding.
- LEGACY - Enum constant in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
This is the default type used in the
Percentile
.This method has the following formulae for index and estimates
\( \begin{align} &index = (N+1)p\ \\ &estimate = x_{\lceil h\,-\,1/2 \rceil} \\ &minLimit = 0 \\ &maxLimit = 1 \\ \end{align}\) - legendre(int) - Method in class org.hipparchus.analysis.integration.gauss.FieldGaussIntegratorFactory
-
Creates a Gauss-Legendre integrator of the given order.
- legendre(int) - Method in class org.hipparchus.analysis.integration.gauss.GaussIntegratorFactory
-
Creates a Gauss-Legendre integrator of the given order.
- legendre(int, double, double) - Method in class org.hipparchus.analysis.integration.gauss.GaussIntegratorFactory
-
Creates a Gauss-Legendre integrator of the given order.
- legendre(int, T, T) - Method in class org.hipparchus.analysis.integration.gauss.FieldGaussIntegratorFactory
-
Creates a Gauss-Legendre integrator of the given order.
- LegendreEllipticIntegral - Class in org.hipparchus.special.elliptic.legendre
-
Complete and incomplete elliptic integrals in Legendre form.
- legendreHighPrecision(int) - Method in class org.hipparchus.analysis.integration.gauss.GaussIntegratorFactory
-
Creates a Gauss-Legendre integrator of the given order.
- legendreHighPrecision(int, double, double) - Method in class org.hipparchus.analysis.integration.gauss.GaussIntegratorFactory
-
Creates an integrator of the given order, and whose call to the
integrate
method will perform an integration on the given interval. - LegendreRuleFactory - Class in org.hipparchus.analysis.integration.gauss
-
Factory that creates Gauss-type quadrature rule using Legendre polynomials.
- LegendreRuleFactory() - Constructor for class org.hipparchus.analysis.integration.gauss.LegendreRuleFactory
-
Empty constructor.
- LENGTH - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
LENGTH.
- LENGTH - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.LENGTH.
- LEQ - Enum constant in enum org.hipparchus.optim.linear.Relationship
-
Lesser than or equal relationship.
- LESS_THAN - Enum constant in enum org.hipparchus.stat.inference.AlternativeHypothesis
-
Represents a left-sided test.
- lessThan(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Check if instance is less than x.
- LevenbergMarquardtOptimizer - Class in org.hipparchus.optim.nonlinear.vector.leastsquares
-
This class solves a least-squares problem using the Levenberg-Marquardt algorithm.
- LevenbergMarquardtOptimizer() - Constructor for class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Default constructor.
- LevenbergMarquardtOptimizer(double, double, double, double, double) - Constructor for class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Construct an instance with all parameters specified.
- LevyDistribution - Class in org.hipparchus.distribution.continuous
-
This class implements the Lévy distribution.
- LevyDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.LevyDistribution
-
Build a new instance.
- LimitAngle - Class in org.hipparchus.geometry.spherical.oned
-
This class represents a 1D oriented hyperplane on the circle.
- LimitAngle(S1Point, boolean, double) - Constructor for class org.hipparchus.geometry.spherical.oned.LimitAngle
-
Simple constructor.
- Line - Class in org.hipparchus.geometry.euclidean.threed
-
The class represent lines in a three dimensional space.
- Line - Class in org.hipparchus.geometry.euclidean.twod
-
This class represents an oriented line in the 2D plane.
- Line(Line) - Constructor for class org.hipparchus.geometry.euclidean.threed.Line
-
Copy constructor.
- Line(Vector3D, Vector3D, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.Line
-
Build a line from two points.
- Line(Line) - Constructor for class org.hipparchus.geometry.euclidean.twod.Line
-
Copy constructor.
- Line(Vector2D, double, double) - Constructor for class org.hipparchus.geometry.euclidean.twod.Line
-
Build a line from a point and an angle.
- Line(Vector2D, Vector2D, double) - Constructor for class org.hipparchus.geometry.euclidean.twod.Line
-
Build a line from two points.
- LinearBoundedConstraint - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
A set of linear inequality constraints expressed as ub>Ax>lb.
- LinearBoundedConstraint(double[][], double[], double[]) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.LinearBoundedConstraint
-
Construct a set of linear inequality constraints from Ax < B
- LinearBoundedConstraint(RealMatrix, RealVector, RealVector) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.LinearBoundedConstraint
-
Construct a set of linear inequality constraints from Ax < B
- linearCombination(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Compute a linear combination accurately.
- linearCombination(double[], DerivativeStructure[]) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute a linear combination.
- linearCombination(double[], FieldDerivativeStructure<T>[]) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute a linear combination.
- linearCombination(double[], FieldGradient<T>[]) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute a linear combination.
- linearCombination(double[], FieldUnivariateDerivative1<T>[]) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute a linear combination.
- linearCombination(double[], FieldUnivariateDerivative2<T>[]) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute a linear combination.
- linearCombination(double[], Gradient[]) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute a linear combination.
- linearCombination(double[], SparseGradient[]) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute a linear combination.
- linearCombination(double[], UnivariateDerivative1[]) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute a linear combination.
- linearCombination(double[], UnivariateDerivative2[]) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute a linear combination.
- linearCombination(double[], Complex[]) - Method in class org.hipparchus.complex.Complex
-
Compute a linear combination.
- linearCombination(double[], FieldComplex<T>[]) - Method in class org.hipparchus.complex.FieldComplex
-
Compute a linear combination.
- linearCombination(double[], Dfp[]) - Method in class org.hipparchus.dfp.Dfp
-
Compute a linear combination.
- linearCombination(double[], Binary64[]) - Method in class org.hipparchus.util.Binary64
-
Compute a linear combination.
- linearCombination(double[], FieldTuple<T>[]) - Method in class org.hipparchus.util.FieldTuple
-
Compute a linear combination.
- linearCombination(double[], Tuple[]) - Method in class org.hipparchus.util.Tuple
-
Compute a linear combination.
- linearCombination(double[], T[]) - Method in interface org.hipparchus.CalculusFieldElement
-
Compute a linear combination.
- linearCombination(double, double[], int, double, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute linear combination.
- linearCombination(double, double[], int, double, double[], int, double, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute linear combination.
- linearCombination(double, double[], int, double, double[], int, double, double[], int, double, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute linear combination.
- linearCombination(double, double, double, double) - Static method in class org.hipparchus.util.MathArrays
-
Compute a linear combination accurately.
- linearCombination(double, double, double, double, double, double) - Static method in class org.hipparchus.util.MathArrays
-
Compute a linear combination accurately.
- linearCombination(double, double, double, double, double, double, double, double) - Static method in class org.hipparchus.util.MathArrays
-
Compute a linear combination accurately.
- linearCombination(double, DerivativeStructure, double, DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute a linear combination.
- linearCombination(double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute a linear combination.
- linearCombination(double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute a linear combination.
- linearCombination(double, FieldDerivativeStructure<T>, double, FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute a linear combination.
- linearCombination(double, FieldDerivativeStructure<T>, double, FieldDerivativeStructure<T>, double, FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute a linear combination.
- linearCombination(double, FieldDerivativeStructure<T>, double, FieldDerivativeStructure<T>, double, FieldDerivativeStructure<T>, double, FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute a linear combination.
- linearCombination(double, FieldGradient<T>, double, FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute a linear combination.
- linearCombination(double, FieldGradient<T>, double, FieldGradient<T>, double, FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute a linear combination.
- linearCombination(double, FieldGradient<T>, double, FieldGradient<T>, double, FieldGradient<T>, double, FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute a linear combination.
- linearCombination(double, FieldUnivariateDerivative1<T>, double, FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute a linear combination.
- linearCombination(double, FieldUnivariateDerivative1<T>, double, FieldUnivariateDerivative1<T>, double, FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute a linear combination.
- linearCombination(double, FieldUnivariateDerivative1<T>, double, FieldUnivariateDerivative1<T>, double, FieldUnivariateDerivative1<T>, double, FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute a linear combination.
- linearCombination(double, FieldUnivariateDerivative2<T>, double, FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute a linear combination.
- linearCombination(double, FieldUnivariateDerivative2<T>, double, FieldUnivariateDerivative2<T>, double, FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute a linear combination.
- linearCombination(double, FieldUnivariateDerivative2<T>, double, FieldUnivariateDerivative2<T>, double, FieldUnivariateDerivative2<T>, double, FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute a linear combination.
- linearCombination(double, Gradient, double, Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute a linear combination.
- linearCombination(double, Gradient, double, Gradient, double, Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute a linear combination.
- linearCombination(double, Gradient, double, Gradient, double, Gradient, double, Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute a linear combination.
- linearCombination(double, SparseGradient, double, SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute a linear combination.
- linearCombination(double, SparseGradient, double, SparseGradient, double, SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute a linear combination.
- linearCombination(double, SparseGradient, double, SparseGradient, double, SparseGradient, double, SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute a linear combination.
- linearCombination(double, UnivariateDerivative1, double, UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute a linear combination.
- linearCombination(double, UnivariateDerivative1, double, UnivariateDerivative1, double, UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute a linear combination.
- linearCombination(double, UnivariateDerivative1, double, UnivariateDerivative1, double, UnivariateDerivative1, double, UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute a linear combination.
- linearCombination(double, UnivariateDerivative2, double, UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute a linear combination.
- linearCombination(double, UnivariateDerivative2, double, UnivariateDerivative2, double, UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute a linear combination.
- linearCombination(double, UnivariateDerivative2, double, UnivariateDerivative2, double, UnivariateDerivative2, double, UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute a linear combination.
- linearCombination(double, Complex, double, Complex) - Method in class org.hipparchus.complex.Complex
-
Compute a linear combination.
- linearCombination(double, Complex, double, Complex, double, Complex) - Method in class org.hipparchus.complex.Complex
-
Compute a linear combination.
- linearCombination(double, Complex, double, Complex, double, Complex, double, Complex) - Method in class org.hipparchus.complex.Complex
-
Compute a linear combination.
- linearCombination(double, FieldComplex<T>, double, FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
Compute a linear combination.
- linearCombination(double, FieldComplex<T>, double, FieldComplex<T>, double, FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
Compute a linear combination.
- linearCombination(double, FieldComplex<T>, double, FieldComplex<T>, double, FieldComplex<T>, double, FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
Compute a linear combination.
- linearCombination(double, Dfp, double, Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Compute a linear combination.
- linearCombination(double, Dfp, double, Dfp, double, Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Compute a linear combination.
- linearCombination(double, Dfp, double, Dfp, double, Dfp, double, Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Compute a linear combination.
- linearCombination(double, Binary64, double, Binary64) - Method in class org.hipparchus.util.Binary64
-
Compute a linear combination.
- linearCombination(double, Binary64, double, Binary64, double, Binary64) - Method in class org.hipparchus.util.Binary64
-
Compute a linear combination.
- linearCombination(double, Binary64, double, Binary64, double, Binary64, double, Binary64) - Method in class org.hipparchus.util.Binary64
-
Compute a linear combination.
- linearCombination(double, FieldTuple<T>, double, FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Compute a linear combination.
- linearCombination(double, FieldTuple<T>, double, FieldTuple<T>, double, FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Compute a linear combination.
- linearCombination(double, FieldTuple<T>, double, FieldTuple<T>, double, FieldTuple<T>, double, FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Compute a linear combination.
- linearCombination(double, Tuple, double, Tuple) - Method in class org.hipparchus.util.Tuple
-
Compute a linear combination.
- linearCombination(double, Tuple, double, Tuple, double, Tuple) - Method in class org.hipparchus.util.Tuple
-
Compute a linear combination.
- linearCombination(double, Tuple, double, Tuple, double, Tuple, double, Tuple) - Method in class org.hipparchus.util.Tuple
-
Compute a linear combination.
- linearCombination(double, T[], int, double, T[], int, double, T[], int, double, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute linear combination.
- linearCombination(double, T[], int, double, T[], int, double, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute linear combination.
- linearCombination(double, T[], int, double, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute linear combination.
- linearCombination(double, T, double, T) - Method in interface org.hipparchus.CalculusFieldElement
-
Compute a linear combination.
- linearCombination(double, T, double, T, double, T) - Method in interface org.hipparchus.CalculusFieldElement
-
Compute a linear combination.
- linearCombination(double, T, double, T, double, T, double, T) - Method in interface org.hipparchus.CalculusFieldElement
-
Compute a linear combination.
- linearCombination(DerivativeStructure[], DerivativeStructure[]) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute a linear combination.
- linearCombination(DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute a linear combination.
- linearCombination(DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute a linear combination.
- linearCombination(DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute a linear combination.
- linearCombination(FieldDerivativeStructure<T>[], FieldDerivativeStructure<T>[]) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute a linear combination.
- linearCombination(FieldDerivativeStructure<T>, FieldDerivativeStructure<T>, FieldDerivativeStructure<T>, FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute a linear combination.
- linearCombination(FieldDerivativeStructure<T>, FieldDerivativeStructure<T>, FieldDerivativeStructure<T>, FieldDerivativeStructure<T>, FieldDerivativeStructure<T>, FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute a linear combination.
- linearCombination(FieldDerivativeStructure<T>, FieldDerivativeStructure<T>, FieldDerivativeStructure<T>, FieldDerivativeStructure<T>, FieldDerivativeStructure<T>, FieldDerivativeStructure<T>, FieldDerivativeStructure<T>, FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute a linear combination.
- linearCombination(FieldGradient<T>[], FieldGradient<T>[]) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute a linear combination.
- linearCombination(FieldGradient<T>, FieldGradient<T>, FieldGradient<T>, FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute a linear combination.
- linearCombination(FieldGradient<T>, FieldGradient<T>, FieldGradient<T>, FieldGradient<T>, FieldGradient<T>, FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute a linear combination.
- linearCombination(FieldGradient<T>, FieldGradient<T>, FieldGradient<T>, FieldGradient<T>, FieldGradient<T>, FieldGradient<T>, FieldGradient<T>, FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute a linear combination.
- linearCombination(FieldUnivariateDerivative1<T>[], FieldUnivariateDerivative1<T>[]) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute a linear combination.
- linearCombination(FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute a linear combination.
- linearCombination(FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute a linear combination.
- linearCombination(FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>, FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute a linear combination.
- linearCombination(FieldUnivariateDerivative2<T>[], FieldUnivariateDerivative2<T>[]) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute a linear combination.
- linearCombination(FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute a linear combination.
- linearCombination(FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute a linear combination.
- linearCombination(FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>, FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute a linear combination.
- linearCombination(Gradient[], Gradient[]) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute a linear combination.
- linearCombination(Gradient, Gradient, Gradient, Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute a linear combination.
- linearCombination(Gradient, Gradient, Gradient, Gradient, Gradient, Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute a linear combination.
- linearCombination(Gradient, Gradient, Gradient, Gradient, Gradient, Gradient, Gradient, Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute a linear combination.
- linearCombination(SparseGradient[], SparseGradient[]) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute a linear combination.
- linearCombination(SparseGradient, SparseGradient, SparseGradient, SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute a linear combination.
- linearCombination(SparseGradient, SparseGradient, SparseGradient, SparseGradient, SparseGradient, SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute a linear combination.
- linearCombination(SparseGradient, SparseGradient, SparseGradient, SparseGradient, SparseGradient, SparseGradient, SparseGradient, SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute a linear combination.
- linearCombination(UnivariateDerivative1[], UnivariateDerivative1[]) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute a linear combination.
- linearCombination(UnivariateDerivative1, UnivariateDerivative1, UnivariateDerivative1, UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute a linear combination.
- linearCombination(UnivariateDerivative1, UnivariateDerivative1, UnivariateDerivative1, UnivariateDerivative1, UnivariateDerivative1, UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute a linear combination.
- linearCombination(UnivariateDerivative1, UnivariateDerivative1, UnivariateDerivative1, UnivariateDerivative1, UnivariateDerivative1, UnivariateDerivative1, UnivariateDerivative1, UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute a linear combination.
- linearCombination(UnivariateDerivative2[], UnivariateDerivative2[]) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute a linear combination.
- linearCombination(UnivariateDerivative2, UnivariateDerivative2, UnivariateDerivative2, UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute a linear combination.
- linearCombination(UnivariateDerivative2, UnivariateDerivative2, UnivariateDerivative2, UnivariateDerivative2, UnivariateDerivative2, UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute a linear combination.
- linearCombination(UnivariateDerivative2, UnivariateDerivative2, UnivariateDerivative2, UnivariateDerivative2, UnivariateDerivative2, UnivariateDerivative2, UnivariateDerivative2, UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute a linear combination.
- linearCombination(Complex[], Complex[]) - Method in class org.hipparchus.complex.Complex
-
Compute a linear combination.
- linearCombination(Complex, Complex, Complex, Complex) - Method in class org.hipparchus.complex.Complex
-
Compute a linear combination.
- linearCombination(Complex, Complex, Complex, Complex, Complex, Complex) - Method in class org.hipparchus.complex.Complex
-
Compute a linear combination.
- linearCombination(Complex, Complex, Complex, Complex, Complex, Complex, Complex, Complex) - Method in class org.hipparchus.complex.Complex
-
Compute a linear combination.
- linearCombination(FieldComplex<T>[], FieldComplex<T>[]) - Method in class org.hipparchus.complex.FieldComplex
-
Compute a linear combination.
- linearCombination(FieldComplex<T>, FieldComplex<T>, FieldComplex<T>, FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
Compute a linear combination.
- linearCombination(FieldComplex<T>, FieldComplex<T>, FieldComplex<T>, FieldComplex<T>, FieldComplex<T>, FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
Compute a linear combination.
- linearCombination(FieldComplex<T>, FieldComplex<T>, FieldComplex<T>, FieldComplex<T>, FieldComplex<T>, FieldComplex<T>, FieldComplex<T>, FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
Compute a linear combination.
- linearCombination(Dfp[], Dfp[]) - Method in class org.hipparchus.dfp.Dfp
-
Compute a linear combination.
- linearCombination(Dfp, Dfp, Dfp, Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Compute a linear combination.
- linearCombination(Dfp, Dfp, Dfp, Dfp, Dfp, Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Compute a linear combination.
- linearCombination(Dfp, Dfp, Dfp, Dfp, Dfp, Dfp, Dfp, Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Compute a linear combination.
- linearCombination(Binary64[], Binary64[]) - Method in class org.hipparchus.util.Binary64
-
Compute a linear combination.
- linearCombination(Binary64, Binary64, Binary64, Binary64) - Method in class org.hipparchus.util.Binary64
-
Compute a linear combination.
- linearCombination(Binary64, Binary64, Binary64, Binary64, Binary64, Binary64) - Method in class org.hipparchus.util.Binary64
-
Compute a linear combination.
- linearCombination(Binary64, Binary64, Binary64, Binary64, Binary64, Binary64, Binary64, Binary64) - Method in class org.hipparchus.util.Binary64
-
Compute a linear combination.
- linearCombination(FieldTuple<T>[], FieldTuple<T>[]) - Method in class org.hipparchus.util.FieldTuple
-
Compute a linear combination.
- linearCombination(FieldTuple<T>, FieldTuple<T>, FieldTuple<T>, FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Compute a linear combination.
- linearCombination(FieldTuple<T>, FieldTuple<T>, FieldTuple<T>, FieldTuple<T>, FieldTuple<T>, FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Compute a linear combination.
- linearCombination(FieldTuple<T>, FieldTuple<T>, FieldTuple<T>, FieldTuple<T>, FieldTuple<T>, FieldTuple<T>, FieldTuple<T>, FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Compute a linear combination.
- linearCombination(Tuple[], Tuple[]) - Method in class org.hipparchus.util.Tuple
-
Compute a linear combination.
- linearCombination(Tuple, Tuple, Tuple, Tuple) - Method in class org.hipparchus.util.Tuple
-
Compute a linear combination.
- linearCombination(Tuple, Tuple, Tuple, Tuple, Tuple, Tuple) - Method in class org.hipparchus.util.Tuple
-
Compute a linear combination.
- linearCombination(Tuple, Tuple, Tuple, Tuple, Tuple, Tuple, Tuple, Tuple) - Method in class org.hipparchus.util.Tuple
-
Compute a linear combination.
- linearCombination(T[], FieldDerivativeStructure<T>[]) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute a linear combination.
- linearCombination(T[], FieldGradient<T>[]) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute a linear combination.
- linearCombination(T[], FieldUnivariateDerivative1<T>[]) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute a linear combination.
- linearCombination(T[], FieldUnivariateDerivative2<T>[]) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute a linear combination.
- linearCombination(T[], T[]) - Method in interface org.hipparchus.CalculusFieldElement
-
Compute a linear combination.
- linearCombination(T, FieldDerivativeStructure<T>, T, FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute a linear combination.
- linearCombination(T, FieldDerivativeStructure<T>, T, FieldDerivativeStructure<T>, T, FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute a linear combination.
- linearCombination(T, FieldDerivativeStructure<T>, T, FieldDerivativeStructure<T>, T, FieldDerivativeStructure<T>, T, FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute a linear combination.
- linearCombination(T, FieldGradient<T>, T, FieldGradient<T>, T, FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute a linear combination.
- linearCombination(T, FieldUnivariateDerivative1<T>, T, FieldUnivariateDerivative1<T>, T, FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute a linear combination.
- linearCombination(T, FieldUnivariateDerivative2<T>, T, FieldUnivariateDerivative2<T>, T, FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute a linear combination.
- linearCombination(T, T[], int, T, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute linear combination.
- linearCombination(T, T[], int, T, T[], int, T, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute linear combination.
- linearCombination(T, T[], int, T, T[], int, T, T[], int, T, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute linear combination.
- linearCombination(T, T, T, T) - Method in interface org.hipparchus.CalculusFieldElement
-
Compute a linear combination.
- linearCombination(T, T, T, T, T, T) - Method in interface org.hipparchus.CalculusFieldElement
-
Compute a linear combination.
- linearCombination(T, T, T, T, T, T, T, T) - Method in interface org.hipparchus.CalculusFieldElement
-
Compute a linear combination.
- LinearConstraint - Class in org.hipparchus.optim.linear
-
A linear constraint for a linear optimization problem.
- LinearConstraint(double[], double, Relationship, double[], double) - Constructor for class org.hipparchus.optim.linear.LinearConstraint
-
Build a constraint involving two linear equations.
- LinearConstraint(double[], Relationship, double) - Constructor for class org.hipparchus.optim.linear.LinearConstraint
-
Build a constraint involving a single linear equation.
- LinearConstraint(RealVector, double, Relationship, RealVector, double) - Constructor for class org.hipparchus.optim.linear.LinearConstraint
-
Build a constraint involving two linear equations.
- LinearConstraint(RealVector, Relationship, double) - Constructor for class org.hipparchus.optim.linear.LinearConstraint
-
Build a constraint involving a single linear equation.
- LinearConstraintSet - Class in org.hipparchus.optim.linear
-
Class that represents a set of
linear constraints
. - LinearConstraintSet(Collection<LinearConstraint>) - Constructor for class org.hipparchus.optim.linear.LinearConstraintSet
-
Creates a set containing the given constraints.
- LinearConstraintSet(LinearConstraint...) - Constructor for class org.hipparchus.optim.linear.LinearConstraintSet
-
Creates a set containing the given constraints.
- LinearEqualityConstraint - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
A set of linear equality constraints given as Ax = b.
- LinearEqualityConstraint(double[][], double[]) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.LinearEqualityConstraint
-
Construct a set of linear equality constraints ax = b.
- LinearEqualityConstraint(RealMatrix, RealVector) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.LinearEqualityConstraint
-
Construct a set of linear equality constraints ax = b.
- LinearEvolution - Class in org.hipparchus.filtering.kalman.linear
-
Container for
linear process
evolution data. - LinearEvolution(RealMatrix, RealMatrix, RealVector, RealMatrix, RealMatrix) - Constructor for class org.hipparchus.filtering.kalman.linear.LinearEvolution
-
Simple constructor.
- LinearInequalityConstraint - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Set of linear inequality constraints expressed as \( A x \gt B\).
- LinearInequalityConstraint(double[][], double[]) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.LinearInequalityConstraint
-
Construct a set of linear inequality constraints from Ax > B
- LinearInequalityConstraint(RealMatrix, RealVector) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.LinearInequalityConstraint
-
Construct a set of linear inequality constraints from \( A x \gt B\).
- LinearInterpolator - Class in org.hipparchus.analysis.interpolation
-
Implements a linear function for interpolation of real univariate functions.
- LinearInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.LinearInterpolator
-
Empty constructor.
- LinearKalmanFilter<T extends Measurement> - Class in org.hipparchus.filtering.kalman.linear
-
Kalman filter for
linear process
. - LinearKalmanFilter(MatrixDecomposer, LinearProcess<T>, ProcessEstimate) - Constructor for class org.hipparchus.filtering.kalman.linear.LinearKalmanFilter
-
Simple constructor.
- LinearObjectiveFunction - Class in org.hipparchus.optim.linear
-
An objective function for a linear optimization problem.
- LinearObjectiveFunction(double[], double) - Constructor for class org.hipparchus.optim.linear.LinearObjectiveFunction
-
Simple constructor.
- LinearObjectiveFunction(RealVector, double) - Constructor for class org.hipparchus.optim.linear.LinearObjectiveFunction
-
Simple constructor.
- LinearOptimizer - Class in org.hipparchus.optim.linear
-
Base class for implementing linear optimizers.
- LinearOptimizer() - Constructor for class org.hipparchus.optim.linear.LinearOptimizer
-
Simple constructor with default settings.
- LinearProcess<T extends Measurement> - Interface in org.hipparchus.filtering.kalman.linear
-
Linear process that can be estimated by a
LinearKalmanFilter
. - LineSearch - Class in org.hipparchus.optim.nonlinear.scalar
-
Class for finding the minimum of the objective function along a given direction.
- LineSearch(MultivariateOptimizer, double, double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.LineSearch
-
The
BrentOptimizer
default stopping criterion uses the tolerances to check the domain (point) values, not the function values. - load(double[]) - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Computes the empirical distribution from the provided array of numbers.
- load(File) - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Computes the empirical distribution from the input file.
- load(URL) - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Computes the empirical distribution using data read from a URL.
- Localizable - Interface in org.hipparchus.exception
-
Interface for localizable strings.
- LocalizedClusteringFormats - Enum in org.hipparchus.clustering
-
Enumeration for localized messages formats used in exceptions messages.
- LocalizedCoreFormats - Enum in org.hipparchus.exception
-
Enumeration for localized messages formats used in exceptions messages.
- LocalizedException - Interface in org.hipparchus.exception
-
This interface specified methods implemented by localized exception classes.
- LocalizedFFTFormats - Enum in org.hipparchus.transform
-
Enumeration for localized messages formats used in exceptions messages.
- LocalizedFormats - Enum in org.hipparchus.migration.exception.util
-
Deprecated.this class is only meant as a migration help from Apache Commons Math, it is really replaced by
LocalizedCoreFormats
,LocalizedGeometryFormats
,LocalizedODEFormats
,LocalizedOptimFormats
andLocalizedFFTFormats
- LocalizedGeometryFormats - Enum in org.hipparchus.geometry
-
Enumeration for localized messages formats used in exceptions messages.
- LocalizedMigrationFormats - Enum in org.hipparchus.migration
-
Deprecated.these formats are not used at all, they are intended only as a migration help from Apache Commons Math
- LocalizedODEFormats - Enum in org.hipparchus.ode
-
Enumeration for localized messages formats used in exceptions messages.
- LocalizedOptimFormats - Enum in org.hipparchus.optim
-
Enumeration for localized messages formats used in exceptions messages.
- LocalizedStatFormats - Enum in org.hipparchus.stat
-
Enumeration for localized messages formats used in exceptions messages.
- locate(int) - Method in class org.hipparchus.util.AbstractOpenIntHashMap
-
Locate the index of value associated with the given key
- LOESS_EXPECTS_AT_LEAST_ONE_POINT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.LOESS_EXPECTS_AT_LEAST_ONE_POINT.
- LOESS_EXPECTS_AT_LEAST_ONE_POINT - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.LOESS_EXPECTS_AT_LEAST_ONE_POINT.
- LoessInterpolator - Class in org.hipparchus.analysis.interpolation
-
Implements the Local Regression Algorithm (also Loess, Lowess) for interpolation of real univariate functions.
- LoessInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.LoessInterpolator
-
Constructs a new
LoessInterpolator
with a bandwidth ofLoessInterpolator.DEFAULT_BANDWIDTH
,LoessInterpolator.DEFAULT_ROBUSTNESS_ITERS
robustness iterations and an accuracy of {#link #DEFAULT_ACCURACY}. - LoessInterpolator(double, int) - Constructor for class org.hipparchus.analysis.interpolation.LoessInterpolator
-
Construct a new
LoessInterpolator
with given bandwidth and number of robustness iterations. - LoessInterpolator(double, int, double) - Constructor for class org.hipparchus.analysis.interpolation.LoessInterpolator
-
Construct a new
LoessInterpolator
with given bandwidth, number of robustness iterations and accuracy. - log() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Natural logarithm.
- log() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Natural logarithm.
- log() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Natural logarithm.
- log() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Natural logarithm.
- log() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Natural logarithm.
- log() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Natural logarithm.
- log() - Method in interface org.hipparchus.CalculusFieldElement
-
Natural logarithm.
- log() - Method in class org.hipparchus.complex.Complex
-
Compute the natural logarithm of this complex number.
- log() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the natural logarithm of this complex number.
- log() - Method in class org.hipparchus.dfp.Dfp
-
Natural logarithm.
- log() - Method in class org.hipparchus.util.Binary64
-
Natural logarithm.
- log() - Method in class org.hipparchus.util.FieldTuple
-
Natural logarithm.
- log() - Method in class org.hipparchus.util.Tuple
-
Natural logarithm.
- log(double) - Static method in class org.hipparchus.util.FastMath
-
Natural logarithm.
- log(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute natural logarithm of a derivative structure.
- log(double, double) - Static method in class org.hipparchus.util.FastMath
-
Computes the logarithm in a given base.
- log(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
Returns the natural logarithm of a.
- log(T) - Static method in class org.hipparchus.util.FastMath
-
Natural logarithm.
- log(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute natural logarithm of a derivative structure.
- Log - Class in org.hipparchus.analysis.function
-
Natural logarithm function.
- Log() - Constructor for class org.hipparchus.analysis.function.Log
-
Empty constructor.
- log10() - Method in interface org.hipparchus.analysis.differentiation.Derivative
-
Base 10 logarithm.
- log10() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Base 10 logarithm.
- log10() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Base 10 logarithm.
- log10() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Base 10 logarithm.
- log10() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Base 10 logarithm.
- log10() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Base 10 logarithm.
- log10() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Base 10 logarithm.
- log10() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Base 10 logarithm.
- log10() - Method in interface org.hipparchus.CalculusFieldElement
-
Base 10 logarithm.
- log10() - Method in class org.hipparchus.complex.Complex
-
Base 10 logarithm.
- log10() - Method in class org.hipparchus.complex.FieldComplex
-
Base 10 logarithm.
- log10() - Method in class org.hipparchus.dfp.Dfp
-
Base 10 logarithm.
- log10() - Method in class org.hipparchus.util.Binary64
-
Base 10 logarithm.
- log10() - Method in class org.hipparchus.util.FieldTuple
-
Base 10 logarithm.
- log10() - Method in class org.hipparchus.util.Tuple
-
Base 10 logarithm.
- log10(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the base 10 logarithm.
- log10(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Computes base 10 logarithm of a derivative structure.
- log10(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the base 10 logarithm.
- log10(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Computes base 10 logarithm of a derivative structure.
- Log10 - Class in org.hipparchus.analysis.function
-
Base 10 logarithm function.
- Log10() - Constructor for class org.hipparchus.analysis.function.Log10
-
Empty constructor.
- log10K() - Method in class org.hipparchus.dfp.Dfp
-
Get the exponent of the greatest power of 10000 that is less than or equal to the absolute value of this.
- log1p() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Shifted natural logarithm.
- log1p() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Shifted natural logarithm.
- log1p() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Shifted natural logarithm.
- log1p() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Shifted natural logarithm.
- log1p() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Shifted natural logarithm.
- log1p() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Shifted natural logarithm.
- log1p() - Method in interface org.hipparchus.CalculusFieldElement
-
Shifted natural logarithm.
- log1p() - Method in class org.hipparchus.complex.Complex
-
Shifted natural logarithm.
- log1p() - Method in class org.hipparchus.complex.FieldComplex
-
Shifted natural logarithm.
- log1p() - Method in class org.hipparchus.dfp.Dfp
-
Shifted natural logarithm.
- log1p() - Method in class org.hipparchus.util.Binary64
-
Shifted natural logarithm.
- log1p() - Method in class org.hipparchus.util.FieldTuple
-
Shifted natural logarithm.
- log1p() - Method in class org.hipparchus.util.Tuple
-
Shifted natural logarithm.
- log1p(double) - Static method in class org.hipparchus.util.FastMath
-
Computes log(1 + x).
- log1p(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Computes shifted logarithm of a derivative structure.
- log1p(T) - Static method in class org.hipparchus.util.FastMath
-
Computes log(1 + x).
- log1p(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Computes shifted logarithm of a derivative structure.
- Log1p - Class in org.hipparchus.analysis.function
-
log(1 + p)
function. - Log1p() - Constructor for class org.hipparchus.analysis.function.Log1p
-
Empty constructor.
- logBeta(double, double) - Static method in class org.hipparchus.special.Beta
-
Returns the value of log B(p, q) for 0 ≤ x ≤ 1 and p, q > 0.
- logDensity(double) - Method in class org.hipparchus.distribution.continuous.AbstractRealDistribution
-
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point
x
. - logDensity(double) - Method in class org.hipparchus.distribution.continuous.BetaDistribution
-
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point
x
. - logDensity(double) - Method in class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point
x
. - logDensity(double) - Method in class org.hipparchus.distribution.continuous.ExponentialDistribution
-
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point
x
. - logDensity(double) - Method in class org.hipparchus.distribution.continuous.FDistribution
-
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point
x
. - logDensity(double) - Method in class org.hipparchus.distribution.continuous.GammaDistribution
-
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point
x
. - logDensity(double) - Method in class org.hipparchus.distribution.continuous.LevyDistribution
-
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point
x
. - logDensity(double) - Method in class org.hipparchus.distribution.continuous.LogNormalDistribution
-
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point
x
. - logDensity(double) - Method in class org.hipparchus.distribution.continuous.NormalDistribution
-
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point
x
. - logDensity(double) - Method in class org.hipparchus.distribution.continuous.ParetoDistribution
-
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point
x
. - logDensity(double) - Method in class org.hipparchus.distribution.continuous.TDistribution
-
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point
x
. - logDensity(double) - Method in class org.hipparchus.distribution.continuous.WeibullDistribution
-
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point
x
. - logDensity(double) - Method in interface org.hipparchus.distribution.RealDistribution
-
Returns the natural logarithm of the probability density function (PDF) of this distribution evaluated at the specified point
x
. - logGamma(double) - Static method in class org.hipparchus.special.Gamma
-
Returns the value of log Γ(x) for x > 0.
- logGamma(T) - Static method in class org.hipparchus.special.Gamma
-
Returns the value of log Γ(x) for x > 0.
- logGamma1p(double) - Static method in class org.hipparchus.special.Gamma
-
Returns the value of log Γ(1 + x) for -0.5 ≤ x ≤ 1.5.
- logGamma1p(T) - Static method in class org.hipparchus.special.Gamma
-
Returns the value of log Γ(1 + x) for -0.5 ≤ x ≤ 1.5.
- logInternal(Dfp[]) - Static method in class org.hipparchus.dfp.DfpMath
-
Computes the natural log of a number between 0 and 2.
- Logistic - Class in org.hipparchus.analysis.function
-
Generalised logistic function.
- Logistic(double, double, double, double, double, double) - Constructor for class org.hipparchus.analysis.function.Logistic
-
Simple constructor.
- Logistic.Parametric - Class in org.hipparchus.analysis.function
-
Parametric function where the input array contains the parameters of the
logistic function
, ordered as follows: k m b q a n - LogisticDistribution - Class in org.hipparchus.distribution.continuous
-
This class implements the Logistic distribution.
- LogisticDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.LogisticDistribution
-
Build a new instance.
- Logit - Class in org.hipparchus.analysis.function
-
Logit function.
- Logit() - Constructor for class org.hipparchus.analysis.function.Logit
-
Usual logit function, where the lower bound is 0 and the higher bound is 1.
- Logit(double, double) - Constructor for class org.hipparchus.analysis.function.Logit
-
Logit function.
- Logit.Parametric - Class in org.hipparchus.analysis.function
-
Parametric function where the input array contains the parameters of the logit function, ordered as follows: Lower bound Higher bound
- LogNormalDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the log-normal (gaussian) distribution.
- LogNormalDistribution() - Constructor for class org.hipparchus.distribution.continuous.LogNormalDistribution
-
Create a log-normal distribution, where the mean and standard deviation of the
normally distributed
natural logarithm of the log-normal distribution are equal to zero and one respectively. - LogNormalDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.LogNormalDistribution
-
Create a log-normal distribution using the specified location and shape.
- LogNormalDistribution(double, double, double) - Constructor for class org.hipparchus.distribution.continuous.LogNormalDistribution
-
Creates a log-normal distribution.
- logProbability(int) - Method in class org.hipparchus.distribution.discrete.AbstractIntegerDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnslog(P(X = x))
, wherelog
is the natural logarithm. - logProbability(int) - Method in class org.hipparchus.distribution.discrete.BinomialDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnslog(P(X = x))
, wherelog
is the natural logarithm. - logProbability(int) - Method in class org.hipparchus.distribution.discrete.GeometricDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnslog(P(X = x))
, wherelog
is the natural logarithm. - logProbability(int) - Method in class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnslog(P(X = x))
, wherelog
is the natural logarithm. - logProbability(int) - Method in class org.hipparchus.distribution.discrete.PascalDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnslog(P(X = x))
, wherelog
is the natural logarithm. - logProbability(int) - Method in class org.hipparchus.distribution.discrete.PoissonDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnslog(P(X = x))
, wherelog
is the natural logarithm. - logProbability(int) - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnslog(P(X = x))
, wherelog
is the natural logarithm. - logProbability(int) - Method in interface org.hipparchus.distribution.IntegerDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnslog(P(X = x))
, wherelog
is the natural logarithm. - LongFrequency - Class in org.hipparchus.stat
-
Maintains a frequency distribution of Long values.
- LongFrequency() - Constructor for class org.hipparchus.stat.LongFrequency
-
Default constructor.
- LongFrequency(Comparator<? super Long>) - Constructor for class org.hipparchus.stat.LongFrequency
-
Constructor allowing values Comparator to be specified.
- longValue() - Method in class org.hipparchus.fraction.BigFraction
-
Gets the fraction as a
long
. - longValue() - Method in class org.hipparchus.fraction.Fraction
-
Gets the fraction as a
long
. - longValue() - Method in class org.hipparchus.util.Binary64
-
The current implementation performs casting to a
long
. - LowDiscrepancyGeneratorComparison - Class in org.hipparchus.samples
-
Plots 2D samples drawn from various pseudo / quasi-random generators.
- LowDiscrepancyGeneratorComparison() - Constructor for class org.hipparchus.samples.LowDiscrepancyGeneratorComparison
-
Empty constructor.
- LowDiscrepancyGeneratorComparison.Display - Class in org.hipparchus.samples
-
Main frame for displaying low discrepancy points.
- LowDiscrepancyGeneratorComparison.Plot - Class in org.hipparchus.samples
-
Plotting component.
- LOWER_BOUND_NOT_BELOW_UPPER_BOUND - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
LOWER_BOUND_NOT_BELOW_UPPER_BOUND.
- LOWER_BOUND_NOT_BELOW_UPPER_BOUND - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.LOWER_BOUND_NOT_BELOW_UPPER_BOUND.
- LOWER_ENDPOINT_ABOVE_UPPER_ENDPOINT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
LOWER_ENDPOINT_ABOVE_UPPER_ENDPOINT.
- LOWER_ENDPOINT_ABOVE_UPPER_ENDPOINT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.LOWER_ENDPOINT_ABOVE_UPPER_ENDPOINT.
- LUDecomposer - Class in org.hipparchus.linear
-
Matrix decomposer using LU-decomposition.
- LUDecomposer(double) - Constructor for class org.hipparchus.linear.LUDecomposer
-
Creates a LU decomposer with specify threshold for several matrices.
- LUDecomposition - Class in org.hipparchus.linear
-
Calculates the LUP-decomposition of a square matrix.
- LUDecomposition(RealMatrix) - Constructor for class org.hipparchus.linear.LUDecomposition
-
Calculates the LU-decomposition of the given matrix.
- LUDecomposition(RealMatrix, double) - Constructor for class org.hipparchus.linear.LUDecomposition
-
Calculates the LU-decomposition of the given matrix.
- LutherFieldIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This class implements the Luther sixth order Runge-Kutta integrator for Ordinary Differential Equations.
- LutherFieldIntegrator(Field<T>, T) - Constructor for class org.hipparchus.ode.nonstiff.LutherFieldIntegrator
-
Simple constructor.
- LutherIntegrator - Class in org.hipparchus.ode.nonstiff
-
This class implements the Luther sixth order Runge-Kutta integrator for Ordinary Differential Equations.
- LutherIntegrator(double) - Constructor for class org.hipparchus.ode.nonstiff.LutherIntegrator
-
Simple constructor.
M
- m1 - Variable in class org.hipparchus.stat.descriptive.moment.SecondMoment
-
First moment of values that have been added
- m2 - Variable in class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Second moment of values that have been added
- main(String[]) - Static method in class org.hipparchus.samples.ClusterAlgorithmComparison
-
Example entry point.
- main(String[]) - Static method in class org.hipparchus.samples.clustering.ImageClusteringExample
-
Program entry point.
- main(String[]) - Static method in class org.hipparchus.samples.complex.GnuplotComplexPlotter
-
Main program.
- main(String[]) - Static method in class org.hipparchus.samples.geometry.GeometryExample
-
Main entry point.
- main(String[]) - Static method in class org.hipparchus.samples.IntegerDistributionComparison
-
Program entry point.
- main(String[]) - Static method in class org.hipparchus.samples.LowDiscrepancyGeneratorComparison
-
Program entry point.
- main(String[]) - Static method in class org.hipparchus.samples.RealDistributionComparison
-
Program entry point.
- MainStateJacobianProvider - Interface in org.hipparchus.migration.ode
-
Deprecated.as of 1.0, replaced with
ODEJacobiansProvider
- makeBlobs(int, int, double, double, double, boolean, RandomGenerator) - Static method in class org.hipparchus.samples.ClusterAlgorithmComparison
-
Make blobs patterns.
- makeCircle(int, RandomVectorGenerator) - Static method in class org.hipparchus.samples.LowDiscrepancyGeneratorComparison
-
Generate points within a circle.
- makeCircles(int, boolean, double, double, RandomGenerator) - Static method in class org.hipparchus.samples.ClusterAlgorithmComparison
-
Make circles patterns.
- makeMoons(int, boolean, double, RandomGenerator) - Static method in class org.hipparchus.samples.ClusterAlgorithmComparison
-
Make Moons patterns.
- makeRandom(int, RandomVectorGenerator) - Static method in class org.hipparchus.samples.LowDiscrepancyGeneratorComparison
-
Generate points.
- makeSobol(int) - Static method in class org.hipparchus.samples.ClusterAlgorithmComparison
-
Make Sobol patterns.
- manageDependent(int, List<RealVector>) - Method in enum org.hipparchus.linear.DependentVectorsHandler
-
Manage a dependent vector.
- manageDependent(Field<T>, int, List<FieldVector<T>>) - Method in enum org.hipparchus.linear.DependentVectorsHandler
-
Manage a dependent vector.
- ManhattanDistance - Class in org.hipparchus.clustering.distance
-
Calculates the L1 (sum of abs) distance between two points.
- ManhattanDistance() - Constructor for class org.hipparchus.clustering.distance.ManhattanDistance
-
Empty constructor.
- mannWhitneyU(double[], double[]) - Method in class org.hipparchus.stat.inference.MannWhitneyUTest
-
Computes the Mann-Whitney U statistic comparing means for two independent samples possibly of different lengths.
- mannWhitneyUTest(double[], double[]) - Method in class org.hipparchus.stat.inference.MannWhitneyUTest
-
Returns the asymptotic observed significance level, or p-value, associated with a Mann-Whitney U Test comparing means for two independent samples.
- mannWhitneyUTest(double[], double[], boolean) - Method in class org.hipparchus.stat.inference.MannWhitneyUTest
-
Returns the asymptotic observed significance level, or p-value, associated with a Mann-Whitney U Test comparing means for two independent samples.
- MannWhitneyUTest - Class in org.hipparchus.stat.inference
-
An implementation of the Mann-Whitney U test.
- MannWhitneyUTest() - Constructor for class org.hipparchus.stat.inference.MannWhitneyUTest
-
Create a test instance using where NaN's are left in place and ties get the average of applicable ranks.
- MannWhitneyUTest(NaNStrategy, TiesStrategy) - Constructor for class org.hipparchus.stat.inference.MannWhitneyUTest
-
Create a test instance using the given strategies for NaN's and ties.
- mant - Variable in class org.hipparchus.dfp.Dfp
-
Mantissa.
- map(Function<T, T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Acts as if implemented as:
- map(UnivariateFunction) - Method in class org.hipparchus.linear.ArrayRealVector
-
Acts as if implemented as:
- map(UnivariateFunction) - Method in interface org.hipparchus.linear.RealMatrix
-
Acts as if implemented as:
- map(UnivariateFunction) - Method in class org.hipparchus.linear.RealVector
-
Acts as if implemented as:
- MAP_MODIFIED_WHILE_ITERATING - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.MAP_MODIFIED_WHILE_ITERATING.
- MAP_MODIFIED_WHILE_ITERATING - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.MAP_MODIFIED_WHILE_ITERATING.
- mapAdd(double) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Add a value to each entry.
- mapAdd(double) - Method in class org.hipparchus.linear.RealVector
-
Add a value to each entry.
- mapAdd(T) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Map an addition operation to each entry.
- mapAdd(T) - Method in interface org.hipparchus.linear.FieldVector
-
Map an addition operation to each entry.
- mapAdd(T) - Method in class org.hipparchus.linear.SparseFieldVector
-
Map an addition operation to each entry.
- mapAddToSelf(double) - Method in class org.hipparchus.linear.ArrayRealVector
-
Add a value to each entry.
- mapAddToSelf(double) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Add a value to each entry.
- mapAddToSelf(double) - Method in class org.hipparchus.linear.RealVector
-
Add a value to each entry.
- mapAddToSelf(T) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Map an addition operation to each entry.
- mapAddToSelf(T) - Method in interface org.hipparchus.linear.FieldVector
-
Map an addition operation to each entry.
- mapAddToSelf(T) - Method in class org.hipparchus.linear.SparseFieldVector
-
Map an addition operation to each entry.
- mapDivide(double) - Method in class org.hipparchus.linear.RealVector
-
Divide each entry by the argument.
- mapDivide(T) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Map a division operation to each entry.
- mapDivide(T) - Method in interface org.hipparchus.linear.FieldVector
-
Map a division operation to each entry.
- mapDivide(T) - Method in class org.hipparchus.linear.SparseFieldVector
-
Map a division operation to each entry.
- mapDivideToSelf(double) - Method in class org.hipparchus.linear.ArrayRealVector
-
Divide each entry by the argument.
- mapDivideToSelf(double) - Method in class org.hipparchus.linear.RealVector
-
Divide each entry by the argument.
- mapDivideToSelf(T) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Map a division operation to each entry.
- mapDivideToSelf(T) - Method in interface org.hipparchus.linear.FieldVector
-
Map a division operation to each entry.
- mapDivideToSelf(T) - Method in class org.hipparchus.linear.SparseFieldVector
-
Map a division operation to each entry.
- mapInv() - Method in class org.hipparchus.linear.ArrayFieldVector
-
Map the 1/x function to each entry.
- mapInv() - Method in interface org.hipparchus.linear.FieldVector
-
Map the 1/x function to each entry.
- mapInv() - Method in class org.hipparchus.linear.SparseFieldVector
-
Map the 1/x function to each entry.
- mapInvToSelf() - Method in class org.hipparchus.linear.ArrayFieldVector
-
Map the 1/x function to each entry.
- mapInvToSelf() - Method in interface org.hipparchus.linear.FieldVector
-
Map the 1/x function to each entry.
- mapInvToSelf() - Method in class org.hipparchus.linear.SparseFieldVector
-
Map the 1/x function to each entry.
- mapMultiply(double) - Method in class org.hipparchus.linear.RealVector
-
Multiply each entry by the argument.
- mapMultiply(T) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Map a multiplication operation to each entry.
- mapMultiply(T) - Method in interface org.hipparchus.linear.FieldVector
-
Map a multiplication operation to each entry.
- mapMultiply(T) - Method in class org.hipparchus.linear.SparseFieldVector
-
Map a multiplication operation to each entry.
- mapMultiplyToSelf(double) - Method in class org.hipparchus.linear.ArrayRealVector
-
Multiply each entry.
- mapMultiplyToSelf(double) - Method in class org.hipparchus.linear.RealVector
-
Multiply each entry.
- mapMultiplyToSelf(T) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Map a multiplication operation to each entry.
- mapMultiplyToSelf(T) - Method in interface org.hipparchus.linear.FieldVector
-
Map a multiplication operation to each entry.
- mapMultiplyToSelf(T) - Method in class org.hipparchus.linear.SparseFieldVector
-
Map a multiplication operation to each entry.
- mapStateAndDerivative(double, double[], double[]) - Method in class org.hipparchus.ode.EquationsMapper
-
Map flat arrays to a state and derivative.
- mapStateAndDerivative(T, T[], T[]) - Method in class org.hipparchus.ode.FieldEquationsMapper
-
Map flat arrays to a state and derivative.
- mapSubtract(double) - Method in class org.hipparchus.linear.RealVector
-
Subtract a value from each entry.
- mapSubtract(T) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Map a subtraction operation to each entry.
- mapSubtract(T) - Method in interface org.hipparchus.linear.FieldVector
-
Map a subtraction operation to each entry.
- mapSubtract(T) - Method in class org.hipparchus.linear.SparseFieldVector
-
Map a subtraction operation to each entry.
- mapSubtractToSelf(double) - Method in class org.hipparchus.linear.ArrayRealVector
-
Subtract a value from each entry.
- mapSubtractToSelf(double) - Method in class org.hipparchus.linear.RealVector
-
Subtract a value from each entry.
- mapSubtractToSelf(T) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Map a subtraction operation to each entry.
- mapSubtractToSelf(T) - Method in interface org.hipparchus.linear.FieldVector
-
Map a subtraction operation to each entry.
- mapSubtractToSelf(T) - Method in class org.hipparchus.linear.SparseFieldVector
-
Map a subtraction operation to each entry.
- mapToSelf(Function<T, T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Replace each entry by the result of applying the function to it.
- mapToSelf(UnivariateFunction) - Method in class org.hipparchus.linear.ArrayRealVector
-
Acts as if it is implemented as:
- mapToSelf(UnivariateFunction) - Method in interface org.hipparchus.linear.RealMatrix
-
Replace each entry by the result of applying the function to it.
- mapToSelf(UnivariateFunction) - Method in class org.hipparchus.linear.RealVector
-
Acts as if it is implemented as:
- MathArithmeticException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, replaced with
MathRuntimeException
- MathArithmeticException() - Constructor for exception org.hipparchus.migration.exception.MathArithmeticException
-
Deprecated.Default constructor.
- MathArithmeticException(Localizable, Object...) - Constructor for exception org.hipparchus.migration.exception.MathArithmeticException
-
Deprecated.Constructor with a specific message.
- MathArrays - Class in org.hipparchus.util
-
Arrays utilities.
- MathArrays.Function - Interface in org.hipparchus.util
-
Real-valued function that operates on an array or a part of it.
- MathArrays.OrderDirection - Enum in org.hipparchus.util
-
Specification of ordering direction.
- MathArrays.Position - Enum in org.hipparchus.util
-
Specification for indicating that some operation applies before or after a given index.
- MathIllegalArgumentException - Exception in org.hipparchus.exception
-
Base class for all preconditions violation exceptions.
- MathIllegalArgumentException(Throwable, Localizable, Object...) - Constructor for exception org.hipparchus.exception.MathIllegalArgumentException
-
Simple constructor.
- MathIllegalArgumentException(Localizable, Object...) - Constructor for exception org.hipparchus.exception.MathIllegalArgumentException
-
Simple constructor.
- MathIllegalNumberException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- MathIllegalNumberException(Localizable, Number, Object...) - Constructor for exception org.hipparchus.migration.exception.MathIllegalNumberException
-
Deprecated.Construct an exception.
- MathIllegalStateException - Exception in org.hipparchus.exception
-
Base class for all exceptions that signal that the process throwing the exception is in a state that does not comply with the set of states that it is designed to be in.
- MathIllegalStateException(Throwable, Localizable, Object...) - Constructor for exception org.hipparchus.exception.MathIllegalStateException
-
Simple constructor.
- MathIllegalStateException(Localizable, Object...) - Constructor for exception org.hipparchus.exception.MathIllegalStateException
-
Simple constructor.
- MathInternalError - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalStateException
- MathInternalError() - Constructor for exception org.hipparchus.migration.exception.MathInternalError
-
Deprecated.Simple constructor.
- MathInternalError(Throwable) - Constructor for exception org.hipparchus.migration.exception.MathInternalError
-
Deprecated.Simple constructor.
- MathInternalError(Localizable, Object...) - Constructor for exception org.hipparchus.migration.exception.MathInternalError
-
Deprecated.Constructor accepting a localized message.
- MathParseException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalStateException
- MathParseException(String, int) - Constructor for exception org.hipparchus.migration.exception.MathParseException
-
Deprecated.Simple constructor.
- MathParseException(String, int, Class<?>) - Constructor for exception org.hipparchus.migration.exception.MathParseException
-
Deprecated.Simple constructor.
- MathRuntimeException - Exception in org.hipparchus.exception
-
All exceptions thrown by the Hipparchus code inherit from this class.
- MathRuntimeException(Throwable, Localizable, Object...) - Constructor for exception org.hipparchus.exception.MathRuntimeException
-
Simple constructor.
- MathRuntimeException(Localizable, Object...) - Constructor for exception org.hipparchus.exception.MathRuntimeException
-
Simple constructor.
- MathUnsupportedOperationException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, replaced with
MathRuntimeException
- MathUnsupportedOperationException() - Constructor for exception org.hipparchus.migration.exception.MathUnsupportedOperationException
-
Deprecated.Default constructor.
- MathUnsupportedOperationException(Localizable, Object...) - Constructor for exception org.hipparchus.migration.exception.MathUnsupportedOperationException
-
Deprecated.Simple constructor.
- MathUtils - Class in org.hipparchus.util
-
Miscellaneous utility functions.
- MathUtils.FieldSumAndResidual<T extends FieldElement<T>> - Class in org.hipparchus.util
-
Result class for
MathUtils.twoSum(FieldElement, FieldElement)
containing the sum and the residual error in the sum. - MathUtils.SumAndResidual - Class in org.hipparchus.util
-
Result class for
MathUtils.twoSum(double, double)
containing the sum and the residual error in the sum. - matricesToEigenArrays() - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Reset eigenvalues and eigen vectors from matrices.
- MatrixDecomposer - Interface in org.hipparchus.linear
-
Interface for all algorithms providing matrix decomposition.
- MatrixDimensionMismatchException - Exception in org.hipparchus.migration.linear
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- MatrixDimensionMismatchException(int, int, int, int) - Constructor for exception org.hipparchus.migration.linear.MatrixDimensionMismatchException
-
Deprecated.Construct an exception from the mismatched dimensions.
- matrixExponential(RealMatrix) - Static method in class org.hipparchus.linear.MatrixUtils
-
Computes the matrix exponential of the given matrix.
- MatrixUtils - Class in org.hipparchus.linear
-
A collection of static methods that operate on or return matrices.
- max(double...) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the maximum of the entries in the input array, or
Double.NaN
if the array is empty. - max(double[], int, int) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the maximum of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - max(double, double) - Static method in class org.hipparchus.util.FastMath
-
Compute the maximum of two values
- max(float, float) - Static method in class org.hipparchus.util.FastMath
-
Compute the maximum of two values
- max(int, int) - Static method in class org.hipparchus.util.FastMath
-
Compute the maximum of two values
- max(long, long) - Static method in class org.hipparchus.util.FastMath
-
Compute the maximum of two values
- max(T, double) - Static method in class org.hipparchus.util.FastMath
-
Compute the maximum of two values
- max(T, T) - Static method in class org.hipparchus.util.FastMath
-
Compute the maximum of two values
- max(T, T) - Static method in class org.hipparchus.util.MathUtils
-
Find the maximum of two field elements.
- Max - Class in org.hipparchus.analysis.function
-
Maximum function.
- Max - Class in org.hipparchus.stat.descriptive.rank
-
Returns the maximum of the available values.
- Max() - Constructor for class org.hipparchus.analysis.function.Max
-
Empty constructor.
- Max() - Constructor for class org.hipparchus.stat.descriptive.rank.Max
-
Create a Max instance.
- Max(Max) - Constructor for class org.hipparchus.stat.descriptive.rank.Max
-
Copy constructor, creates a new
Max
identical to theoriginal
. - MAX_BELL - Static variable in class org.hipparchus.util.CombinatoricsUtils
-
Maximum index of Bell number that fits into a long.
- MAX_COUNT_EXCEEDED - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
MAX_COUNT_EXCEEDED.
- MAX_COUNT_EXCEEDED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.MAX_COUNT_EXCEEDED.
- MAX_EXP - Static variable in class org.hipparchus.dfp.Dfp
-
The maximum exponent before overflow is signaled and results flushed to infinity
- MAX_ITERATIONS_EXCEEDED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.MAX_ITERATIONS_EXCEEDED.
- MAX_ITERATIONS_EXCEEDED - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.MAX_ITERATIONS_EXCEEDED.
- MaxCountExceededException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalStateException
- MaxCountExceededException(Number) - Constructor for exception org.hipparchus.migration.exception.MaxCountExceededException
-
Deprecated.Construct the exception.
- MaxCountExceededException(Localizable, Number, Object...) - Constructor for exception org.hipparchus.migration.exception.MaxCountExceededException
-
Deprecated.Construct the exception with a specific context.
- maxDual(RealVector, RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPConvergenceChecker
-
Compute dual vectors max.
- MaxEval - Class in org.hipparchus.optim
-
Maximum number of evaluations of the function to be optimized.
- MaxEval(int) - Constructor for class org.hipparchus.optim.MaxEval
-
Simple constructor.
- maxEvaluations(int) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the max evaluations.
- MAXIMAL - Enum constant in enum org.hipparchus.stat.ranking.NaNStrategy
-
NaNs are considered maximal in the ordering
- MAXIMIZE - Enum constant in enum org.hipparchus.optim.nonlinear.scalar.GoalType
-
Maximization.
- MAXIMUM - Enum constant in enum org.hipparchus.stat.ranking.TiesStrategy
-
Ties get the maximum applicable rank
- MAXIMUM_PARTIAL_SUM_COUNT - Static variable in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Bound on the number of partial sums in
KolmogorovSmirnovTest.ksSum(double, double, int)
- MaxIter - Class in org.hipparchus.optim
-
Maximum number of iterations performed by an (iterative) algorithm.
- MaxIter(int) - Constructor for class org.hipparchus.optim.MaxIter
-
Simple constructor.
- maxIterations(int) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the max iterations.
- maxPrimal(RealVector, RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPConvergenceChecker
-
Compute primal vectors max.
- maxValuesRetained(double) - Static method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Returns the maximum number of
double
values that aRandomPercentile
instance created with the givenepsilon
value will retain in memory. - mean(double...) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the arithmetic mean of the entries in the input array, or
Double.NaN
if the array is empty. - mean(double[], int, int) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the arithmetic mean of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - Mean - Class in org.hipparchus.stat.descriptive.moment
-
Computes the arithmetic mean of a set of values.
- Mean() - Constructor for class org.hipparchus.stat.descriptive.moment.Mean
-
Constructs a Mean.
- Mean(FirstMoment) - Constructor for class org.hipparchus.stat.descriptive.moment.Mean
-
Constructs a Mean with an External Moment.
- Mean(Mean) - Constructor for class org.hipparchus.stat.descriptive.moment.Mean
-
Copy constructor, creates a new
Mean
identical to theoriginal
. - MEAN - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
MEAN.
- MEAN - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.MEAN.
- meanDifference(double[], double[]) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the mean of the (signed) differences between corresponding elements of the input arrays -- i.e., sum(sample1[i] - sample2[i]) / sample1.length.
- Measurement - Interface in org.hipparchus.filtering.kalman
-
Interface defining a measurement on process.
- Median - Class in org.hipparchus.stat.descriptive.rank
-
Returns the median of the available values.
- Median() - Constructor for class org.hipparchus.stat.descriptive.rank.Median
-
Default constructor.
- MEDIAN_OF_3 - Enum constant in enum org.hipparchus.util.PivotingStrategy
-
Classic median of 3 strategy given begin and end indices.
- merge(Collection<? extends Frequency<? extends T>>) - Method in class org.hipparchus.stat.Frequency
-
Merge a
Collection
ofFrequency
objects into this instance. - merge(BSPTree<S>, BSPTree.LeafMerger<S>) - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Merge a BSP tree with the instance.
- merge(BSPTree<S>, BSPTree<S>, BSPTree<S>, boolean, boolean) - Method in interface org.hipparchus.geometry.partitioning.BSPTree.LeafMerger
-
Merge a leaf node and a tree node.
- merge(Frequency<? extends T>) - Method in class org.hipparchus.stat.Frequency
-
Merge another Frequency object's counts into this instance.
- MersenneTwister - Class in org.hipparchus.random
-
This class implements a powerful pseudo-random number generator developed by Makoto Matsumoto and Takuji Nishimura during 1996-1997.
- MersenneTwister() - Constructor for class org.hipparchus.random.MersenneTwister
-
Creates a new random number generator.
- MersenneTwister(int) - Constructor for class org.hipparchus.random.MersenneTwister
-
Creates a new random number generator using a single int seed.
- MersenneTwister(int[]) - Constructor for class org.hipparchus.random.MersenneTwister
-
Creates a new random number generator using an int array seed.
- MersenneTwister(long) - Constructor for class org.hipparchus.random.MersenneTwister
-
Creates a new random number generator using a single long seed.
- MerweUnscentedTransform - Class in org.hipparchus.util
-
Unscented transform as defined by Merwe and Wan.
- MerweUnscentedTransform(int) - Constructor for class org.hipparchus.util.MerweUnscentedTransform
-
Default constructor.
- MerweUnscentedTransform(int, double, double, double) - Constructor for class org.hipparchus.util.MerweUnscentedTransform
-
Simple constructor.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.AdamsBashforthIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.AdamsMoultonIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.EulerFieldIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.EulerIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.GillFieldIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.GillIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.HighamHall54Integrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.LutherFieldIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.LutherIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.MidpointFieldIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.MidpointIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.ThreeEighthesFieldIntegrator
-
Name of integration scheme.
- METHOD_NAME - Static variable in class org.hipparchus.ode.nonstiff.ThreeEighthesIntegrator
-
Name of integration scheme.
- MicrosphereProjectionInterpolator - Class in org.hipparchus.analysis.interpolation
-
Interpolator that implements the algorithm described in William Dudziak's MS thesis.
- MicrosphereProjectionInterpolator(int, int, double, double, double, double, boolean, double) - Constructor for class org.hipparchus.analysis.interpolation.MicrosphereProjectionInterpolator
-
Create a microsphere interpolator.
- MicrosphereProjectionInterpolator(InterpolatingMicrosphere, double, boolean, double) - Constructor for class org.hipparchus.analysis.interpolation.MicrosphereProjectionInterpolator
-
Create a microsphere interpolator.
- midpoint(double, double) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
Compute the midpoint of two values.
- MIDPOINT_MAX_ITERATIONS_COUNT - Static variable in class org.hipparchus.analysis.integration.FieldMidPointIntegrator
-
Maximum number of iterations for midpoint.
- MIDPOINT_MAX_ITERATIONS_COUNT - Static variable in class org.hipparchus.analysis.integration.MidPointIntegrator
-
Maximum number of iterations for midpoint.
- MidpointFieldIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This class implements a second order Runge-Kutta integrator for Ordinary Differential Equations.
- MidpointFieldIntegrator(Field<T>, T) - Constructor for class org.hipparchus.ode.nonstiff.MidpointFieldIntegrator
-
Simple constructor.
- MidpointIntegrator - Class in org.hipparchus.ode.nonstiff
-
This class implements a second order Runge-Kutta integrator for Ordinary Differential Equations.
- MidpointIntegrator(double) - Constructor for class org.hipparchus.ode.nonstiff.MidpointIntegrator
-
Simple constructor.
- MidPointIntegrator - Class in org.hipparchus.analysis.integration
-
Implements the Midpoint Rule for integration of real univariate functions.
- MidPointIntegrator() - Constructor for class org.hipparchus.analysis.integration.MidPointIntegrator
-
Construct a midpoint integrator with default settings.
- MidPointIntegrator(double, double, int, int) - Constructor for class org.hipparchus.analysis.integration.MidPointIntegrator
-
Build a midpoint integrator with given accuracies and iterations counts.
- MidPointIntegrator(int, int) - Constructor for class org.hipparchus.analysis.integration.MidPointIntegrator
-
Build a midpoint integrator with given iteration counts.
- MillerUpdatingRegression - Class in org.hipparchus.stat.regression
-
This class is a concrete implementation of the
UpdatingMultipleLinearRegression
interface. - MillerUpdatingRegression(int, boolean) - Constructor for class org.hipparchus.stat.regression.MillerUpdatingRegression
-
Primary constructor for the MillerUpdatingRegression.
- MillerUpdatingRegression(int, boolean, double) - Constructor for class org.hipparchus.stat.regression.MillerUpdatingRegression
-
This is the augmented constructor for the MillerUpdatingRegression class.
- min(double...) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the minimum of the entries in the input array, or
Double.NaN
if the array is empty. - min(double[], int, int) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the minimum of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - min(double, double) - Static method in class org.hipparchus.util.FastMath
-
Compute the minimum of two values
- min(float, float) - Static method in class org.hipparchus.util.FastMath
-
Compute the minimum of two values
- min(int, int) - Static method in class org.hipparchus.util.FastMath
-
Compute the minimum of two values
- min(long, long) - Static method in class org.hipparchus.util.FastMath
-
Compute the minimum of two values
- min(T, double) - Static method in class org.hipparchus.util.FastMath
-
Compute the minimum of two values
- min(T, T) - Static method in class org.hipparchus.util.FastMath
-
Compute the minimum of two values
- min(T, T) - Static method in class org.hipparchus.util.MathUtils
-
Find the minimum of two field elements.
- Min - Class in org.hipparchus.analysis.function
-
Minimum function.
- Min - Class in org.hipparchus.stat.descriptive.rank
-
Returns the minimum of the available values.
- Min() - Constructor for class org.hipparchus.analysis.function.Min
-
Empty constructor.
- Min() - Constructor for class org.hipparchus.stat.descriptive.rank.Min
-
Create a Min instance.
- Min(Min) - Constructor for class org.hipparchus.stat.descriptive.rank.Min
-
Copy constructor, creates a new
Min
identical to theoriginal
. - MIN_EXP - Static variable in class org.hipparchus.dfp.Dfp
-
The minimum exponent before underflow is signaled.
- MINIMAL - Enum constant in enum org.hipparchus.stat.ranking.NaNStrategy
-
NaNs are considered minimal in the ordering
- MINIMAL_STEPSIZE_REACHED_DURING_INTEGRATION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.MINIMAL_STEPSIZE_REACHED_DURING_INTEGRATION.
- MINIMAL_STEPSIZE_REACHED_DURING_INTEGRATION - Enum constant in enum org.hipparchus.ode.LocalizedODEFormats
-
MINIMAL_STEPSIZE_REACHED_DURING_INTEGRATION.
- MINIMIZE - Enum constant in enum org.hipparchus.optim.nonlinear.scalar.GoalType
-
Minimization.
- MINIMUM - Enum constant in enum org.hipparchus.stat.ranking.TiesStrategy
-
Ties get the minimum applicable rank
- MINIMUM_PROBLEM_DIMENSION - Static variable in class org.hipparchus.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
-
Minimum dimension of the problem: 2
- Minus - Class in org.hipparchus.analysis.function
-
Minus function.
- Minus() - Constructor for class org.hipparchus.analysis.function.Minus
-
Empty constructor.
- MINUS - Enum constant in enum org.hipparchus.geometry.partitioning.Side
-
Code for the minus side of the hyperplane.
- MINUS_I - Static variable in class org.hipparchus.complex.Complex
-
The square root of -1.
- MINUS_I - Static variable in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Opposite of the first canonical vector (coordinates: -1, 0, 0).
- MINUS_I - Static variable in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Opposite of the first canonical vector (coordinates: -1, 0).
- MINUS_I - Static variable in class org.hipparchus.geometry.spherical.twod.S2Point
-
-I (coordinates: \( \theta = \pi, \varphi = \pi/2 \)).
- MINUS_J - Static variable in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Opposite of the second canonical vector (coordinates: 0, -1, 0).
- MINUS_J - Static variable in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Opposite of the second canonical vector (coordinates: 0, -1).
- MINUS_J - Static variable in class org.hipparchus.geometry.spherical.twod.S2Point
-
-J (coordinates: \( \theta = 3\pi/2, \varphi = \pi/2 \)).
- MINUS_K - Static variable in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Opposite of the third canonical vector (coordinates: 0, 0, -1).
- MINUS_K - Static variable in class org.hipparchus.geometry.spherical.twod.S2Point
-
-K (coordinates: \( \theta = any angle, \varphi = \pi \)).
- MINUS_ONE - Static variable in class org.hipparchus.complex.Complex
-
A complex number representing "-1.0 + 0.0i".
- MINUS_ONE - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "-1 / 1".
- MINUS_ONE - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "-1 / 1".
- MINUS_PLUS_SUB - Enum constant in enum org.hipparchus.geometry.partitioning.BSPTreeVisitor.Order
-
Indicator for visit order minus sub-tree, then plus sub-tree, and last cut sub-hyperplane.
- MINUS_SUB_PLUS - Enum constant in enum org.hipparchus.geometry.partitioning.BSPTreeVisitor.Order
-
Indicator for visit order minus sub-tree, then cut sub-hyperplane, and last plus sub-tree.
- MISMATCHED_LOESS_ABSCISSA_ORDINATE_ARRAYS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.MISMATCHED_LOESS_ABSCISSA_ORDINATE_ARRAYS.
- MISMATCHED_LOESS_ABSCISSA_ORDINATE_ARRAYS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.MISMATCHED_LOESS_ABSCISSA_ORDINATE_ARRAYS.
- MismatchedEquations() - Constructor for exception org.hipparchus.migration.ode.JacobianMatrices.MismatchedEquations
-
Deprecated.Simple constructor.
- MismatchedEquations() - Constructor for exception org.hipparchus.ode.VariationalEquation.MismatchedEquations
-
Simple constructor.
- MixtureMultivariateNormalDistribution - Class in org.hipparchus.distribution.multivariate
-
Multivariate normal mixture distribution.
- MixtureMultivariateNormalDistribution(double[], double[][], double[][][]) - Constructor for class org.hipparchus.distribution.multivariate.MixtureMultivariateNormalDistribution
-
Creates a multivariate normal mixture distribution.
- MixtureMultivariateNormalDistribution(List<Pair<Double, MultivariateNormalDistribution>>) - Constructor for class org.hipparchus.distribution.multivariate.MixtureMultivariateNormalDistribution
-
Creates a mixture model from a list of distributions and their associated weights.
- MixtureMultivariateNormalDistribution(RandomGenerator, List<Pair<Double, MultivariateNormalDistribution>>) - Constructor for class org.hipparchus.distribution.multivariate.MixtureMultivariateNormalDistribution
-
Creates a mixture model from a list of distributions and their associated weights.
- MixtureMultivariateRealDistribution<T extends MultivariateRealDistribution> - Class in org.hipparchus.distribution.multivariate
-
Class for representing mixture model distributions.
- MixtureMultivariateRealDistribution(List<Pair<Double, T>>) - Constructor for class org.hipparchus.distribution.multivariate.MixtureMultivariateRealDistribution
-
Creates a mixture model from a list of distributions and their associated weights.
- MixtureMultivariateRealDistribution(RandomGenerator, List<Pair<Double, T>>) - Constructor for class org.hipparchus.distribution.multivariate.MixtureMultivariateRealDistribution
-
Creates a mixture model from a list of distributions and their associated weights.
- mode(double...) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the sample mode(s).
- mode(double[], int, int) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the sample mode(s).
- model(MultivariateVectorFunction, MultivariateMatrixFunction) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the model function.
- model(MultivariateVectorFunction, MultivariateMatrixFunction) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
Combine a
MultivariateVectorFunction
with aMultivariateMatrixFunction
to produce aMultivariateJacobianFunction
. - model(MultivariateJacobianFunction) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the model function.
- ModelSpecificationException - Exception in org.hipparchus.migration.stat.regression
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- ModelSpecificationException(Localizable, Object...) - Constructor for exception org.hipparchus.migration.stat.regression.ModelSpecificationException
-
Deprecated.Simple constructor.
- moment - Variable in class org.hipparchus.stat.descriptive.moment.Kurtosis
-
Fourth Moment on which this statistic is based
- moment - Variable in class org.hipparchus.stat.descriptive.moment.Mean
-
First moment on which this statistic is based.
- moment - Variable in class org.hipparchus.stat.descriptive.moment.Skewness
-
Third moment on which this statistic is based
- moment - Variable in class org.hipparchus.stat.descriptive.moment.Variance
-
SecondMoment is used in incremental calculation of Variance
- moments(boolean) - Method in class org.hipparchus.stat.descriptive.StreamingStatistics.StreamingStatisticsBuilder
-
Sets the computeMoments setting of the factory
- MonotoneChain - Class in org.hipparchus.geometry.euclidean.twod.hull
-
Implements Andrew's monotone chain method to generate the convex hull of a finite set of points in the two-dimensional euclidean space.
- MonotoneChain() - Constructor for class org.hipparchus.geometry.euclidean.twod.hull.MonotoneChain
-
Create a new MonotoneChain instance.
- MonotoneChain(boolean) - Constructor for class org.hipparchus.geometry.euclidean.twod.hull.MonotoneChain
-
Create a new MonotoneChain instance.
- MonotoneChain(boolean, double) - Constructor for class org.hipparchus.geometry.euclidean.twod.hull.MonotoneChain
-
Create a new MonotoneChain instance.
- mulAndCheck(int, int) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Multiply two integers, checking for overflow.
- mulAndCheck(long, long) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Multiply two long integers, checking for overflow.
- MullerSolver - Class in org.hipparchus.analysis.solvers
-
This class implements the Muller's Method for root finding of real univariate functions.
- MullerSolver() - Constructor for class org.hipparchus.analysis.solvers.MullerSolver
-
Construct a solver with default accuracy (1e-6).
- MullerSolver(double) - Constructor for class org.hipparchus.analysis.solvers.MullerSolver
-
Construct a solver.
- MullerSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.MullerSolver
-
Construct a solver.
- MullerSolver2 - Class in org.hipparchus.analysis.solvers
-
This class implements the Muller's Method for root finding of real univariate functions.
- MullerSolver2() - Constructor for class org.hipparchus.analysis.solvers.MullerSolver2
-
Construct a solver with default accuracy (1e-6).
- MullerSolver2(double) - Constructor for class org.hipparchus.analysis.solvers.MullerSolver2
-
Construct a solver.
- MullerSolver2(double, double) - Constructor for class org.hipparchus.analysis.solvers.MullerSolver2
-
Construct a solver.
- MultidimensionalCounter - Class in org.hipparchus.util
-
Converter between unidimensional storage structure and multidimensional conceptual structure.
- MultidimensionalCounter(int...) - Constructor for class org.hipparchus.util.MultidimensionalCounter
-
Create a counter.
- MultidimensionalCounter.Iterator - Class in org.hipparchus.util
-
Perform iteration over the multidimensional counter.
- MultiDimensionMismatchException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- MultiDimensionMismatchException(Integer[], Integer[]) - Constructor for exception org.hipparchus.migration.exception.MultiDimensionMismatchException
-
Deprecated.Construct an exception from the mismatched dimensions.
- MultiDimensionMismatchException(Localizable, Integer[], Integer[]) - Constructor for exception org.hipparchus.migration.exception.MultiDimensionMismatchException
-
Deprecated.Construct an exception from the mismatched dimensions.
- MultiDirectionalSimplex - Class in org.hipparchus.optim.nonlinear.scalar.noderiv
-
This class implements the multi-directional direct search method.
- MultiDirectionalSimplex(double[]) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
-
Build a multi-directional simplex with default coefficients.
- MultiDirectionalSimplex(double[][]) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
-
Build a multi-directional simplex with default coefficients.
- MultiDirectionalSimplex(double[][], double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
-
Build a multi-directional simplex with specified coefficients.
- MultiDirectionalSimplex(double[], double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
-
Build a multi-directional simplex with specified coefficients.
- MultiDirectionalSimplex(int) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
-
Build a multi-directional simplex with default coefficients.
- MultiDirectionalSimplex(int, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
-
Build a multi-directional simplex with default coefficients.
- MultiDirectionalSimplex(int, double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
-
Build a multi-directional simplex with specified coefficients.
- MultiDirectionalSimplex(int, double, double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
-
Build a multi-directional simplex with specified coefficients.
- MultiKMeansPlusPlusClusterer<T extends Clusterable> - Class in org.hipparchus.clustering
-
A wrapper around a k-means++ clustering algorithm which performs multiple trials and returns the best solution.
- MultiKMeansPlusPlusClusterer(KMeansPlusPlusClusterer<T>, int) - Constructor for class org.hipparchus.clustering.MultiKMeansPlusPlusClusterer
-
Build a clusterer.
- MultiKMeansPlusPlusClusterer(KMeansPlusPlusClusterer<T>, int, ClusterEvaluator<T>) - Constructor for class org.hipparchus.clustering.MultiKMeansPlusPlusClusterer
-
Build a clusterer.
- MultipleLinearRegression - Interface in org.hipparchus.stat.regression
-
The multiple linear regression can be represented in matrix-notation.
- MULTIPLES - Enum constant in enum org.hipparchus.ode.sampling.StepNormalizerMode
-
Steps are multiples of a fixed value.
- MULTIPLICATIVE - Enum constant in enum org.hipparchus.util.ResizableDoubleArray.ExpansionMode
-
Multiplicative expansion mode.
- multiply(double) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
'×' operator.
- multiply(double) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'×' operator.
- multiply(double) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
'×' operator.
- multiply(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'×' operator.
- multiply(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'×' operator.
- multiply(double) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
'×' operator.
- multiply(double) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
'×' operator.
- multiply(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
'×' operator.
- multiply(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
'×' operator.
- multiply(double) - Method in interface org.hipparchus.CalculusFieldElement
-
'×' operator.
- multiply(double) - Method in class org.hipparchus.complex.Complex
-
Returns a
Complex
whose value isthis * factor
, withfactor
interpreted as a real number. - multiply(double) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value isthis * factor
, withfactor
interpreted as a real number. - multiply(double) - Method in class org.hipparchus.complex.Quaternion
-
Multiplies the instance by a scalar.
- multiply(double) - Method in class org.hipparchus.util.Binary64
-
'×' operator.
- multiply(double) - Method in class org.hipparchus.util.FieldTuple
-
'×' operator.
- multiply(double) - Method in class org.hipparchus.util.Tuple
-
'×' operator.
- multiply(double[], int, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform multiplication of two derivative structures.
- multiply(int) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute n × this.
- multiply(int) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute n × this.
- multiply(int) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute n × this.
- multiply(int) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute n × this.
- multiply(int) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute n × this.
- multiply(int) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute n × this.
- multiply(int) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute n × this.
- multiply(int) - Method in interface org.hipparchus.CalculusFieldElement
-
Compute n × this.
- multiply(int) - Method in class org.hipparchus.complex.Complex
-
Returns a
Complex
whose value isthis * factor
, withfactor
interpreted as a integer number. - multiply(int) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value isthis * factor
, withfactor
interpreted as a integer number. - multiply(int) - Method in class org.hipparchus.dfp.Dfp
-
Multiply this by a single digit x.
- multiply(int) - Method in interface org.hipparchus.FieldElement
-
Compute n × this.
- multiply(int) - Method in class org.hipparchus.fraction.BigFraction
-
Multiply the value of this fraction by the passed
int
, returning the result in reduced form. - multiply(int) - Method in class org.hipparchus.fraction.Fraction
-
Multiply the fraction by an integer.
- multiply(int) - Method in class org.hipparchus.util.BigReal
-
Compute n × this.
- multiply(int) - Method in class org.hipparchus.util.Binary64
-
Compute n × this.
- multiply(int) - Method in class org.hipparchus.util.FieldTuple
-
Compute n × this.
- multiply(int) - Method in class org.hipparchus.util.Tuple
-
Compute n × this.
- multiply(long) - Method in class org.hipparchus.fraction.BigFraction
-
Multiply the value of this fraction by the passed
long
, returning the result in reduced form. - multiply(BigInteger) - Method in class org.hipparchus.fraction.BigFraction
-
Multiplies the value of this fraction by the passed
BigInteger
, returning the result in reduced form. - multiply(DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute this × a.
- multiply(FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute this × a.
- multiply(FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute this × a.
- multiply(FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute this × a.
- multiply(FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute this × a.
- multiply(Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute this × a.
- multiply(SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute this × a.
- multiply(UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute this × a.
- multiply(UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute this × a.
- multiply(UnivariateDifferentiableFunction...) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Multiplies functions.
- multiply(FieldPolynomialFunction<T>) - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Multiply the instance by a polynomial.
- multiply(PolynomialFunction) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Multiply the instance by a polynomial.
- multiply(UnivariateFunction...) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Multiplies functions.
- multiply(Complex) - Method in class org.hipparchus.complex.Complex
-
Returns a
Complex
whose value isthis * factor
. - multiply(FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value isthis * factor
. - multiply(Quaternion) - Method in class org.hipparchus.complex.Quaternion
-
Returns the Hamilton product of the instance by a quaternion.
- multiply(Quaternion, Quaternion) - Static method in class org.hipparchus.complex.Quaternion
-
Returns the Hamilton product of two quaternions.
- multiply(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Multiply this by x.
- multiply(BigFraction) - Method in class org.hipparchus.fraction.BigFraction
-
Multiplies the value of this fraction by another, returning the result in reduced form.
- multiply(Fraction) - Method in class org.hipparchus.fraction.Fraction
-
Multiplies the value of this fraction by another, returning the result in reduced form.
- multiply(Array2DRowFieldMatrix<T>) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Postmultiplying this matrix by
m
. - multiply(Array2DRowRealMatrix) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Returns the result of postmultiplying
this
bym
. - multiply(BlockFieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Returns the result of postmultiplying
this
bym
. - multiply(BlockRealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the result of postmultiplying this by
m
. - multiply(DiagonalMatrix) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns the result of postmultiplying
this
bym
. - multiply(FieldMatrix<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Postmultiply this matrix by
m
. - multiply(FieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Postmultiply this matrix by
m
. - multiply(FieldMatrix<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Postmultiply this matrix by
m
. - multiply(OpenMapRealMatrix) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Postmultiply this matrix by
m
. - multiply(RealMatrix) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the result of postmultiplying
this
bym
. - multiply(RealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the result of postmultiplying
this
bym
. - multiply(RealMatrix) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns the result of postmultiplying
this
bym
. - multiply(RealMatrix) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Returns the result of postmultiplying
this
bym
. - multiply(RealMatrix) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the result of postmultiplying
this
bym
. - multiply(BigReal) - Method in class org.hipparchus.util.BigReal
-
Compute this × a.
- multiply(Binary64) - Method in class org.hipparchus.util.Binary64
-
Compute this × a.
- multiply(FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Compute this × a.
- multiply(Tuple) - Method in class org.hipparchus.util.Tuple
-
Compute this × a.
- multiply(T) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'×' operator.
- multiply(T) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
'×' operator.
- multiply(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'×' operator.
- multiply(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'×' operator.
- multiply(T) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value isthis * factor
, withfactor
interpreted as a real number. - multiply(T) - Method in interface org.hipparchus.FieldElement
-
Compute this × a.
- multiply(T[], int, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform multiplication of two derivative structures.
- Multiply - Class in org.hipparchus.analysis.function
-
Multiply the two operands.
- Multiply() - Constructor for class org.hipparchus.analysis.function.Multiply
-
Empty constructor.
- multiplyEntry(int, int, double) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Multiplies (in place) the specified entry of
this
matrix by the specified value. - multiplyEntry(int, int, double) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Multiplies (in place) the specified entry of
this
matrix by the specified value. - multiplyEntry(int, int, double) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Multiplies (in place) the specified entry of
this
matrix by the specified value. - multiplyEntry(int, int, double) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Multiplies (in place) the specified entry of
this
matrix by the specified value. - multiplyEntry(int, int, double) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Multiplies (in place) the specified entry of
this
matrix by the specified value. - multiplyEntry(int, int, double) - Method in interface org.hipparchus.linear.RealMatrix
-
Multiplies (in place) the specified entry of
this
matrix by the specified value. - multiplyEntry(int, int, T) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Change an entry in the specified row and column.
- multiplyEntry(int, int, T) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Change an entry in the specified row and column.
- multiplyEntry(int, int, T) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Change an entry in the specified row and column.
- multiplyEntry(int, int, T) - Method in interface org.hipparchus.linear.FieldMatrix
-
Change an entry in the specified row and column.
- multiplyEntry(int, int, T) - Method in class org.hipparchus.linear.SparseFieldMatrix
-
Change an entry in the specified row and column.
- multiplyExact(int, int) - Static method in class org.hipparchus.util.FastMath
-
Multiply two numbers, detecting overflows.
- multiplyExact(long, int) - Static method in class org.hipparchus.util.FastMath
-
Multiply two numbers, detecting overflows.
- multiplyExact(long, long) - Static method in class org.hipparchus.util.FastMath
-
Multiply two numbers, detecting overflows.
- multiplyFull(int, int) - Static method in class org.hipparchus.util.FastMath
-
Multiply two integers and give an exact result without overflow.
- multiplyHigh(long, long) - Static method in class org.hipparchus.util.FastMath
-
Multiply two long integers and give the 64 most significant bits of the result.
- multiplyInPlace(SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Multiply in place.
- multiplyMinusI() - Method in class org.hipparchus.complex.Complex
-
Compute this *- -i.
- multiplyMinusI() - Method in class org.hipparchus.complex.FieldComplex
-
Compute this *- -i.
- multiplyPlusI() - Method in class org.hipparchus.complex.Complex
-
Compute this * i.
- multiplyPlusI() - Method in class org.hipparchus.complex.FieldComplex
-
Compute this * i.
- multiplyTransposed(Array2DRowFieldMatrix<T>) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Returns the result of postmultiplying
this
bym^T
. - multiplyTransposed(Array2DRowRealMatrix) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Returns the result of postmultiplying
this
bym^T
. - multiplyTransposed(BlockFieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Returns the result of postmultiplying
this
bym^T
. - multiplyTransposed(BlockRealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the result of postmultiplying
this
bym^T
. - multiplyTransposed(DiagonalMatrix) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns the result of postmultiplying
this
bym^T
. - multiplyTransposed(FieldMatrix<T>) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Returns the result of postmultiplying
this
bym^T
. - multiplyTransposed(FieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Returns the result of postmultiplying
this
bym^T
. - multiplyTransposed(FieldMatrix<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Returns the result of postmultiplying
this
bym^T
. - multiplyTransposed(FieldMatrix<T>) - Method in class org.hipparchus.linear.SparseFieldMatrix
-
Returns the result of postmultiplying
this
bym^T
. - multiplyTransposed(RealMatrix) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Returns the result of postmultiplying
this
bym^T
. - multiplyTransposed(RealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the result of postmultiplying
this
bym^T
. - multiplyTransposed(RealMatrix) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns the result of postmultiplying
this
bym^T
. - multiplyTransposed(RealMatrix) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Returns the result of postmultiplying
this
bym^T
. - multiplyTransposed(RealMatrix) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the result of postmultiplying
this
bym^T
. - MultiStartMultivariateOptimizer - Class in org.hipparchus.optim.nonlinear.scalar
-
Multi-start optimizer.
- MultiStartMultivariateOptimizer(MultivariateOptimizer, int, RandomVectorGenerator) - Constructor for class org.hipparchus.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
-
Create a multi-start optimizer from a single-start optimizer.
- MultiStartUnivariateOptimizer - Class in org.hipparchus.optim.univariate
-
Special implementation of the
UnivariateOptimizer
interface adding multi-start features to an existing optimizer. - MultiStartUnivariateOptimizer(UnivariateOptimizer, int, RandomGenerator) - Constructor for class org.hipparchus.optim.univariate.MultiStartUnivariateOptimizer
-
Create a multi-start optimizer from a single-start optimizer.
- MULTISTEP_STARTER_STOPPED_EARLY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.MULTISTEP_STARTER_STOPPED_EARLY.
- MULTISTEP_STARTER_STOPPED_EARLY - Enum constant in enum org.hipparchus.ode.LocalizedODEFormats
-
MULTISTEP_STARTER_STOPPED_EARLY.
- MultistepFieldIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode
-
This class is the base class for multistep integrators for Ordinary Differential Equations.
- MultistepFieldIntegrator(Field<T>, String, int, int, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.MultistepFieldIntegrator
-
Build a multistep integrator with the given stepsize bounds.
- MultistepFieldIntegrator(Field<T>, String, int, int, double, double, double, double) - Constructor for class org.hipparchus.ode.MultistepFieldIntegrator
-
Build a multistep integrator with the given stepsize bounds.
- MultistepIntegrator - Class in org.hipparchus.ode
-
This class is the base class for multistep integrators for Ordinary Differential Equations.
- MultistepIntegrator(String, int, int, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.MultistepIntegrator
-
Build a multistep integrator with the given stepsize bounds.
- MultistepIntegrator(String, int, int, double, double, double, double) - Constructor for class org.hipparchus.ode.MultistepIntegrator
-
Build a multistep integrator with the given stepsize bounds.
- MultivariateDifferentiableFunction - Interface in org.hipparchus.analysis.differentiation
-
Extension of
MultivariateFunction
representing a multivariate differentiable real function. - MultivariateDifferentiableVectorFunction - Interface in org.hipparchus.analysis.differentiation
-
Extension of
MultivariateVectorFunction
representing a multivariate differentiable vectorial function. - MultivariateFunction - Interface in org.hipparchus.analysis
-
An interface representing a multivariate real function.
- MultivariateFunctionMappingAdapter - Class in org.hipparchus.optim.nonlinear.scalar
-
Adapter for mapping bounded
MultivariateFunction
to unbounded ones. - MultivariateFunctionMappingAdapter(MultivariateFunction, double[], double[]) - Constructor for class org.hipparchus.optim.nonlinear.scalar.MultivariateFunctionMappingAdapter
-
Simple constructor.
- MultivariateFunctionPenaltyAdapter - Class in org.hipparchus.optim.nonlinear.scalar
-
Adapter extending bounded
MultivariateFunction
to an unbouded domain using a penalty function. - MultivariateFunctionPenaltyAdapter(MultivariateFunction, double[], double[], double, double[]) - Constructor for class org.hipparchus.optim.nonlinear.scalar.MultivariateFunctionPenaltyAdapter
-
Simple constructor.
- MultivariateInterpolator - Interface in org.hipparchus.analysis.interpolation
-
Interface representing a univariate real interpolating function.
- MultivariateJacobianFunction - Interface in org.hipparchus.optim.nonlinear.vector.leastsquares
-
A interface for functions that compute a vector of values and can compute their derivatives (Jacobian).
- MultivariateMatrixFunction - Interface in org.hipparchus.analysis
-
An interface representing a multivariate matrix function.
- MultivariateNormalDistribution - Class in org.hipparchus.distribution.multivariate
-
Implementation of the multivariate normal (Gaussian) distribution.
- MultivariateNormalDistribution(double[], double[][]) - Constructor for class org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
-
Creates a multivariate normal distribution with the given mean vector and covariance matrix.
The number of dimensions is equal to the length of the mean vector and to the number of rows and columns of the covariance matrix. - MultivariateNormalDistribution(double[], double[][], double) - Constructor for class org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
-
Creates a multivariate normal distribution with the given mean vector and covariance matrix.
The number of dimensions is equal to the length of the mean vector and to the number of rows and columns of the covariance matrix. - MultivariateNormalDistribution(RandomGenerator, double[], double[][]) - Constructor for class org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
-
Creates a multivariate normal distribution with the given mean vector and covariance matrix.
- MultivariateNormalDistribution(RandomGenerator, double[], double[][], double) - Constructor for class org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
-
Creates a multivariate normal distribution with the given mean vector and covariance matrix.
- MultivariateNormalMixtureExpectationMaximization - Class in org.hipparchus.stat.fitting
-
Expectation-Maximization algorithm for fitting the parameters of multivariate normal mixture model distributions.
- MultivariateNormalMixtureExpectationMaximization(double[][]) - Constructor for class org.hipparchus.stat.fitting.MultivariateNormalMixtureExpectationMaximization
-
Creates an object to fit a multivariate normal mixture model to data.
- MultivariateOptimizer - Class in org.hipparchus.optim.nonlinear.scalar
-
Base class for a multivariate scalar function optimizer.
- MultivariateOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.hipparchus.optim.nonlinear.scalar.MultivariateOptimizer
-
Simple constructor.
- MultivariateRealDistribution - Interface in org.hipparchus.distribution
-
Base interface for multivariate continuous distributions.
- MultivariateSummaryStatistics - Class in org.hipparchus.stat.descriptive
-
Computes summary statistics for a stream of n-tuples added using the
addValue
method. - MultivariateSummaryStatistics(int) - Constructor for class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Construct a MultivariateSummaryStatistics instance for the given dimension.
- MultivariateSummaryStatistics(int, boolean) - Constructor for class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Construct a MultivariateSummaryStatistics instance for the given dimension.
- MultivariateVectorFunction - Interface in org.hipparchus.analysis
-
An interface representing a multivariate vectorial function.
N
- n - Variable in class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Count of values that have been added
- N_POINTS_GAUSS_LEGENDRE_INTEGRATOR_NOT_SUPPORTED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.N_POINTS_GAUSS_LEGENDRE_INTEGRATOR_NOT_SUPPORTED.
- N_POINTS_GAUSS_LEGENDRE_INTEGRATOR_NOT_SUPPORTED - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.N_POINTS_GAUSS_LEGENDRE_INTEGRATOR_NOT_SUPPORTED.
- NakagamiDistribution - Class in org.hipparchus.distribution.continuous
-
This class implements the Nakagami distribution.
- NakagamiDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.NakagamiDistribution
-
Build a new instance.
- NakagamiDistribution(double, double, double) - Constructor for class org.hipparchus.distribution.continuous.NakagamiDistribution
-
Build a new instance.
- NamedParameterJacobianProvider - Interface in org.hipparchus.ode
-
Interface to compute exactly Jacobian matrix for some parameter when computing
partial derivatives equations
. - NaN - Static variable in class org.hipparchus.complex.Complex
-
A complex number representing "NaN + NaNi".
- NaN - Static variable in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
A vector with all coordinates set to NaN.
- NaN - Static variable in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
A vector with all coordinates set to NaN.
- NaN - Static variable in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
A vector with all coordinates set to NaN.
- NaN - Static variable in class org.hipparchus.geometry.spherical.oned.S1Point
-
A vector with all coordinates set to NaN.
- NaN - Static variable in class org.hipparchus.geometry.spherical.twod.S2Point
-
A vector with all coordinates set to NaN.
- NAN - Static variable in class org.hipparchus.util.Binary64
-
The constant value of
Double.NaN
as aBinary64
. - NAN_APPEARING_DURING_INTEGRATION - Enum constant in enum org.hipparchus.ode.LocalizedODEFormats
-
NAN_APPEARING_DURING_INTEGRATION.
- NAN_ELEMENT_AT_INDEX - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NAN_ELEMENT_AT_INDEX.
- NAN_ELEMENT_AT_INDEX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NAN_ELEMENT_AT_INDEX.
- NAN_NOT_ALLOWED - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NAN_NOT_ALLOWED.
- NAN_NOT_ALLOWED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NAN_NOT_ALLOWED.
- NAN_VALUE_CONVERSION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NAN_VALUE_CONVERSION.
- NAN_VALUE_CONVERSION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NAN_VALUE_CONVERSION.
- nans - Variable in class org.hipparchus.dfp.Dfp
-
Indicator for non-finite / non-number values.
- NaNStrategy - Enum in org.hipparchus.stat.ranking
-
Strategies for handling NaN values in rank transformations.
- natural(int) - Static method in class org.hipparchus.util.MathArrays
-
Returns an array representing the natural number
n
. - NaturalRanking - Class in org.hipparchus.stat.ranking
-
Ranking based on the natural ordering on doubles.
- NaturalRanking() - Constructor for class org.hipparchus.stat.ranking.NaturalRanking
-
Create a NaturalRanking with default strategies for handling ties and NaNs.
- NaturalRanking(RandomGenerator) - Constructor for class org.hipparchus.stat.ranking.NaturalRanking
-
Create a NaturalRanking with TiesStrategy.RANDOM and the given RandomGenerator as the source of random data.
- NaturalRanking(NaNStrategy) - Constructor for class org.hipparchus.stat.ranking.NaturalRanking
-
Create a NaturalRanking with the given NaNStrategy.
- NaturalRanking(NaNStrategy, RandomGenerator) - Constructor for class org.hipparchus.stat.ranking.NaturalRanking
-
Create a NaturalRanking with the given NaNStrategy, TiesStrategy.RANDOM and the given source of random data.
- NaturalRanking(NaNStrategy, TiesStrategy) - Constructor for class org.hipparchus.stat.ranking.NaturalRanking
-
Create a NaturalRanking with the given NaNStrategy and TiesStrategy.
- NaturalRanking(TiesStrategy) - Constructor for class org.hipparchus.stat.ranking.NaturalRanking
-
Create a NaturalRanking with the given TiesStrategy.
- nc() - Method in class org.hipparchus.special.elliptic.jacobi.CopolarC
-
Get the value of the nc function.
- nc() - Method in class org.hipparchus.special.elliptic.jacobi.FieldCopolarC
-
Get the value of the nc function.
- nd() - Method in class org.hipparchus.special.elliptic.jacobi.CopolarD
-
Get the value of the nd function.
- nd() - Method in class org.hipparchus.special.elliptic.jacobi.FieldCopolarD
-
Get the value of the nd function.
- nDev - Variable in class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Deviation of most recently added value from previous first moment, normalized by previous sample size.
- negate() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Returns the additive inverse of
this
element. - negate() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Returns the additive inverse of
this
element. - negate() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Returns the additive inverse of
this
element. - negate() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Returns the additive inverse of
this
element. - negate() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Returns the additive inverse of
this
element. - negate() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Returns the additive inverse of
this
element. - negate() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Returns the additive inverse of
this
element. - negate() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Returns the additive inverse of
this
element. - negate() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Returns the additive inverse of
this
element. - negate() - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Negate the instance.
- negate() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Negate the instance.
- negate() - Method in class org.hipparchus.complex.Complex
-
Returns a
Complex
whose value is(-this)
. - negate() - Method in class org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value is(-this)
. - negate() - Method in class org.hipparchus.dfp.Dfp
-
Returns a number that is this number with the sign bit reversed.
- negate() - Method in interface org.hipparchus.FieldElement
-
Returns the additive inverse of
this
element. - negate() - Method in class org.hipparchus.fraction.BigFraction
-
Return the additive inverse of this fraction, returning the result in reduced form.
- negate() - Method in class org.hipparchus.fraction.Fraction
-
Return the additive inverse of this fraction.
- negate() - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Get the opposite of the instance.
- negate() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get the opposite of the instance.
- negate() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get the opposite of the instance.
- negate() - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Get the opposite of the instance.
- negate() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Get the opposite of the instance.
- negate() - Method in class org.hipparchus.geometry.spherical.twod.S2Point
-
Get the opposite of the instance.
- negate() - Method in interface org.hipparchus.geometry.Vector
-
Get the opposite of the instance.
- negate() - Method in class org.hipparchus.util.BigReal
-
Returns the additive inverse of
this
element. - negate() - Method in class org.hipparchus.util.Binary64
-
Returns the additive inverse of
this
element. - negate() - Method in class org.hipparchus.util.FieldTuple
-
Returns the additive inverse of
this
element. - negate() - Method in class org.hipparchus.util.Tuple
-
Returns the additive inverse of
this
element. - negateExact(int) - Static method in class org.hipparchus.util.FastMath
-
Negates the argument.
- negateExact(long) - Static method in class org.hipparchus.util.FastMath
-
Negates the argument.
- NEGATIVE_BRIGHTNESS_EXPONENT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NEGATIVE_BRIGHTNESS_EXPONENT.
- NEGATIVE_BRIGHTNESS_EXPONENT - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NEGATIVE_BRIGHTNESS_EXPONENT.
- NEGATIVE_COMPLEX_MODULE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NEGATIVE_COMPLEX_MODULE.
- NEGATIVE_COMPLEX_MODULE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NEGATIVE_COMPLEX_MODULE.
- NEGATIVE_DEFINITE_MATRIX - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NEGATIVE_DEFINITE_MATRIX.
- NEGATIVE_ELEMENT_AT_2D_INDEX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NEGATIVE_ELEMENT_AT_2D_INDEX.
- NEGATIVE_ELEMENT_AT_2D_INDEX - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NEGATIVE_ELEMENT_AT_2D_INDEX.
- NEGATIVE_ELEMENT_AT_INDEX - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NEGATIVE_ELEMENT_AT_INDEX.
- NEGATIVE_ELEMENT_AT_INDEX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NEGATIVE_ELEMENT_AT_INDEX.
- NEGATIVE_INFINITY - Static variable in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
A vector with all coordinates set to negative infinity.
- NEGATIVE_INFINITY - Static variable in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
A vector with all coordinates set to negative infinity.
- NEGATIVE_INFINITY - Static variable in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
A vector with all coordinates set to negative infinity.
- NEGATIVE_INFINITY - Static variable in class org.hipparchus.util.Binary64
-
The constant value of
Double.NEGATIVE_INFINITY
as aBinary64
. - NEGATIVE_NUMBER_OF_SUCCESSES - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NEGATIVE_NUMBER_OF_SUCCESSES.
- NEGATIVE_NUMBER_OF_SUCCESSES - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NEGATIVE_NUMBER_OF_SUCCESSES.
- NEGATIVE_NUMBER_OF_TRIALS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NEGATIVE_NUMBER_OF_TRIALS.
- NEGATIVE_NUMBER_OF_TRIALS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NEGATIVE_NUMBER_OF_TRIALS.
- negativeOrNull() - Method in class org.hipparchus.dfp.Dfp
-
Check if instance is less than or equal to 0.
- NEITHER - Enum constant in enum org.hipparchus.ode.sampling.StepNormalizerBounds
-
Do not include the first and last points.
- NelderMeadSimplex - Class in org.hipparchus.optim.nonlinear.scalar.noderiv
-
This class implements the Nelder-Mead simplex algorithm.
- NelderMeadSimplex(double[]) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
-
Build a Nelder-Mead simplex with default coefficients.
- NelderMeadSimplex(double[][]) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
-
Build a Nelder-Mead simplex with default coefficients.
- NelderMeadSimplex(double[][], double, double, double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
-
Build a Nelder-Mead simplex with specified coefficients.
- NelderMeadSimplex(double[], double, double, double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
-
Build a Nelder-Mead simplex with specified coefficients.
- NelderMeadSimplex(int) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
-
Build a Nelder-Mead simplex with default coefficients.
- NelderMeadSimplex(int, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
-
Build a Nelder-Mead simplex with default coefficients.
- NelderMeadSimplex(int, double, double, double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
-
Build a Nelder-Mead simplex with specified coefficients.
- NelderMeadSimplex(int, double, double, double, double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
-
Build a Nelder-Mead simplex with specified coefficients.
- NevilleInterpolator - Class in org.hipparchus.analysis.interpolation
-
Implements the Neville's Algorithm for interpolation of real univariate functions.
- NevilleInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.NevilleInterpolator
-
Empty constructor.
- newBundle(String, Locale, String, ClassLoader, boolean) - Method in class org.hipparchus.exception.UTF8Control
- newCovarianceData(double[][]) - Method in class org.hipparchus.stat.regression.GLSMultipleLinearRegression
-
Add the covariance data.
- newDfp() - Method in class org.hipparchus.dfp.DfpField
-
Makes a
Dfp
with a value of 0. - newDfp(byte) - Method in class org.hipparchus.dfp.DfpField
-
Create an instance from a byte value.
- newDfp(byte, byte) - Method in class org.hipparchus.dfp.DfpField
-
Creates a
Dfp
with a non-finite value. - newDfp(double) - Method in class org.hipparchus.dfp.DfpField
-
Create an instance from a double value.
- newDfp(int) - Method in class org.hipparchus.dfp.DfpField
-
Create an instance from an int value.
- newDfp(long) - Method in class org.hipparchus.dfp.DfpField
-
Create an instance from a long value.
- newDfp(String) - Method in class org.hipparchus.dfp.DfpField
-
Create a
Dfp
given a String representation. - newDfp(Dfp) - Method in class org.hipparchus.dfp.DfpField
-
Copy constructor.
- newInstance() - Method in class org.hipparchus.dfp.Dfp
-
Create an instance with a value of 0.
- newInstance() - Method in class org.hipparchus.dfp.DfpDec
-
Create an instance with a value of 0.
- newInstance(byte) - Method in class org.hipparchus.dfp.Dfp
-
Create an instance from a byte value.
- newInstance(byte) - Method in class org.hipparchus.dfp.DfpDec
-
Create an instance from a byte value.
- newInstance(byte, byte) - Method in class org.hipparchus.dfp.Dfp
-
Creates an instance with a non-finite value.
- newInstance(byte, byte) - Method in class org.hipparchus.dfp.DfpDec
-
Creates an instance with a non-finite value.
- newInstance(double) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in interface org.hipparchus.CalculusFieldElement
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.complex.Complex
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.complex.FieldComplex
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.dfp.Dfp
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.dfp.DfpDec
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.util.Binary64
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.util.FieldTuple
-
Create an instance corresponding to a constant real value.
- newInstance(double) - Method in class org.hipparchus.util.Tuple
-
Create an instance corresponding to a constant real value.
- newInstance(int) - Method in class org.hipparchus.dfp.Dfp
-
Create an instance from an int value.
- newInstance(int) - Method in class org.hipparchus.dfp.DfpDec
-
Create an instance from an int value.
- newInstance(long) - Method in class org.hipparchus.dfp.Dfp
-
Create an instance from a long value.
- newInstance(long) - Method in class org.hipparchus.dfp.DfpDec
-
Create an instance from a long value.
- newInstance(String) - Method in class org.hipparchus.dfp.Dfp
-
Create an instance from a String representation.
- newInstance(String) - Method in class org.hipparchus.dfp.DfpDec
-
Create an instance from a String representation.
- newInstance(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Create an instance by copying an existing one.
- newInstance(Dfp) - Method in class org.hipparchus.dfp.DfpDec
-
Create an instance by copying an existing one.
- newInstance(DfpField, DfpField.RoundingMode) - Method in class org.hipparchus.dfp.Dfp
-
Creates an instance by converting the instance to a different field (i.e.
- newInstance(S) - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Create an instance corresponding to a constant Field value.
- newInstance(T) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Create an instance corresponding to a constant Field value.
- newInstance(T) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Create an instance corresponding to a constant Field value.
- newInstance(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Create an instance corresponding to a constant Field value.
- newInstance(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Create an instance corresponding to a constant Field value.
- newMarkers(List<Double>, double) - Static method in class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
A creation method to build Markers
- newSampleData(double[], double[][]) - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Loads model x and y sample data, overriding any previous sample.
- newSampleData(double[], double[][], double[][]) - Method in class org.hipparchus.stat.regression.GLSMultipleLinearRegression
-
Replace sample data, overriding any previous sample.
- newSampleData(double[], int, int) - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Loads model x and y sample data from a flat input array, overriding any previous sample.
- newSampleData(double[], int, int) - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Loads model x and y sample data from a flat input array, overriding any previous sample.
- NewtonRaphsonSolver - Class in org.hipparchus.analysis.solvers
-
Implements Newton's Method for finding zeros of real univariate differentiable functions.
- NewtonRaphsonSolver() - Constructor for class org.hipparchus.analysis.solvers.NewtonRaphsonSolver
-
Construct a solver.
- NewtonRaphsonSolver(double) - Constructor for class org.hipparchus.analysis.solvers.NewtonRaphsonSolver
-
Construct a solver.
- newXSampleData(double[][]) - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Loads new x sample data, overriding any previous data.
- newXSampleData(double[][]) - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Loads new x sample data, overriding any previous data.
- newYSampleData(double[]) - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Loads new y sample data, overriding any previous data.
- next() - Method in class org.hipparchus.linear.OpenMapRealVector.OpenMapSparseIterator
- next() - Method in class org.hipparchus.linear.RealVector.SparseEntryIterator
- next() - Method in class org.hipparchus.util.MultidimensionalCounter.Iterator
- next() - Method in class org.hipparchus.util.RosenNumberPartitionIterator
- next(double) - Method in class org.hipparchus.random.GaussMarkovGenerator
-
Generate next step in the autoregressive process.
- nextAfter(double, double) - Static method in class org.hipparchus.util.FastMath
-
Get the next machine representable number after a number, moving in the direction of another number.
- nextAfter(float, double) - Static method in class org.hipparchus.util.FastMath
-
Get the next machine representable number after a number, moving in the direction of another number.
- nextAfter(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Returns the next number greater than this one in the direction of x.
- nextAfter(Dfp) - Method in class org.hipparchus.dfp.DfpDec
-
Returns the next number greater than this one in the direction of x.
- nextBeta(double, double) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns the next pseudo-random beta-distributed value with the given shape and scale parameters.
- nextBoolean() - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns the next pseudorandom, uniformly distributed
boolean
value from this random number generator's sequence. - nextBoolean() - Method in class org.hipparchus.random.Well44497b
-
Returns the next pseudorandom, uniformly distributed
boolean
value from this random number generator's sequence. - nextBoolean() - Method in class org.hipparchus.random.JDKRandomGenerator
-
Returns the next pseudorandom, uniformly distributed
boolean
value from this random number generator's sequence. - nextBoolean() - Method in class org.hipparchus.random.RandomAdaptor
-
Returns the next pseudorandom, uniformly distributed
boolean
value from this random number generator's sequence. - nextBoolean() - Method in interface org.hipparchus.random.RandomGenerator
-
Returns the next pseudorandom, uniformly distributed
boolean
value from this random number generator's sequence. - nextBoolean() - Method in class org.hipparchus.random.SynchronizedRandomGenerator
-
Returns the next pseudorandom, uniformly distributed
boolean
value from this random number generator's sequence. - nextBytes(byte[]) - Method in class org.hipparchus.random.RandomDataGenerator
-
Generates random bytes and places them into a user-supplied byte array.
- nextBytes(byte[]) - Method in class org.hipparchus.random.Well44497b
-
Generates random bytes and places them into a user-supplied byte array.
- nextBytes(byte[]) - Method in class org.hipparchus.random.JDKRandomGenerator
-
Generates random bytes and places them into a user-supplied byte array.
- nextBytes(byte[]) - Method in class org.hipparchus.random.RandomAdaptor
-
Generates random bytes and places them into a user-supplied byte array.
- nextBytes(byte[]) - Method in interface org.hipparchus.random.RandomGenerator
-
Generates random bytes and places them into a user-supplied byte array.
- nextBytes(byte[]) - Method in class org.hipparchus.random.SynchronizedRandomGenerator
-
Generates random bytes and places them into a user-supplied byte array.
- nextBytes(byte[], int, int) - Method in class org.hipparchus.random.RandomDataGenerator
-
Generates random bytes and places them into a user-supplied byte array.
- nextBytes(byte[], int, int) - Method in class org.hipparchus.random.JDKRandomGenerator
-
Generates random bytes and places them into a user-supplied byte array.
- nextBytes(byte[], int, int) - Method in class org.hipparchus.random.RandomAdaptor
-
Generates random bytes and places them into a user-supplied byte array.
- nextBytes(byte[], int, int) - Method in interface org.hipparchus.random.RandomGenerator
-
Generates random bytes and places them into a user-supplied byte array.
- nextBytes(byte[], int, int) - Method in class org.hipparchus.random.SynchronizedRandomGenerator
-
Generates random bytes and places them into a user-supplied byte array.
- nextDeviate(IntegerDistribution) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns a random deviate from the given distribution.
- nextDeviate(RealDistribution) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns a random deviate from the given distribution.
- nextDeviates(IntegerDistribution, int) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns an array of random deviates from the given distribution.
- nextDeviates(RealDistribution, int) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns an array of random deviates from the given distribution.
- nextDouble() - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns the next pseudorandom, uniformly distributed
double
value between0.0
and1.0
from this random number generator's sequence. - nextDouble() - Method in class org.hipparchus.random.Well44497b
-
Returns the next pseudorandom, uniformly distributed
double
value between0.0
and1.0
from this random number generator's sequence. - nextDouble() - Method in class org.hipparchus.random.JDKRandomGenerator
-
Returns the next pseudorandom, uniformly distributed
double
value between0.0
and1.0
from this random number generator's sequence. - nextDouble() - Method in class org.hipparchus.random.RandomAdaptor
-
Returns the next pseudorandom, uniformly distributed
double
value between0.0
and1.0
from this random number generator's sequence. - nextDouble() - Method in interface org.hipparchus.random.RandomGenerator
-
Returns the next pseudorandom, uniformly distributed
double
value between0.0
and1.0
from this random number generator's sequence. - nextDouble() - Method in class org.hipparchus.random.SynchronizedRandomGenerator
-
Returns the next pseudorandom, uniformly distributed
double
value between0.0
and1.0
from this random number generator's sequence. - nextDown(double) - Static method in class org.hipparchus.util.FastMath
-
Compute next number towards negative infinity.
- nextDown(float) - Static method in class org.hipparchus.util.FastMath
-
Compute next number towards negative infinity.
- nextExponential(double) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns the next pseudo-random, exponentially distributed deviate.
- nextFloat() - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns the next pseudorandom, uniformly distributed
float
value between0.0
and1.0
from this random number generator's sequence. - nextFloat() - Method in class org.hipparchus.random.Well44497b
-
Returns the next pseudorandom, uniformly distributed
float
value between0.0
and1.0
from this random number generator's sequence. - nextFloat() - Method in class org.hipparchus.random.JDKRandomGenerator
-
Returns the next pseudorandom, uniformly distributed
float
value between0.0
and1.0
from this random number generator's sequence. - nextFloat() - Method in class org.hipparchus.random.RandomAdaptor
-
Returns the next pseudorandom, uniformly distributed
float
value between0.0
and1.0
from this random number generator's sequence. - nextFloat() - Method in interface org.hipparchus.random.RandomGenerator
-
Returns the next pseudorandom, uniformly distributed
float
value between0.0
and1.0
from this random number generator's sequence. - nextFloat() - Method in class org.hipparchus.random.SynchronizedRandomGenerator
-
Returns the next pseudorandom, uniformly distributed
float
value between0.0
and1.0
from this random number generator's sequence. - nextGamma(double, double) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns the next pseudo-random gamma-distributed value with the given shape and scale parameters.
- nextGaussian() - Method in class org.hipparchus.random.Well44497b
-
Returns the next pseudorandom, Gaussian ("normally") distributed
double
value with mean0.0
and standard deviation1.0
from this random number generator's sequence. - nextGaussian() - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns the next pseudorandom, Gaussian ("normally") distributed
double
value with mean0.0
and standard deviation1.0
from this random number generator's sequence. - nextGaussian() - Method in class org.hipparchus.random.JDKRandomGenerator
-
Returns the next pseudorandom, Gaussian ("normally") distributed
double
value with mean0.0
and standard deviation1.0
from this random number generator's sequence. - nextGaussian() - Method in class org.hipparchus.random.RandomAdaptor
-
Returns the next pseudorandom, Gaussian ("normally") distributed
double
value with mean0.0
and standard deviation1.0
from this random number generator's sequence. - nextGaussian() - Method in interface org.hipparchus.random.RandomGenerator
-
Returns the next pseudorandom, Gaussian ("normally") distributed
double
value with mean0.0
and standard deviation1.0
from this random number generator's sequence. - nextGaussian() - Method in class org.hipparchus.random.SynchronizedRandomGenerator
-
Returns the next pseudorandom, Gaussian ("normally") distributed
double
value with mean0.0
and standard deviation1.0
from this random number generator's sequence. - nextHexString(int) - Method in class org.hipparchus.random.RandomDataGenerator
-
Generates a random string of hex characters of length
len
. - nextInt() - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt() - Method in class org.hipparchus.random.AbstractWell
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt() - Method in class org.hipparchus.random.ISAACRandom
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt() - Method in class org.hipparchus.random.JDKRandomGenerator
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt() - Method in class org.hipparchus.random.MersenneTwister
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt() - Method in class org.hipparchus.random.RandomAdaptor
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt() - Method in interface org.hipparchus.random.RandomGenerator
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt() - Method in class org.hipparchus.random.SynchronizedRandomGenerator
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt() - Method in class org.hipparchus.random.Well1024a
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt() - Method in class org.hipparchus.random.Well19937a
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt() - Method in class org.hipparchus.random.Well19937c
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt() - Method in class org.hipparchus.random.Well44497a
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt() - Method in class org.hipparchus.random.Well44497b
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt() - Method in class org.hipparchus.random.Well512a
-
Returns the next pseudorandom, uniformly distributed
int
value from this random number generator's sequence. - nextInt(int) - Method in class org.hipparchus.random.Well44497b
-
Returns a pseudorandom, uniformly distributed
int
value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence. - nextInt(int) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns a pseudorandom, uniformly distributed
int
value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence. - nextInt(int) - Method in class org.hipparchus.random.JDKRandomGenerator
-
Returns a pseudorandom, uniformly distributed
int
value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence. - nextInt(int) - Method in class org.hipparchus.random.RandomAdaptor
-
Returns a pseudorandom, uniformly distributed
int
value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence. - nextInt(int) - Method in interface org.hipparchus.random.RandomGenerator
-
Returns a pseudorandom, uniformly distributed
int
value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence. - nextInt(int) - Method in class org.hipparchus.random.SynchronizedRandomGenerator
-
Returns a pseudorandom, uniformly distributed
int
value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence. - nextInt(int, int) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns a uniformly distributed random integer between lower and upper (inclusive).
- nextLogNormal(double, double) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns the next log-normally-distributed pseudo-random deviate.
- nextLong() - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns the next pseudorandom, uniformly distributed
long
value from this random number generator's sequence. - nextLong() - Method in class org.hipparchus.random.Well44497b
-
Returns the next pseudorandom, uniformly distributed
long
value from this random number generator's sequence. - nextLong() - Method in class org.hipparchus.random.JDKRandomGenerator
-
Returns the next pseudorandom, uniformly distributed
long
value from this random number generator's sequence. - nextLong() - Method in class org.hipparchus.random.RandomAdaptor
-
Returns the next pseudorandom, uniformly distributed
long
value from this random number generator's sequence. - nextLong() - Method in interface org.hipparchus.random.RandomGenerator
-
Returns the next pseudorandom, uniformly distributed
long
value from this random number generator's sequence. - nextLong() - Method in class org.hipparchus.random.SynchronizedRandomGenerator
-
Returns the next pseudorandom, uniformly distributed
long
value from this random number generator's sequence. - nextLong(long) - Method in class org.hipparchus.random.JDKRandomGenerator
-
Returns a pseudorandom, uniformly distributed
int
value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence. - nextLong(long) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns a pseudorandom, uniformly distributed
int
value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence. - nextLong(long) - Method in class org.hipparchus.random.RandomAdaptor
-
Returns a pseudorandom, uniformly distributed
int
value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence. - nextLong(long) - Method in interface org.hipparchus.random.RandomGenerator
-
Returns a pseudorandom, uniformly distributed
int
value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence. - nextLong(long) - Method in class org.hipparchus.random.SynchronizedRandomGenerator
-
Returns a pseudorandom, uniformly distributed
int
value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence. - nextLong(long, long) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns a uniformly distributed random long integer between lower and upper (inclusive).
- nextNormal(double, double) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns the next normally-distributed pseudo-random deviate.
- nextNormalizedDouble() - Method in class org.hipparchus.random.GaussianRandomGenerator
-
Generate a random scalar with null mean and unit standard deviation.
- nextNormalizedDouble() - Method in interface org.hipparchus.random.NormalizedRandomGenerator
-
Generate a random scalar with null mean and unit standard deviation.
- nextNormalizedDouble() - Method in class org.hipparchus.random.StableRandomGenerator
-
Generate a random scalar with zero location and unit scale.
- nextNormalizedDouble() - Method in class org.hipparchus.random.UniformRandomGenerator
-
Generate a random scalar with null mean and unit standard deviation.
- nextPermutation(int, int) - Method in class org.hipparchus.random.RandomDataGenerator
-
Generates an integer array of length
k
whose entries are selected randomly, without repetition, from the integers0, ..., n - 1
(inclusive). - nextPoisson(double) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns a poisson-distributed deviate with the given mean.
- nextSample(double[], int) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns an array of
k
double values selected randomly from the double arraya
. - nextSample(Collection<?>, int) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns an array of
k
objects selected randomly from the Collectionc
. - nextSampleWithReplacement(int, double[]) - Method in class org.hipparchus.random.RandomDataGenerator
-
Generates a random sample of size sampleSize from {0, 1, ...
- nextUniform(double, double) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns a double value uniformly distributed over [lower, upper]
- nextUp(double) - Static method in class org.hipparchus.util.FastMath
-
Compute next number towards positive infinity.
- nextUp(float) - Static method in class org.hipparchus.util.FastMath
-
Compute next number towards positive infinity.
- nextVector() - Method in class org.hipparchus.random.CorrelatedRandomVectorGenerator
-
Generate a correlated random vector.
- nextVector() - Method in class org.hipparchus.random.HaltonSequenceGenerator
-
Generate a random vector.
- nextVector() - Method in interface org.hipparchus.random.RandomVectorGenerator
-
Generate a random vector.
- nextVector() - Method in class org.hipparchus.random.SobolSequenceGenerator
-
Generate a random vector.
- nextVector() - Method in class org.hipparchus.random.UncorrelatedRandomVectorGenerator
-
Generate an uncorrelated random vector.
- nextVector() - Method in class org.hipparchus.random.UnitSphereRandomVectorGenerator
-
Generate a random vector.
- nextZipf(int, double) - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns an integer value following a Zipf distribution with the given parameter.
- NO_BIN_SELECTED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NO_BIN_SELECTED.
- NO_BIN_SELECTED - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NO_BIN_SELECTED.
- NO_CONVERGENCE_WITH_ANY_START_POINT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NO_CONVERGENCE_WITH_ANY_START_POINT.
- NO_CONVERGENCE_WITH_ANY_START_POINT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NO_CONVERGENCE_WITH_ANY_START_POINT.
- NO_DATA - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NO_DATA.
- NO_DATA - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NO_DATA.
- NO_DEGREES_OF_FREEDOM - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NO_DEGREES_OF_FREEDOM.
- NO_DEGREES_OF_FREEDOM - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NO_DEGREES_OF_FREEDOM.
- NO_DENSITY_FOR_THIS_DISTRIBUTION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NO_DENSITY_FOR_THIS_DISTRIBUTION.
- NO_DENSITY_FOR_THIS_DISTRIBUTION - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NO_DENSITY_FOR_THIS_DISTRIBUTION.
- NO_FEASIBLE_SOLUTION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NO_FEASIBLE_SOLUTION.
- NO_FEASIBLE_SOLUTION - Enum constant in enum org.hipparchus.optim.LocalizedOptimFormats
-
NO_FEASIBLE_SOLUTION.
- NO_OPTIMUM_COMPUTED_YET - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NO_OPTIMUM_COMPUTED_YET.
- NO_OPTIMUM_COMPUTED_YET - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NO_OPTIMUM_COMPUTED_YET.
- NO_REGRESSORS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NO_REGRESSORS.
- NO_REGRESSORS - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
NO_REGRESSORS.
- NO_RESULT_AVAILABLE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NO_RESULT_AVAILABLE.
- NO_RESULT_AVAILABLE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NO_RESULT_AVAILABLE.
- NO_SUCH_MATRIX_ENTRY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NO_SUCH_MATRIX_ENTRY.
- NO_SUCH_MATRIX_ENTRY - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NO_SUCH_MATRIX_ENTRY.
- NoBracketingException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NoBracketingException(double, double, double, double) - Constructor for exception org.hipparchus.migration.exception.NoBracketingException
-
Deprecated.Construct the exception.
- NoBracketingException(Localizable, double, double, double, double, Object...) - Constructor for exception org.hipparchus.migration.exception.NoBracketingException
-
Deprecated.Construct the exception with a specific context.
- NoDataException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NoDataException() - Constructor for exception org.hipparchus.migration.exception.NoDataException
-
Deprecated.Construct the exception.
- NoDataException(Localizable) - Constructor for exception org.hipparchus.migration.exception.NoDataException
-
Deprecated.Construct the exception with a specific context.
- node(int) - Method in class org.hipparchus.analysis.interpolation.GridAxis
-
Get the interpolation node at specified index.
- NodesSet<S extends Space> - Class in org.hipparchus.geometry.partitioning
-
Set of
BSP tree
nodes. - NodesSet() - Constructor for class org.hipparchus.geometry.partitioning.NodesSet
-
Simple constructor.
- NoFeasibleSolutionException - Exception in org.hipparchus.migration.optim.linear
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalStateException
- NoFeasibleSolutionException() - Constructor for exception org.hipparchus.migration.optim.linear.NoFeasibleSolutionException
-
Deprecated.Simple constructor using a default message.
- nome(double) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the nome q.
- nome(T) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the nome q.
- NON_CONVERGENT_CONTINUED_FRACTION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NON_CONVERGENT_CONTINUED_FRACTION.
- NON_CONVERGENT_CONTINUED_FRACTION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NON_CONVERGENT_CONTINUED_FRACTION.
- NON_INVERTIBLE_TRANSFORM - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
NON_INVERTIBLE_TRANSFORM.
- NON_INVERTIBLE_TRANSFORM - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NON_INVERTIBLE_TRANSFORM.
- NON_POSITIVE_DEFINITE_MATRIX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NON_POSITIVE_DEFINITE_MATRIX.
- NON_POSITIVE_DEFINITE_MATRIX - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NON_POSITIVE_DEFINITE_MATRIX.
- NON_POSITIVE_DEFINITE_OPERATOR - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NON_POSITIVE_DEFINITE_OPERATOR.
- NON_POSITIVE_DEFINITE_OPERATOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NON_POSITIVE_DEFINITE_OPERATOR.
- NON_POSITIVE_MICROSPHERE_ELEMENTS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NON_POSITIVE_MICROSPHERE_ELEMENTS.
- NON_POSITIVE_MICROSPHERE_ELEMENTS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NON_POSITIVE_MICROSPHERE_ELEMENTS.
- NON_POSITIVE_POLYNOMIAL_DEGREE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NON_POSITIVE_POLYNOMIAL_DEGREE.
- NON_POSITIVE_POLYNOMIAL_DEGREE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NON_POSITIVE_POLYNOMIAL_DEGREE.
- NON_REAL_FINITE_ABSCISSA - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NON_REAL_FINITE_ABSCISSA.
- NON_REAL_FINITE_ABSCISSA - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NON_REAL_FINITE_ABSCISSA.
- NON_REAL_FINITE_ORDINATE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NON_REAL_FINITE_ORDINATE.
- NON_REAL_FINITE_ORDINATE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NON_REAL_FINITE_ORDINATE.
- NON_REAL_FINITE_WEIGHT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NON_REAL_FINITE_WEIGHT.
- NON_REAL_FINITE_WEIGHT - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NON_REAL_FINITE_WEIGHT.
- NON_SELF_ADJOINT_OPERATOR - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NON_SELF_ADJOINT_OPERATOR.
- NON_SELF_ADJOINT_OPERATOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NON_SELF_ADJOINT_OPERATOR.
- NON_SQUARE_MATRIX - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NON_SQUARE_MATRIX.
- NON_SQUARE_MATRIX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NON_SQUARE_MATRIX.
- NON_SQUARE_OPERATOR - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NON_SQUARE_OPERATOR.
- NON_SQUARE_OPERATOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NON_SQUARE_OPERATOR.
- NON_SYMMETRIC_MATRIX - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NON_SYMMETRIC_MATRIX.
- NON_SYMMETRIC_MATRIX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NON_SYMMETRIC_MATRIX.
- NonLinearConjugateGradientOptimizer - Class in org.hipparchus.optim.nonlinear.scalar.gradient
-
Non-linear conjugate gradient optimizer.
- NonLinearConjugateGradientOptimizer(NonLinearConjugateGradientOptimizer.Formula, ConvergenceChecker<PointValuePair>) - Constructor for class org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
-
Constructor with default tolerances for the line search (1e-8) and
preconditioner
. - NonLinearConjugateGradientOptimizer(NonLinearConjugateGradientOptimizer.Formula, ConvergenceChecker<PointValuePair>, double, double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
-
Constructor with default
preconditioner
. - NonLinearConjugateGradientOptimizer(NonLinearConjugateGradientOptimizer.Formula, ConvergenceChecker<PointValuePair>, double, double, double, Preconditioner) - Constructor for class org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
-
Simple constructor.
- NonLinearConjugateGradientOptimizer.Formula - Enum in org.hipparchus.optim.nonlinear.scalar.gradient
-
Available choices of update formulas for the updating the parameter that is used to compute the successive conjugate search directions.
- NonLinearConjugateGradientOptimizer.IdentityPreconditioner - Class in org.hipparchus.optim.nonlinear.scalar.gradient
-
Default identity preconditioner.
- NonLinearEvolution - Class in org.hipparchus.filtering.kalman.extended
-
Container for
non-linear process
evolution data. - NonLinearEvolution(double, RealVector, RealMatrix, RealMatrix, RealMatrix) - Constructor for class org.hipparchus.filtering.kalman.extended.NonLinearEvolution
-
Simple constructor.
- NonLinearProcess<T extends Measurement> - Interface in org.hipparchus.filtering.kalman.extended
-
Non-linear process that can be estimated by a
ExtendedKalmanFilter
. - NonMonotonicSequenceException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NonMonotonicSequenceException(Number, Number, int) - Constructor for exception org.hipparchus.migration.exception.NonMonotonicSequenceException
-
Deprecated.Construct the exception.
- NonMonotonicSequenceException(Number, Number, int, MathArrays.OrderDirection, boolean) - Constructor for exception org.hipparchus.migration.exception.NonMonotonicSequenceException
-
Deprecated.Construct the exception.
- NonNegativeConstraint - Class in org.hipparchus.optim.linear
-
A constraint for a linear optimization problem indicating whether all variables must be restricted to non-negative values.
- NonNegativeConstraint(boolean) - Constructor for class org.hipparchus.optim.linear.NonNegativeConstraint
-
Simple constructor.
- NonPositiveDefiniteMatrixException - Exception in org.hipparchus.migration.linear
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NonPositiveDefiniteMatrixException(double, int, double) - Constructor for exception org.hipparchus.migration.linear.NonPositiveDefiniteMatrixException
-
Deprecated.Construct an exception.
- NonPositiveDefiniteOperatorException - Exception in org.hipparchus.migration.linear
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NonPositiveDefiniteOperatorException() - Constructor for exception org.hipparchus.migration.linear.NonPositiveDefiniteOperatorException
-
Deprecated.Creates a new instance of this class.
- NonSelfAdjointOperatorException - Exception in org.hipparchus.migration.linear
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NonSelfAdjointOperatorException() - Constructor for exception org.hipparchus.migration.linear.NonSelfAdjointOperatorException
-
Deprecated.Creates a new instance of this class.
- NonSquareMatrixException - Exception in org.hipparchus.migration.linear
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NonSquareMatrixException(int, int) - Constructor for exception org.hipparchus.migration.linear.NonSquareMatrixException
-
Deprecated.Construct an exception from the mismatched dimensions.
- NonSquareOperatorException - Exception in org.hipparchus.migration.linear
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NonSquareOperatorException(int, int) - Constructor for exception org.hipparchus.migration.linear.NonSquareOperatorException
-
Deprecated.Construct an exception from the mismatched dimensions.
- NonSymmetricMatrixException - Exception in org.hipparchus.migration.linear
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NonSymmetricMatrixException(int, int, double) - Constructor for exception org.hipparchus.migration.linear.NonSymmetricMatrixException
-
Deprecated.Construct an exception.
- nordsieck - Variable in class org.hipparchus.ode.MultistepFieldIntegrator
-
Nordsieck matrix of the higher scaled derivatives.
- nordsieck - Variable in class org.hipparchus.ode.MultistepIntegrator
-
Nordsieck matrix of the higher scaled derivatives.
- norm() - Method in interface org.hipparchus.CalculusFieldElement
-
norm.
- norm() - Method in class org.hipparchus.complex.Complex
-
norm.
- norm(T) - Static method in class org.hipparchus.util.FastMath
-
Norm.
- NORM - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NORM.
- NORM - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NORM.
- normalApproximateProbability(int) - Method in class org.hipparchus.distribution.discrete.PoissonDistribution
-
Calculates the Poisson distribution function using a normal approximation.
- NormalDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the normal (gaussian) distribution.
- NormalDistribution() - Constructor for class org.hipparchus.distribution.continuous.NormalDistribution
-
Create a normal distribution with mean equal to zero and standard deviation equal to one.
- NormalDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.NormalDistribution
-
Create a normal distribution using the given mean, standard deviation.
- normalize() - Method in class org.hipparchus.complex.Quaternion
-
Computes the normalized quaternion (the versor of the instance).
- normalize() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get a normalized vector aligned with the instance.
- normalize() - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Get a normalized vector aligned with the instance.
- normalize() - Method in interface org.hipparchus.geometry.Vector
-
Get a normalized vector aligned with the instance.
- normalize(double...) - Static method in class org.hipparchus.stat.StatUtils
-
Normalize (standardize) the sample, so it is has a mean of 0 and a standard deviation of 1.
- normalize(double, int) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPModifiedRuizEquilibrium
-
Normalize matrices.
- normalize(List<Vector2D>) - Static method in class org.hipparchus.samples.LowDiscrepancyGeneratorComparison
-
Normalize points.
- normalize(List<Vector2D>, double, double, double, double) - Static method in class org.hipparchus.samples.ClusterAlgorithmComparison
-
Normolize points in a rectangular area
- NORMALIZE_INFINITE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NORMALIZE_INFINITE.
- NORMALIZE_INFINITE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NORMALIZE_INFINITE.
- NORMALIZE_NAN - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NORMALIZE_NAN.
- NORMALIZE_NAN - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NORMALIZE_NAN.
- normalizeAngle(double, double) - Static method in class org.hipparchus.util.MathUtils
-
Normalize an angle in a 2π wide interval around a center value.
- normalizeAngle(T, T) - Static method in class org.hipparchus.util.MathUtils
-
Normalize an angle in a 2π wide interval around a center value.
- normalizeArray(double[], double) - Static method in class org.hipparchus.util.MathArrays
-
Normalizes an array to make it sum to a specified value.
- NormalizedRandomGenerator - Interface in org.hipparchus.random
-
This interface represent a normalized random generator for scalars.
- normalizeInput(double, double, double) - Method in class org.hipparchus.analysis.polynomials.SmoothStepFactory.SmoothStepFunction
-
Normalize input between left and right edges.
- normalizeInput(double, double, T) - Method in class org.hipparchus.analysis.polynomials.SmoothStepFactory.FieldSmoothStepFunction
-
Normalize input between left and right edges.
- NoSubSpaceException() - Constructor for exception org.hipparchus.geometry.euclidean.oned.Euclidean1D.NoSubSpaceException
-
Simple constructor.
- NoSubSpaceException() - Constructor for exception org.hipparchus.geometry.spherical.oned.Sphere1D.NoSubSpaceException
-
Simple constructor.
- NOT_ADDITION_COMPATIBLE_MATRICES - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_ADDITION_COMPATIBLE_MATRICES.
- NOT_ADDITION_COMPATIBLE_MATRICES - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_ADDITION_COMPATIBLE_MATRICES.
- NOT_BRACKETING_INTERVAL - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NOT_BRACKETING_INTERVAL.
- NOT_BRACKETING_INTERVAL - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_BRACKETING_INTERVAL.
- NOT_CONVEX - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
NOT_CONVEX.
- NOT_CONVEX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_CONVEX.
- NOT_CONVEX_HYPERPLANES - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
NOT_CONVEX_HYPERPLANES.
- NOT_CONVEX_HYPERPLANES - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_CONVEX_HYPERPLANES.
- NOT_DECREASING_NUMBER_OF_POINTS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_DECREASING_NUMBER_OF_POINTS.
- NOT_DECREASING_NUMBER_OF_POINTS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_DECREASING_NUMBER_OF_POINTS.
- NOT_DECREASING_SEQUENCE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NOT_DECREASING_SEQUENCE.
- NOT_DECREASING_SEQUENCE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_DECREASING_SEQUENCE.
- NOT_ENOUGH_DATA_FOR_NUMBER_OF_PREDICTORS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_ENOUGH_DATA_FOR_NUMBER_OF_PREDICTORS.
- NOT_ENOUGH_DATA_FOR_NUMBER_OF_PREDICTORS - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
NOT_ENOUGH_DATA_FOR_NUMBER_OF_PREDICTORS.
- NOT_ENOUGH_DATA_REGRESSION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_ENOUGH_DATA_REGRESSION.
- NOT_ENOUGH_DATA_REGRESSION - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
NOT_ENOUGH_DATA_REGRESSION.
- NOT_ENOUGH_POINTS_IN_SPLINE_PARTITION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NOT_ENOUGH_POINTS_IN_SPLINE_PARTITION.
- NOT_ENOUGH_POINTS_IN_SPLINE_PARTITION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_ENOUGH_POINTS_IN_SPLINE_PARTITION.
- NOT_FINITE_NUMBER - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NOT_FINITE_NUMBER.
- NOT_FINITE_NUMBER - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_FINITE_NUMBER.
- NOT_INCREASING_NUMBER_OF_POINTS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_INCREASING_NUMBER_OF_POINTS.
- NOT_INCREASING_NUMBER_OF_POINTS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_INCREASING_NUMBER_OF_POINTS.
- NOT_INCREASING_SEQUENCE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NOT_INCREASING_SEQUENCE.
- NOT_INCREASING_SEQUENCE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_INCREASING_SEQUENCE.
- NOT_MULTIPLICATION_COMPATIBLE_MATRICES - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_MULTIPLICATION_COMPATIBLE_MATRICES.
- NOT_MULTIPLICATION_COMPATIBLE_MATRICES - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_MULTIPLICATION_COMPATIBLE_MATRICES.
- NOT_POSITIVE_DEFINITE_MATRIX - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NOT_POSITIVE_DEFINITE_MATRIX.
- NOT_POSITIVE_DEFINITE_MATRIX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_DEFINITE_MATRIX.
- NOT_POSITIVE_DEGREES_OF_FREEDOM - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_DEGREES_OF_FREEDOM.
- NOT_POSITIVE_DEGREES_OF_FREEDOM - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_POSITIVE_DEGREES_OF_FREEDOM.
- NOT_POSITIVE_ELEMENT_AT_INDEX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_ELEMENT_AT_INDEX.
- NOT_POSITIVE_ELEMENT_AT_INDEX - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_POSITIVE_ELEMENT_AT_INDEX.
- NOT_POSITIVE_EXPONENT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NOT_POSITIVE_EXPONENT.
- NOT_POSITIVE_EXPONENT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_EXPONENT.
- NOT_POSITIVE_LENGTH - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_LENGTH.
- NOT_POSITIVE_LENGTH - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_POSITIVE_LENGTH.
- NOT_POSITIVE_MEAN - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_MEAN.
- NOT_POSITIVE_MEAN - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_POSITIVE_MEAN.
- NOT_POSITIVE_NUMBER_OF_SAMPLES - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NOT_POSITIVE_NUMBER_OF_SAMPLES.
- NOT_POSITIVE_NUMBER_OF_SAMPLES - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_NUMBER_OF_SAMPLES.
- NOT_POSITIVE_PERMUTATION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_PERMUTATION.
- NOT_POSITIVE_PERMUTATION - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_POSITIVE_PERMUTATION.
- NOT_POSITIVE_POISSON_MEAN - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_POISSON_MEAN.
- NOT_POSITIVE_POISSON_MEAN - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_POSITIVE_POISSON_MEAN.
- NOT_POSITIVE_POPULATION_SIZE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_POPULATION_SIZE.
- NOT_POSITIVE_POPULATION_SIZE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_POSITIVE_POPULATION_SIZE.
- NOT_POSITIVE_ROW_DIMENSION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_ROW_DIMENSION.
- NOT_POSITIVE_ROW_DIMENSION - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_POSITIVE_ROW_DIMENSION.
- NOT_POSITIVE_SAMPLE_SIZE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_SAMPLE_SIZE.
- NOT_POSITIVE_SAMPLE_SIZE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_POSITIVE_SAMPLE_SIZE.
- NOT_POSITIVE_SCALE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NOT_POSITIVE_SCALE.
- NOT_POSITIVE_SCALE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_SCALE.
- NOT_POSITIVE_SHAPE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_SHAPE.
- NOT_POSITIVE_SHAPE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_POSITIVE_SHAPE.
- NOT_POSITIVE_STANDARD_DEVIATION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_STANDARD_DEVIATION.
- NOT_POSITIVE_STANDARD_DEVIATION - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_POSITIVE_STANDARD_DEVIATION.
- NOT_POSITIVE_UPPER_BOUND - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_UPPER_BOUND.
- NOT_POSITIVE_UPPER_BOUND - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_POSITIVE_UPPER_BOUND.
- NOT_POSITIVE_WINDOW_SIZE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NOT_POSITIVE_WINDOW_SIZE.
- NOT_POSITIVE_WINDOW_SIZE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POSITIVE_WINDOW_SIZE.
- NOT_POWER_OF_TWO - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POWER_OF_TWO.
- NOT_POWER_OF_TWO - Enum constant in enum org.hipparchus.transform.LocalizedFFTFormats
-
NOT_POWER_OF_TWO.
- NOT_POWER_OF_TWO_CONSIDER_PADDING - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POWER_OF_TWO_CONSIDER_PADDING.
- NOT_POWER_OF_TWO_CONSIDER_PADDING - Enum constant in enum org.hipparchus.transform.LocalizedFFTFormats
-
NOT_POWER_OF_TWO_CONSIDER_PADDING.
- NOT_POWER_OF_TWO_PLUS_ONE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_POWER_OF_TWO_PLUS_ONE.
- NOT_POWER_OF_TWO_PLUS_ONE - Enum constant in enum org.hipparchus.transform.LocalizedFFTFormats
-
NOT_POWER_OF_TWO_PLUS_ONE.
- NOT_STRICTLY_DECREASING_NUMBER_OF_POINTS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_STRICTLY_DECREASING_NUMBER_OF_POINTS.
- NOT_STRICTLY_DECREASING_NUMBER_OF_POINTS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_STRICTLY_DECREASING_NUMBER_OF_POINTS.
- NOT_STRICTLY_DECREASING_SEQUENCE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NOT_STRICTLY_DECREASING_SEQUENCE.
- NOT_STRICTLY_DECREASING_SEQUENCE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_STRICTLY_DECREASING_SEQUENCE.
- NOT_STRICTLY_INCREASING_KNOT_VALUES - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_STRICTLY_INCREASING_KNOT_VALUES.
- NOT_STRICTLY_INCREASING_KNOT_VALUES - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_STRICTLY_INCREASING_KNOT_VALUES.
- NOT_STRICTLY_INCREASING_NUMBER_OF_POINTS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_STRICTLY_INCREASING_NUMBER_OF_POINTS.
- NOT_STRICTLY_INCREASING_NUMBER_OF_POINTS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_STRICTLY_INCREASING_NUMBER_OF_POINTS.
- NOT_STRICTLY_INCREASING_SEQUENCE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NOT_STRICTLY_INCREASING_SEQUENCE.
- NOT_STRICTLY_INCREASING_SEQUENCE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_STRICTLY_INCREASING_SEQUENCE.
- NOT_SUBTRACTION_COMPATIBLE_MATRICES - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_SUBTRACTION_COMPATIBLE_MATRICES.
- NOT_SUBTRACTION_COMPATIBLE_MATRICES - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_SUBTRACTION_COMPATIBLE_MATRICES.
- NOT_SUPPORTED_IN_DIMENSION_N - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
NOT_SUPPORTED_IN_DIMENSION_N.
- NOT_SUPPORTED_IN_DIMENSION_N - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_SUPPORTED_IN_DIMENSION_N.
- NOT_SUPPORTED_NAN_STRATEGY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_SUPPORTED_NAN_STRATEGY.
- NOT_SUPPORTED_NAN_STRATEGY - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
NOT_SUPPORTED_NAN_STRATEGY.
- NOT_SYMMETRIC_MATRIX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NOT_SYMMETRIC_MATRIX.
- NOT_SYMMETRIC_MATRIX - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.NOT_SYMMETRIC_MATRIX.
- NotANumberException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NotANumberException() - Constructor for exception org.hipparchus.migration.exception.NotANumberException
-
Deprecated.Construct the exception.
- NotARotationMatrixException - Exception in org.hipparchus.migration.geometry.euclidean.threed
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalStateException
- NotARotationMatrixException(Localizable, Object...) - Constructor for exception org.hipparchus.migration.geometry.euclidean.threed.NotARotationMatrixException
-
Deprecated.Simple constructor.
- NotFiniteNumberException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NotFiniteNumberException(Number, Object...) - Constructor for exception org.hipparchus.migration.exception.NotFiniteNumberException
-
Deprecated.Construct the exception.
- NotFiniteNumberException(Localizable, Number, Object...) - Constructor for exception org.hipparchus.migration.exception.NotFiniteNumberException
-
Deprecated.Construct the exception with a specific context.
- NotPositiveException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NotPositiveException(Number) - Constructor for exception org.hipparchus.migration.exception.NotPositiveException
-
Deprecated.Construct the exception.
- NotPositiveException(Localizable, Number) - Constructor for exception org.hipparchus.migration.exception.NotPositiveException
-
Deprecated.Construct the exception with a specific context.
- NotStrictlyPositiveException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NotStrictlyPositiveException(Number) - Constructor for exception org.hipparchus.migration.exception.NotStrictlyPositiveException
-
Deprecated.Construct the exception.
- NotStrictlyPositiveException(Localizable, Number) - Constructor for exception org.hipparchus.migration.exception.NotStrictlyPositiveException
-
Deprecated.Construct the exception with a specific context.
- ns() - Method in class org.hipparchus.special.elliptic.jacobi.CopolarS
-
Get the value of the ns function.
- ns() - Method in class org.hipparchus.special.elliptic.jacobi.FieldCopolarS
-
Get the value of the ns function.
- nthRoot(int) - Method in class org.hipparchus.complex.Complex
-
Computes the n-th roots of this complex number.
- nthRoot(int) - Method in class org.hipparchus.complex.FieldComplex
-
Computes the n-th roots of this complex number.
- NULL_NOT_ALLOWED - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NULL_NOT_ALLOWED.
- NULL_NOT_ALLOWED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NULL_NOT_ALLOWED.
- NullArgumentException - Exception in org.hipparchus.exception
-
All conditions checks that fail due to a
null
argument must throw this exception. - NullArgumentException() - Constructor for exception org.hipparchus.exception.NullArgumentException
-
Default constructor.
- NullArgumentException(Localizable, Object...) - Constructor for exception org.hipparchus.exception.NullArgumentException
-
Simple constructor.
- NUMBER_OF_ELEMENTS_SHOULD_BE_POSITIVE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMBER_OF_ELEMENTS_SHOULD_BE_POSITIVE.
- NUMBER_OF_ELEMENTS_SHOULD_BE_POSITIVE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMBER_OF_ELEMENTS_SHOULD_BE_POSITIVE.
- NUMBER_OF_INTERPOLATION_POINTS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMBER_OF_INTERPOLATION_POINTS.
- NUMBER_OF_INTERPOLATION_POINTS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMBER_OF_INTERPOLATION_POINTS.
- NUMBER_OF_POINTS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMBER_OF_POINTS.
- NUMBER_OF_POINTS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMBER_OF_POINTS.
- NUMBER_OF_SAMPLES - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMBER_OF_SAMPLES.
- NUMBER_OF_SAMPLES - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMBER_OF_SAMPLES.
- NUMBER_OF_SUCCESS_LARGER_THAN_POPULATION_SIZE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMBER_OF_SUCCESS_LARGER_THAN_POPULATION_SIZE.
- NUMBER_OF_SUCCESS_LARGER_THAN_POPULATION_SIZE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMBER_OF_SUCCESS_LARGER_THAN_POPULATION_SIZE.
- NUMBER_OF_SUCCESSES - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMBER_OF_SUCCESSES.
- NUMBER_OF_SUCCESSES - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMBER_OF_SUCCESSES.
- NUMBER_OF_TRIALS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMBER_OF_TRIALS.
- NUMBER_OF_TRIALS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMBER_OF_TRIALS.
- NUMBER_TOO_LARGE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMBER_TOO_LARGE.
- NUMBER_TOO_LARGE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMBER_TOO_LARGE.
- NUMBER_TOO_LARGE_BOUND_EXCLUDED - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMBER_TOO_LARGE_BOUND_EXCLUDED.
- NUMBER_TOO_LARGE_BOUND_EXCLUDED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMBER_TOO_LARGE_BOUND_EXCLUDED.
- NUMBER_TOO_SMALL - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMBER_TOO_SMALL.
- NUMBER_TOO_SMALL - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMBER_TOO_SMALL.
- NUMBER_TOO_SMALL_BOUND_EXCLUDED - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMBER_TOO_SMALL_BOUND_EXCLUDED.
- NUMBER_TOO_SMALL_BOUND_EXCLUDED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMBER_TOO_SMALL_BOUND_EXCLUDED.
- NumberIsTooLargeException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NumberIsTooLargeException(Number, Number, boolean) - Constructor for exception org.hipparchus.migration.exception.NumberIsTooLargeException
-
Deprecated.Construct the exception.
- NumberIsTooLargeException(Localizable, Number, Number, boolean) - Constructor for exception org.hipparchus.migration.exception.NumberIsTooLargeException
-
Deprecated.Construct the exception with a specific context.
- NumberIsTooSmallException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- NumberIsTooSmallException(Number, Number, boolean) - Constructor for exception org.hipparchus.migration.exception.NumberIsTooSmallException
-
Deprecated.Construct the exception.
- NumberIsTooSmallException(Localizable, Number, Number, boolean) - Constructor for exception org.hipparchus.migration.exception.NumberIsTooSmallException
-
Deprecated.Construct the exception with a specific context.
- NUMERATOR - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMERATOR.
- NUMERATOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMERATOR.
- NUMERATOR_FORMAT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMERATOR_FORMAT.
- NUMERATOR_FORMAT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMERATOR_FORMAT.
- NUMERATOR_OVERFLOW_AFTER_MULTIPLY - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
NUMERATOR_OVERFLOW_AFTER_MULTIPLY.
- NUMERATOR_OVERFLOW_AFTER_MULTIPLY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.NUMERATOR_OVERFLOW_AFTER_MULTIPLY.
- numVars() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Deprecated.
O
- OBJECT_TRANSFORMATION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OBJECT_TRANSFORMATION.
- OBJECT_TRANSFORMATION - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.OBJECT_TRANSFORMATION.
- ObjectiveFunction - Class in org.hipparchus.optim.nonlinear.scalar
-
Scalar function to be optimized.
- ObjectiveFunction(MultivariateFunction) - Constructor for class org.hipparchus.optim.nonlinear.scalar.ObjectiveFunction
-
Simple constructor.
- ObjectiveFunctionGradient - Class in org.hipparchus.optim.nonlinear.scalar
-
Gradient of the scalar function to be optimized.
- ObjectiveFunctionGradient(MultivariateVectorFunction) - Constructor for class org.hipparchus.optim.nonlinear.scalar.ObjectiveFunctionGradient
-
Simple constructor.
- OBSERVED_COUNTS_ALL_ZERO - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OBSERVED_COUNTS_ALL_ZERO.
- OBSERVED_COUNTS_ALL_ZERO - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.OBSERVED_COUNTS_ALL_ZERO.
- OBSERVED_COUNTS_BOTTH_ZERO_FOR_ENTRY - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
OBSERVED_COUNTS_BOTTH_ZERO_FOR_ENTRY.
- OBSERVED_COUNTS_BOTTH_ZERO_FOR_ENTRY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OBSERVED_COUNTS_BOTTH_ZERO_FOR_ENTRY.
- OCTAVE_FORMAT - Static variable in class org.hipparchus.linear.MatrixUtils
-
A format for
RealMatrix
objects compatible with octave. - ODEEventDetector - Interface in org.hipparchus.ode.events
-
This interface represents a detector for discrete events triggered during ODE integration.
- ODEEventHandler - Interface in org.hipparchus.ode.events
-
This interface represents a handler for discrete events triggered during ODE integration.
- ODEFixedStepHandler - Interface in org.hipparchus.ode.sampling
-
This interface represents a handler that should be called after each successful fixed step.
- ODEIntegrator - Interface in org.hipparchus.ode
-
This interface represents a first order integrator for differential equations.
- ODEJacobiansProvider - Interface in org.hipparchus.ode
-
Interface expanding
first order differential equations
in order to compute exactly the Jacobian matrices forpartial derivatives equations
. - ODEState - Class in org.hipparchus.ode
-
Container for time, main and secondary state vectors.
- ODEState(double, double[]) - Constructor for class org.hipparchus.ode.ODEState
-
Simple constructor.
- ODEState(double, double[], double[][]) - Constructor for class org.hipparchus.ode.ODEState
-
Simple constructor.
- ODEStateAndDerivative - Class in org.hipparchus.ode
-
Container for time, main and secondary state vectors as well as their derivatives.
- ODEStateAndDerivative(double, double[], double[]) - Constructor for class org.hipparchus.ode.ODEStateAndDerivative
-
Simple constructor.
- ODEStateAndDerivative(double, double[], double[], double[][], double[][]) - Constructor for class org.hipparchus.ode.ODEStateAndDerivative
-
Simple constructor.
- ODEStateInterpolator - Interface in org.hipparchus.ode.sampling
-
This interface represents an interpolator over the last step during an ODE integration.
- ODEStepEndHandler - Interface in org.hipparchus.ode.events
-
This interface represents a handler for discrete events triggered during ODE integration at each step end.
- ODEStepHandler - Interface in org.hipparchus.ode.sampling
-
This interface represents a handler that should be called after each successful step.
- of(LeastSquaresProblem.Evaluation, int, int) - Static method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresOptimizer.Optimum
-
Create a new optimum from an evaluation and the values of the counters.
- of(RandomGenerator) - Static method in class org.hipparchus.random.RandomAdaptor
-
Factory method to create a
Random
using the suppliedRandomGenerator
. - of(RandomGenerator) - Static method in class org.hipparchus.random.RandomDataGenerator
-
Factory method to create a
RandomData
instance using the suppliedRandomGenerator
. - OLSMultipleLinearRegression - Class in org.hipparchus.stat.regression
-
Implements ordinary least squares (OLS) to estimate the parameters of a multiple linear regression model.
- OLSMultipleLinearRegression() - Constructor for class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Create an empty OLSMultipleLinearRegression instance.
- OLSMultipleLinearRegression(double) - Constructor for class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Create an empty OLSMultipleLinearRegression instance, using the given singularity threshold for the QR decomposition.
- ONE - Static variable in class org.hipparchus.complex.Complex
-
A complex number representing "1.0 + 0.0i".
- ONE - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "1".
- ONE - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "1".
- ONE - Static variable in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Unit (coordinates: 1).
- ONE - Static variable in class org.hipparchus.util.BigReal
-
A big real representing 1.
- ONE - Static variable in class org.hipparchus.util.Binary64
-
The constant value of
1d
as aBinary64
. - ONE_FIFTH - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "1/5".
- ONE_FIFTH - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "1/5".
- ONE_HALF - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "1/2".
- ONE_HALF - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "1/2".
- ONE_QUARTER - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "1/4".
- ONE_QUARTER - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "1/4".
- ONE_THIRD - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "1/3".
- ONE_THIRD - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "1/3".
- OneWayAnova - Class in org.hipparchus.stat.inference
-
Implements one-way ANOVA (analysis of variance) statistics.
- OneWayAnova() - Constructor for class org.hipparchus.stat.inference.OneWayAnova
-
Empty constructor.
- oneWayAnovaFValue(Collection<double[]>) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes the ANOVA F-value for a collection of
double[]
arrays. - oneWayAnovaPValue(Collection<double[]>) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes the ANOVA P-value for a collection of
double[]
arrays. - oneWayAnovaTest(Collection<double[]>, double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Performs an ANOVA test, evaluating the null hypothesis that there is no difference among the means of the data categories.
- OpenIntToDoubleHashMap - Class in org.hipparchus.util
-
Open addressed map from int to double.
- OpenIntToDoubleHashMap() - Constructor for class org.hipparchus.util.OpenIntToDoubleHashMap
-
Build an empty map with default size and using NaN for missing entries.
- OpenIntToDoubleHashMap(double) - Constructor for class org.hipparchus.util.OpenIntToDoubleHashMap
-
Build an empty map with default size
- OpenIntToDoubleHashMap(int) - Constructor for class org.hipparchus.util.OpenIntToDoubleHashMap
-
Build an empty map with specified size and using NaN for missing entries.
- OpenIntToDoubleHashMap(int, double) - Constructor for class org.hipparchus.util.OpenIntToDoubleHashMap
-
Build an empty map with specified size.
- OpenIntToDoubleHashMap(OpenIntToDoubleHashMap) - Constructor for class org.hipparchus.util.OpenIntToDoubleHashMap
-
Copy constructor.
- OpenIntToDoubleHashMap.Iterator - Class in org.hipparchus.util
-
Iterator class for the map.
- OpenIntToFieldHashMap<T extends FieldElement<T>> - Class in org.hipparchus.util
-
Open addressed map from int to FieldElement.
- OpenIntToFieldHashMap(Field<T>) - Constructor for class org.hipparchus.util.OpenIntToFieldHashMap
-
Build an empty map with default size and using zero for missing entries.
- OpenIntToFieldHashMap(Field<T>, int) - Constructor for class org.hipparchus.util.OpenIntToFieldHashMap
-
Build an empty map with specified size and using zero for missing entries.
- OpenIntToFieldHashMap(Field<T>, int, T) - Constructor for class org.hipparchus.util.OpenIntToFieldHashMap
-
Build an empty map with specified size.
- OpenIntToFieldHashMap(Field<T>, T) - Constructor for class org.hipparchus.util.OpenIntToFieldHashMap
-
Build an empty map with default size
- OpenIntToFieldHashMap(OpenIntToFieldHashMap<T>) - Constructor for class org.hipparchus.util.OpenIntToFieldHashMap
-
Copy constructor.
- OpenIntToFieldHashMap.Iterator - Class in org.hipparchus.util
-
Iterator class for the map.
- OpenMapEntry(OpenIntToDoubleHashMap.Iterator) - Constructor for class org.hipparchus.linear.OpenMapRealVector.OpenMapEntry
-
Build an entry from an iterator point to an element.
- OpenMapRealMatrix - Class in org.hipparchus.linear
-
Sparse matrix implementation based on an open addressed map.
- OpenMapRealMatrix(int, int) - Constructor for class org.hipparchus.linear.OpenMapRealMatrix
-
Build a sparse matrix with the supplied row and column dimensions.
- OpenMapRealMatrix(OpenMapRealMatrix) - Constructor for class org.hipparchus.linear.OpenMapRealMatrix
-
Build a matrix by copying another one.
- OpenMapRealVector - Class in org.hipparchus.linear
-
This class implements the
RealVector
interface with aOpenIntToDoubleHashMap
backing store. - OpenMapRealVector() - Constructor for class org.hipparchus.linear.OpenMapRealVector
-
Build a 0-length vector.
- OpenMapRealVector(double[]) - Constructor for class org.hipparchus.linear.OpenMapRealVector
-
Create from an array.
- OpenMapRealVector(double[], double) - Constructor for class org.hipparchus.linear.OpenMapRealVector
-
Create from an array, specifying zero tolerance.
- OpenMapRealVector(int) - Constructor for class org.hipparchus.linear.OpenMapRealVector
-
Construct a vector of zeroes.
- OpenMapRealVector(int, double) - Constructor for class org.hipparchus.linear.OpenMapRealVector
-
Construct a vector of zeroes, specifying zero tolerance.
- OpenMapRealVector(int, int) - Constructor for class org.hipparchus.linear.OpenMapRealVector
-
Build a vector with known the sparseness (for advanced use only).
- OpenMapRealVector(int, int, double) - Constructor for class org.hipparchus.linear.OpenMapRealVector
-
Build a vector with known the sparseness and zero tolerance setting (for advanced use only).
- OpenMapRealVector(Double[]) - Constructor for class org.hipparchus.linear.OpenMapRealVector
-
Create from an array.
- OpenMapRealVector(Double[], double) - Constructor for class org.hipparchus.linear.OpenMapRealVector
-
Create from an array.
- OpenMapRealVector(OpenMapRealVector) - Constructor for class org.hipparchus.linear.OpenMapRealVector
-
Copy constructor.
- OpenMapRealVector(OpenMapRealVector, int) - Constructor for class org.hipparchus.linear.OpenMapRealVector
-
Build a resized vector, for use with append.
- OpenMapRealVector(RealVector) - Constructor for class org.hipparchus.linear.OpenMapRealVector
-
Generic copy constructor.
- OpenMapRealVector.OpenMapEntry - Class in org.hipparchus.linear
-
Implementation of
Entry
optimized for OpenMap. - OpenMapRealVector.OpenMapSparseIterator - Class in org.hipparchus.linear
-
Iterator class to do iteration over just the non-zero elements.
- OpenMapSparseIterator() - Constructor for class org.hipparchus.linear.OpenMapRealVector.OpenMapSparseIterator
-
Simple constructor.
- operate(double[]) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(double[]) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(double[]) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(double[]) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(double[]) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(FieldVector<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(RealVector) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(RealVector) - Method in class org.hipparchus.linear.JacobiPreconditioner
-
Returns the result of multiplying
this
by the vectorx
. - operate(RealVector) - Method in interface org.hipparchus.linear.RealLinearOperator
-
Returns the result of multiplying
this
by the vectorx
. - operate(RealVector) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(T[]) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(T[]) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(T[]) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(T[]) - Method in interface org.hipparchus.linear.FieldMatrix
-
Returns the result of multiplying this by the vector
v
. - operateTranspose(RealVector) - Method in interface org.hipparchus.linear.RealLinearOperator
-
Returns the result of multiplying the transpose of
this
operator by the vectorx
(optional operation). - OPERATOR - Static variable in class org.hipparchus.linear.ConjugateGradient
-
Key for the exception context.
- oppositeRelationship() - Method in enum org.hipparchus.optim.linear.Relationship
-
Gets the relationship obtained when multiplying all coefficients by -1.
- OptimizationData - Interface in org.hipparchus.optim
-
Marker interface.
- OptimizationProblem<P> - Interface in org.hipparchus.optim
-
Common settings for all optimization problems.
- optimize() - Method in class org.hipparchus.optim.BaseOptimizer
-
Performs the optimization.
- optimize(LeastSquaresProblem) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
-
Solve the non-linear least squares problem.
- optimize(LeastSquaresProblem) - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresOptimizer
-
Solve the non-linear least squares problem.
- optimize(LeastSquaresProblem) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Solve the non-linear least squares problem.
- optimize(LeastSquaresProblem) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
-
Solve the non-linear least squares problem.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.BaseMultiStartMultivariateOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.BaseMultivariateOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.BaseOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.linear.LinearOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.linear.SimplexSolver
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.scalar.GradientMultivariateOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.scalar.MultivariateOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.SimplexOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.AbstractSQPOptimizer
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ConstraintOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.univariate.MultiStartUnivariateOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - Method in class org.hipparchus.optim.univariate.UnivariateOptimizer
-
Stores data and performs the optimization.
- OrderedComplexEigenDecomposition - Class in org.hipparchus.linear
-
Given a matrix A, it computes a complex eigen decomposition A = VDV^{T}.
- OrderedComplexEigenDecomposition(RealMatrix) - Constructor for class org.hipparchus.linear.OrderedComplexEigenDecomposition
-
Constructor for the decomposition.
- OrderedComplexEigenDecomposition(RealMatrix, double, double, double) - Constructor for class org.hipparchus.linear.OrderedComplexEigenDecomposition
-
Constructor for decomposition.
- OrderedComplexEigenDecomposition(RealMatrix, double, double, double, Comparator<Complex>) - Constructor for class org.hipparchus.linear.OrderedComplexEigenDecomposition
-
Constructor for decomposition.
- OrdinaryDifferentialEquation - Interface in org.hipparchus.ode
-
This interface represents a first order differential equations set.
- org.hipparchus - package org.hipparchus
-
Common classes used throughout the Hipparchus library.
- org.hipparchus.analysis - package org.hipparchus.analysis
-
Parent package for common numerical analysis procedures, including root finding, function interpolation and integration.
- org.hipparchus.analysis.differentiation - package org.hipparchus.analysis.differentiation
-
This package holds the main interfaces and basic building block classes dealing with differentiation.
- org.hipparchus.analysis.function - package org.hipparchus.analysis.function
-
The
function
package contains function objects that wrap the methods contained inMath
, as well as common mathematical functions such as the gaussian and sinc functions. - org.hipparchus.analysis.integration - package org.hipparchus.analysis.integration
-
Numerical integration (quadrature) algorithms for univariate real functions.
- org.hipparchus.analysis.integration.gauss - package org.hipparchus.analysis.integration.gauss
-
Gauss family of quadrature schemes.
- org.hipparchus.analysis.interpolation - package org.hipparchus.analysis.interpolation
-
Univariate real functions interpolation algorithms.
- org.hipparchus.analysis.polynomials - package org.hipparchus.analysis.polynomials
-
Univariate real polynomials implementations, seen as differentiable univariate real functions.
- org.hipparchus.analysis.solvers - package org.hipparchus.analysis.solvers
-
Root finding algorithms, for univariate real functions.
- org.hipparchus.clustering - package org.hipparchus.clustering
-
Clustering algorithms.
- org.hipparchus.clustering.distance - package org.hipparchus.clustering.distance
-
Common distance measures.
- org.hipparchus.clustering.evaluation - package org.hipparchus.clustering.evaluation
-
Cluster evaluation methods.
- org.hipparchus.complex - package org.hipparchus.complex
-
Complex number type and implementations of complex transcendental functions.
- org.hipparchus.dfp - package org.hipparchus.dfp
-
Decimal floating point library for Java
- org.hipparchus.distribution - package org.hipparchus.distribution
-
Interfaces and implementations of common discrete and continuous distributions.
- org.hipparchus.distribution.continuous - package org.hipparchus.distribution.continuous
-
Implementations of common continuous distributions.
- org.hipparchus.distribution.discrete - package org.hipparchus.distribution.discrete
-
Implementations of common discrete distributions.
- org.hipparchus.distribution.multivariate - package org.hipparchus.distribution.multivariate
-
Implementations of multivariate distributions.
- org.hipparchus.exception - package org.hipparchus.exception
-
Specialized exceptions for algorithms errors.
- org.hipparchus.filtering - package org.hipparchus.filtering
-
Filtering algorithms, including Kalman filtering).
- org.hipparchus.filtering.kalman - package org.hipparchus.filtering.kalman
-
Kalman filter.
- org.hipparchus.filtering.kalman.extended - package org.hipparchus.filtering.kalman.extended
-
Kalman filter implementation for non-linear processes.
- org.hipparchus.filtering.kalman.linear - package org.hipparchus.filtering.kalman.linear
-
Kalman filter implementation for linear processes.
- org.hipparchus.filtering.kalman.unscented - package org.hipparchus.filtering.kalman.unscented
-
Unscented Kalman filter implementation.
- org.hipparchus.fitting - package org.hipparchus.fitting
-
Classes to perform curve fitting.
- org.hipparchus.fraction - package org.hipparchus.fraction
-
Fraction number type and fraction number formatting.
- org.hipparchus.geometry - package org.hipparchus.geometry
-
This package is the top level package for geometry.
- org.hipparchus.geometry.enclosing - package org.hipparchus.geometry.enclosing
-
This package provides interfaces and classes related to the smallest enclosing ball problem.
- org.hipparchus.geometry.euclidean.oned - package org.hipparchus.geometry.euclidean.oned
-
This package provides basic 1D geometry components.
- org.hipparchus.geometry.euclidean.threed - package org.hipparchus.geometry.euclidean.threed
-
This package provides basic 3D geometry components.
- org.hipparchus.geometry.euclidean.twod - package org.hipparchus.geometry.euclidean.twod
-
This package provides basic 2D geometry components.
- org.hipparchus.geometry.euclidean.twod.hull - package org.hipparchus.geometry.euclidean.twod.hull
-
This package provides algorithms to generate the convex hull for a set of points in an two-dimensional euclidean space.
- org.hipparchus.geometry.hull - package org.hipparchus.geometry.hull
-
This package provides interfaces and classes related to the convex hull problem.
- org.hipparchus.geometry.partitioning - package org.hipparchus.geometry.partitioning
-
This package provides classes to implement Binary Space Partition trees.
- org.hipparchus.geometry.spherical.oned - package org.hipparchus.geometry.spherical.oned
-
This package provides basic geometry components on the 1-sphere.
- org.hipparchus.geometry.spherical.twod - package org.hipparchus.geometry.spherical.twod
-
This package provides basic geometry components on the 2-sphere.
- org.hipparchus.linear - package org.hipparchus.linear
-
Linear algebra support.
- org.hipparchus.migration - package org.hipparchus.migration
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.exception - package org.hipparchus.migration.exception
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.exception.util - package org.hipparchus.migration.exception.util
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.genetics - package org.hipparchus.migration.genetics
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.geometry - package org.hipparchus.migration.geometry
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.geometry.euclidean - package org.hipparchus.migration.geometry.euclidean
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.geometry.euclidean.threed - package org.hipparchus.migration.geometry.euclidean.threed
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.linear - package org.hipparchus.migration.linear
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.ode - package org.hipparchus.migration.ode
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.ode.events - package org.hipparchus.migration.ode.events
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.ode.sampling - package org.hipparchus.migration.ode.sampling
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.optim - package org.hipparchus.migration.optim
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.optim.linear - package org.hipparchus.migration.optim.linear
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.stat - package org.hipparchus.migration.stat
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.stat.regression - package org.hipparchus.migration.stat.regression
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.ode - package org.hipparchus.ode
-
This package provides classes to solve Ordinary Differential Equations problems.
- org.hipparchus.ode.events - package org.hipparchus.ode.events
-
Events
- org.hipparchus.ode.nonstiff - package org.hipparchus.ode.nonstiff
-
This package provides classes to solve non-stiff Ordinary Differential Equations problems.
- org.hipparchus.ode.sampling - package org.hipparchus.ode.sampling
-
This package provides classes to handle sampling steps during Ordinary Differential Equations integration.
- org.hipparchus.optim - package org.hipparchus.optim
-
Generally, optimizers are algorithms that will either
minimize
ormaximize
a scalar function, called theobjective function
. - org.hipparchus.optim.linear - package org.hipparchus.optim.linear
-
Optimization algorithms for linear constrained problems.
- org.hipparchus.optim.nonlinear.scalar - package org.hipparchus.optim.nonlinear.scalar
-
Algorithms for optimizing a scalar function.
- org.hipparchus.optim.nonlinear.scalar.gradient - package org.hipparchus.optim.nonlinear.scalar.gradient
-
This package provides optimization algorithms that require derivatives.
- org.hipparchus.optim.nonlinear.scalar.noderiv - package org.hipparchus.optim.nonlinear.scalar.noderiv
-
This package provides optimization algorithms that do not require derivatives.
- org.hipparchus.optim.nonlinear.vector.constrained - package org.hipparchus.optim.nonlinear.vector.constrained
-
This package provides algorithms that minimize the residuals between observations and model values.
- org.hipparchus.optim.nonlinear.vector.leastsquares - package org.hipparchus.optim.nonlinear.vector.leastsquares
-
This package provides algorithms that minimize the residuals between observations and model values.
- org.hipparchus.optim.univariate - package org.hipparchus.optim.univariate
-
One-dimensional optimization algorithms.
- org.hipparchus.random - package org.hipparchus.random
-
Random number and random data generators.
- org.hipparchus.samples - package org.hipparchus.samples
-
Various examples.
- org.hipparchus.samples.clustering - package org.hipparchus.samples.clustering
-
Clustering examples.
- org.hipparchus.samples.complex - package org.hipparchus.samples.complex
-
Complex functions plots.
- org.hipparchus.samples.geometry - package org.hipparchus.samples.geometry
-
Geometry examples.
- org.hipparchus.special - package org.hipparchus.special
-
Implementations of special functions such as Beta and Gamma.
- org.hipparchus.special.elliptic - package org.hipparchus.special.elliptic
-
Implementations of elliptic functions and integrals.
- org.hipparchus.special.elliptic.carlson - package org.hipparchus.special.elliptic.carlson
-
Implementations of Carlson elliptic integrals.
- org.hipparchus.special.elliptic.jacobi - package org.hipparchus.special.elliptic.jacobi
-
Implementations of Jacobi elliptic functions.
- org.hipparchus.special.elliptic.legendre - package org.hipparchus.special.elliptic.legendre
-
Implementations of Legendre elliptic integrals.
- org.hipparchus.stat - package org.hipparchus.stat
-
Data storage, manipulation and summary routines.
- org.hipparchus.stat.correlation - package org.hipparchus.stat.correlation
-
Correlations/Covariance computations.
- org.hipparchus.stat.descriptive - package org.hipparchus.stat.descriptive
-
Generic univariate and multivariate summary statistic objects.
- org.hipparchus.stat.descriptive.moment - package org.hipparchus.stat.descriptive.moment
-
Summary statistics based on moments.
- org.hipparchus.stat.descriptive.rank - package org.hipparchus.stat.descriptive.rank
-
Summary statistics based on ranks.
- org.hipparchus.stat.descriptive.summary - package org.hipparchus.stat.descriptive.summary
-
Other summary statistics.
- org.hipparchus.stat.descriptive.vector - package org.hipparchus.stat.descriptive.vector
-
Multivariate statistics.
- org.hipparchus.stat.fitting - package org.hipparchus.stat.fitting
-
Statistical methods for fitting distributions.
- org.hipparchus.stat.inference - package org.hipparchus.stat.inference
-
Classes providing hypothesis testing.
- org.hipparchus.stat.interval - package org.hipparchus.stat.interval
-
Utilities to calculate binomial proportion confidence intervals.
- org.hipparchus.stat.projection - package org.hipparchus.stat.projection
-
Parent package for projections like decomposition (principal component analysis).
- org.hipparchus.stat.ranking - package org.hipparchus.stat.ranking
-
Classes providing rank transformations.
- org.hipparchus.stat.regression - package org.hipparchus.stat.regression
-
Statistical routines involving multivariate data.
- org.hipparchus.transform - package org.hipparchus.transform
-
Implementations of transform methods, including Fast Fourier transforms.
- org.hipparchus.util - package org.hipparchus.util
-
Convenience routines and common data structures used throughout the Hipparchus library.
- orientation(FieldVector2D<T>, FieldVector2D<T>, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the orientation of a triplet of points.
- orientation(Vector2D, Vector2D, Vector2D) - Static method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the orientation of a triplet of points.
- OrientedPoint - Class in org.hipparchus.geometry.euclidean.oned
-
This class represents a 1D oriented hyperplane.
- OrientedPoint(Vector1D, boolean, double) - Constructor for class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Simple constructor.
- orthogonal() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get a vector orthogonal to the instance.
- orthogonal() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get a vector orthogonal to the instance.
- ORTHOGONAL_DCT_I - Enum constant in enum org.hipparchus.transform.DctNormalization
-
Should be passed to the constructor of
FastCosineTransformer
to use the orthogonal normalization convention. - ORTHOGONAL_DST_I - Enum constant in enum org.hipparchus.transform.DstNormalization
-
Should be passed to the constructor of
FastSineTransformer
to use the orthogonal normalization convention. - orthonormalize(List<RealVector>, double, DependentVectorsHandler) - Static method in class org.hipparchus.linear.MatrixUtils
-
Orthonormalize a list of vectors.
- orthonormalize(Field<T>, List<FieldVector<T>>, T, DependentVectorsHandler) - Static method in class org.hipparchus.linear.MatrixUtils
-
Orthonormalize a list of vectors.
- OUT_OF_BOUND_SIGNIFICANCE_LEVEL - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OUT_OF_BOUND_SIGNIFICANCE_LEVEL.
- OUT_OF_BOUND_SIGNIFICANCE_LEVEL - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
OUT_OF_BOUND_SIGNIFICANCE_LEVEL.
- OUT_OF_BOUNDS_CONFIDENCE_LEVEL - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OUT_OF_BOUNDS_CONFIDENCE_LEVEL.
- OUT_OF_BOUNDS_CONFIDENCE_LEVEL - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
OUT_OF_BOUNDS_CONFIDENCE_LEVEL.
- OUT_OF_BOUNDS_QUANTILE_VALUE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OUT_OF_BOUNDS_QUANTILE_VALUE.
- OUT_OF_BOUNDS_QUANTILE_VALUE - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
OUT_OF_BOUNDS_QUANTILE_VALUE.
- OUT_OF_ORDER_ABSCISSA_ARRAY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OUT_OF_ORDER_ABSCISSA_ARRAY.
- OUT_OF_ORDER_ABSCISSA_ARRAY - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.OUT_OF_ORDER_ABSCISSA_ARRAY.
- OUT_OF_PLANE - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
OUT_OF_PLANE.
- OUT_OF_PLANE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OUT_OF_PLANE.
- OUT_OF_RANGE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
OUT_OF_RANGE.
- OUT_OF_RANGE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OUT_OF_RANGE.
- OUT_OF_RANGE_LEFT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
OUT_OF_RANGE_LEFT.
- OUT_OF_RANGE_LEFT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OUT_OF_RANGE_LEFT.
- OUT_OF_RANGE_RIGHT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OUT_OF_RANGE_RIGHT.
- OUT_OF_RANGE_RIGHT - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.OUT_OF_RANGE_RIGHT.
- OUT_OF_RANGE_ROOT_OF_UNITY_INDEX - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
OUT_OF_RANGE_ROOT_OF_UNITY_INDEX.
- OUT_OF_RANGE_ROOT_OF_UNITY_INDEX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OUT_OF_RANGE_ROOT_OF_UNITY_INDEX.
- OUT_OF_RANGE_SIMPLE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
OUT_OF_RANGE_SIMPLE.
- OUT_OF_RANGE_SIMPLE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OUT_OF_RANGE_SIMPLE.
- outerProduct(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute the outer product.
- outerProduct(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute the outer product.
- outerProduct(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Compute the outer product.
- outerProduct(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Compute the outer product.
- outerProduct(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Compute the outer product.
- outerProduct(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Compute the outer product.
- outerProduct(SparseFieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Optimized method to compute outer product when both vectors are sparse.
- OUTLINE_BOUNDARY_LOOP_OPEN - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
OUTLINE_BOUNDARY_LOOP_OPEN.
- OUTLINE_BOUNDARY_LOOP_OPEN - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OUTLINE_BOUNDARY_LOOP_OPEN.
- OutlineExtractor - Class in org.hipparchus.geometry.euclidean.threed
-
Extractor for
polyhedrons sets
outlines. - OutlineExtractor(Vector3D, Vector3D) - Constructor for class org.hipparchus.geometry.euclidean.threed.OutlineExtractor
-
Build an extractor for a specific projection plane.
- OutOfRangeException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- OutOfRangeException(Number, Number, Number) - Constructor for exception org.hipparchus.migration.exception.OutOfRangeException
-
Deprecated.Construct an exception from the mismatched dimensions.
- OutOfRangeException(Localizable, Number, Number, Number) - Constructor for exception org.hipparchus.migration.exception.OutOfRangeException
-
Deprecated.Construct an exception from the mismatched dimensions with a specific context information.
- OUTSIDE - Enum constant in enum org.hipparchus.geometry.partitioning.Region.Location
-
Code for points outside of the partition.
- OVERFLOW - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
OVERFLOW.
- OVERFLOW - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OVERFLOW.
- OVERFLOW_IN_ADDITION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
OVERFLOW_IN_ADDITION.
- OVERFLOW_IN_ADDITION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OVERFLOW_IN_ADDITION.
- OVERFLOW_IN_FRACTION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
OVERFLOW_IN_FRACTION.
- OVERFLOW_IN_FRACTION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OVERFLOW_IN_FRACTION.
- OVERFLOW_IN_MULTIPLICATION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
OVERFLOW_IN_MULTIPLICATION.
- OVERFLOW_IN_MULTIPLICATION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OVERFLOW_IN_MULTIPLICATION.
- OVERFLOW_IN_SUBTRACTION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
OVERFLOW_IN_SUBTRACTION.
- OVERFLOW_IN_SUBTRACTION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.OVERFLOW_IN_SUBTRACTION.
- overshoot(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.BoundedConstraint
-
Check how much a point overshoots the constraint.
- overshoot(RealVector) - Method in interface org.hipparchus.optim.nonlinear.vector.constrained.Constraint
-
Check how much a point overshoots the constraint.
P
- paintComponent(Graphics) - Method in class org.hipparchus.samples.ClusterAlgorithmComparison.ClusterPlot
- paintComponent(Graphics) - Method in class org.hipparchus.samples.LowDiscrepancyGeneratorComparison.Plot
- paintConvexHull() - Method in class org.hipparchus.samples.geometry.GeometryExample.Display
-
Paint a convex hull.
- Pair<K,
V> - Class in org.hipparchus.util -
Generic pair.
- Pair(K, V) - Constructor for class org.hipparchus.util.Pair
-
Create an entry representing a mapping from the specified key to the specified value.
- Pair(Pair<? extends K, ? extends V>) - Constructor for class org.hipparchus.util.Pair
-
Create an entry representing the same mapping as the specified entry.
- pairedT(double[], double[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes a paired, 2-sample t-statistic based on the data in the input arrays.
- pairedT(double[], double[]) - Method in class org.hipparchus.stat.inference.TTest
-
Computes a paired, 2-sample t-statistic based on the data in the input arrays.
- pairedTTest(double[], double[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Returns the observed significance level, or p-value, associated with a paired, two-sample, two-tailed t-test based on the data in the input arrays.
- pairedTTest(double[], double[]) - Method in class org.hipparchus.stat.inference.TTest
-
Returns the observed significance level, or p-value, associated with a paired, two-sample, two-tailed t-test based on the data in the input arrays.
- pairedTTest(double[], double[], double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Performs a paired t-test evaluating the null hypothesis that the mean of the paired differences between
sample1
andsample2
is 0 in favor of the two-sided alternative that the mean paired difference is not equal to 0, with significance levelalpha
. - pairedTTest(double[], double[], double) - Method in class org.hipparchus.stat.inference.TTest
-
Performs a paired t-test evaluating the null hypothesis that the mean of the paired differences between
sample1
andsample2
is 0 in favor of the two-sided alternative that the mean paired difference is not equal to 0, with significance levelalpha
. - ParameterConfiguration - Class in org.hipparchus.ode
-
Simple container pairing a parameter name with a step in order to compute the associated Jacobian matrix by finite difference.
- ParameterGuesser(Collection<WeightedObservedPoint>) - Constructor for class org.hipparchus.fitting.GaussianCurveFitter.ParameterGuesser
-
Constructs instance with the specified observed points.
- ParameterGuesser(Collection<WeightedObservedPoint>) - Constructor for class org.hipparchus.fitting.HarmonicCurveFitter.ParameterGuesser
-
Simple constructor.
- Parameterizable - Interface in org.hipparchus.ode
-
This interface enables to process any parameterizable object.
- ParameterJacobianProvider - Interface in org.hipparchus.migration.ode
-
Deprecated.as of 1.0, replaced with
NamedParameterJacobianProvider
- ParametersController - Interface in org.hipparchus.ode
-
Interface to compute by finite difference Jacobian matrix for some parameter when computing
partial derivatives equations
. - parameterValidator(ParameterValidator) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the validator of the model parameters.
- ParameterValidator - Interface in org.hipparchus.optim.nonlinear.vector.leastsquares
-
Interface for validating a set of model parameters.
- Parametric() - Constructor for class org.hipparchus.analysis.function.Gaussian.Parametric
-
Empty constructor.
- Parametric() - Constructor for class org.hipparchus.analysis.function.HarmonicOscillator.Parametric
-
Empty constructor.
- Parametric() - Constructor for class org.hipparchus.analysis.function.Logistic.Parametric
-
Empty constructor.
- Parametric() - Constructor for class org.hipparchus.analysis.function.Logit.Parametric
-
Empty constructor.
- Parametric() - Constructor for class org.hipparchus.analysis.function.Sigmoid.Parametric
-
Empty constructor.
- Parametric() - Constructor for class org.hipparchus.analysis.polynomials.PolynomialFunction.Parametric
-
Empty constructor.
- ParametricUnivariateFunction - Interface in org.hipparchus.analysis
-
An interface representing a real function that depends on one independent variable plus some extra parameters.
- ParetoDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the Pareto distribution.
- ParetoDistribution() - Constructor for class org.hipparchus.distribution.continuous.ParetoDistribution
-
Create a Pareto distribution with a scale of
1
and a shape of1
. - ParetoDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.ParetoDistribution
-
Create a Pareto distribution using the specified scale and shape.
- ParetoDistribution(double, double, double) - Constructor for class org.hipparchus.distribution.continuous.ParetoDistribution
-
Creates a Pareto distribution.
- parse(String) - Method in class org.hipparchus.complex.ComplexFormat
-
Parses a string to produce a
Complex
object. - parse(String) - Method in class org.hipparchus.fraction.BigFractionFormat
-
Parses a string to produce a
BigFraction
object. - parse(String) - Method in class org.hipparchus.fraction.FractionFormat
-
Parses a string to produce a
Fraction
object. - parse(String) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1DFormat
-
Parses a string to produce a
Vector
object. - parse(String) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3DFormat
-
Parses a string to produce a
Vector3D
object. - parse(String) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2DFormat
-
Parses a string to produce a
Vector
object. - parse(String) - Method in class org.hipparchus.geometry.VectorFormat
-
Parses a string to produce a
Vector
object. - parse(String) - Method in class org.hipparchus.linear.RealMatrixFormat
-
Parse a string to produce a
RealMatrix
object. - parse(String) - Method in class org.hipparchus.linear.RealVectorFormat
-
Parse a string to produce a
RealVector
object. - parse(String, ParsePosition) - Method in class org.hipparchus.complex.ComplexFormat
-
Parses a string to produce a
Complex
object. - parse(String, ParsePosition) - Method in class org.hipparchus.fraction.BigFractionFormat
-
Parses a string to produce a
BigFraction
object. - parse(String, ParsePosition) - Method in class org.hipparchus.fraction.FractionFormat
-
Parses a string to produce a
Fraction
object. - parse(String, ParsePosition) - Method in class org.hipparchus.fraction.ProperBigFractionFormat
-
Parses a string to produce a
BigFraction
object. - parse(String, ParsePosition) - Method in class org.hipparchus.fraction.ProperFractionFormat
-
Parses a string to produce a
Fraction
object. - parse(String, ParsePosition) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1DFormat
-
Parses a string to produce a
Vector
object. - parse(String, ParsePosition) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3DFormat
-
Parses a string to produce a
Vector3D
object. - parse(String, ParsePosition) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2DFormat
-
Parses a string to produce a
Vector
object. - parse(String, ParsePosition) - Method in class org.hipparchus.geometry.VectorFormat
-
Parses a string to produce a
Vector
object. - parse(String, ParsePosition) - Method in class org.hipparchus.linear.RealMatrixFormat
-
Parse a string to produce a
RealMatrix
object. - parse(String, ParsePosition) - Method in class org.hipparchus.linear.RealVectorFormat
-
Parse a string to produce a
RealVector
object. - parseAndIgnoreWhitespace(String, ParsePosition) - Static method in class org.hipparchus.fraction.ProperBigFractionFormat
-
Parses
source
until a non-whitespace character is found. - parseAndIgnoreWhitespace(String, ParsePosition) - Static method in class org.hipparchus.util.CompositeFormat
-
Parses
source
until a non-whitespace character is found. - parseCoordinates(int, String, ParsePosition) - Method in class org.hipparchus.geometry.VectorFormat
-
Parses a string to produce an array of coordinates.
- parseFixedstring(String, String, ParsePosition) - Static method in class org.hipparchus.util.CompositeFormat
-
Parse
source
for an expected fixed string. - parseNextBigInteger(String, ParsePosition) - Method in class org.hipparchus.fraction.BigFractionFormat
-
Parses a string to produce a
BigInteger
. - parseNextCharacter(String, ParsePosition) - Static method in class org.hipparchus.fraction.ProperBigFractionFormat
-
Parses
source
until a non-whitespace character is found. - parseNextCharacter(String, ParsePosition) - Static method in class org.hipparchus.util.CompositeFormat
-
Parses
source
until a non-whitespace character is found. - parseNumber(String, NumberFormat, ParsePosition) - Static method in class org.hipparchus.util.CompositeFormat
-
Parses
source
for a number. - parseOptimizationData(OptimizationData...) - Method in class org.hipparchus.optim.BaseMultivariateOptimizer
-
Scans the list of (required and optional) optimization data that characterize the problem.
- parseOptimizationData(OptimizationData...) - Method in class org.hipparchus.optim.BaseOptimizer
-
Scans the list of (required and optional) optimization data that characterize the problem.
- parseOptimizationData(OptimizationData...) - Method in class org.hipparchus.optim.linear.LinearOptimizer
-
Scans the list of (required and optional) optimization data that characterize the problem.
- parseOptimizationData(OptimizationData...) - Method in class org.hipparchus.optim.linear.SimplexSolver
-
Scans the list of (required and optional) optimization data that characterize the problem.
- parseOptimizationData(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
-
Scans the list of (required and optional) optimization data that characterize the problem.
- parseOptimizationData(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.scalar.GradientMultivariateOptimizer
-
Scans the list of (required and optional) optimization data that characterize the problem.
- parseOptimizationData(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.scalar.MultivariateOptimizer
-
Scans the list of (required and optional) optimization data that characterize the problem.
- parseOptimizationData(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
Scans the list of (required and optional) optimization data that characterize the problem.
- parseOptimizationData(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.SimplexOptimizer
-
Scans the list of (required and optional) optimization data that characterize the problem.
- parseOptimizationData(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.AbstractSQPOptimizer
- parseOptimizationData(OptimizationData...) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOptimizer
-
Scans the list of (required and optional) optimization data that characterize the problem.
- parseOptimizationData(OptimizationData...) - Method in class org.hipparchus.optim.univariate.UnivariateOptimizer
-
Scans the list of (required and optional) optimization data that characterize the problem.
- partitions(List<T>) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Generate a stream of partitions of a list.
- PascalDistribution - Class in org.hipparchus.distribution.discrete
-
Implementation of the Pascal distribution.
- PascalDistribution(int, double) - Constructor for class org.hipparchus.distribution.discrete.PascalDistribution
-
Create a Pascal distribution with the given number of successes and probability of success.
- PCA - Class in org.hipparchus.stat.projection
-
Principal component analysis (PCA) is a statistical technique for reducing the dimensionality of a dataset.
- PCA(int) - Constructor for class org.hipparchus.stat.projection.PCA
-
A default PCA will center but not scale.
- PCA(int, boolean, boolean) - Constructor for class org.hipparchus.stat.projection.PCA
-
Create a PCA with the ability to adjust scaling parameters.
- PearsonsCorrelation - Class in org.hipparchus.stat.correlation
-
Computes Pearson's product-moment correlation coefficients for pairs of arrays or columns of a matrix.
- PearsonsCorrelation() - Constructor for class org.hipparchus.stat.correlation.PearsonsCorrelation
-
Create a PearsonsCorrelation instance without data.
- PearsonsCorrelation(double[][]) - Constructor for class org.hipparchus.stat.correlation.PearsonsCorrelation
-
Create a PearsonsCorrelation from a rectangular array whose columns represent values of variables to be correlated.
- PearsonsCorrelation(RealMatrix) - Constructor for class org.hipparchus.stat.correlation.PearsonsCorrelation
-
Create a PearsonsCorrelation from a RealMatrix whose columns represent variables to be correlated.
- PearsonsCorrelation(RealMatrix, int) - Constructor for class org.hipparchus.stat.correlation.PearsonsCorrelation
-
Create a PearsonsCorrelation from a covariance matrix.
- PearsonsCorrelation(Covariance) - Constructor for class org.hipparchus.stat.correlation.PearsonsCorrelation
-
Create a PearsonsCorrelation from a
Covariance
. - PEGASUS - Enum constant in enum org.hipparchus.analysis.solvers.BaseSecantSolver.Method
-
The
Pegasus
method. - PegasusSolver - Class in org.hipparchus.analysis.solvers
-
Implements the Pegasus method for root-finding (approximating a zero of a univariate real function).
- PegasusSolver() - Constructor for class org.hipparchus.analysis.solvers.PegasusSolver
-
Construct a solver with default accuracy (1e-6).
- PegasusSolver(double) - Constructor for class org.hipparchus.analysis.solvers.PegasusSolver
-
Construct a solver.
- PegasusSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.PegasusSolver
-
Construct a solver.
- PegasusSolver(double, double, double) - Constructor for class org.hipparchus.analysis.solvers.PegasusSolver
-
Construct a solver.
- pelzGood(double, int) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Computes the Pelz-Good approximation for \(P(D_n < d)\) as described in [2] in the class javadoc.
- percentageValue() - Method in class org.hipparchus.fraction.BigFraction
-
Gets the fraction percentage as a
double
. - percentageValue() - Method in class org.hipparchus.fraction.Fraction
-
Gets the fraction percentage as a
double
. - percentile(double[], double) - Static method in class org.hipparchus.stat.StatUtils
-
Returns an estimate of the
p
th percentile of the values in thevalues
array. - percentile(double[], int, int, double) - Static method in class org.hipparchus.stat.StatUtils
-
Returns an estimate of the
p
th percentile of the values in thevalues
array, starting with the element in (0-based) positionbegin
in the array and includinglength
values. - Percentile - Class in org.hipparchus.stat.descriptive.rank
-
Provides percentile computation.
- Percentile() - Constructor for class org.hipparchus.stat.descriptive.rank.Percentile
-
Constructs a Percentile with the following defaults.
- Percentile(double) - Constructor for class org.hipparchus.stat.descriptive.rank.Percentile
-
Constructs a Percentile with the specific quantile value and the following default method type:
Percentile.EstimationType.LEGACY
default NaN strategy:NaNStrategy.REMOVED
a Kth Selector :KthSelector
- Percentile(double, Percentile.EstimationType, NaNStrategy, KthSelector) - Constructor for class org.hipparchus.stat.descriptive.rank.Percentile
-
Constructs a Percentile with the specific quantile value,
Percentile.EstimationType
,NaNStrategy
andKthSelector
. - Percentile(Percentile) - Constructor for class org.hipparchus.stat.descriptive.rank.Percentile
-
Copy constructor, creates a new
Percentile
identical to theoriginal
- Percentile.EstimationType - Enum in org.hipparchus.stat.descriptive.rank
-
An enum for various estimation strategies of a percentile referred in wikipedia on quantile with the names of enum matching those of types mentioned in wikipedia.
- percentiles(double, RandomGenerator) - Method in class org.hipparchus.stat.descriptive.StreamingStatistics.StreamingStatisticsBuilder
-
Sets the computePercentiles setting of the factory.
- performHouseholderReflection(int, double[][]) - Method in class org.hipparchus.linear.QRDecomposition
-
Perform Householder reflection for a minor A(minor, minor) of A.
- performHouseholderReflection(int, double[][]) - Method in class org.hipparchus.linear.RRQRDecomposition
-
Perform Householder reflection for a minor A(minor, minor) of A.
- performHouseholderReflection(int, T[][]) - Method in class org.hipparchus.linear.FieldQRDecomposition
-
Perform Householder reflection for a minor A(minor, minor) of A.
- PERMUTATION_EXCEEDS_N - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
PERMUTATION_EXCEEDS_N.
- PERMUTATION_EXCEEDS_N - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.PERMUTATION_EXCEEDS_N.
- PERMUTATION_SIZE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
PERMUTATION_SIZE.
- PERMUTATION_SIZE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.PERMUTATION_SIZE.
- permutations(List<T>) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Generate a stream of permutations of a list.
- PG_SUM_RELATIVE_ERROR - Static variable in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Convergence criterion for the sums in #pelzGood(double, double, int)}
- PI - Static variable in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
The constant value of π as a
UnivariateDerivative1
. - PI - Static variable in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
The constant value of π as a
UnivariateDerivative2
. - PI - Static variable in class org.hipparchus.complex.Complex
-
A complex number representing "π + 0.0i".
- PI - Static variable in class org.hipparchus.util.Binary64
-
The constant value of π as a
Binary64
. - PI - Static variable in class org.hipparchus.util.FastMath
-
Archimede's constant PI, ratio of circle circumference to diameter.
- PI_SQUARED - Static variable in class org.hipparchus.util.MathUtils
-
\(\pi^2\)
- PiecewiseBicubicSplineInterpolatingFunction - Class in org.hipparchus.analysis.interpolation
-
Function that implements the bicubic spline interpolation.
- PiecewiseBicubicSplineInterpolatingFunction(double[], double[], double[][]) - Constructor for class org.hipparchus.analysis.interpolation.PiecewiseBicubicSplineInterpolatingFunction
-
Simple constructor.
- PiecewiseBicubicSplineInterpolator - Class in org.hipparchus.analysis.interpolation
-
Generates a piecewise-bicubic interpolating function.
- PiecewiseBicubicSplineInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.PiecewiseBicubicSplineInterpolator
-
Empty constructor.
- pivotIndex(double[], int, int) - Method in enum org.hipparchus.util.PivotingStrategy
-
Find pivot index of the array so that partition and Kth element selection can be made
- PivotingStrategy - Enum in org.hipparchus.util
-
A strategy to pick a pivoting index of an array for doing partitioning.
- PivotSelectionRule - Enum in org.hipparchus.optim.linear
-
Pivot selection rule to the use for a Simplex solver.
- Plane - Class in org.hipparchus.geometry.euclidean.threed
-
The class represent planes in a three dimensional space.
- Plane(Plane) - Constructor for class org.hipparchus.geometry.euclidean.threed.Plane
-
Copy constructor.
- Plane(Vector3D, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.Plane
-
Build a plane normal to a given direction and containing the origin.
- Plane(Vector3D, Vector3D, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.Plane
-
Build a plane from a point and a normal.
- Plane(Vector3D, Vector3D, Vector3D, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.Plane
-
Build a plane from three points.
- plot() - Method in class org.hipparchus.samples.complex.GnuplotComplexPlotter
-
Plot the function.
- Plot(List<Vector2D>) - Constructor for class org.hipparchus.samples.LowDiscrepancyGeneratorComparison.Plot
-
Simple constructor.
- PLUS - Enum constant in enum org.hipparchus.geometry.partitioning.Side
-
Code for the plus side of the hyperplane.
- PLUS_I - Static variable in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
First canonical vector (coordinates: 1, 0, 0).
- PLUS_I - Static variable in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
First canonical vector (coordinates: 1, 0).
- PLUS_I - Static variable in class org.hipparchus.geometry.spherical.twod.S2Point
-
+I (coordinates: \( \theta = 0, \varphi = \pi/2 \)).
- PLUS_J - Static variable in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Second canonical vector (coordinates: 0, 1, 0).
- PLUS_J - Static variable in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Second canonical vector (coordinates: 0, 1).
- PLUS_J - Static variable in class org.hipparchus.geometry.spherical.twod.S2Point
-
+J (coordinates: \( \theta = \pi/2, \varphi = \pi/2 \))).
- PLUS_K - Static variable in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Third canonical vector (coordinates: 0, 0, 1).
- PLUS_K - Static variable in class org.hipparchus.geometry.spherical.twod.S2Point
-
+K (coordinates: \( \theta = any angle, \varphi = 0 \)).
- PLUS_MINUS_SUB - Enum constant in enum org.hipparchus.geometry.partitioning.BSPTreeVisitor.Order
-
Indicator for visit order plus sub-tree, then minus sub-tree, and last cut sub-hyperplane.
- PLUS_SUB_MINUS - Enum constant in enum org.hipparchus.geometry.partitioning.BSPTreeVisitor.Order
-
Indicator for visit order plus sub-tree, then cut sub-hyperplane, and last minus sub-tree.
- Point<S extends Space> - Interface in org.hipparchus.geometry
-
This interface represents a generic geometrical point.
- pointAt(double) - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Get one point from the line.
- pointAt(double) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Get one point from the line.
- pointAt(T) - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Get one point from the line.
- PointValuePair - Class in org.hipparchus.optim
-
This class holds a point and the value of an objective function at that point.
- PointValuePair(double[], double) - Constructor for class org.hipparchus.optim.PointValuePair
-
Builds a point/objective function value pair.
- PointValuePair(double[], double, boolean) - Constructor for class org.hipparchus.optim.PointValuePair
-
Builds a point/objective function value pair.
- PointVectorValuePair - Class in org.hipparchus.optim
-
This class holds a point and the vectorial value of an objective function at that point.
- PointVectorValuePair(double[], double[]) - Constructor for class org.hipparchus.optim.PointVectorValuePair
-
Builds a point/objective function value pair.
- PointVectorValuePair(double[], double[], boolean) - Constructor for class org.hipparchus.optim.PointVectorValuePair
-
Build a point/objective function value pair.
- PoissonDistribution - Class in org.hipparchus.distribution.discrete
-
Implementation of the Poisson distribution.
- PoissonDistribution(double) - Constructor for class org.hipparchus.distribution.discrete.PoissonDistribution
-
Creates a new Poisson distribution with specified mean.
- PoissonDistribution(double, double) - Constructor for class org.hipparchus.distribution.discrete.PoissonDistribution
-
Creates a new Poisson distribution with the specified mean and convergence criterion.
- PoissonDistribution(double, double, int) - Constructor for class org.hipparchus.distribution.discrete.PoissonDistribution
-
Creates a new Poisson distribution with specified mean, convergence criterion and maximum number of iterations.
- PoissonDistribution(double, int) - Constructor for class org.hipparchus.distribution.discrete.PoissonDistribution
-
Creates a new Poisson distribution with the specified mean and maximum number of iterations.
- POLAK_RIBIERE - Enum constant in enum org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.Formula
-
Polak-Ribière formula.
- polar2Complex(double, double) - Static method in class org.hipparchus.complex.ComplexUtils
-
Creates a complex number from the given polar representation.
- polar2Complex(T, T) - Static method in class org.hipparchus.complex.ComplexUtils
-
Creates a complex number from the given polar representation.
- PolygonsSet - Class in org.hipparchus.geometry.euclidean.twod
-
This class represents a 2D region: a set of polygons.
- PolygonsSet(double) - Constructor for class org.hipparchus.geometry.euclidean.twod.PolygonsSet
-
Build a polygons set representing the whole plane.
- PolygonsSet(double, double, double, double, double) - Constructor for class org.hipparchus.geometry.euclidean.twod.PolygonsSet
-
Build a parallellepipedic box.
- PolygonsSet(double, Vector2D...) - Constructor for class org.hipparchus.geometry.euclidean.twod.PolygonsSet
-
Build a polygon from a simple list of vertices.
- PolygonsSet(Collection<SubHyperplane<Euclidean2D>>, double) - Constructor for class org.hipparchus.geometry.euclidean.twod.PolygonsSet
-
Build a polygons set from a Boundary REPresentation (B-rep).
- PolygonsSet(BSPTree<Euclidean2D>, double) - Constructor for class org.hipparchus.geometry.euclidean.twod.PolygonsSet
-
Build a polygons set from a BSP tree.
- PolyhedronsSet - Class in org.hipparchus.geometry.euclidean.threed
-
This class represents a 3D region: a set of polyhedrons.
- PolyhedronsSet(double) - Constructor for class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Build a polyhedrons set representing the whole real line.
- PolyhedronsSet(double, double, double, double, double, double, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Build a parallellepipedic box.
- PolyhedronsSet(Collection<SubHyperplane<Euclidean3D>>, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Build a polyhedrons set from a Boundary REPresentation (B-rep) specified by sub-hyperplanes.
- PolyhedronsSet(List<Vector3D>, List<int[]>, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Build a polyhedrons set from a Boundary REPresentation (B-rep) specified by connected vertices.
- PolyhedronsSet(PolyhedronsSet.BRep, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Build a polyhedrons set from a Boundary REPresentation (B-rep) specified by connected vertices.
- PolyhedronsSet(BSPTree<Euclidean3D>, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Build a polyhedrons set from a BSP tree.
- PolyhedronsSet.BRep - Class in org.hipparchus.geometry.euclidean.threed
-
Container for Boundary REPresentation (B-Rep).
- POLYNOMIAL - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
POLYNOMIAL.
- POLYNOMIAL - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.POLYNOMIAL.
- POLYNOMIAL_INTERPOLANTS_MISMATCH_SEGMENTS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.POLYNOMIAL_INTERPOLANTS_MISMATCH_SEGMENTS.
- POLYNOMIAL_INTERPOLANTS_MISMATCH_SEGMENTS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.POLYNOMIAL_INTERPOLANTS_MISMATCH_SEGMENTS.
- PolynomialCurveFitter - Class in org.hipparchus.fitting
-
Fits points to a
polynomial
function. - polynomialDerivative() - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Returns the derivative as a
FieldPolynomialFunction
. - polynomialDerivative() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Returns the derivative as a
PolynomialFunction
. - PolynomialFunction - Class in org.hipparchus.analysis.polynomials
-
Immutable representation of a real polynomial function with real coefficients.
- PolynomialFunction(double...) - Constructor for class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Construct a polynomial with the given coefficients.
- PolynomialFunction.Parametric - Class in org.hipparchus.analysis.polynomials
-
Dedicated parametric polynomial class.
- PolynomialFunctionLagrangeForm - Class in org.hipparchus.analysis.polynomials
-
Implements the representation of a real polynomial function in Lagrange Form.
- PolynomialFunctionLagrangeForm(double[], double[]) - Constructor for class org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Construct a Lagrange polynomial with the given abscissas and function values.
- PolynomialFunctionNewtonForm - Class in org.hipparchus.analysis.polynomials
-
Implements the representation of a real polynomial function in Newton Form.
- PolynomialFunctionNewtonForm(double[], double[]) - Constructor for class org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Construct a Newton polynomial with the given a[] and c[].
- PolynomialSolver - Interface in org.hipparchus.analysis.solvers
-
Interface for (polynomial) root-finding algorithms.
- polynomialSplineDerivative() - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
-
Get the derivative of the polynomial spline function.
- polynomialSplineDerivative() - Method in class org.hipparchus.analysis.polynomials.PolynomialSplineFunction
-
Get the derivative of the polynomial spline function.
- PolynomialSplineFunction - Class in org.hipparchus.analysis.polynomials
-
Represents a polynomial spline function.
- PolynomialSplineFunction(double[], PolynomialFunction[]) - Constructor for class org.hipparchus.analysis.polynomials.PolynomialSplineFunction
-
Construct a polynomial spline function with the given segment delimiters and interpolating polynomials.
- PolynomialsUtils - Class in org.hipparchus.analysis.polynomials
-
A collection of static methods that operate on or return polynomials.
- POPULATION_SIZE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
POPULATION_SIZE.
- POPULATION_SIZE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.POPULATION_SIZE.
- PopulationSize(int) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer.PopulationSize
-
Simple constructor.
- populationVariance(double...) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the population variance of the entries in the input array, or
Double.NaN
if the array is empty. - populationVariance(double[], double) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the population variance of the entries in the input array, using the precomputed mean value.
- populationVariance(double[], double, int, int) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the population variance of the entries in the specified portion of the input array, using the precomputed mean value.
- populationVariance(double[], int, int) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the population variance of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - POSITIVE_INFINITY - Static variable in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
A vector with all coordinates set to positive infinity.
- POSITIVE_INFINITY - Static variable in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
A vector with all coordinates set to positive infinity.
- POSITIVE_INFINITY - Static variable in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
A vector with all coordinates set to positive infinity.
- POSITIVE_INFINITY - Static variable in class org.hipparchus.util.Binary64
-
The constant value of
Double.POSITIVE_INFINITY
as aBinary64
. - positiveOrNull() - Method in class org.hipparchus.dfp.Dfp
-
Check if instance is greater than or equal to 0.
- POSITIVITY_THRESHOLD - Static variable in class org.hipparchus.linear.SemiDefinitePositiveCholeskyDecomposition
-
Default threshold below which elements are not considered positive.
- pow(double) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Power operation.
- pow(double) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Power operation.
- pow(double) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Power operation.
- pow(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Power operation.
- pow(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Power operation.
- pow(double) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Power operation.
- pow(double) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Power operation.
- pow(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Power operation.
- pow(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Power operation.
- pow(double) - Method in interface org.hipparchus.CalculusFieldElement
-
Power operation.
- pow(double) - Method in class org.hipparchus.complex.Complex
-
Returns of value of this complex number raised to the power of
x
. - pow(double) - Method in class org.hipparchus.complex.FieldComplex
-
Returns of value of this complex number raised to the power of
x
. - pow(double) - Method in class org.hipparchus.dfp.Dfp
-
Power operation.
- pow(double) - Method in class org.hipparchus.fraction.BigFraction
-
Returns a
double
whose value is thisexponent, returning the result in reduced form. - pow(double) - Method in class org.hipparchus.util.Binary64
-
Power operation.
- pow(double) - Method in class org.hipparchus.util.FieldTuple
-
Power operation.
- pow(double) - Method in class org.hipparchus.util.Tuple
-
Power operation.
- pow(double[], int, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute power of a derivative structure.
- pow(double[], int, double, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute power of a derivative structure.
- pow(double[], int, int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute integer power of a derivative structure.
- pow(double, double) - Static method in class org.hipparchus.util.FastMath
-
Power function.
- pow(double, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute power of a double to a derivative structure.
- pow(double, int) - Static method in class org.hipparchus.util.FastMath
-
Raise a double to an int power.
- pow(double, long) - Static method in class org.hipparchus.util.FastMath
-
Raise a double to a long power.
- pow(double, DerivativeStructure) - Static method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute ax where a is a double and x a
DerivativeStructure
- pow(double, FieldDerivativeStructure<T>) - Static method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute ax where a is a double and x a
FieldDerivativeStructure
- pow(double, FieldGradient<T>) - Static method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute ax where a is a double and x a
FieldGradient
- pow(double, FieldUnivariateDerivative1<T>) - Static method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute ax where a is a double and x a
FieldUnivariateDerivative1
- pow(double, FieldUnivariateDerivative2<T>) - Static method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute ax where a is a double and x a
FieldUnivariateDerivative2
- pow(double, Gradient) - Static method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute ax where a is a double and x a
Gradient
- pow(double, SparseGradient) - Static method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute ax where a is a double and x a
SparseGradient
- pow(double, UnivariateDerivative1) - Static method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute ax where a is a double and x a
UnivariateDerivative1
- pow(double, UnivariateDerivative2) - Static method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute ax where a is a double and x a
UnivariateDerivative2
- pow(double, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute power of a double to a derivative structure.
- pow(int) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Integer power operation.
- pow(int) - Method in interface org.hipparchus.CalculusFieldElement
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.complex.Complex
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.complex.FieldComplex
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.dfp.Dfp
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.fraction.BigFraction
-
Returns a
BigFraction
whose value is(this<sup>exponent</sup>)
, returning the result in reduced form. - pow(int) - Method in class org.hipparchus.util.Binary64
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.util.FieldTuple
-
Integer power operation.
- pow(int) - Method in class org.hipparchus.util.Tuple
-
Integer power operation.
- pow(int, int) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Raise an int to an int power.
- pow(long) - Method in class org.hipparchus.fraction.BigFraction
-
Returns a
BigFraction
whose value is thisexponent, returning the result in reduced form. - pow(long, int) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Raise a long to an int power.
- pow(BigInteger) - Method in class org.hipparchus.fraction.BigFraction
-
Returns a
BigFraction
whose value is thisexponent, returning the result in reduced form. - pow(BigInteger, int) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Raise a BigInteger to an int power.
- pow(BigInteger, long) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Raise a BigInteger to a long power.
- pow(BigInteger, BigInteger) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Raise a BigInteger to a BigInteger power.
- pow(DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Power operation.
- pow(FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Power operation.
- pow(Complex) - Method in class org.hipparchus.complex.Complex
-
Returns of value of this complex number raised to the power of
x
. - pow(FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
Returns of value of this complex number raised to the power of
x
. - pow(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Power operation.
- pow(Dfp, int) - Static method in class org.hipparchus.dfp.DfpMath
-
Raises base to the power a by successive squaring.
- pow(Dfp, Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
Computes x to the y power.
- pow(Binary64) - Method in class org.hipparchus.util.Binary64
-
Power operation.
- pow(FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Power operation.
- pow(Tuple) - Method in class org.hipparchus.util.Tuple
-
Power operation.
- pow(T) - Method in interface org.hipparchus.analysis.differentiation.Derivative
-
Power operation.
- pow(T) - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Power operation.
- pow(T) - Method in interface org.hipparchus.CalculusFieldElement
-
Power operation.
- pow(T) - Method in class org.hipparchus.complex.FieldComplex
-
Returns of value of this complex number raised to the power of
x
. - pow(T[], int, double, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute power of a derivative structure.
- pow(T[], int, int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute integer power of a derivative structure.
- pow(T[], int, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute power of a derivative structure.
- pow(T, double) - Static method in class org.hipparchus.util.FastMath
-
Power function.
- pow(T, int) - Static method in class org.hipparchus.util.FastMath
-
Raise a double to an int power.
- pow(T, T) - Static method in class org.hipparchus.util.FastMath
-
Power function.
- Pow - Class in org.hipparchus.analysis.function
-
Power function.
- Pow() - Constructor for class org.hipparchus.analysis.function.Pow
-
Empty constructor.
- PowellOptimizer - Class in org.hipparchus.optim.nonlinear.scalar.noderiv
-
Powell's algorithm.
- PowellOptimizer(double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.PowellOptimizer
-
The parameters control the default convergence checking procedure.
- PowellOptimizer(double, double, double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.PowellOptimizer
-
Builds an instance with the default convergence checking procedure.
- PowellOptimizer(double, double, double, double, ConvergenceChecker<PointValuePair>) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.PowellOptimizer
-
This constructor allows to specify a user-defined convergence checker, in addition to the parameters that control the default convergence checking procedure and the line search tolerances.
- PowellOptimizer(double, double, ConvergenceChecker<PointValuePair>) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.PowellOptimizer
-
This constructor allows to specify a user-defined convergence checker, in addition to the parameters that control the default convergence checking procedure.
- power(int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Returns the result multiplying this with itself
p
times. - power(int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the result of multiplying
this
with itselfp
times. - power(int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Returns the result multiplying this with itself
p
times. - power(int) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the result of multiplying
this
with itselfp
times. - Power - Class in org.hipparchus.analysis.function
-
Power function.
- Power(double) - Constructor for class org.hipparchus.analysis.function.Power
-
Simple constructor.
- POWER_NEGATIVE_PARAMETERS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.POWER_NEGATIVE_PARAMETERS.
- POWER_NEGATIVE_PARAMETERS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.POWER_NEGATIVE_PARAMETERS.
- power10(int) - Method in class org.hipparchus.dfp.Dfp
-
Return the specified power of 10.
- power10K(int) - Method in class org.hipparchus.dfp.Dfp
-
Get the specified power of 10000.
- Precision - Class in org.hipparchus.util
-
Utilities for comparing numbers.
- precondition(double[], double[]) - Method in class org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.IdentityPreconditioner
-
Precondition a search direction.
- precondition(double[], double[]) - Method in interface org.hipparchus.optim.nonlinear.scalar.gradient.Preconditioner
-
Precondition a search direction.
- PreconditionedIterativeLinearSolver - Class in org.hipparchus.linear
-
This abstract class defines preconditioned iterative solvers.
- PreconditionedIterativeLinearSolver(int) - Constructor for class org.hipparchus.linear.PreconditionedIterativeLinearSolver
-
Creates a new instance of this class, with default iteration manager.
- PreconditionedIterativeLinearSolver(IterationManager) - Constructor for class org.hipparchus.linear.PreconditionedIterativeLinearSolver
-
Creates a new instance of this class, with custom iteration manager.
- Preconditioner - Interface in org.hipparchus.optim.nonlinear.scalar.gradient
-
This interface represents a preconditioner for differentiable scalar objective function optimizers.
- predict(double) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the "predicted"
y
value associated with the suppliedx
value, based on the data that has been added to the model when this method is activated. - predict(double, RealVector, RealMatrix, RealMatrix) - Method in class org.hipparchus.filtering.kalman.AbstractKalmanFilter
-
Perform prediction step.
- predictionAndCorrectionSteps(T, RealVector[]) - Method in class org.hipparchus.filtering.kalman.unscented.UnscentedKalmanFilter
-
This method perform the prediction and correction steps of the Unscented Kalman Filter.
- preMultiply(double[]) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - preMultiply(double[]) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - preMultiply(double[]) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - preMultiply(double[]) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - preMultiply(double[]) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - preMultiply(FieldMatrix<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Premultiply this matrix by
m
. - preMultiply(FieldMatrix<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Premultiply this matrix by
m
. - preMultiply(FieldVector<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - preMultiply(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - preMultiply(RealMatrix) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the result of premultiplying
this
bym
. - preMultiply(RealMatrix) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the result of premultiplying
this
bym
. - preMultiply(RealVector) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - preMultiply(RealVector) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - preMultiply(RealVector) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - preMultiply(T[]) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - preMultiply(T[]) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - preMultiply(T[]) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - preMultiply(T[]) - Method in interface org.hipparchus.linear.FieldMatrix
-
Returns the (row) vector result of premultiplying this by the vector
v
. - probability(double) - Method in class org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(X = x)
. - probability(double, double) - Method in class org.hipparchus.distribution.continuous.AbstractRealDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(x0 < X <= x1)
. - probability(double, double) - Method in class org.hipparchus.distribution.continuous.LogNormalDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(x0 < X <= x1)
. - probability(double, double) - Method in class org.hipparchus.distribution.continuous.NormalDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(x0 < X <= x1)
. - probability(double, double) - Method in interface org.hipparchus.distribution.RealDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(x0 < X <= x1)
. - probability(int) - Method in class org.hipparchus.distribution.discrete.BinomialDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(X = x)
. - probability(int) - Method in class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(X = x)
. - probability(int) - Method in class org.hipparchus.distribution.discrete.GeometricDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(X = x)
. - probability(int) - Method in class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(X = x)
. - probability(int) - Method in class org.hipparchus.distribution.discrete.PascalDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(X = x)
. - probability(int) - Method in class org.hipparchus.distribution.discrete.PoissonDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(X = x)
. - probability(int) - Method in class org.hipparchus.distribution.discrete.UniformIntegerDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(X = x)
. - probability(int) - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(X = x)
. - probability(int) - Method in interface org.hipparchus.distribution.IntegerDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(X = x)
. - probability(int, int) - Method in class org.hipparchus.distribution.discrete.AbstractIntegerDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(x0 < X <= x1)
. - probability(int, int) - Method in interface org.hipparchus.distribution.IntegerDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(x0 < X <= x1)
. - probability(T) - Method in class org.hipparchus.distribution.EnumeratedDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(X = x)
. - processDataPoint(double) - Method in interface org.hipparchus.stat.descriptive.rank.PSquarePercentile.PSquareMarkers
-
Process a data point by moving the marker heights based on estimator.
- ProcessEstimate - Class in org.hipparchus.filtering.kalman
-
Holder for process state and covariance.
- ProcessEstimate(double, RealVector, RealMatrix) - Constructor for class org.hipparchus.filtering.kalman.ProcessEstimate
-
Simple constructor.
- ProcessEstimate(double, RealVector, RealMatrix, RealMatrix, RealMatrix, RealMatrix, RealMatrix) - Constructor for class org.hipparchus.filtering.kalman.ProcessEstimate
-
Simple constructor.
- product(double...) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the product of the entries in the input array, or
Double.NaN
if the array is empty. - product(double[], int, int) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the product of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - Product - Class in org.hipparchus.stat.descriptive.summary
-
Returns the product of the available values.
- Product() - Constructor for class org.hipparchus.stat.descriptive.summary.Product
-
Create a Product instance.
- Product(Product) - Constructor for class org.hipparchus.stat.descriptive.summary.Product
-
Copy constructor, creates a new
Product
identical to theoriginal
. - project(Point<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Project a point to the hyperplane.
- project(Point<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Project a point to the hyperplane.
- project(Point<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Project a point to the hyperplane.
- project(Point<Sphere1D>) - Method in class org.hipparchus.geometry.spherical.oned.LimitAngle
-
Project a point to the hyperplane.
- project(Point<Sphere2D>) - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Project a point to the hyperplane.
- project(Point<S>) - Method in interface org.hipparchus.geometry.partitioning.Hyperplane
-
Project a point to the hyperplane.
- projection(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Find the orthogonal projection of this vector onto another vector.
- projection(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Find the orthogonal projection of this vector onto another vector.
- projection(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Find the orthogonal projection of this vector onto another vector.
- projection(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Find the orthogonal projection of this vector onto another vector.
- projection(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Find the orthogonal projection of this vector onto another vector.
- projectToBoundary(Point<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.IntervalsSet
-
Project a point on the boundary of the region.
- projectToBoundary(Point<Sphere1D>) - Method in class org.hipparchus.geometry.spherical.oned.ArcsSet
-
Project a point on the boundary of the region.
- projectToBoundary(Point<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Project a point on the boundary of the region.
- projectToBoundary(Point<S>) - Method in interface org.hipparchus.geometry.partitioning.Region
-
Project a point on the boundary of the region.
- PROPAGATION_DIRECTION_MISMATCH - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.PROPAGATION_DIRECTION_MISMATCH.
- PROPAGATION_DIRECTION_MISMATCH - Enum constant in enum org.hipparchus.ode.LocalizedODEFormats
-
PROPAGATION_DIRECTION_MISMATCH.
- ProperBigFractionFormat - Class in org.hipparchus.fraction
-
Formats a BigFraction number in proper format.
- ProperBigFractionFormat() - Constructor for class org.hipparchus.fraction.ProperBigFractionFormat
-
Create a proper formatting instance with the default number format for the whole, numerator, and denominator.
- ProperBigFractionFormat(NumberFormat) - Constructor for class org.hipparchus.fraction.ProperBigFractionFormat
-
Create a proper formatting instance with a custom number format for the whole, numerator, and denominator.
- ProperBigFractionFormat(NumberFormat, NumberFormat, NumberFormat) - Constructor for class org.hipparchus.fraction.ProperBigFractionFormat
-
Create a proper formatting instance with a custom number format for each of the whole, numerator, and denominator.
- ProperFractionFormat - Class in org.hipparchus.fraction
-
Formats a Fraction number in proper format.
- ProperFractionFormat() - Constructor for class org.hipparchus.fraction.ProperFractionFormat
-
Create a proper formatting instance with the default number format for the whole, numerator, and denominator.
- ProperFractionFormat(NumberFormat) - Constructor for class org.hipparchus.fraction.ProperFractionFormat
-
Create a proper formatting instance with a custom number format for the whole, numerator, and denominator.
- ProperFractionFormat(NumberFormat, NumberFormat, NumberFormat) - Constructor for class org.hipparchus.fraction.ProperFractionFormat
-
Create a proper formatting instance with a custom number format for each of the whole, numerator, and denominator.
- providesResidual() - Method in class org.hipparchus.linear.DefaultIterativeLinearSolverEvent
-
Returns
true
ifIterativeLinearSolverEvent.getResidual()
is supported. - providesResidual() - Method in class org.hipparchus.linear.IterativeLinearSolverEvent
-
Returns
true
ifIterativeLinearSolverEvent.getResidual()
is supported. - pruneAroundConvexCell(Object, Object, Object) - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Prune a tree around a cell.
- PSquarePercentile - Class in org.hipparchus.stat.descriptive.rank
-
A
StorelessUnivariateStatistic
estimating percentiles using the P2 Algorithm as explained by Raj Jain and Imrich Chlamtac in P2 Algorithm for Dynamic Calculation of Quantiles and Histogram Without Storing Observations. - PSquarePercentile(double) - Constructor for class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
Constructs a PSquarePercentile with the specific percentile value.
- PSquarePercentile(PSquarePercentile) - Constructor for class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
Copy constructor, creates a new
PSquarePercentile
identical to theoriginal
. - PSquarePercentile.PSquareMarkers - Interface in org.hipparchus.stat.descriptive.rank
-
An interface that encapsulates abstractions of the P-square algorithm markers as is explained in the original works.
- put(int) - Method in class org.hipparchus.util.AbstractOpenIntHashMap
-
Put a value associated with a key in the map.
- put(int, double) - Method in class org.hipparchus.util.OpenIntToDoubleHashMap
-
Put a value associated with a key in the map.
- put(int, T) - Method in class org.hipparchus.util.OpenIntToFieldHashMap
-
Put a value associated with a key in the map.
Q
- QNAN - Static variable in class org.hipparchus.dfp.Dfp
-
Indicator value for quiet NaN.
- QPOptimizer - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Quadratic programming Optimizater.
- QPOptimizer() - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.QPOptimizer
- QRDecomposer - Class in org.hipparchus.linear
-
Matrix decomposer using QR-decomposition.
- QRDecomposer(double) - Constructor for class org.hipparchus.linear.QRDecomposer
-
Creates a QR decomposer with specify threshold for several matrices.
- QRDecomposition - Class in org.hipparchus.linear
-
Calculates the QR-decomposition of a matrix.
- QRDecomposition(RealMatrix) - Constructor for class org.hipparchus.linear.QRDecomposition
-
Calculates the QR-decomposition of the given matrix.
- QRDecomposition(RealMatrix, double) - Constructor for class org.hipparchus.linear.QRDecomposition
-
Calculates the QR-decomposition of the given matrix.
- QuadraticFunction - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Given P, Q, d, implements \(\frac{1}{2}x^T P X + Q^T x + d\).
- QuadraticFunction(double[][], double[], double) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.QuadraticFunction
-
Construct quadratic function \(\frac{1}{2}x^T P X + Q^T x + d\).
- QuadraticFunction(RealMatrix, RealVector, double) - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.QuadraticFunction
-
Construct quadratic function \(\frac{1}{2}x^T P X + Q^T x + d\).
- quantile() - Method in class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
Returns the quantile estimated by this statistic in the range [0.0-1.0]
- Quaternion - Class in org.hipparchus.complex
-
This class implements quaternions (Hamilton's hypercomplex numbers).
- Quaternion(double[]) - Constructor for class org.hipparchus.complex.Quaternion
-
Builds a pure quaternion from a vector (assuming that the scalar part is zero).
- Quaternion(double, double[]) - Constructor for class org.hipparchus.complex.Quaternion
-
Builds a quaternion from scalar and vector parts.
- Quaternion(double, double, double, double) - Constructor for class org.hipparchus.complex.Quaternion
-
Builds a quaternion from its components.
R
- R_1 - Enum constant in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
The method R_1 has the following formulae for index and estimates
\( \begin{align} &index= Np + 1/2\, \\ &estimate= x_{\lceil h\,-\,1/2 \rceil} \\ &minLimit = 0 \\ \end{align}\) - R_2 - Enum constant in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
The method R_2 has the following formulae for index and estimates
\( \begin{align} &index= Np + 1/2\, \\ &estimate=\frac{x_{\lceil h\,-\,1/2 \rceil} + x_{\lfloor h\,+\,1/2 \rfloor}}{2} \\ &minLimit = 0 \\ &maxLimit = 1 \\ \end{align}\) - R_3 - Enum constant in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
The method R_3 has the following formulae for index and estimates
\( \begin{align} &index= Np \\ &estimate= x_{\lfloor h \rceil}\, \\ &minLimit = 0.5/N \\ \end{align}\) - R_4 - Enum constant in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
The method R_4 has the following formulae for index and estimates
\( \begin{align} &index= Np\, \\ &estimate= x_{\lfloor h \rfloor} + (h - \lfloor h \rfloor) (x_{\lfloor h \rfloor + 1} - x_{\lfloor h \rfloor}) \\ &minLimit = 1/N \\ &maxLimit = 1 \\ \end{align}\) - R_5 - Enum constant in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
The method R_5 has the following formulae for index and estimates
\( \begin{align} &index= Np + 1/2\\ &estimate= x_{\lfloor h \rfloor} + (h - \lfloor h \rfloor) (x_{\lfloor h \rfloor + 1} - x_{\lfloor h \rfloor}) \\ &minLimit = 0.5/N \\ &maxLimit = (N-0.5)/N \end{align}\) - R_6 - Enum constant in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
The method R_6 has the following formulae for index and estimates
\( \begin{align} &index= (N + 1)p \\ &estimate= x_{\lfloor h \rfloor} + (h - \lfloor h \rfloor) (x_{\lfloor h \rfloor + 1} - x_{\lfloor h \rfloor}) \\ &minLimit = 1/(N+1) \\ &maxLimit = N/(N+1) \\ \end{align}\) - R_7 - Enum constant in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
The method R_7 implements Microsoft Excel style computation has the following formulae for index and estimates.
\( \begin{align} &index = (N-1)p + 1 \\ &estimate = x_{\lfloor h \rfloor} + (h - \lfloor h \rfloor) (x_{\lfloor h \rfloor + 1} - x_{\lfloor h \rfloor}) \\ &minLimit = 0 \\ &maxLimit = 1 \\ \end{align}\) - R_8 - Enum constant in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
The method R_8 has the following formulae for index and estimates
\( \begin{align} &index = (N + 1/3)p + 1/3 \\ &estimate = x_{\lfloor h \rfloor} + (h - \lfloor h \rfloor) (x_{\lfloor h \rfloor + 1} - x_{\lfloor h \rfloor}) \\ &minLimit = (2/3)/(N+1/3) \\ &maxLimit = (N-1/3)/(N+1/3) \\ \end{align}\) - R_9 - Enum constant in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
The method R_9 has the following formulae for index and estimates
\( \begin{align} &index = (N + 1/4)p + 3/8\\ &estimate = x_{\lfloor h \rfloor} + (h - \lfloor h \rfloor) (x_{\lfloor h \rfloor + 1} - x_{\lfloor h \rfloor}) \\ &minLimit = (5/8)/(N+1/4) \\ &maxLimit = (N-3/8)/(N+1/4) \\ \end{align}\) - RADIX - Static variable in class org.hipparchus.dfp.Dfp
-
The radix, or base of this system.
- random - Variable in class org.hipparchus.distribution.multivariate.AbstractMultivariateRealDistribution
-
RNG instance used to generate samples from the distribution.
- random() - Static method in class org.hipparchus.util.FastMath
-
Returns a pseudo-random number between 0.0 and 1.0.
- RANDOM - Enum constant in enum org.hipparchus.stat.ranking.TiesStrategy
-
Ties get a random integral value from among applicable ranks
- RandomAdaptor - Class in org.hipparchus.random
-
Extension of
Random
wrapping aRandomGenerator
. - RandomAdaptor(RandomGenerator) - Constructor for class org.hipparchus.random.RandomAdaptor
-
Construct a RandomAdaptor wrapping the supplied RandomGenerator.
- randomData - Variable in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
RandomDataGenerator instance to use in repeated calls to getNext()
- RandomDataGenerator - Class in org.hipparchus.random
-
A class for generating random data.
- RandomDataGenerator() - Constructor for class org.hipparchus.random.RandomDataGenerator
-
Construct a RandomDataGenerator with a default RandomGenerator as its source of random data.
- RandomDataGenerator(long) - Constructor for class org.hipparchus.random.RandomDataGenerator
-
Construct a RandomDataGenerator with a default RandomGenerator as its source of random data, initialized with the given seed value.
- RandomGenerator - Interface in org.hipparchus.random
-
Interface for generators of random number sequences.
- RandomPercentile - Class in org.hipparchus.stat.descriptive.rank
-
A
StorelessUnivariateStatistic
estimating percentiles using the RANDOM Algorithm. - RandomPercentile() - Constructor for class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Constructs a
RandomPercentile
with quantile estimation error set to the default (RandomPercentile.DEFAULT_EPSILON
), using the default PRNG as source of random data. - RandomPercentile(double) - Constructor for class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Constructs a
RandomPercentile
with quantile estimation errorepsilon
using the default PRNG as source of random data. - RandomPercentile(double, RandomGenerator) - Constructor for class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Constructs a
RandomPercentile
with quantile estimation errorepsilon
usingrandomGenerator
as its source of random data. - RandomPercentile(RandomGenerator) - Constructor for class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Constructs a
RandomPercentile
with default estimation error usingrandomGenerator
as its source of random data. - RandomPercentile(RandomPercentile) - Constructor for class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Copy constructor, creates a new
RandomPercentile
identical to theoriginal
. - RandomVectorGenerator - Interface in org.hipparchus.random
-
This interface represents a random generator for whole vectors.
- rank(double[]) - Method in class org.hipparchus.stat.ranking.NaturalRanking
-
Rank
data
using the natural ordering on Doubles, with NaN values handled according tonanStrategy
and ties resolved usingtiesStrategy.
- rank(double[]) - Method in interface org.hipparchus.stat.ranking.RankingAlgorithm
-
Performs a rank transformation on the input data, returning an array of ranks.
- RankingAlgorithm - Interface in org.hipparchus.stat.ranking
-
Interface representing a rank transformation.
- rC(double, double) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RC.
- rC(Complex, Complex) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RC.
- rC(FieldComplex<T>, FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RC.
- rC(T, T) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RC.
- rD(double, double, double) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RD.
- rD(Complex, Complex, Complex) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RD.
- rD(FieldComplex<T>, FieldComplex<T>, FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RD.
- rD(T, T, T) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RD.
- readResolve() - Method in class org.hipparchus.complex.Complex
-
Resolve the transient fields in a deserialized Complex Object.
- REAL_FORMAT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
REAL_FORMAT.
- REAL_FORMAT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.REAL_FORMAT.
- RealDistribution - Interface in org.hipparchus.distribution
-
Base interface for continuous distributions.
- RealDistributionComparison - Class in org.hipparchus.samples
-
Displays pdf/cdf for real distributions.
- RealDistributionComparison.Display - Class in org.hipparchus.samples
-
Main frame for displaying distributions.
- RealLinearOperator - Interface in org.hipparchus.linear
-
This class defines a linear operator operating on real (
double
) vector spaces. - RealMatrix - Interface in org.hipparchus.linear
-
Interface defining a real-valued matrix with basic algebraic operations.
- RealMatrixChangingVisitor - Interface in org.hipparchus.linear
-
Interface defining a visitor for matrix entries.
- RealMatrixFormat - Class in org.hipparchus.linear
-
Formats a
nxm
matrix in components list format "{{a00,a01, ..., a0m-1},{a10, a11, ..., a1m-1},{...},{ an-10, an-11, ..., an-1m-1}}". - RealMatrixFormat() - Constructor for class org.hipparchus.linear.RealMatrixFormat
-
Create an instance with default settings.
- RealMatrixFormat(String, String, String, String, String, String) - Constructor for class org.hipparchus.linear.RealMatrixFormat
-
Create an instance with custom prefix, suffix and separator.
- RealMatrixFormat(String, String, String, String, String, String, NumberFormat) - Constructor for class org.hipparchus.linear.RealMatrixFormat
-
Create an instance with custom prefix, suffix, separator and format for components.
- RealMatrixFormat(NumberFormat) - Constructor for class org.hipparchus.linear.RealMatrixFormat
-
Create an instance with a custom number format for components.
- RealMatrixPreservingVisitor - Interface in org.hipparchus.linear
-
Interface defining a visitor for matrix entries.
- RealTransformer - Interface in org.hipparchus.transform
-
Interface for one-dimensional data sets transformations producing real results.
- RealVector - Class in org.hipparchus.linear
-
Class defining a real-valued vector with basic algebraic operations.
- RealVector() - Constructor for class org.hipparchus.linear.RealVector
-
Empty constructor.
- RealVector.Entry - Class in org.hipparchus.linear
-
An entry in the vector.
- RealVector.SparseEntryIterator - Class in org.hipparchus.linear
-
This class should rarely be used, but is here to provide a default implementation of sparseIterator(), which is implemented by walking over the entries, skipping those that are zero.
- RealVectorChangingVisitor - Interface in org.hipparchus.linear
-
This interface defines a visitor for the entries of a vector.
- RealVectorFormat - Class in org.hipparchus.linear
-
Formats a vector in components list format "{v0; v1; ...; vk-1}".
- RealVectorFormat() - Constructor for class org.hipparchus.linear.RealVectorFormat
-
Create an instance with default settings.
- RealVectorFormat(String, String, String) - Constructor for class org.hipparchus.linear.RealVectorFormat
-
Create an instance with custom prefix, suffix and separator.
- RealVectorFormat(String, String, String, NumberFormat) - Constructor for class org.hipparchus.linear.RealVectorFormat
-
Create an instance with custom prefix, suffix, separator and format for components.
- RealVectorFormat(NumberFormat) - Constructor for class org.hipparchus.linear.RealVectorFormat
-
Create an instance with a custom number format for components.
- RealVectorPreservingVisitor - Interface in org.hipparchus.linear
-
This interface defines a visitor for the entries of a vector.
- rebase(double[], int, DSCompiler, double[], double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Rebase derivative structure with respect to low level parameter functions.
- rebase(DerivativeStructure...) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Rebase instance with respect to low level parameter functions.
- rebase(FieldDerivativeStructure<T>...) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Rebase instance with respect to low level parameter functions.
- rebase(T[], int, DSCompiler, T[], T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Rebase derivative structure with respect to low level parameter functions.
- reciprocal() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Returns the multiplicative inverse of
this
element. - reciprocal() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Returns the multiplicative inverse of
this
element. - reciprocal() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Returns the multiplicative inverse of
this
element. - reciprocal() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Returns the multiplicative inverse of
this
element. - reciprocal() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Returns the multiplicative inverse of
this
element. - reciprocal() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Returns the multiplicative inverse of
this
element. - reciprocal() - Method in class org.hipparchus.complex.Complex
-
Returns the multiplicative inverse of
this
element. - reciprocal() - Method in class org.hipparchus.complex.FieldComplex
-
Returns the multiplicative inverse of
this
element. - reciprocal() - Method in class org.hipparchus.dfp.Dfp
-
Returns the multiplicative inverse of
this
element. - reciprocal() - Method in interface org.hipparchus.FieldElement
-
Returns the multiplicative inverse of
this
element. - reciprocal() - Method in class org.hipparchus.fraction.BigFraction
-
Return the multiplicative inverse of this fraction.
- reciprocal() - Method in class org.hipparchus.fraction.Fraction
-
Return the multiplicative inverse of this fraction.
- reciprocal() - Method in class org.hipparchus.util.BigReal
-
Returns the multiplicative inverse of
this
element. - reciprocal() - Method in class org.hipparchus.util.Binary64
-
Returns the multiplicative inverse of
this
element. - reciprocal() - Method in class org.hipparchus.util.FieldTuple
-
Returns the multiplicative inverse of
this
element. - reciprocal() - Method in class org.hipparchus.util.Tuple
-
Returns the multiplicative inverse of
this
element. - reciprocal(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute reciprocal of derivative structure.
- reciprocal(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute reciprocal of derivative structure.
- RectangularCholeskyDecomposition - Class in org.hipparchus.linear
-
Calculates the rectangular Cholesky decomposition of a matrix.
- RectangularCholeskyDecomposition(RealMatrix) - Constructor for class org.hipparchus.linear.RectangularCholeskyDecomposition
-
Decompose a symmetric positive semidefinite matrix.
- RectangularCholeskyDecomposition(RealMatrix, double) - Constructor for class org.hipparchus.linear.RectangularCholeskyDecomposition
-
Decompose a symmetric positive semidefinite matrix.
- reduce() - Method in class org.hipparchus.fraction.BigFraction
-
Reduce this
BigFraction
to its lowest terms. - reduce(double, double, double) - Static method in class org.hipparchus.util.MathUtils
-
Reduce
|a - offset|
to the primary interval[0, |period|)
. - reduce(double, Collection<RandomPercentile>) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Computes the given percentile by combining the data from the collection of aggregates.
- REDUCE_BASE_TO_SPAN - Enum constant in enum org.hipparchus.linear.DependentVectorsHandler
-
Ignore dependent vectors.
- reducePoints(Collection<Vector2D>) - Static method in class org.hipparchus.geometry.euclidean.twod.hull.AklToussaintHeuristic
-
Returns a point set that is reduced by all points for which it is safe to assume that they are not part of the convex hull.
- Region<S extends Space> - Interface in org.hipparchus.geometry.partitioning
-
This interface represents a region of a space as a partition.
- Region.Location - Enum in org.hipparchus.geometry.partitioning
-
Enumerate for the location of a point with respect to the region.
- RegionFactory<S extends Space> - Class in org.hipparchus.geometry.partitioning
-
This class is a factory for
Region
. - RegionFactory() - Constructor for class org.hipparchus.geometry.partitioning.RegionFactory
-
Simple constructor.
- registerVariationalEquations(ExpandableODE) - Method in class org.hipparchus.migration.ode.JacobianMatrices
-
Deprecated.Register the variational equations for the Jacobians matrices to the expandable set.
- regress() - Method in class org.hipparchus.stat.regression.MillerUpdatingRegression
-
Conducts a regression on the data in the model, using all regressors.
- regress() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Performs a regression on data present in buffers and outputs a RegressionResults object.
- regress() - Method in interface org.hipparchus.stat.regression.UpdatingMultipleLinearRegression
-
Performs a regression on data present in buffers and outputs a RegressionResults object
- regress(int) - Method in class org.hipparchus.stat.regression.MillerUpdatingRegression
-
Conducts a regression on the data in the model, using a subset of regressors.
- regress(int[]) - Method in class org.hipparchus.stat.regression.MillerUpdatingRegression
-
Conducts a regression on the data in the model, using regressors in array Calling this method will change the internal order of the regressors and care is required in interpreting the hatmatrix.
- regress(int[]) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Performs a regression on data present in buffers including only regressors indexed in variablesToInclude and outputs a RegressionResults object
- regress(int[]) - Method in interface org.hipparchus.stat.regression.UpdatingMultipleLinearRegression
-
Performs a regression on data present in buffers including only regressors indexed in variablesToInclude and outputs a RegressionResults object
- RegressionResults - Class in org.hipparchus.stat.regression
-
Results of a Multiple Linear Regression model fit.
- RegressionResults(double[], double[][], boolean, long, int, double, double, double, boolean, boolean) - Constructor for class org.hipparchus.stat.regression.RegressionResults
-
Constructor for Regression Results.
- REGULA_FALSI - Enum constant in enum org.hipparchus.analysis.solvers.BaseSecantSolver.Method
-
The
Regula Falsi
or False Position method. - RegulaFalsiSolver - Class in org.hipparchus.analysis.solvers
-
Implements the Regula Falsi or False position method for root-finding (approximating a zero of a univariate real function).
- RegulaFalsiSolver() - Constructor for class org.hipparchus.analysis.solvers.RegulaFalsiSolver
-
Construct a solver with default accuracy (1e-6).
- RegulaFalsiSolver(double) - Constructor for class org.hipparchus.analysis.solvers.RegulaFalsiSolver
-
Construct a solver.
- RegulaFalsiSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.RegulaFalsiSolver
-
Construct a solver.
- RegulaFalsiSolver(double, double, double) - Constructor for class org.hipparchus.analysis.solvers.RegulaFalsiSolver
-
Construct a solver.
- regularizedBeta(double, double, double) - Static method in class org.hipparchus.special.Beta
-
Returns the regularized beta function I(x, a, b).
- regularizedBeta(double, double, double, double) - Static method in class org.hipparchus.special.Beta
-
Returns the regularized beta function I(x, a, b).
- regularizedBeta(double, double, double, double, int) - Static method in class org.hipparchus.special.Beta
-
Returns the regularized beta function I(x, a, b).
- regularizedBeta(double, double, double, int) - Static method in class org.hipparchus.special.Beta
-
Returns the regularized beta function I(x, a, b).
- regularizedGammaP(double, double) - Static method in class org.hipparchus.special.Gamma
-
Returns the regularized gamma function P(a, x).
- regularizedGammaP(double, double, double, int) - Static method in class org.hipparchus.special.Gamma
-
Returns the regularized gamma function P(a, x).
- regularizedGammaP(T, T) - Static method in class org.hipparchus.special.Gamma
-
Returns the regularized gamma function P(a, x).
- regularizedGammaP(T, T, double, int) - Static method in class org.hipparchus.special.Gamma
-
Returns the regularized gamma function P(a, x).
- regularizedGammaQ(double, double) - Static method in class org.hipparchus.special.Gamma
-
Returns the regularized gamma function Q(a, x) = 1 - P(a, x).
- regularizedGammaQ(double, double, double, int) - Static method in class org.hipparchus.special.Gamma
-
Returns the regularized gamma function Q(a, x) = 1 - P(a, x).
- regularizedGammaQ(T, T) - Static method in class org.hipparchus.special.Gamma
-
Returns the regularized gamma function Q(a, x) = 1 - P(a, x).
- regularizedGammaQ(T, T, double, int) - Static method in class org.hipparchus.special.Gamma
-
Returns the regularized gamma function Q(a, x) = 1 - P(a, x).
- reinitializeBegin(FieldODEStateInterpolator<T>) - Method in class org.hipparchus.ode.events.FieldDetectorBasedEventState
-
Reinitialize the beginning of the step.
- reinitializeBegin(ODEStateInterpolator) - Method in class org.hipparchus.ode.events.DetectorBasedEventState
-
Reinitialize the beginning of the step.
- Relationship - Enum in org.hipparchus.optim.linear
-
Types of relationships between two cells in a Solver
LinearConstraint
. - remainder(double) - Method in interface org.hipparchus.analysis.differentiation.Derivative
-
IEEE remainder operator.
- remainder(double) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
IEEE remainder operator.
- remainder(double) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
IEEE remainder operator.
- remainder(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
IEEE remainder operator.
- remainder(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
IEEE remainder operator.
- remainder(double) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
IEEE remainder operator.
- remainder(double) - Method in interface org.hipparchus.CalculusFieldElement
-
IEEE remainder operator.
- remainder(double) - Method in class org.hipparchus.complex.Complex
-
IEEE remainder operator.
- remainder(double) - Method in class org.hipparchus.complex.FieldComplex
-
IEEE remainder operator.
- remainder(double) - Method in class org.hipparchus.dfp.Dfp
-
IEEE remainder operator.
- remainder(double) - Method in class org.hipparchus.util.Binary64
-
IEEE remainder operator.
- remainder(double) - Method in class org.hipparchus.util.FieldTuple
-
IEEE remainder operator.
- remainder(double) - Method in class org.hipparchus.util.Tuple
-
IEEE remainder operator.
- remainder(double[], int, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform remainder of two derivative structures.
- remainder(DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
IEEE remainder operator.
- remainder(FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
IEEE remainder operator.
- remainder(FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
IEEE remainder operator.
- remainder(FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
IEEE remainder operator.
- remainder(FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
IEEE remainder operator.
- remainder(Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
IEEE remainder operator.
- remainder(SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
IEEE remainder operator.
- remainder(UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
IEEE remainder operator.
- remainder(UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
IEEE remainder operator.
- remainder(Complex) - Method in class org.hipparchus.complex.Complex
-
IEEE remainder operator.
- remainder(FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
IEEE remainder operator.
- remainder(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Returns the IEEE remainder.
- remainder(Binary64) - Method in class org.hipparchus.util.Binary64
-
IEEE remainder operator.
- remainder(FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
IEEE remainder operator.
- remainder(Tuple) - Method in class org.hipparchus.util.Tuple
-
IEEE remainder operator.
- remainder(T) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
IEEE remainder operator.
- remainder(T) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
IEEE remainder operator.
- remainder(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
IEEE remainder operator.
- remainder(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
IEEE remainder operator.
- remainder(T) - Method in interface org.hipparchus.CalculusFieldElement
-
IEEE remainder operator.
- remainder(T[], int, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform remainder of two derivative structures.
- remainderUnsigned(int, int) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Returns the unsigned remainder from dividing the first argument by the second where each argument and the result is interpreted as an unsigned value.
- remainderUnsigned(long, long) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Returns the unsigned remainder from dividing the first argument by the second where each argument and the result is interpreted as an unsigned value.
- remove() - Method in class org.hipparchus.linear.OpenMapRealVector.OpenMapSparseIterator
- remove() - Method in class org.hipparchus.linear.RealVector.SparseEntryIterator
- remove() - Method in class org.hipparchus.util.MultidimensionalCounter.Iterator
- remove(int) - Method in class org.hipparchus.util.OpenIntToDoubleHashMap
-
Remove the value associated with a key.
- remove(int) - Method in class org.hipparchus.util.OpenIntToFieldHashMap
-
Remove the value associated with a key.
- REMOVED - Enum constant in enum org.hipparchus.stat.ranking.NaNStrategy
-
NaNs are removed before computing ranks
- removeData(double[][]) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Removes observations represented by the elements in
data
. - removeData(double, double) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Removes the observation (x,y) from the regression data set.
- removeIterationListener(IterationListener) - Method in class org.hipparchus.util.IterationManager
-
Removes the specified iteration listener from the list of listeners currently attached to
this
object. - removeMostRecentValue() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Removes the most recent value from the dataset.
- replaceMostRecentValue(double) - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Replaces the most recently stored value with the given value.
- replaceWorstPoint(PointValuePair, Comparator<PointValuePair>) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Replace the worst point of the simplex by a new point.
- representableDelta(double, double) - Static method in class org.hipparchus.util.Precision
-
Computes a number
delta
close tooriginalDelta
with the property that - rescale(double) - Method in class org.hipparchus.ode.MultistepIntegrator
-
Rescale the instance.
- rescale(T) - Method in class org.hipparchus.ode.MultistepFieldIntegrator
-
Rescale the instance.
- reSeed(long) - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Reseeds the random number generator used by
EmpiricalDistribution.getNextValue()
. - reseedRandomGenerator(long) - Method in class org.hipparchus.distribution.multivariate.AbstractMultivariateRealDistribution
-
Reseeds the random generator used to generate samples.
- reseedRandomGenerator(long) - Method in class org.hipparchus.distribution.multivariate.MixtureMultivariateRealDistribution
-
Reseeds the random generator used to generate samples.
- reseedRandomGenerator(long) - Method in interface org.hipparchus.distribution.MultivariateRealDistribution
-
Reseeds the random generator used to generate samples.
- reseedRandomGenerator(long) - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Reseed the underlying PRNG.
- reset() - Method in class org.hipparchus.util.Incrementor
-
Resets the counter to 0.
- reset() - Method in class org.hipparchus.util.RosenNumberPartitionIterator
-
Reset this iterator to the start condition.
- reset(FieldVector3D<T>, FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Reset the instance as if built from two points.
- reset(Plane) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Reset the instance from another one.
- reset(Vector3D) - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Reset the instance as if built from a pole.
- reset(Vector3D, Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Reset the instance as if built from two points.
- reset(Vector3D, Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Reset the instance as if built from a point and a normal.
- reset(Vector2D, double) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Reset the instance as if built from a line and an angle.
- reset(Vector2D, Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Reset the instance as if built from two points.
- RESET_DERIVATIVES - Enum constant in enum org.hipparchus.migration.ode.events.EventHandler.Action
-
Deprecated.Reset derivatives indicator.
- RESET_DERIVATIVES - Enum constant in enum org.hipparchus.ode.events.Action
-
Reset derivatives indicator.
- RESET_EVENTS - Enum constant in enum org.hipparchus.ode.events.Action
-
Reset events indicator.
- RESET_STATE - Enum constant in enum org.hipparchus.migration.ode.events.EventHandler.Action
-
Deprecated.Reset state indicator.
- RESET_STATE - Enum constant in enum org.hipparchus.ode.events.Action
-
Reset state indicator.
- resetCount() - Method in class org.hipparchus.util.AbstractOpenIntHashMap
-
Reset count.
- resetInternalState() - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Reset internal state to dummy values.
- resetInternalState() - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Reset internal state to dummy values.
- resetIterationCount() - Method in class org.hipparchus.util.IterationManager
-
Sets the iteration count to 0.
- resetOccurred() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Check if a reset occurred while last step was accepted.
- resetOccurred() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Check if a reset occurred while last step was accepted.
- resetState(double, double[]) - Method in interface org.hipparchus.migration.ode.events.EventHandler
-
Deprecated.Reset the state prior to continue the integration.
- resetState(FieldODEEventDetector<T>, FieldODEStateAndDerivative<T>) - Method in interface org.hipparchus.ode.events.FieldODEEventHandler
-
Reset the state prior to continue the integration.
- resetState(ODEEventDetector, ODEStateAndDerivative) - Method in interface org.hipparchus.ode.events.ODEEventHandler
-
Reset the state prior to continue the integration.
- resetState(FieldODEStateAndDerivative<T>) - Method in interface org.hipparchus.ode.events.FieldODEStepEndHandler
-
Reset the state prior to continue the integration.
- resetState(ODEStateAndDerivative) - Method in interface org.hipparchus.ode.events.ODEStepEndHandler
-
Reset the state prior to continue the integration.
- residualDual(RealVector, RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPConvergenceChecker
-
Compute dual residual.
- residualPrime(RealVector, RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPConvergenceChecker
-
Compute primal residual.
- ResizableDoubleArray - Class in org.hipparchus.util
-
A variable length primitive double array implementation that automatically handles expanding and contracting its internal storage array as elements are added and removed.
- ResizableDoubleArray() - Constructor for class org.hipparchus.util.ResizableDoubleArray
-
Creates an instance with default properties.
- ResizableDoubleArray(double[]) - Constructor for class org.hipparchus.util.ResizableDoubleArray
-
Creates an instance from an existing
double[]
with the initial capacity and numElements corresponding to the size of the supplieddouble[]
array. - ResizableDoubleArray(int) - Constructor for class org.hipparchus.util.ResizableDoubleArray
-
Creates an instance with the specified initial capacity.
- ResizableDoubleArray(int, double) - Constructor for class org.hipparchus.util.ResizableDoubleArray
-
Creates an instance with the specified initial capacity and expansion factor.
- ResizableDoubleArray(int, double, double) - Constructor for class org.hipparchus.util.ResizableDoubleArray
-
Creates an instance with the specified initial capacity, expansion factor, and contraction criteria.
- ResizableDoubleArray(int, double, double, ResizableDoubleArray.ExpansionMode, double...) - Constructor for class org.hipparchus.util.ResizableDoubleArray
-
Creates an instance with the specified properties.
- ResizableDoubleArray(ResizableDoubleArray) - Constructor for class org.hipparchus.util.ResizableDoubleArray
-
Copy constructor.
- ResizableDoubleArray.ExpansionMode - Enum in org.hipparchus.util
-
Specification of expansion algorithm.
- RESIZE_MULTIPLIER - Static variable in class org.hipparchus.util.AbstractOpenIntHashMap
-
Multiplier for size growth when map fills up.
- resizeImage(BufferedImage, int, int, int) - Static method in class org.hipparchus.samples.ExampleUtils
-
Resize an image.
- restrictStep(FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>) - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Create a new restricted version of the instance.
- restrictStep(ODEStateAndDerivative, ODEStateAndDerivative) - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Create a new restricted version of the instance.
- reunite(SubHyperplane<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Compute the union of the instance and another sub-hyperplane.
- reunite(SubHyperplane<S>) - Method in interface org.hipparchus.geometry.partitioning.SubHyperplane
-
Compute the union of the instance and another sub-hyperplane.
- revert() - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Get a line with reversed direction.
- revert() - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Revert a rotation.
- revert() - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Get a line with reversed direction.
- revert() - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Revert a rotation.
- revertSelf() - Method in class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Revert the instance.
- revertSelf() - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Revert the plane.
- revertSelf() - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Revert the instance.
- revertSelf() - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Revert the instance.
- rF(double, double, double) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RF.
- rF(Complex, Complex, Complex) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RF.
- rF(FieldComplex<T>, FieldComplex<T>, FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RF.
- rF(T, T, T) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RF.
- rG(double, double, double) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RG.
- rG(Complex, Complex, Complex) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RG.
- rG(FieldComplex<T>, FieldComplex<T>, FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RG.
- rG(T, T, T) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RG.
- RiccatiEquationSolver - Interface in org.hipparchus.linear
-
An algebraic Riccati equation is a type of nonlinear equation that arises in the context of infinite-horizon optimal control problems in continuous time or discrete time.
- RiccatiEquationSolverImpl - Class in org.hipparchus.linear
-
This solver computes the solution using the following approach: 1.
- RiccatiEquationSolverImpl(RealMatrix, RealMatrix, RealMatrix, RealMatrix) - Constructor for class org.hipparchus.linear.RiccatiEquationSolverImpl
-
Constructor of the solver.
- RiddersSolver - Class in org.hipparchus.analysis.solvers
-
Implements the Ridders' Method for root finding of real univariate functions.
- RiddersSolver() - Constructor for class org.hipparchus.analysis.solvers.RiddersSolver
-
Construct a solver with default accuracy (1e-6).
- RiddersSolver(double) - Constructor for class org.hipparchus.analysis.solvers.RiddersSolver
-
Construct a solver.
- RiddersSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.RiddersSolver
-
Construct a solver.
- RIGHT_EDGE_GREATER_THAN_LEFT_EDGE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
RIGHT_EDGE_GREATER_THAN_LEFT_EDGE.
- RIGHT_SIDE - Enum constant in enum org.hipparchus.analysis.solvers.AllowedSolution
-
Only solutions that are greater than or equal to the actual root are acceptable as solutions for root-finding.
- rint() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Get the whole number that is the nearest to the instance, or the even one if x is exactly half way between two integers.
- rint() - Method in interface org.hipparchus.CalculusFieldElement
-
Get the whole number that is the nearest to the instance, or the even one if x is exactly half way between two integers.
- rint() - Method in class org.hipparchus.complex.Complex
-
Get the whole number that is the nearest to the instance, or the even one if x is exactly half way between two integers.
- rint() - Method in class org.hipparchus.complex.FieldComplex
-
Get the whole number that is the nearest to the instance, or the even one if x is exactly half way between two integers.
- rint() - Method in class org.hipparchus.dfp.Dfp
-
Round to nearest integer using the round-half-even method.
- rint() - Method in class org.hipparchus.util.Binary64
-
Get the whole number that is the nearest to the instance, or the even one if x is exactly half way between two integers.
- rint() - Method in class org.hipparchus.util.FieldTuple
-
Get the whole number that is the nearest to the instance, or the even one if x is exactly half way between two integers.
- rint() - Method in class org.hipparchus.util.Tuple
-
Get the whole number that is the nearest to the instance, or the even one if x is exactly half way between two integers.
- rint(double) - Static method in class org.hipparchus.util.FastMath
-
Get the whole number that is the nearest to x, or the even one if x is exactly half way between two integers.
- rint(T) - Static method in class org.hipparchus.util.FastMath
-
Get the whole number that is the nearest to x, or the even one if x is exactly half way between two integers.
- Rint - Class in org.hipparchus.analysis.function
-
rint
function. - Rint() - Constructor for class org.hipparchus.analysis.function.Rint
-
Empty constructor.
- rJ(double, double, double, double) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RJ.
- rJ(double, double, double, double, double) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RJ.
- rJ(Complex, Complex, Complex, Complex) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RJ.
- rJ(Complex, Complex, Complex, Complex, Complex) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RJ.
- rJ(FieldComplex<T>, FieldComplex<T>, FieldComplex<T>, FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RJ.
- rJ(FieldComplex<T>, FieldComplex<T>, FieldComplex<T>, FieldComplex<T>, FieldComplex<T>) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RJ.
- rJ(T, T, T, T) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RJ.
- rJ(T, T, T, T, T) - Static method in class org.hipparchus.special.elliptic.carlson.CarlsonEllipticIntegral
-
Compute Carlson elliptic integral RJ.
- rjBesl(double, double, int) - Static method in class org.hipparchus.special.BesselJ
-
Calculates Bessel functions \(J_{n+alpha}(x)\) for non-negative argument x, and non-negative order n + alpha.
- ROBUSTNESS_ITERATIONS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ROBUSTNESS_ITERATIONS.
- ROBUSTNESS_ITERATIONS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ROBUSTNESS_ITERATIONS.
- ROMBERG_MAX_ITERATIONS_COUNT - Static variable in class org.hipparchus.analysis.integration.FieldRombergIntegrator
-
Maximal number of iterations for Romberg.
- ROMBERG_MAX_ITERATIONS_COUNT - Static variable in class org.hipparchus.analysis.integration.RombergIntegrator
-
Maximal number of iterations for Romberg.
- RombergIntegrator - Class in org.hipparchus.analysis.integration
-
Implements the Romberg Algorithm for integration of real univariate functions.
- RombergIntegrator() - Constructor for class org.hipparchus.analysis.integration.RombergIntegrator
-
Construct a Romberg integrator with default settings (max iteration count set to
RombergIntegrator.ROMBERG_MAX_ITERATIONS_COUNT
) - RombergIntegrator(double, double, int, int) - Constructor for class org.hipparchus.analysis.integration.RombergIntegrator
-
Build a Romberg integrator with given accuracies and iterations counts.
- RombergIntegrator(int, int) - Constructor for class org.hipparchus.analysis.integration.RombergIntegrator
-
Build a Romberg integrator with given iteration counts.
- rootLogLikelihoodRatio(long, long, long, long) - Method in class org.hipparchus.stat.inference.GTest
-
Calculates the root log-likelihood ratio for 2 state Datasets.
- rootLogLikelihoodRatio(long, long, long, long) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Calculates the root log-likelihood ratio for 2 state Datasets.
- rootN(double[], int, int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute nth root of a derivative structure.
- rootN(int) - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Nth root.
- rootN(int) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Nth root.
- rootN(int) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Nth root.
- rootN(int) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Nth root.
- rootN(int) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Nth root.
- rootN(int) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Nth root.
- rootN(int) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Nth root.
- rootN(int) - Method in interface org.hipparchus.CalculusFieldElement
-
Nth root.
- rootN(int) - Method in class org.hipparchus.complex.Complex
-
Nth root.
- rootN(int) - Method in class org.hipparchus.complex.FieldComplex
-
Nth root.
- rootN(int) - Method in class org.hipparchus.dfp.Dfp
-
Nth root.
- rootN(int) - Method in class org.hipparchus.util.Binary64
-
Nth root.
- rootN(int) - Method in class org.hipparchus.util.FieldTuple
-
Nth root.
- rootN(int) - Method in class org.hipparchus.util.Tuple
-
Nth root.
- rootN(T[], int, int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute nth root of a derivative structure.
- ROOTS_OF_UNITY_NOT_COMPUTED_YET - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ROOTS_OF_UNITY_NOT_COMPUTED_YET.
- ROOTS_OF_UNITY_NOT_COMPUTED_YET - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ROOTS_OF_UNITY_NOT_COMPUTED_YET.
- RootsOfUnity - Class in org.hipparchus.complex
-
A helper class for the computation and caching of the
n
-th roots of unity. - RootsOfUnity() - Constructor for class org.hipparchus.complex.RootsOfUnity
-
Build an engine for computing the
n
-th roots of unity. - RosenNumberPartitionIterator - Class in org.hipparchus.util
-
An iterator that generates all partitions of
n
elements, intok
parts containing the number of elements in each part, based on Rosen's algorithm. - RosenNumberPartitionIterator(int, int) - Constructor for class org.hipparchus.util.RosenNumberPartitionIterator
-
Simple constructor.
- rotate(Vector3D, Rotation) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Rotate the plane around the specified point.
- rotate(Vector3D, Rotation) - Method in class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Rotate the region around the specified point.
- Rotation - Class in org.hipparchus.geometry.euclidean.threed
-
This class implements rotations in a three-dimensional space.
- Rotation(double[][], double) - Constructor for class org.hipparchus.geometry.euclidean.threed.Rotation
-
Build a rotation from a 3X3 matrix.
- Rotation(double, double, double, double, boolean) - Constructor for class org.hipparchus.geometry.euclidean.threed.Rotation
-
Build a rotation from the quaternion coordinates.
- Rotation(RotationOrder, RotationConvention, double, double, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.Rotation
-
Build a rotation from three Cardan or Euler elementary rotations.
- Rotation(Vector3D, double, RotationConvention) - Constructor for class org.hipparchus.geometry.euclidean.threed.Rotation
-
Build a rotation from an axis and an angle.
- Rotation(Vector3D, Vector3D) - Constructor for class org.hipparchus.geometry.euclidean.threed.Rotation
-
Build one of the rotations that transform one vector into another one.
- Rotation(Vector3D, Vector3D, Vector3D, Vector3D) - Constructor for class org.hipparchus.geometry.euclidean.threed.Rotation
-
Build the rotation that transforms a pair of vectors into another pair.
- ROTATION_MATRIX_DIMENSIONS - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
ROTATION_MATRIX_DIMENSIONS.
- ROTATION_MATRIX_DIMENSIONS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ROTATION_MATRIX_DIMENSIONS.
- RotationConvention - Enum in org.hipparchus.geometry.euclidean.threed
-
This enumerates is used to differentiate the semantics of a rotation.
- RotationOrder - Enum in org.hipparchus.geometry.euclidean.threed
-
Enumerate representing a rotation order specification for Cardan or Euler angles.
- round() - Method in interface org.hipparchus.CalculusFieldElement
-
Get the closest long to instance real value.
- round(double) - Static method in class org.hipparchus.util.FastMath
-
Get the closest long to x.
- round(double, int) - Static method in class org.hipparchus.util.Precision
-
Rounds the given value to the specified number of decimal places.
- round(double, int, RoundingMode) - Static method in class org.hipparchus.util.Precision
-
Rounds the given value to the specified number of decimal places.
- round(float) - Static method in class org.hipparchus.util.FastMath
-
Get the closest int to x.
- round(float, int) - Static method in class org.hipparchus.util.Precision
-
Rounds the given value to the specified number of decimal places.
- round(float, int, RoundingMode) - Static method in class org.hipparchus.util.Precision
-
Rounds the given value to the specified number of decimal places.
- round(int) - Method in class org.hipparchus.dfp.Dfp
-
Round this given the next digit n using the current rounding mode.
- round(int) - Method in class org.hipparchus.dfp.DfpDec
-
Round this given the next digit n using the current rounding mode.
- round(T) - Static method in class org.hipparchus.util.FastMath
-
Get the closest long to x.
- ROUND_CEIL - Enum constant in enum org.hipparchus.dfp.DfpField.RoundingMode
-
Rounds towards positive infinity.
- ROUND_DOWN - Enum constant in enum org.hipparchus.dfp.DfpField.RoundingMode
-
Rounds toward zero (truncation).
- ROUND_FLOOR - Enum constant in enum org.hipparchus.dfp.DfpField.RoundingMode
-
Rounds towards negative infinity.
- ROUND_HALF_DOWN - Enum constant in enum org.hipparchus.dfp.DfpField.RoundingMode
-
Rounds towards nearest unless both are equidistant in which case it rounds toward zero.
- ROUND_HALF_EVEN - Enum constant in enum org.hipparchus.dfp.DfpField.RoundingMode
-
Rounds towards nearest unless both are equidistant in which case it rounds toward the even neighbor.
- ROUND_HALF_ODD - Enum constant in enum org.hipparchus.dfp.DfpField.RoundingMode
-
Rounds towards nearest unless both are equidistant in which case it rounds toward the odd neighbor.
- ROUND_HALF_UP - Enum constant in enum org.hipparchus.dfp.DfpField.RoundingMode
-
Rounds towards nearest unless both are equidistant in which case it rounds away from zero.
- ROUND_UP - Enum constant in enum org.hipparchus.dfp.DfpField.RoundingMode
-
Rounds away from zero if discarded digit is non-zero.
- ROW_INDEX - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ROW_INDEX.
- ROW_INDEX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ROW_INDEX.
- ROW_INDEX_OUT_OF_RANGE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ROW_INDEX_OUT_OF_RANGE.
- ROW_INDEX_OUT_OF_RANGE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.ROW_INDEX_OUT_OF_RANGE.
- RRQRDecomposition - Class in org.hipparchus.linear
-
Calculates the rank-revealing QR-decomposition of a matrix, with column pivoting.
- RRQRDecomposition(RealMatrix) - Constructor for class org.hipparchus.linear.RRQRDecomposition
-
Calculates the QR-decomposition of the given matrix.
- RRQRDecomposition(RealMatrix, double) - Constructor for class org.hipparchus.linear.RRQRDecomposition
-
Calculates the QR-decomposition of the given matrix.
- RuleFactory - Interface in org.hipparchus.analysis.integration.gauss
-
Interface for rules that determines the integration nodes and their weights.
- RungeKuttaFieldIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This class implements the common part of all fixed step Runge-Kutta integrators for Ordinary Differential Equations.
- RungeKuttaFieldIntegrator(Field<T>, String, T) - Constructor for class org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegrator
-
Simple constructor.
- RungeKuttaIntegrator - Class in org.hipparchus.ode.nonstiff
-
This class implements the common part of all fixed step Runge-Kutta integrators for Ordinary Differential Equations.
- RungeKuttaIntegrator(String, double) - Constructor for class org.hipparchus.ode.nonstiff.RungeKuttaIntegrator
-
Simple constructor.
- RyuDouble - Class in org.hipparchus.util
-
An implementation of Ryū for double.
S
- 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 - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.SAME_SIGN_AT_ENDPOINTS.
- SAME_SIGN_AT_ENDPOINTS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.SAME_SIGN_AT_ENDPOINTS.
- 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 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
SAMPLE_SIZE_EXCEEDS_COLLECTION_SIZE.
- SAMPLE_SIZE_EXCEEDS_COLLECTION_SIZE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.SAMPLE_SIZE_EXCEEDS_COLLECTION_SIZE.
- SAMPLE_SIZE_LARGER_THAN_POPULATION_SIZE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
SAMPLE_SIZE_LARGER_THAN_POPULATION_SIZE.
- SAMPLE_SIZE_LARGER_THAN_POPULATION_SIZE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.SAMPLE_SIZE_LARGER_THAN_POPULATION_SIZE.
- 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.
- saturation(Complex) - Method in class org.hipparchus.samples.complex.DomainColoring
-
Get saturation for a complex value.
- SawToothModuleValue - Class in org.hipparchus.samples.complex
-
Domain coloring enhancing modules changes.
- SawToothModuleValue(double) - Constructor for class org.hipparchus.samples.complex.SawToothModuleValue
-
Simple constructor.
- SawToothPhaseModuleValue - Class in org.hipparchus.samples.complex
-
Domain coloring enhancing both phase and module changes.
- SawToothPhaseModuleValue(double, double, double, int) - Constructor for class org.hipparchus.samples.complex.SawToothPhaseModuleValue
-
Simple constructor.
- sc() - Method in class org.hipparchus.special.elliptic.jacobi.CopolarC
-
Get the value of the sc function.
- sc() - Method in class org.hipparchus.special.elliptic.jacobi.FieldCopolarC
-
Get the value of the sc function.
- scalarAdd(double) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the result of adding
d
to each entry ofthis
. - scalarAdd(double) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the result of adding
d
to each entry ofthis
. - scalarAdd(double) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the result of adding
d
to each entry ofthis
. - 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.FieldVector2D
-
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
byd
. - scalarMultiply(double) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the result of multiplying each entry of
this
byd
. - scalarMultiply(double) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the result of multiplying each entry of
this
byd
. - scalarMultiply(T) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Multiply the instance by a scalar.
- scalarMultiply(T) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
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.FieldGradient
-
Multiply the instance by a power of 2.
- scalb(int) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Multiply the instance by a power of 2.
- scalb(int) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Multiply the instance by a power of 2.
- scalb(int) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
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.analysis.differentiation.UnivariateDerivative1
-
Multiply the instance by a power of 2.
- scalb(int) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Multiply the instance by a power of 2.
- scalb(int) - Method in interface org.hipparchus.CalculusFieldElement
-
Multiply the instance by a power of 2.
- scalb(int) - Method in class org.hipparchus.complex.Complex
-
Multiply the instance by a power of 2.
- scalb(int) - Method in class org.hipparchus.complex.FieldComplex
-
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 class org.hipparchus.util.Binary64
-
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 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
SCALE.
- SCALE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.SCALE.
- 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.
- SchurTransformer - Class in org.hipparchus.linear
-
Class transforming a general real matrix to Schur form.
- SchurTransformer(RealMatrix) - Constructor for class org.hipparchus.linear.SchurTransformer
-
Build the transformation to Schur form of a general real matrix.
- SchurTransformer(RealMatrix, double) - Constructor for class org.hipparchus.linear.SchurTransformer
-
Build the transformation to Schur form of a general real matrix.
- 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: - sd() - Method in class org.hipparchus.special.elliptic.jacobi.CopolarD
-
Get the value of the sd function.
- sd() - Method in class org.hipparchus.special.elliptic.jacobi.FieldCopolarD
-
Get the value of the sd function.
- search(double[], double[]) - Method in class org.hipparchus.optim.nonlinear.scalar.LineSearch
-
Finds the number
alpha
that optimizesf(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
-
Simple constructor.
- SearchInterval(double, double, double) - Constructor for class org.hipparchus.optim.univariate.SearchInterval
-
Simple constructor.
- 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
-
Deprecated.as of 1.0, replaced with
SecondaryODE
- 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 theoriginal
. - SecondOrderDifferentialEquations - Interface in org.hipparchus.migration.ode
-
Deprecated.as of 1.0, replaced with
SecondOrderODE
- 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, double) - Constructor for class org.hipparchus.geometry.euclidean.twod.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.
- SEMI_PI - Static variable in class org.hipparchus.util.MathUtils
-
\(\pi/2\).
- SemiDefinitePositiveCholeskyDecomposition - Class in org.hipparchus.linear
-
Calculates the Cholesky decomposition of a positive semidefinite matrix.
- SemiDefinitePositiveCholeskyDecomposition(RealMatrix) - Constructor for class org.hipparchus.linear.SemiDefinitePositiveCholeskyDecomposition
-
Calculates the Cholesky decomposition of the given matrix.
- SemiDefinitePositiveCholeskyDecomposition(RealMatrix, double) - Constructor for class org.hipparchus.linear.SemiDefinitePositiveCholeskyDecomposition
-
Calculates the Cholesky decomposition of the given matrix.
- 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 specifiedDirection
property. - SemiVariance(SemiVariance) - Constructor for class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Copy constructor, creates a new
SemiVariance
identical to theoriginal
. - 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 atstart
, skippingstride
numbers. - SEQUENTIAL - Enum constant in enum org.hipparchus.stat.ranking.TiesStrategy
-
Ties assigned sequential ranks in order of occurrence
- SequentialGaussNewtonOptimizer - Class in org.hipparchus.optim.nonlinear.vector.leastsquares
-
Sequential Gauss-Newton least-squares solver.
- SequentialGaussNewtonOptimizer() - Constructor for class org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
-
Create a sequential Gauss Newton optimizer.
- SequentialGaussNewtonOptimizer(MatrixDecomposer, boolean, LeastSquaresProblem.Evaluation) - Constructor for class org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
-
Create a sequential Gauss Newton optimizer that uses the given matrix decomposition algorithm to solve the normal equations.
- 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.
- setAlpha(double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Set value of alpha filter for ADMM iteration.
- 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.
- setB(double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Set parameter for quadratic line search.
- setBarycenter(Point<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Set the barycenter of the instance.
- setBarycenter(Vector<S, V>) - 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
ofthis
matrix to the entries of the specifiedarray
. - setColumn(int, double[]) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Sets the specified
column
ofthis
matrix to the entries of the specifiedarray
. - setColumn(int, double[]) - Method in interface org.hipparchus.linear.RealMatrix
-
Sets the specified
column
ofthis
matrix to the entries of the specifiedarray
. - 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
ofthis
matrix to the entries of the specified columnmatrix
. - setColumnMatrix(int, RealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Sets the specified
column
ofthis
matrix to the entries of the specified columnmatrix
. - setColumnMatrix(int, RealMatrix) - Method in interface org.hipparchus.linear.RealMatrix
-
Sets the specified
column
ofthis
matrix to the entries of the specified columnmatrix
. - 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
ofthis
matrix to the entries of the specifiedvector
. - setColumnVector(int, RealVector) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Sets the specified
column
ofthis
matrix to the entries of the specifiedvector
. - setColumnVector(int, RealVector) - Method in interface org.hipparchus.linear.RealMatrix
-
Sets the specified
column
ofthis
matrix to the entries of the specifiedvector
. - setControlFactors(double, double, double, double) - Method in class org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegrator
-
Set the step size control factors.
- setConvCriteria(int) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Set convergence criteria.
- 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.
- setEps(double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Set absolute and Relative Tolerance for convergence.
- setEps(double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Set tolerance for convergence and active constraint evaluation.
- setEpsInfeasible(double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Set absolute and Relative Tolerance for infeasible criteria.
- 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.AdaptiveStepsizeFieldIntegrator
-
Set the initial step size.
- setInitialStepSize(double) - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Set the initial step size.
- setInitialStepSize(double) - Method in class org.hipparchus.ode.nonstiff.StepsizeHelper
-
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
-
Deprecated.as of 1.0, replaced with
ODEStateInterpolator.getInterpolatedState(double)
- 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.
- setMainSetDimension(int) - Method in class org.hipparchus.ode.nonstiff.StepsizeHelper
-
Set main set dimension.
- 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.
- setMaxLineSearchIteration(int) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Set max Iteration for the line search
- setMaxRhoIteration(int) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Set max number of weight changes.
- 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.
- setMu(double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Set parameter for evaluation of Armijo condition for descend direction.
- setNoIntercept(boolean) - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Set intercept flag.
- 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
-
Deprecated.as of 1.0, replaced with
JacobianMatrices.setParametersController(ParametersController)
- 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.
- setPolishing(boolean) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Set polishing enabling flag.
- setPolishingIteration(int) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Set number of iterations of polishing algorithm.
- setQpMaxLoop(int) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Set max iteration admitted for QP subproblem evaluation.
- 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).
- setRhoCons(double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Set weight for augmented QP subproblem.
- setRhoMax(double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Set max Value for the Weight for ADMM iteration.
- setRhoMin(double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Set min Value for the Weight for ADMM iteration.
- 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
ofthis
matrix to the entries of the specifiedarray
. - setRow(int, double[]) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Sets the specified
row
ofthis
matrix to the entries of the specifiedarray
. - setRow(int, double[]) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Sets the specified
row
ofthis
matrix to the entries of the specifiedarray
. - setRow(int, double[]) - Method in interface org.hipparchus.linear.RealMatrix
-
Sets the specified
row
ofthis
matrix to the entries of the specifiedarray
. - 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
ofthis
matrix to the entries of the specified rowmatrix
. - setRowMatrix(int, RealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Sets the specified
row
ofthis
matrix to the entries of the specified rowmatrix
. - setRowMatrix(int, RealMatrix) - Method in interface org.hipparchus.linear.RealMatrix
-
Sets the specified
row
ofthis
matrix to the entries of the specified rowmatrix
. - 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
ofthis
matrix to the entries of the specifiedvector
. - setRowVector(int, RealVector) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Sets the specified
row
ofthis
matrix to the entries of the specifiedvector
. - setRowVector(int, RealVector) - Method in interface org.hipparchus.linear.RealMatrix
-
Sets the specified
row
ofthis
matrix to the entries of the specifiedvector
. - 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.
- setScaleMaxIteration(int) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Set max iteration for the scaling.
- setScaling(boolean) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Set scaling enabling flag.
- setSeed(int) - Method in class org.hipparchus.random.Well44497b
-
Sets the seed of the underlying random number generator using an
int
seed. - setSeed(int) - Method in class org.hipparchus.random.RandomDataGenerator
-
Sets the seed of the underlying random number generator using an
int
seed. - 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.RandomDataGenerator
-
Sets the seed of the underlying random number generator using an
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.Well44497b
-
Sets the seed of the underlying random number generator using a
long
seed. - setSeed(long) - Method in class org.hipparchus.random.RandomDataGenerator
-
Sets the seed of the underlying random number generator using a
long
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. - setSigma(double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Set value of regularization term sigma for Karush–Kuhn–Tucker solver.
- setSigmaMax(double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Set max value admitted for the solution of the additional variable in QP subproblem.
- 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.
- setStepEnd(double) - Method in class org.hipparchus.ode.events.StepEndEventState
-
Set the step end.
- setStepEnd(T) - Method in class org.hipparchus.ode.events.FieldStepEndEventState
-
Set the step end.
- 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 inputsubMatrix
array. - setSubMatrix(double[][], int, int) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Replace the submatrix starting at
row, column
using data in the inputsubMatrix
array. - setSubMatrix(double[][], int, int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Replace the submatrix starting at
row, column
using data in the inputsubMatrix
array. - setSubMatrix(double[][], int, int) - Method in interface org.hipparchus.linear.RealMatrix
-
Replace the submatrix starting at
row, column
using data in the inputsubMatrix
array. - setSubMatrix(T[][], int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Replace the submatrix starting at
(row, column)
using data in the inputsubMatrix
array. - setSubMatrix(T[][], int, int) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Replace the submatrix starting at
(row, column)
using data in the inputsubMatrix
array. - setSubMatrix(T[][], int, int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Replace the submatrix starting at
(row, column)
using data in the inputsubMatrix
array. - setSubMatrix(T[][], int, int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Replace the submatrix starting at
(row, column)
using data in the inputsubMatrix
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, F, double, double, double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Prepare for computation.
- setup(int, CalculusFieldUnivariateFunction<T>, T, T) - Method in class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
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.
- setUpdateRho(boolean) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Set weight updating flag.
- 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.
- setUseFunHessian(boolean) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Enable or Disable using direct the function Hessian.
- setUsingFieldCoefficients(boolean) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Setter for the flag between real or Field coefficients in the Butcher array.
- setUsingFieldCoefficients(boolean) - Method in class org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegrator
-
Setter for the flag between real or Field coefficients in the Butcher array.
- 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 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
SHAPE.
- SHAPE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.SHAPE.
- 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 atx + 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.Binary64
-
The current implementation performs casting to a
short
. - shouldCheck() - Method in class org.hipparchus.linear.ConjugateGradient
-
Returns
true
if positive-definiteness should be checked for both matrix and preconditioner. - shouldCheck() - 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. - showExampleFrame(ExampleUtils.ExampleFrame) - Static method in class org.hipparchus.samples.ExampleUtils
-
Display example.
- 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 - 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
-
Simple constructor.
- Sigmoid - Class in org.hipparchus.analysis.function
-
Sigmoid 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.
- sign() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Compute the sign of the instance.
- sign() - Method in interface org.hipparchus.CalculusFieldElement
-
Compute the sign of the instance.
- sign() - Method in class org.hipparchus.complex.Complex
-
Compute the sign of the instance.
- sign() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the sign of the instance.
- sign() - Method in class org.hipparchus.dfp.Dfp
-
Compute the sign of the instance.
- sign() - Method in class org.hipparchus.util.Binary64
-
Compute the sign of the instance.
- sign() - Method in class org.hipparchus.util.FieldTuple
-
Compute the sign of the instance.
- sign() - Method in class org.hipparchus.util.Tuple
-
Compute the sign of the instance.
- sign(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the sign of a number.
- SIGNIFICANCE_LEVEL - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.SIGNIFICANCE_LEVEL.
- SIGNIFICANCE_LEVEL - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
SIGNIFICANCE_LEVEL.
- signum() - Method in class org.hipparchus.fraction.BigFraction
-
Returns the signum function of this
BigFraction
. - signum() - Method in class org.hipparchus.fraction.Fraction
-
Returns the signum function of this fraction.
- 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.
- SIMPLE_MESSAGE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
SIMPLE_MESSAGE.
- SIMPLE_MESSAGE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.SIMPLE_MESSAGE.
- SimpleBounds - Class in org.hipparchus.optim
-
Simple optimization constraints: lower and upper bounds.
- SimpleBounds(double[], double[]) - Constructor for class org.hipparchus.optim.SimpleBounds
-
Simple constructor.
- SimpleCurveFitter - Class in org.hipparchus.fitting
-
Fits points to a user-defined
function
. - SimplePointChecker<P extends Pair<double[],
? extends Object>> - Class in org.hipparchus.optim -
Simple implementation of the
ConvergenceChecker
interface using only point coordinates. - 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 - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.SIMPLEX_NEED_ONE_POINT.
- SIMPLEX_NEED_ONE_POINT - Enum constant in enum org.hipparchus.optim.LocalizedOptimFormats
-
SIMPLEX_NEED_ONE_POINT.
- 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
-
Simple constructor.
- SimplexOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.SimplexOptimizer
-
Simple constructor.
- 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.FieldSimpsonIntegrator
-
Maximal number of iterations for Simpson.
- 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 interface org.hipparchus.analysis.differentiation.Derivative1
-
Sine operation.
- sin() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Sine operation.
- sin() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Sine operation.
- sin() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Sine operation.
- sin() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Sine operation.
- sin() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Sine operation.
- sin() - Method in interface org.hipparchus.CalculusFieldElement
-
Sine operation.
- sin() - Method in class org.hipparchus.complex.Complex
-
Compute the sine of this complex number.
- sin() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the sine of this complex number.
- sin() - Method in class org.hipparchus.dfp.Dfp
-
Sine operation.
- sin() - Method in class org.hipparchus.util.Binary64
-
Sine operation.
- sin() - Method in class org.hipparchus.util.FieldSinCos
-
Get the value of the sine.
- 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
-
Empty constructor.
- 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() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Combined Sine and Cosine operation.
- sinCos() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Combined Sine and Cosine operation.
- sinCos() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Combined Sine and Cosine operation.
- sinCos() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Combined Sine and Cosine operation.
- sinCos() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Combined Sine and Cosine operation.
- sinCos() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Combined Sine and Cosine operation.
- sinCos() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Combined Sine and Cosine operation.
- sinCos() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Combined Sine and Cosine operation.
- sinCos() - Method in interface org.hipparchus.CalculusFieldElement
-
Combined Sine and Cosine operation.
- sinCos() - Method in class org.hipparchus.complex.Complex
-
Combined Sine and Cosine operation.
- sinCos() - Method in class org.hipparchus.complex.FieldComplex
-
Combined Sine and Cosine operation.
- sinCos() - Method in class org.hipparchus.util.Binary64
-
Combined Sine and Cosine operation.
- sinCos() - Method in class org.hipparchus.util.FieldTuple
-
Combined Sine and Cosine operation.
- sinCos() - Method in class org.hipparchus.util.Tuple
-
Combined Sine and Cosine operation.
- sinCos(double) - Static method in class org.hipparchus.util.FastMath
-
Combined Sine and Cosine function.
- sinCos(double[], int, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute combined sine and cosine of a derivative structure.
- sinCos(T) - Static method in class org.hipparchus.util.FastMath
-
Combined Sine and Cosine function.
- sinCos(T[], int, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute combined sine and cosine of a derivative structure.
- SinCos - Class in org.hipparchus.util
-
Holder for both sine and cosine values.
- singleStep(FieldOrdinaryDifferentialEquation<T>, T, T[], T) - Method in interface org.hipparchus.ode.nonstiff.FieldExplicitRungeKuttaIntegrator
-
Fast computation of a single step of ODE integration.
- singleStep(OrdinaryDifferentialEquation, double, double[], double) - Method in interface org.hipparchus.ode.nonstiff.ExplicitRungeKuttaIntegrator
-
Fast computation of a single step of ODE integration.
- SINGULAR_MATRIX - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
SINGULAR_MATRIX.
- SINGULAR_MATRIX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.SINGULAR_MATRIX.
- SINGULAR_OPERATOR - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
SINGULAR_OPERATOR.
- SINGULAR_OPERATOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.SINGULAR_OPERATOR.
- SingularMatrixException - Exception in org.hipparchus.migration.linear
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalStateException
- SingularMatrixException() - Constructor for exception org.hipparchus.migration.linear.SingularMatrixException
-
Deprecated.Construct an exception.
- SingularOperatorException - Exception in org.hipparchus.migration.linear
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- 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
-
Empty constructor.
- 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 interface org.hipparchus.analysis.differentiation.Derivative
-
Hyperbolic sine operation.
- sinh() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Hyperbolic sine operation.
- sinh() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Hyperbolic sine operation.
- sinh() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Hyperbolic sine operation.
- sinh() - Method in interface org.hipparchus.CalculusFieldElement
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.complex.Complex
-
Compute the hyperbolic sine of this complex number.
- sinh() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the hyperbolic sine of this complex number.
- sinh() - Method in class org.hipparchus.dfp.Dfp
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.util.Binary64
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.util.FieldSinhCosh
-
Get the value of the hyperbolic sine.
- sinh() - Method in class org.hipparchus.util.FieldTuple
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.util.SinhCosh
-
Get the value of the hyperbolic sine.
- 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
-
Empty constructor.
- sinhCosh() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in interface org.hipparchus.CalculusFieldElement
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in class org.hipparchus.complex.Complex
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in class org.hipparchus.complex.FieldComplex
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in class org.hipparchus.dfp.Dfp
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in class org.hipparchus.util.Binary64
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in class org.hipparchus.util.FieldTuple
-
Combined hyperbolic sine and cosine operation.
- sinhCosh() - Method in class org.hipparchus.util.Tuple
-
Combined hyperbolic sine and cosine operation.
- sinhCosh(double) - Static method in class org.hipparchus.util.FastMath
-
Combined hyperbolic sine and hyperbolic cosine function.
- sinhCosh(double[], int, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute combined hyperbolic sine and cosine of a derivative structure.
- sinhCosh(T) - Static method in class org.hipparchus.util.FastMath
-
Combined hyperbolic sine and hyperbolic cosine function.
- sinhCosh(T[], int, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute combined hyperbolic sine and cosine of a derivative structure.
- SinhCosh - Class in org.hipparchus.util
-
Holder for both hyperbolic sine and hyperbolic cosine values.
- 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.analysis.interpolation.GridAxis
-
Get the number of points of the grid.
- size() - Method in class org.hipparchus.util.AbstractOpenIntHashMap
-
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 theoriginal
. - 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.
- SMALLEST_TOLERANCE - Static variable in class org.hipparchus.geometry.spherical.oned.Sphere1D
-
Smallest tolerance that can be managed.
- SMALLEST_TOLERANCE - Static variable in class org.hipparchus.geometry.spherical.twod.Sphere2D
-
Smallest tolerance that can be managed.
- 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.
- SmoothStepFactory - Class in org.hipparchus.analysis.polynomials
-
Smoothstep function factory.
- SmoothStepFactory.FieldSmoothStepFunction<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.polynomials
-
Smoothstep function as defined here.
- SmoothStepFactory.QuadraticSmoothStepFunction - Class in org.hipparchus.analysis.polynomials
-
Specific smoothstep function that cannot be built using the
SmoothStepFactory.getGeneralOrder(int)
. - SmoothStepFactory.SmoothStepFunction - Class in org.hipparchus.analysis.polynomials
-
Smoothstep function as defined here.
- sn() - Method in class org.hipparchus.special.elliptic.jacobi.CopolarN
-
Get the value of the sn function.
- sn() - Method in class org.hipparchus.special.elliptic.jacobi.FieldCopolarN
-
Get the value of the sn function.
- 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
-
Empty constructor.
- solve(int, F, double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Solve for a zero in the vicinity of
startValue
. - solve(int, F, double) - Method in interface org.hipparchus.analysis.solvers.BaseUnivariateSolver
-
Solve for a zero in the vicinity of
startValue
. - solve(int, F, double, double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Solve for a zero root in the given interval.
- solve(int, F, double, double) - Method in interface org.hipparchus.analysis.solvers.BaseUnivariateSolver
-
Solve for a zero root in the given interval.
- solve(int, F, double, double, double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Solve for a zero in the given interval, start at
startValue
. - solve(int, F, double, double, double) - Method in interface org.hipparchus.analysis.solvers.BaseUnivariateSolver
-
Solve for a zero in the given interval, start at
startValue
. - solve(int, F, 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, F, double, double, AllowedSolution) - Method in interface org.hipparchus.analysis.solvers.BracketedUnivariateSolver
-
Solve for a zero in the given interval.
- solve(int, CalculusFieldUnivariateFunction<T>, T, T, AllowedSolution) - Method in interface org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
-
Solve for a zero in the given interval.
- solve(int, CalculusFieldUnivariateFunction<T>, T, T, AllowedSolution) - Method in class org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
-
Solve for a zero in the given interval.
- solve(int, CalculusFieldUnivariateFunction<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, CalculusFieldUnivariateFunction<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, UnivariateDifferentiableFunction, double, double) - Method in class org.hipparchus.analysis.solvers.NewtonRaphsonSolver
-
Find a zero near the midpoint of
min
andmax
. - 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(RealVector) - Method in interface org.hipparchus.linear.DecompositionSolver
-
Solve the linear equation A × X = B for matrices A.
- solve(RealVector, RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPKKT
-
Solve Karush–Kuhn–Tucker equation from given right hand value.
- solve(RealVector, RealVector) - Method in interface org.hipparchus.optim.nonlinear.vector.constrained.KarushKuhnTuckerSolver
-
Solve Karush–Kuhn–Tucker equation from given right hand value.
- 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.
- solveAllComplex(double[], int, 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, F, 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, F, 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, CalculusFieldUnivariateFunction<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, CalculusFieldUnivariateFunction<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, CalculusFieldUnivariateFunction<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
-
This is a utility function used by
AbstractIntegerDistribution.inverseCumulativeProbability(double)
. - 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
-
This class implements the
FieldVector
interface with aOpenIntToFieldHashMap
backing store. - 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
-
Empty constructor.
- 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
-
Empty constructor.
- SphericalCoordinates - Class in org.hipparchus.geometry.euclidean.threed
-
This class provides conversions related to spherical coordinates.
- 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
-
Empty constructor.
- split(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
- 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.
- SQPOptimizerGM - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Sequential Quadratic Programming Optimizer.
- SQPOptimizerGM() - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.SQPOptimizerGM
- SQPOptimizerS - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Sequential Quadratic Programming Optimizer.
- SQPOptimizerS() - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.SQPOptimizerS
- SQPOption - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
Parameter for SQP Algorithm.
- SQPOption() - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Simple constructor.
- sqrt() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Square root.
- sqrt() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Square root.
- sqrt() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Square root.
- sqrt() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Square root.
- sqrt() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Square root.
- sqrt() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Square root.
- sqrt() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Square root.
- sqrt() - Method in interface org.hipparchus.CalculusFieldElement
-
Square root.
- sqrt() - Method in class org.hipparchus.complex.Complex
-
Compute the square root of this complex number.
- sqrt() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the square root of this complex number.
- 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 class org.hipparchus.util.Binary64
-
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(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute square root of a derivative structure.
- sqrt(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the square root of a number.
- sqrt(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute square root of a derivative structure.
- Sqrt - Class in org.hipparchus.analysis.function
-
Square-root function.
- Sqrt() - Constructor for class org.hipparchus.analysis.function.Sqrt
-
Empty constructor.
- sqrt1z() - Method in class org.hipparchus.complex.Complex
-
Compute the square root of
1 - this2
for this complex number. - sqrt1z() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the square root of
1 - this2
for this complex number. - square() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Compute this × this.
- square() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute this × this.
- square() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Compute this × this.
- square() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute this × this.
- square() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute this × this.
- square() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute this × this.
- square() - Method in interface org.hipparchus.CalculusFieldElement
-
Compute this × this.
- square() - Method in class org.hipparchus.complex.Complex
-
Compute this × this.
- square() - Method in class org.hipparchus.complex.FieldComplex
- square() - Method in class org.hipparchus.dfp.Dfp
-
Compute this × this.
- square() - Method in class org.hipparchus.util.Binary64
- square() - Method in class org.hipparchus.util.FieldTuple
-
Compute this × this.
- square() - Method in class org.hipparchus.util.Tuple
-
Compute this × this.
- 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 - Enum constant in enum org.hipparchus.transform.DftNormalization
-
Should be passed to the constructor of
FastFourierTransformer
to use the standard normalization convention. - STANDARD_DCT_I - Enum constant in enum org.hipparchus.transform.DctNormalization
-
Should be passed to the constructor of
FastCosineTransformer
to use the standard normalization convention. - STANDARD_DEVIATION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
STANDARD_DEVIATION.
- STANDARD_DEVIATION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.STANDARD_DEVIATION.
- STANDARD_DST_I - Enum constant in enum 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 theoriginal
. - 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 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
START_POINT_NOT_IN_INTERVAL.
- START_POSITION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
START_POSITION.
- START_POSITION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.START_POSITION.
- 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.
- StepEndEventState - Class in org.hipparchus.ode.events
-
This class handles the state for one
event handler
that triggers at step end. - StepEndEventState(ODEStepEndHandler) - Constructor for class org.hipparchus.ode.events.StepEndEventState
-
Simple constructor.
- stepEndOccurred(FieldODEStateAndDerivative<T>, boolean) - Method in interface org.hipparchus.ode.events.FieldODEStepEndHandler
-
Handle an event and choose what to do next.
- stepEndOccurred(ODEStateAndDerivative, boolean) - Method in interface org.hipparchus.ode.events.ODEStepEndHandler
-
Handle an event and choose what to do next.
- 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
-
Deprecated.as of 1.0, replaced with
ODEStepHandler
- StepInterpolator - Interface in org.hipparchus.migration.ode.sampling
-
Deprecated.as of 1.0, replaced with
ODEStateInterpolator
- StepNormalizer - Class in org.hipparchus.ode.sampling
-
This class wraps an object implementing
ODEFixedStepHandler
into aODEStepHandler
. - 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
-
Step normalizer
bounds settings. - StepNormalizerMode - Enum in org.hipparchus.ode.sampling
-
Step normalizer
modes. - StepsizeHelper - Class in org.hipparchus.ode.nonstiff
-
Helper for adaptive stepsize control.
- StepsizeHelper(double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.StepsizeHelper
-
Simple constructor..
- StepsizeHelper(double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.StepsizeHelper
-
Simple constructor.
- stirlingS2(int, int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Returns the Stirling number of the second kind, "
S(n,k)
", the number of ways of partitioning ann
-element set intok
non-empty subsets. - STOP - Enum constant in enum org.hipparchus.migration.ode.events.EventHandler.Action
-
Deprecated.Stop indicator.
- STOP - Enum constant in enum 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(P) - 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
-
Extends the definition of
UnivariateStatistic
withStorelessUnivariateStatistic.increment(double)
andStorelessUnivariateStatistic.incrementAll(double[])
methods for adding values and updating internal state. - 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(double, RandomGenerator) - 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 arguments.
- 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 - Enum constant in enum 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 - Enum constant in enum 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 - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
SUBARRAY_ENDS_AFTER_ARRAY_END.
- SUBARRAY_ENDS_AFTER_ARRAY_END - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.SUBARRAY_ENDS_AFTER_ARRAY_END.
- 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
-
This class represents sub-hyperplane for
OrientedPoint
. - 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 interface org.hipparchus.analysis.differentiation.Derivative
-
'-' operator.
- subtract(double) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'-' operator.
- subtract(double) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
'-' operator.
- subtract(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'-' operator.
- subtract(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'-' operator.
- subtract(double) - Method in interface org.hipparchus.CalculusFieldElement
-
'-' 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.complex.FieldComplex
-
Returns a
Complex
whose value is(this - subtrahend)
. - subtract(double) - Method in class org.hipparchus.util.Binary64
-
'-' 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, FieldVector2D<T>) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Subtract a scaled vector from the instance.
- subtract(double, Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Subtract a scaled vector from the instance.
- subtract(double, Vector<Euclidean1D, Vector1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Subtract a scaled vector from the instance.
- subtract(double, Vector<Euclidean3D, Vector3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Subtract a scaled vector from the instance.
- subtract(double, Vector<Euclidean2D, Vector2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Subtract a scaled vector from the instance.
- subtract(double, Vector<S, V>) - 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 thisBigFraction
, 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 thisBigFraction
, 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 thisBigFraction
, 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(FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute this - a.
- subtract(FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute this - a.
- subtract(FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute this - a.
- subtract(Gradient) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Compute this - a.
- subtract(SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute this - a.
- subtract(UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute this - a.
- subtract(UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute this - a.
- subtract(FieldPolynomialFunction<T>) - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Subtract a polynomial from the instance.
- 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(FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
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(FieldVector2D<T>) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Subtract a vector from the instance.
- subtract(Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Subtract a vector from the instance.
- subtract(Vector<Euclidean1D, Vector1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Subtract a vector from the instance.
- subtract(Vector<Euclidean3D, Vector3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Subtract a vector from the instance.
- subtract(Vector<Euclidean2D, Vector2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Subtract a vector from the instance.
- subtract(Vector<S, V>) - 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
minusm
. - subtract(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute
this
minusv
. - 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
minusm
. - 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
minusv
. - subtract(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Compute
this
minusv
. - subtract(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Compute
this
minusv
. - 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
minusm
. - subtract(RealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns
this
minusm
. - subtract(RealMatrix) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Returns
this
minusm
. - subtract(RealMatrix) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns
this
minusm
. - 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
minusv
. - subtract(BigReal) - Method in class org.hipparchus.util.BigReal
-
Compute this - a.
- subtract(Binary64) - Method in class org.hipparchus.util.Binary64
-
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(S) - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
'-' operator.
- subtract(T) - Method in interface org.hipparchus.CalculusFieldElement
-
Compute this - a.
- subtract(T) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value is(this - subtrahend)
. - 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(T, FieldVector2D<T>) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Subtract a scaled vector from the instance.
- subtract(T, Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
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
-
Empty constructor.
- 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(FieldSinCos<S>, FieldSinCos<S>) - Static method in class org.hipparchus.util.FieldSinCos
-
Compute sine and cosine of angles sum.
- sum(FieldSinhCosh<S>, FieldSinhCosh<S>) - Static method in class org.hipparchus.util.FieldSinhCosh
-
Compute hyperbolic sine and hyperbolic cosine of angles sum.
- sum(SinCos, SinCos) - Static method in class org.hipparchus.util.SinCos
-
Compute sine and cosine of angles sum.
- sum(SinhCosh, SinhCosh) - Static method in class org.hipparchus.util.SinhCosh
-
Compute hyperbolic sine and hyperbolic cosine of angles sum.
- 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 theoriginal
. - 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
-
Simple constructor.
- 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 theoriginal
. - 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 theoriginal
. - 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.
- SymmetricFieldGaussIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.integration.gauss
-
This class's implements
integrate
method assuming that the integral is symmetric about 0. - SymmetricFieldGaussIntegrator(Pair<T[], T[]>) - Constructor for class org.hipparchus.analysis.integration.gauss.SymmetricFieldGaussIntegrator
-
Creates an integrator from the given pair of points (first element of the pair) and weights (second element of the pair.
- SymmetricFieldGaussIntegrator(T[], T[]) - Constructor for class org.hipparchus.analysis.integration.gauss.SymmetricFieldGaussIntegrator
-
Creates an integrator from the given
points
andweights
. - 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
andweights
. - 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
-
Implementation of the SYMMLQ iterative linear solver proposed by Paige and Saunders (1975).
- SymmLQ(int, double, boolean) - Constructor for class org.hipparchus.linear.SymmLQ
-
Creates a new instance of this class, with default stopping criterion.
- SymmLQ(IterationManager, double, boolean) - Constructor for class org.hipparchus.linear.SymmLQ
-
Creates a new instance of this class, with default stopping criterion and custom iteration manager.
- 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.
T
- t(double[], double[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes a 2-sample t statistic, without the hypothesis of equal subpopulation variances.
- t(double[], double[]) - Method in class org.hipparchus.stat.inference.TTest
-
Computes a 2-sample t statistic, without the hypothesis of equal subpopulation variances.
- t(double, double[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes a t statistic given observed values and a comparison constant.
- t(double, double[]) - Method in class org.hipparchus.stat.inference.TTest
-
Computes a t statistic given observed values and a comparison constant.
- t(double, double, double, double) - Method in class org.hipparchus.stat.inference.TTest
-
Computes t test statistic for 1-sample t-test.
- t(double, double, double, double, double, double) - Method in class org.hipparchus.stat.inference.TTest
-
Computes t test statistic for 2-sample t-test.
- t(double, StatisticalSummary) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
- t(double, StatisticalSummary) - Method in class org.hipparchus.stat.inference.TTest
- t(StatisticalSummary, StatisticalSummary) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Computes a 2-sample t statistic, comparing the means of the datasets described by two
StatisticalSummary
instances, without the assumption of equal subpopulation variances. - t(StatisticalSummary, StatisticalSummary) - Method in class org.hipparchus.stat.inference.TTest
-
Computes a 2-sample t statistic, comparing the means of the datasets described by two
StatisticalSummary
instances, without the assumption of equal subpopulation variances. - TAIL - Enum constant in enum org.hipparchus.util.MathArrays.Position
-
Designates the end of the array.
- tan() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Tangent operation.
- tan() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Tangent operation.
- tan() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Tangent operation.
- tan() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Tangent operation.
- tan() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Tangent operation.
- tan() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Tangent operation.
- tan() - Method in interface org.hipparchus.CalculusFieldElement
-
Tangent operation.
- tan() - Method in class org.hipparchus.complex.Complex
-
Compute the tangent of this complex number.
- tan() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the tangent of this complex number.
- tan() - Method in class org.hipparchus.dfp.Dfp
-
Tangent operation.
- tan() - Method in class org.hipparchus.util.Binary64
-
Tangent operation.
- tan() - Method in class org.hipparchus.util.FieldTuple
-
Tangent operation.
- tan() - Method in class org.hipparchus.util.Tuple
-
Tangent operation.
- tan(double) - Static method in class org.hipparchus.util.FastMath
-
Tangent function.
- tan(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute tangent of a derivative structure.
- tan(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
computes the tangent of the argument.
- tan(T) - Static method in class org.hipparchus.util.FastMath
-
Tangent function.
- tan(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute tangent of a derivative structure.
- Tan - Class in org.hipparchus.analysis.function
-
Tangent function.
- Tan() - Constructor for class org.hipparchus.analysis.function.Tan
-
Empty constructor.
- tanh() - Method in interface org.hipparchus.analysis.differentiation.Derivative1
-
Hyperbolic tangent operation.
- tanh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Hyperbolic tangent operation.
- tanh() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative1
-
Hyperbolic tangent operation.
- tanh() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Hyperbolic tangent operation.
- tanh() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Hyperbolic tangent operation.
- tanh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Hyperbolic tangent operation.
- tanh() - Method in interface org.hipparchus.CalculusFieldElement
-
Hyperbolic tangent operation.
- tanh() - Method in class org.hipparchus.complex.Complex
-
Compute the hyperbolic tangent of this complex number.
- tanh() - Method in class org.hipparchus.complex.FieldComplex
-
Compute the hyperbolic tangent of this complex number.
- tanh() - Method in class org.hipparchus.dfp.Dfp
-
Hyperbolic tangent operation.
- tanh() - Method in class org.hipparchus.util.Binary64
-
Hyperbolic tangent operation.
- tanh() - Method in class org.hipparchus.util.FieldTuple
-
Hyperbolic tangent operation.
- tanh() - Method in class org.hipparchus.util.Tuple
-
Hyperbolic tangent operation.
- tanh(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the hyperbolic tangent of a number.
- tanh(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute hyperbolic tangent of a derivative structure.
- tanh(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the hyperbolic tangent of a number.
- tanh(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute hyperbolic tangent of a derivative structure.
- Tanh - Class in org.hipparchus.analysis.function
-
Hyperbolic tangent function.
- Tanh() - Constructor for class org.hipparchus.analysis.function.Tanh
-
Empty constructor.
- target(double[]) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the observed data.
- target(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the observed data.
- taylor(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Evaluate Taylor expansion of a univariate derivative.
- taylor(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Evaluate Taylor expansion a univariate derivative.
- taylor(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Evaluate Taylor expansion a univariate derivative.
- taylor(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Evaluate Taylor expansion a univariate derivative.
- taylor(double...) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Evaluate Taylor expansion a derivative structure.
- taylor(double...) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Evaluate Taylor expansion of a derivative structure.
- taylor(double...) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Evaluate Taylor expansion of a gradient.
- taylor(double...) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Evaluate Taylor expansion a derivative structure.
- taylor(double...) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Evaluate Taylor expansion of a sparse gradient.
- taylor(double[], int, double...) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Evaluate Taylor expansion of a derivative structure.
- taylor(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Evaluate Taylor expansion of a univariate derivative.
- taylor(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Evaluate Taylor expansion a univariate derivative.
- taylor(T...) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Evaluate Taylor expansion of a derivative structure.
- taylor(T...) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Evaluate Taylor expansion of a gradient.
- taylor(T[], int, double...) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Evaluate Taylor expansion of a derivative structure.
- taylor(T[], int, T...) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Evaluate Taylor expansion of a derivative structure.
- TaylorMap - Class in org.hipparchus.analysis.differentiation
-
Container for a Taylor map.
- TaylorMap(double[], DerivativeStructure[]) - Constructor for class org.hipparchus.analysis.differentiation.TaylorMap
-
Simple constructor.
- TaylorMap(int, int, int) - Constructor for class org.hipparchus.analysis.differentiation.TaylorMap
-
Constructor for identity map.
- TDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of Student's t-distribution.
- TDistribution(double) - Constructor for class org.hipparchus.distribution.continuous.TDistribution
-
Create a t distribution using the given degrees of freedom.
- TDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.TDistribution
-
Create a t distribution using the given degrees of freedom and the specified inverse cumulative probability absolute accuracy.
- terminationPerformed(IterationEvent) - Method in interface org.hipparchus.util.IterationListener
-
Invoked after completion of the operations which occur after breaking out of the main iteration loop.
- test(int, int) - Method in interface org.hipparchus.fraction.Fraction.ConvergenceTest
-
Evaluates if the fraction formed by
numerator/denominator
satisfies this convergence test. - test(long, long) - Method in interface org.hipparchus.fraction.BigFraction.ConvergenceTest
-
Evaluates if the fraction formed by
numerator/denominator
satisfies this convergence test. - TheoreticalValuesFunction(ParametricUnivariateFunction, Collection<WeightedObservedPoint>) - Constructor for class org.hipparchus.fitting.AbstractCurveFitter.TheoreticalValuesFunction
-
Simple constructor.
- Theta - Class in org.hipparchus.special.elliptic.jacobi
-
Values of
Jacobi theta
functions. - theta1() - Method in class org.hipparchus.special.elliptic.jacobi.FieldTheta
-
Get the value of the θ₁(z|τ) function.
- theta1() - Method in class org.hipparchus.special.elliptic.jacobi.Theta
-
Get the value of the θ₁(z|τ) function.
- theta2() - Method in class org.hipparchus.special.elliptic.jacobi.FieldTheta
-
Get the value of the θ₂(z|τ) function.
- theta2() - Method in class org.hipparchus.special.elliptic.jacobi.Theta
-
Get the value of the θ₂(z|τ) function.
- theta3() - Method in class org.hipparchus.special.elliptic.jacobi.FieldTheta
-
Get the value of the θ₃(z|τ) function.
- theta3() - Method in class org.hipparchus.special.elliptic.jacobi.Theta
-
Get the value of the θ₃(z|τ) function.
- theta4() - Method in class org.hipparchus.special.elliptic.jacobi.FieldTheta
-
Get the value of the θ₄(z|τ) function.
- theta4() - Method in class org.hipparchus.special.elliptic.jacobi.Theta
-
Get the value of the θ₄(z|τ) function.
- THREE_FIFTHS - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "3/5".
- THREE_FIFTHS - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "3/5".
- THREE_QUARTERS - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "3/4".
- THREE_QUARTERS - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "3/4".
- ThreeEighthesFieldIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This class implements the 3/8 fourth order Runge-Kutta integrator for Ordinary Differential Equations.
- ThreeEighthesFieldIntegrator(Field<T>, T) - Constructor for class org.hipparchus.ode.nonstiff.ThreeEighthesFieldIntegrator
-
Simple constructor.
- ThreeEighthesIntegrator - Class in org.hipparchus.ode.nonstiff
-
This class implements the 3/8 fourth order Runge-Kutta integrator for Ordinary Differential Equations.
- ThreeEighthesIntegrator(double) - Constructor for class org.hipparchus.ode.nonstiff.ThreeEighthesIntegrator
-
Simple constructor.
- TIES_ARE_NOT_ALLOWED - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
TIES_ARE_NOT_ALLOWED.
- TiesStrategy - Enum in org.hipparchus.stat.ranking
-
Strategies for handling tied values in rank transformations.
- toArray() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get the vector coordinates as a dimension 3 array.
- toArray() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get the vector coordinates as a dimension 3 array.
- toArray() - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Get the vector coordinates as a dimension 2 array.
- toArray() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Get the vector coordinates as a dimension 2 array.
- toArray() - Method in class org.hipparchus.linear.ArrayFieldVector
-
Convert the vector to a T array.
- toArray() - Method in class org.hipparchus.linear.ArrayRealVector
-
Convert the vector to an array of
double
s. - toArray() - Method in interface org.hipparchus.linear.FieldVector
-
Convert the vector to a T array.
- toArray() - Method in class org.hipparchus.linear.OpenMapRealVector
-
Convert the vector to an array of
double
s. - toArray() - Method in class org.hipparchus.linear.RealVector
-
Convert the vector to an array of
double
s. - toArray() - Method in class org.hipparchus.linear.SparseFieldVector
-
Convert the vector to a T array.
- toBlocksLayout(double[][]) - Static method in class org.hipparchus.linear.BlockRealMatrix
-
Convert a data array from raw layout to blocks layout.
- toBlocksLayout(T[][]) - Static method in class org.hipparchus.linear.BlockFieldMatrix
-
Convert a data array from raw layout to blocks layout.
- toCalculusFieldBivariateFunction(Field<T>) - Method in interface org.hipparchus.analysis.FieldBivariateFunction
-
Convert to a
CalculusFieldBivariateFunction
with a specific type. - toCalculusFieldMultivariateFunction(Field<T>) - Method in interface org.hipparchus.analysis.FieldMultivariateFunction
-
Convert to a
CalculusFieldMultivariateFunction
with a specific type. - toCalculusFieldMultivariateMatrixFunction(Field<T>) - Method in interface org.hipparchus.analysis.FieldMultivariateMatrixFunction
-
Convert to a
CalculusFieldMultivariateMatrixFunction
with a specific type. - toCalculusFieldMultivariateVectorFunction(Field<T>) - Method in interface org.hipparchus.analysis.FieldMultivariateVectorFunction
-
Convert to a
CalculusFieldMultivariateVectorFunction
with a specific type. - toCalculusFieldUnivariateFunction(Field<T>) - Method in interface org.hipparchus.analysis.FieldUnivariateFunction
-
Convert to a
CalculusFieldUnivariateFunction
with a specific type. - toCalculusFieldUnivariateMatrixFunction(Field<T>) - Method in interface org.hipparchus.analysis.FieldUnivariateMatrixFunction
-
Convert to a
CalculusFieldUnivariateMatrixFunction
with a specific type. - toCalculusFieldUnivariateVectorFunction(Field<T>) - Method in interface org.hipparchus.analysis.FieldUnivariateVectorFunction
-
Convert to a
CalculusFieldUnivariateVectorFunction
with a specific type. - toCartesianGradient(double[]) - Method in class org.hipparchus.geometry.euclidean.threed.SphericalCoordinates
-
Convert a gradient with respect to spherical coordinates into a gradient with respect to Cartesian coordinates.
- toCartesianHessian(double[][], double[]) - Method in class org.hipparchus.geometry.euclidean.threed.SphericalCoordinates
-
Convert a Hessian with respect to spherical coordinates into a Hessian with respect to Cartesian coordinates.
- toDegrees() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in interface org.hipparchus.CalculusFieldElement
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.complex.Complex
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.complex.FieldComplex
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.dfp.Dfp
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.util.Binary64
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.util.FieldTuple
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees() - Method in class org.hipparchus.util.Tuple
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees(double) - Static method in class org.hipparchus.util.FastMath
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDegrees(T) - Static method in class org.hipparchus.util.FastMath
-
Convert radians to degrees, with error of less than 0.5 ULP
- toDerivativeStructure() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Convert the instance to a
FieldDerivativeStructure
. - toDerivativeStructure() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative
-
Convert the instance to a
DerivativeStructure
. - toDerivativeStructure() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Convert the instance to a
FieldDerivativeStructure
. - toDerivativeStructure() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Convert the instance to a
FieldDerivativeStructure
. - toDerivativeStructure() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Convert the instance to a
DerivativeStructure
. - toDerivativeStructure() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative
-
Convert the instance to a
DerivativeStructure
. - toDerivativeStructure() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Convert the instance to a
DerivativeStructure
. - toDerivativeStructure() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Convert the instance to a
DerivativeStructure
. - toDifferentiable(MultivariateFunction, MultivariateVectorFunction) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Convert regular functions to
MultivariateDifferentiableFunction
. - toDifferentiable(UnivariateFunction, UnivariateFunction...) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Convert regular functions to
UnivariateDifferentiableFunction
. - toDouble() - Method in class org.hipparchus.dfp.Dfp
-
Convert the instance into a double.
- toIntExact(long) - Static method in class org.hipparchus.util.FastMath
-
Convert a long to interger, detecting overflows
- toList() - Method in class org.hipparchus.fitting.WeightedObservedPoints
-
Gets a snapshot of the observed points.
- TOO_LARGE_CUTOFF_SINGULAR_VALUE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
TOO_LARGE_CUTOFF_SINGULAR_VALUE.
- TOO_LARGE_CUTOFF_SINGULAR_VALUE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.TOO_LARGE_CUTOFF_SINGULAR_VALUE.
- TOO_MANY_ELEMENTS_TO_DISCARD_FROM_ARRAY - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
TOO_MANY_ELEMENTS_TO_DISCARD_FROM_ARRAY.
- TOO_MANY_ELEMENTS_TO_DISCARD_FROM_ARRAY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.TOO_MANY_ELEMENTS_TO_DISCARD_FROM_ARRAY.
- TOO_MANY_REGRESSORS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.TOO_MANY_REGRESSORS.
- TOO_MANY_REGRESSORS - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
TOO_MANY_REGRESSORS.
- TOO_SMALL_COST_RELATIVE_TOLERANCE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.TOO_SMALL_COST_RELATIVE_TOLERANCE.
- TOO_SMALL_COST_RELATIVE_TOLERANCE - Enum constant in enum org.hipparchus.optim.LocalizedOptimFormats
-
TOO_SMALL_COST_RELATIVE_TOLERANCE.
- TOO_SMALL_INTEGRATION_INTERVAL - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.TOO_SMALL_INTEGRATION_INTERVAL.
- TOO_SMALL_INTEGRATION_INTERVAL - Enum constant in enum org.hipparchus.ode.LocalizedODEFormats
-
TOO_SMALL_INTEGRATION_INTERVAL.
- TOO_SMALL_ORTHOGONALITY_TOLERANCE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.TOO_SMALL_ORTHOGONALITY_TOLERANCE.
- TOO_SMALL_ORTHOGONALITY_TOLERANCE - Enum constant in enum org.hipparchus.optim.LocalizedOptimFormats
-
TOO_SMALL_ORTHOGONALITY_TOLERANCE.
- TOO_SMALL_PARAMETERS_RELATIVE_TOLERANCE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.TOO_SMALL_PARAMETERS_RELATIVE_TOLERANCE.
- TOO_SMALL_PARAMETERS_RELATIVE_TOLERANCE - Enum constant in enum org.hipparchus.optim.LocalizedOptimFormats
-
TOO_SMALL_PARAMETERS_RELATIVE_TOLERANCE.
- TOO_SMALL_TOLERANCE - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
TOO_SMALL_TOLERANCE.
- TooManyEvaluationsException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- TooManyEvaluationsException(Number) - Constructor for exception org.hipparchus.migration.exception.TooManyEvaluationsException
-
Deprecated.Construct the exception.
- TooManyIterationsException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- TooManyIterationsException(Number) - Constructor for exception org.hipparchus.migration.exception.TooManyIterationsException
-
Deprecated.Construct the exception.
- toRadians() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in interface org.hipparchus.CalculusFieldElement
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.complex.Complex
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.complex.FieldComplex
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.dfp.Dfp
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.util.Binary64
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.util.FieldTuple
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians() - Method in class org.hipparchus.util.Tuple
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians(double) - Static method in class org.hipparchus.util.FastMath
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRadians(T) - Static method in class org.hipparchus.util.FastMath
-
Convert degrees to radians, with error of less than 0.5 ULP
- toRotation() - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Convert to a constant vector without derivatives.
- toSpace(Point<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Transform a sub-space point into a space point.
- toSpace(Point<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Transform a sub-space point into a space point.
- toSpace(Point<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Transform an in-plane point into a 3D space point.
- toSpace(Point<Sphere1D>) - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Transform a sub-space point into a space point.
- toSpace(Point<T>) - Method in interface org.hipparchus.geometry.partitioning.Embedding
-
Transform a sub-space point into a space point.
- toSpace(Vector<Euclidean1D, Vector1D>) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Transform a sub-space point into a space point.
- toSpace(Vector<Euclidean1D, Vector1D>) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Transform a sub-space point into a space point.
- toSpace(Vector<Euclidean2D, Vector2D>) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Transform a sub-space point into a space point.
- toSplitDouble() - Method in class org.hipparchus.dfp.Dfp
-
Convert the instance into a split double.
- toString() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Returns a string representation of the polynomial.
- toString() - Method in class org.hipparchus.clustering.DoublePoint
- toString() - Method in class org.hipparchus.complex.Complex
- toString() - Method in class org.hipparchus.complex.FieldComplex
- toString() - Method in class org.hipparchus.complex.Quaternion
- toString() - Method in class org.hipparchus.dfp.Dfp
-
Get a string representation of the instance.
- toString() - Method in class org.hipparchus.exception.DummyLocalizable
- toString() - Method in class org.hipparchus.fraction.BigFraction
-
Returns the
String
representing this fraction, ie "num / dem" or just "num" if the denominator is one. - toString() - Method in class org.hipparchus.fraction.Fraction
-
Returns the
String
representing this fraction, ie "num / dem" or just "num" if the denominator is one. - toString() - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Get a string representation of this vector.
- toString() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get a string representation of this vector.
- toString() - Method in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Get a string representation of the instance.
- toString() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get a string representation of this vector.
- toString() - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Get a string representation of this vector.
- toString() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Get a string representation of this vector.
- toString() - Method in class org.hipparchus.geometry.spherical.twod.S2Point
- toString() - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Get a string representation for this matrix.
- toString() - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Get a string representation for this matrix.
- toString() - Method in class org.hipparchus.linear.ArrayFieldVector
- toString() - Method in class org.hipparchus.linear.ArrayRealVector
- toString() - Method in enum org.hipparchus.optim.linear.Relationship
- toString() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
- toString() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
- toString() - Method in class org.hipparchus.random.JDKRandomGenerator
- toString() - Method in class org.hipparchus.stat.descriptive.AbstractStorelessUnivariateStatistic
- toString() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Generates a text report displaying univariate statistics from values that have been added.
- toString() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Generates a text report displaying summary statistics from values that have been added.
- toString() - Method in class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
Returns a string containing the last observation, the current estimate of the quantile and all markers.
- toString() - Method in class org.hipparchus.stat.descriptive.StatisticalSummaryValues
-
Generates a text report displaying values of statistics.
- toString() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Generates a text report displaying summary statistics from values that have been added.
- toString() - Method in class org.hipparchus.stat.Frequency
-
Return a string representation of this frequency distribution.
- toString() - Method in class org.hipparchus.stat.interval.ConfidenceInterval
-
Get String representation of the confidence interval.
- toString() - Method in class org.hipparchus.util.Binary64
-
The returned
String
is equal toDouble.toString(this.doubleValue())
- toString() - Method in class org.hipparchus.util.MultidimensionalCounter
- toString() - Method in class org.hipparchus.util.Pair
- toString(NumberFormat) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Get a string representation of this vector.
- toString(NumberFormat) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get a string representation of this vector.
- toString(NumberFormat) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get a string representation of this vector.
- toString(NumberFormat) - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Get a string representation of this vector.
- toString(NumberFormat) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Get a string representation of this vector.
- toString(NumberFormat) - Method in interface org.hipparchus.geometry.Vector
-
Get a string representation of this vector.
- toSubSpace(Point<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Transform a space point into a sub-space point.
- toSubSpace(Point<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Transform a 3D space point into an in-plane point.
- toSubSpace(Point<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Transform a space point into a sub-space point.
- toSubSpace(Point<Sphere2D>) - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Transform a space point into a sub-space point.
- toSubSpace(Point<S>) - Method in interface org.hipparchus.geometry.partitioning.Embedding
-
Transform a space point into a sub-space point.
- toSubSpace(Vector<Euclidean3D, Vector3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Transform a space point into a sub-space point.
- toSubSpace(Vector<Euclidean3D, Vector3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Transform a space point into a sub-space point.
- toSubSpace(Vector<Euclidean2D, Vector2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Transform a space point into a sub-space point.
- toVector2D() - Method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Convert to a constant vector without extra field parts.
- toVector3D() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Convert to a constant vector without extra field parts.
- transform(double[][]) - Method in class org.hipparchus.stat.projection.PCA
-
Transform the supplied data using our projection model.
- transform(double[], TransformType) - Method in class org.hipparchus.transform.FastCosineTransformer
-
Returns the (forward, inverse) transform of the specified real data set.
- transform(double[], TransformType) - Method in class org.hipparchus.transform.FastFourierTransformer
-
Returns the (forward, inverse) transform of the specified real data set.
- transform(double[], TransformType) - Method in class org.hipparchus.transform.FastHadamardTransformer
-
Returns the (forward, inverse) transform of the specified real data set.
- transform(double[], TransformType) - Method in class org.hipparchus.transform.FastSineTransformer
-
Returns the (forward, inverse) transform of the specified real data set.
- transform(double[], TransformType) - Method in interface org.hipparchus.transform.RealTransformer
-
Returns the (forward, inverse) transform of the specified real data set.
- transform(int[]) - Method in class org.hipparchus.transform.FastHadamardTransformer
-
Returns the forward transform of the specified integer data set.The integer transform cannot be inverted directly, due to a scaling factor which may lead to double results.
- transform(UnivariateFunction, double, double, int, TransformType) - Method in class org.hipparchus.transform.FastCosineTransformer
-
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
- transform(UnivariateFunction, double, double, int, TransformType) - Method in class org.hipparchus.transform.FastFourierTransformer
-
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
- transform(UnivariateFunction, double, double, int, TransformType) - Method in class org.hipparchus.transform.FastHadamardTransformer
-
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
- transform(UnivariateFunction, double, double, int, TransformType) - Method in class org.hipparchus.transform.FastSineTransformer
-
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
- transform(UnivariateFunction, double, double, int, TransformType) - Method in interface org.hipparchus.transform.RealTransformer
-
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
- transform(Complex[], TransformType) - Method in class org.hipparchus.transform.FastFourierTransformer
-
Returns the (forward, inverse) transform of the specified complex data set.
- Transform<S extends Space,
T extends Space> - Interface in org.hipparchus.geometry.partitioning -
This interface represents an inversible affine transform in a space.
- transformInPlace(double[][], DftNormalization, TransformType) - Static method in class org.hipparchus.transform.FastFourierTransformer
-
Computes the standard transform of the specified complex data.
- TransformType - Enum in org.hipparchus.transform
-
This enumeration defines the type of transform which is to be computed.
- TransformUtils - Class in org.hipparchus.transform
-
Useful functions for the implementation of various transforms.
- translate(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Translate the plane by the specified amount.
- translate(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Translate the region by the specified amount.
- translateToPoint(Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Translate the line to force it passing by a point.
- transpose() - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Returns the transpose of this matrix.
- transpose() - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the transpose of this matrix.
- transpose() - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Returns the transpose of this matrix.
- transpose() - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the transpose of this matrix.
- transpose() - Method in interface org.hipparchus.linear.FieldMatrix
-
Returns the transpose of this matrix.
- transpose() - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the transpose of this matrix.
- transposeMultiply(Array2DRowFieldMatrix<T>) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Returns the result of postmultiplying
this^T
bym
. - transposeMultiply(Array2DRowRealMatrix) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Returns the result of postmultiplying
this^T
bym
. - transposeMultiply(BlockFieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Returns the result of postmultiplying
this^T
bym
. - transposeMultiply(BlockRealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the result of postmultiplying
this^T
bym
. - transposeMultiply(DiagonalMatrix) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns the result of postmultiplying
this^T
bym
. - transposeMultiply(FieldMatrix<T>) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Returns the result of postmultiplying
this^T
bym
. - transposeMultiply(FieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Returns the result of postmultiplying
this^T
bym
. - transposeMultiply(FieldMatrix<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Returns the result of postmultiplying
this^T
bym
. - transposeMultiply(FieldMatrix<T>) - Method in class org.hipparchus.linear.SparseFieldMatrix
-
Returns the result of postmultiplying
this^T
bym
. - transposeMultiply(RealMatrix) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Returns the result of postmultiplying
this^T
bym
. - transposeMultiply(RealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the result of postmultiplying
this^T
bym
. - transposeMultiply(RealMatrix) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns the result of postmultiplying
this^T
bym
. - transposeMultiply(RealMatrix) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Returns the result of postmultiplying
this^T
bym
. - transposeMultiply(RealMatrix) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the result of postmultiplying
this^T
bym
. - trap(int, String, Dfp, Dfp, Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Trap handler.
- TRAPEZOID_MAX_ITERATIONS_COUNT - Static variable in class org.hipparchus.analysis.integration.FieldTrapezoidIntegrator
-
Maximum number of iterations for trapezoid.
- TRAPEZOID_MAX_ITERATIONS_COUNT - Static variable in class org.hipparchus.analysis.integration.TrapezoidIntegrator
-
Maximum number of iterations for trapezoid.
- TrapezoidIntegrator - Class in org.hipparchus.analysis.integration
-
Implements the Trapezoid Rule for integration of real univariate functions.
- TrapezoidIntegrator() - Constructor for class org.hipparchus.analysis.integration.TrapezoidIntegrator
-
Construct a trapezoid integrator with default settings.
- TrapezoidIntegrator(double, double, int, int) - Constructor for class org.hipparchus.analysis.integration.TrapezoidIntegrator
-
Build a trapezoid integrator with given accuracies and iterations counts.
- TrapezoidIntegrator(int, int) - Constructor for class org.hipparchus.analysis.integration.TrapezoidIntegrator
-
Build a trapezoid integrator with given iteration counts.
- TriangularDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the triangular real distribution.
- TriangularDistribution(double, double, double) - Constructor for class org.hipparchus.distribution.continuous.TriangularDistribution
-
Creates a triangular real distribution using the given lower limit, upper limit, and mode.
- TricubicInterpolatingFunction - Class in org.hipparchus.analysis.interpolation
-
Function that implements the tricubic spline interpolation, as proposed in Tricubic interpolation in three dimensions
F. - TricubicInterpolatingFunction(double[], double[], double[], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][]) - Constructor for class org.hipparchus.analysis.interpolation.TricubicInterpolatingFunction
-
Simple constructor.
- TricubicInterpolator - Class in org.hipparchus.analysis.interpolation
-
Generates a tricubic interpolating function.
- TricubicInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.TricubicInterpolator
-
Empty constructor.
- trigamma(double) - Static method in class org.hipparchus.special.Gamma
-
Computes the trigamma function of x.
- trigamma(T) - Static method in class org.hipparchus.special.Gamma
-
Computes the trigamma function of x.
- trigger(int) - Method in interface org.hipparchus.util.Incrementor.MaxCountExceededCallback
-
Function called when the maximal count has been reached.
- TRIGGER_ONLY_DECREASING_EVENTS - Enum constant in enum org.hipparchus.ode.events.FilterType
-
Constant for triggering only decreasing events.
- TRIGGER_ONLY_INCREASING_EVENTS - Enum constant in enum org.hipparchus.ode.events.FilterType
-
Constant for triggering only increasing events.
- TrivariateFunction - Interface in org.hipparchus.analysis
-
An interface representing a trivariate real function.
- TrivariateGridInterpolator - Interface in org.hipparchus.analysis.interpolation
-
Interface representing a trivariate real interpolating function where the sample points must be specified on a regular grid.
- trunc(DfpField.RoundingMode) - Method in class org.hipparchus.dfp.Dfp
-
Does the integer conversions with the specified rounding.
- TRUST_REGION_STEP_FAILED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.TRUST_REGION_STEP_FAILED.
- TRUST_REGION_STEP_FAILED - Enum constant in enum org.hipparchus.optim.LocalizedOptimFormats
-
TRUST_REGION_STEP_FAILED.
- tryAdvance(FieldODEStateAndDerivative<T>, FieldODEStateInterpolator<T>) - Method in class org.hipparchus.ode.events.FieldDetectorBasedEventState
-
Try to accept the current history up to the given time.
- tryAdvance(ODEStateAndDerivative, ODEStateInterpolator) - Method in class org.hipparchus.ode.events.DetectorBasedEventState
-
Try to accept the current history up to the given time.
- tTest(double[], double[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays.
- tTest(double[], double[]) - Method in class org.hipparchus.stat.inference.TTest
-
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays.
- tTest(double[], double[], double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Performs a two-sided t-test evaluating the null hypothesis that
sample1
andsample2
are drawn from populations with the same mean, with significance levelalpha
. - tTest(double[], double[], double) - Method in class org.hipparchus.stat.inference.TTest
-
Performs a two-sided t-test evaluating the null hypothesis that
sample1
andsample2
are drawn from populations with the same mean, with significance levelalpha
. - tTest(double, double[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the input array with the constant
mu
. - tTest(double, double[]) - Method in class org.hipparchus.stat.inference.TTest
-
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the input array with the constant
mu
. - tTest(double, double[], double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which
sample
is drawn equalsmu
. - tTest(double, double[], double) - Method in class org.hipparchus.stat.inference.TTest
-
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which
sample
is drawn equalsmu
. - tTest(double, double, double, double) - Method in class org.hipparchus.stat.inference.TTest
-
Computes p-value for 2-sided, 1-sample t-test.
- tTest(double, double, double, double, double, double) - Method in class org.hipparchus.stat.inference.TTest
-
Computes p-value for 2-sided, 2-sample t-test.
- tTest(double, StatisticalSummary) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the dataset described by
sampleStats
with the constantmu
. - tTest(double, StatisticalSummary) - Method in class org.hipparchus.stat.inference.TTest
-
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the dataset described by
sampleStats
with the constantmu
. - tTest(double, StatisticalSummary, double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which the dataset described by
stats
is drawn equalsmu
. - tTest(double, StatisticalSummary, double) - Method in class org.hipparchus.stat.inference.TTest
-
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which the dataset described by
stats
is drawn equalsmu
. - tTest(StatisticalSummary, StatisticalSummary) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances.
- tTest(StatisticalSummary, StatisticalSummary) - Method in class org.hipparchus.stat.inference.TTest
-
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances.
- tTest(StatisticalSummary, StatisticalSummary, double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
Performs a two-sided t-test evaluating the null hypothesis that
sampleStats1
andsampleStats2
describe datasets drawn from populations with the same mean, with significance levelalpha
. - tTest(StatisticalSummary, StatisticalSummary, double) - Method in class org.hipparchus.stat.inference.TTest
-
Performs a two-sided t-test evaluating the null hypothesis that
sampleStats1
andsampleStats2
describe datasets drawn from populations with the same mean, with significance levelalpha
. - TTest - Class in org.hipparchus.stat.inference
-
An implementation for Student's t-tests.
- TTest() - Constructor for class org.hipparchus.stat.inference.TTest
-
Empty constructor.
- Tuple - Class in org.hipparchus.util
-
This class allows to perform the same computation of all components of a Tuple at once.
- Tuple(double...) - Constructor for class org.hipparchus.util.Tuple
-
Creates a new instance from its components.
- TwiceDifferentiableFunction - Class in org.hipparchus.optim.nonlinear.vector.constrained
-
A MultivariateFunction that also has a defined gradient and Hessian.
- TwiceDifferentiableFunction() - Constructor for class org.hipparchus.optim.nonlinear.vector.constrained.TwiceDifferentiableFunction
- TWO - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "2 / 1".
- TWO - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "2 / 1".
- TWO_FIFTHS - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "2/5".
- TWO_FIFTHS - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "2/5".
- TWO_OR_MORE_CATEGORIES_REQUIRED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.TWO_OR_MORE_CATEGORIES_REQUIRED.
- TWO_OR_MORE_CATEGORIES_REQUIRED - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
TWO_OR_MORE_CATEGORIES_REQUIRED.
- TWO_OR_MORE_VALUES_IN_CATEGORY_REQUIRED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.TWO_OR_MORE_VALUES_IN_CATEGORY_REQUIRED.
- TWO_OR_MORE_VALUES_IN_CATEGORY_REQUIRED - Enum constant in enum org.hipparchus.stat.LocalizedStatFormats
-
TWO_OR_MORE_VALUES_IN_CATEGORY_REQUIRED.
- TWO_PI - Static variable in class org.hipparchus.util.MathUtils
-
\(2\pi\)
- TWO_QUARTERS - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "2/4".
- TWO_QUARTERS - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "2/4".
- TWO_SIDED - Enum constant in enum org.hipparchus.stat.inference.AlternativeHypothesis
-
Represents a two-sided test.
- TWO_THIRDS - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "2/3".
- TWO_THIRDS - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "2/3".
- twoSum(double, double) - Static method in class org.hipparchus.util.MathUtils
-
Sums
a
andb
using Møller's 2Sum algorithm. - twoSum(T, T) - Static method in class org.hipparchus.util.MathUtils
-
Sums
a
andb
using Møller's 2Sum algorithm.
U
- ulp() - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Compute least significant bit (Unit in Last Position) for a number.
- ulp() - Method in interface org.hipparchus.CalculusFieldElement
-
Compute least significant bit (Unit in Last Position) for a number.
- ulp() - Method in class org.hipparchus.complex.Complex
-
Compute least significant bit (Unit in Last Position) for a number.
- ulp() - Method in class org.hipparchus.complex.FieldComplex
-
Compute least significant bit (Unit in Last Position) for a number.
- ulp() - Method in class org.hipparchus.dfp.Dfp
-
Compute least significant bit (Unit in Last Position) for a number.
- ulp() - Method in class org.hipparchus.util.Binary64
-
Compute least significant bit (Unit in Last Position) for a number.
- ulp() - Method in class org.hipparchus.util.FieldTuple
-
Compute least significant bit (Unit in Last Position) for a number.
- ulp() - Method in class org.hipparchus.util.Tuple
-
Compute least significant bit (Unit in Last Position) for a number.
- ulp(double) - Static method in class org.hipparchus.util.FastMath
-
Compute least significant bit (Unit in Last Position) for a number.
- ulp(float) - Static method in class org.hipparchus.util.FastMath
-
Compute least significant bit (Unit in Last Position) for a number.
- ulp(T) - Static method in class org.hipparchus.util.FastMath
-
Compute least significant bit (Unit in Last Position) for a number.
- Ulp - Class in org.hipparchus.analysis.function
-
ulp
function. - Ulp() - Constructor for class org.hipparchus.analysis.function.Ulp
-
Empty constructor.
- UNABLE_TO_BRACKET_OPTIMUM_IN_LINE_SEARCH - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNABLE_TO_BRACKET_OPTIMUM_IN_LINE_SEARCH.
- UNABLE_TO_BRACKET_OPTIMUM_IN_LINE_SEARCH - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.UNABLE_TO_BRACKET_OPTIMUM_IN_LINE_SEARCH.
- UNABLE_TO_COMPUTE_COVARIANCE_SINGULAR_PROBLEM - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNABLE_TO_COMPUTE_COVARIANCE_SINGULAR_PROBLEM.
- UNABLE_TO_COMPUTE_COVARIANCE_SINGULAR_PROBLEM - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.UNABLE_TO_COMPUTE_COVARIANCE_SINGULAR_PROBLEM.
- UNABLE_TO_FIRST_GUESS_HARMONIC_COEFFICIENTS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNABLE_TO_FIRST_GUESS_HARMONIC_COEFFICIENTS.
- UNABLE_TO_FIRST_GUESS_HARMONIC_COEFFICIENTS - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.UNABLE_TO_FIRST_GUESS_HARMONIC_COEFFICIENTS.
- UNABLE_TO_ORTHOGONOLIZE_MATRIX - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
UNABLE_TO_ORTHOGONOLIZE_MATRIX.
- UNABLE_TO_ORTHOGONOLIZE_MATRIX - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNABLE_TO_ORTHOGONOLIZE_MATRIX.
- UNABLE_TO_PERFORM_QR_DECOMPOSITION_ON_JACOBIAN - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNABLE_TO_PERFORM_QR_DECOMPOSITION_ON_JACOBIAN.
- UNABLE_TO_PERFORM_QR_DECOMPOSITION_ON_JACOBIAN - Enum constant in enum org.hipparchus.optim.LocalizedOptimFormats
-
UNABLE_TO_PERFORM_QR_DECOMPOSITION_ON_JACOBIAN.
- UNABLE_TO_SOLVE_SINGULAR_PROBLEM - Enum constant in enum org.hipparchus.optim.LocalizedOptimFormats
-
UNABLE_TO_SOLVE_SINGULAR_PROBLEM.
- unbounded(int) - Static method in class org.hipparchus.optim.SimpleBounds
-
Factory method that creates instance of this class that represents unbounded ranges.
- UNBOUNDED_SOLUTION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNBOUNDED_SOLUTION.
- UNBOUNDED_SOLUTION - Enum constant in enum org.hipparchus.optim.LocalizedOptimFormats
-
UNBOUNDED_SOLUTION.
- UnboundedSolutionException - Exception in org.hipparchus.migration.optim.linear
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalStateException
- UnboundedSolutionException() - Constructor for exception org.hipparchus.migration.optim.linear.UnboundedSolutionException
-
Deprecated.Simple constructor using a default message.
- unboundedToBounded(double[]) - Method in class org.hipparchus.optim.nonlinear.scalar.MultivariateFunctionMappingAdapter
-
Maps an array from unbounded to bounded.
- UncorrelatedRandomVectorGenerator - Class in org.hipparchus.random
-
A
RandomVectorGenerator
that generates vectors with uncorrelated components. - UncorrelatedRandomVectorGenerator(double[], double[], NormalizedRandomGenerator) - Constructor for class org.hipparchus.random.UncorrelatedRandomVectorGenerator
-
Simple constructor.
- UncorrelatedRandomVectorGenerator(int, NormalizedRandomGenerator) - Constructor for class org.hipparchus.random.UncorrelatedRandomVectorGenerator
-
Simple constructor.
- unequal(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Check if instance is not equal to x.
- UniformIntegerDistribution - Class in org.hipparchus.distribution.discrete
-
Implementation of the uniform integer distribution.
- UniformIntegerDistribution(int, int) - Constructor for class org.hipparchus.distribution.discrete.UniformIntegerDistribution
-
Creates a new uniform integer distribution using the given lower and upper bounds (both inclusive).
- UniformRandomGenerator - Class in org.hipparchus.random
-
This class implements a normalized uniform random generator.
- UniformRandomGenerator(RandomGenerator) - Constructor for class org.hipparchus.random.UniformRandomGenerator
-
Create a new generator.
- UniformRealDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the uniform real distribution.
- UniformRealDistribution() - Constructor for class org.hipparchus.distribution.continuous.UniformRealDistribution
-
Create a standard uniform real distribution with lower bound (inclusive) equal to zero and upper bound (exclusive) equal to one.
- UniformRealDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.UniformRealDistribution
-
Create a uniform real distribution using the given lower and upper bounds.
- union(Region<S>, Region<S>) - Method in class org.hipparchus.geometry.partitioning.RegionFactory
-
Compute the union of two regions.
- unique(double[]) - Static method in class org.hipparchus.util.MathArrays
-
Returns an array consisting of the unique values in
data
. - UNITARY - Enum constant in enum org.hipparchus.transform.DftNormalization
-
Should be passed to the constructor of
FastFourierTransformer
to use the unitary normalization convention. - unitize() - Method in class org.hipparchus.linear.OpenMapRealVector
-
Converts this vector into a unit vector.
- unitize() - Method in class org.hipparchus.linear.RealVector
-
Converts this vector into a unit vector.
- UnitSphereRandomVectorGenerator - Class in org.hipparchus.random
-
Generate random vectors isotropically located on the surface of a sphere.
- UnitSphereRandomVectorGenerator(int) - Constructor for class org.hipparchus.random.UnitSphereRandomVectorGenerator
-
Create an object that will use a default RNG (
MersenneTwister
), in order to generate the individual components. - UnitSphereRandomVectorGenerator(int, RandomGenerator) - Constructor for class org.hipparchus.random.UnitSphereRandomVectorGenerator
-
Simple constructor.
- unitVector() - Method in class org.hipparchus.linear.OpenMapRealVector
-
Creates a unit vector pointing in the direction of this vector.
- unitVector() - Method in class org.hipparchus.linear.RealVector
-
Creates a unit vector pointing in the direction of this vector.
- UnivariateDerivative<T extends UnivariateDerivative<T>> - Class in org.hipparchus.analysis.differentiation
-
Abstract class representing both the value and the differentials of a function.
- UnivariateDerivative() - Constructor for class org.hipparchus.analysis.differentiation.UnivariateDerivative
-
Empty constructor.
- UnivariateDerivative1 - Class in org.hipparchus.analysis.differentiation
-
Class representing both the value and the differentials of a function.
- UnivariateDerivative1(double, double) - Constructor for class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Build an instance with values and derivative.
- UnivariateDerivative1(DerivativeStructure) - Constructor for class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Build an instance from a
DerivativeStructure
. - UnivariateDerivative1Field - Class in org.hipparchus.analysis.differentiation
-
Field for
UnivariateDerivative1
instances. - UnivariateDerivative2 - Class in org.hipparchus.analysis.differentiation
-
Class representing both the value and the differentials of a function.
- UnivariateDerivative2(double, double, double) - Constructor for class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Build an instance with values and derivative.
- UnivariateDerivative2(DerivativeStructure) - Constructor for class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Build an instance from a
DerivativeStructure
. - UnivariateDerivative2Field - Class in org.hipparchus.analysis.differentiation
-
Field for
UnivariateDerivative2
instances. - UnivariateDifferentiableFunction - Interface in org.hipparchus.analysis.differentiation
-
Interface for univariate functions derivatives.
- UnivariateDifferentiableMatrixFunction - Interface in org.hipparchus.analysis.differentiation
-
Extension of
UnivariateMatrixFunction
representing a univariate differentiable matrix function. - UnivariateDifferentiableSolver - Interface in org.hipparchus.analysis.solvers
-
Interface for (univariate real) rootfinding algorithms.
- UnivariateDifferentiableVectorFunction - Interface in org.hipparchus.analysis.differentiation
-
Extension of
UnivariateVectorFunction
representing a univariate differentiable vectorial function. - UnivariateFunction - Interface in org.hipparchus.analysis
-
An interface representing a univariate real function.
- UnivariateFunctionDifferentiator - Interface in org.hipparchus.analysis.differentiation
-
Interface defining the function differentiation operation.
- UnivariateIntegrator - Interface in org.hipparchus.analysis.integration
-
Interface for univariate real integration algorithms.
- UnivariateInterpolator - Interface in org.hipparchus.analysis.interpolation
-
Interface representing a univariate real interpolating function.
- UnivariateMatrixFunction - Interface in org.hipparchus.analysis
-
An interface representing a univariate matrix function.
- UnivariateMatrixFunctionDifferentiator - Interface in org.hipparchus.analysis.differentiation
-
Interface defining the function differentiation operation.
- UnivariateObjectiveFunction - Class in org.hipparchus.optim.univariate
-
Scalar function to be optimized.
- UnivariateObjectiveFunction(UnivariateFunction) - Constructor for class org.hipparchus.optim.univariate.UnivariateObjectiveFunction
-
Simple constructor.
- UnivariateOptimizer - Class in org.hipparchus.optim.univariate
-
Base class for a univariate scalar function optimizer.
- UnivariateOptimizer(ConvergenceChecker<UnivariatePointValuePair>) - Constructor for class org.hipparchus.optim.univariate.UnivariateOptimizer
-
Simple constructor.
- UnivariatePeriodicInterpolator - Class in org.hipparchus.analysis.interpolation
-
Adapter for classes implementing the
UnivariateInterpolator
interface. - UnivariatePeriodicInterpolator(UnivariateInterpolator, double) - Constructor for class org.hipparchus.analysis.interpolation.UnivariatePeriodicInterpolator
-
Builds an interpolator.
- UnivariatePeriodicInterpolator(UnivariateInterpolator, double, int) - Constructor for class org.hipparchus.analysis.interpolation.UnivariatePeriodicInterpolator
-
Builds an interpolator.
- UnivariatePointValuePair - Class in org.hipparchus.optim.univariate
-
This class holds a point and the value of an objective function at this point.
- UnivariatePointValuePair(double, double) - Constructor for class org.hipparchus.optim.univariate.UnivariatePointValuePair
-
Build a point/objective function value pair.
- UnivariateSolver - Interface in org.hipparchus.analysis.solvers
-
Interface for (univariate real) root-finding algorithms.
- UnivariateSolverUtils - Class in org.hipparchus.analysis.solvers
-
Utility routines for
UnivariateSolver
objects. - UnivariateStatistic - Interface in org.hipparchus.stat.descriptive
-
Base interface implemented by all statistics.
- UnivariateVectorFunction - Interface in org.hipparchus.analysis
-
An interface representing a univariate vectorial function.
- UnivariateVectorFunctionDifferentiator - Interface in org.hipparchus.analysis.differentiation
-
Interface defining the function differentiation operation.
- UNKNOWN_MODE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
UNKNOWN_MODE.
- UNKNOWN_MODE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNKNOWN_MODE.
- UNKNOWN_PARAMETER - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNKNOWN_PARAMETER.
- UNKNOWN_PARAMETER - Enum constant in enum org.hipparchus.ode.LocalizedODEFormats
-
UNKNOWN_PARAMETER.
- UnknownParameterException - Exception in org.hipparchus.migration.ode
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- UnknownParameterException(String) - Constructor for exception org.hipparchus.migration.ode.UnknownParameterException
-
Deprecated.Construct an exception from the unknown parameter.
- unlimited() - Static method in class org.hipparchus.optim.MaxEval
-
Factory method that creates instance of this class that represents a virtually unlimited number of evaluations.
- unlimited() - Static method in class org.hipparchus.optim.MaxIter
-
Factory method that creates instance of this class that represents a virtually unlimited number of iterations.
- UNMATCHED_ODE_IN_EXPANDED_SET - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNMATCHED_ODE_IN_EXPANDED_SET.
- UNMATCHED_ODE_IN_EXPANDED_SET - Enum constant in enum org.hipparchus.ode.LocalizedODEFormats
-
UNMATCHED_ODE_IN_EXPANDED_SET.
- unmodifiableRealVector(RealVector) - Static method in class org.hipparchus.linear.RealVector
-
Returns an unmodifiable view of the specified vector.
- UNPARSEABLE_3D_VECTOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNPARSEABLE_3D_VECTOR.
- UNPARSEABLE_3D_VECTOR - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.UNPARSEABLE_3D_VECTOR.
- UNPARSEABLE_COMPLEX_NUMBER - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNPARSEABLE_COMPLEX_NUMBER.
- UNPARSEABLE_COMPLEX_NUMBER - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.UNPARSEABLE_COMPLEX_NUMBER.
- UNPARSEABLE_REAL_VECTOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNPARSEABLE_REAL_VECTOR.
- UNPARSEABLE_REAL_VECTOR - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.UNPARSEABLE_REAL_VECTOR.
- unscaleX(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPModifiedRuizEquilibrium
-
Unscale solution vector.
- unscaleY(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPModifiedRuizEquilibrium
-
Unscale Y vector.
- unscaleZ(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPModifiedRuizEquilibrium
-
Unscale Z vector.
- UnscentedEvolution - Class in org.hipparchus.filtering.kalman.unscented
-
Container for
unscented process
evolution data. - UnscentedEvolution(double, RealVector[], RealMatrix) - Constructor for class org.hipparchus.filtering.kalman.unscented.UnscentedEvolution
-
Constructor.
- UnscentedKalmanFilter<T extends Measurement> - Class in org.hipparchus.filtering.kalman.unscented
-
Unscented Kalman filter for
unscented process
. - UnscentedKalmanFilter(MatrixDecomposer, UnscentedProcess<T>, ProcessEstimate, UnscentedTransformProvider) - Constructor for class org.hipparchus.filtering.kalman.unscented.UnscentedKalmanFilter
-
Simple constructor.
- UnscentedProcess<T extends Measurement> - Interface in org.hipparchus.filtering.kalman.unscented
-
Unscented process that can be estimated by a
UnscentedKalmanFilter
. - unscentedTransform(RealVector, RealMatrix) - Method in class org.hipparchus.util.AbstractUnscentedTransform
-
Perform the unscented transform from a state and its covariance.
- unscentedTransform(RealVector, RealMatrix) - Method in interface org.hipparchus.util.UnscentedTransformProvider
-
Perform the unscented transform from a state and its covariance.
- UnscentedTransformProvider - Interface in org.hipparchus.util
-
Provider for unscented transform.
- unsignedMultiplyHigh(long, long) - Static method in class org.hipparchus.util.FastMath
-
Multiply two long unsigned integers and give the 64 most significant bits of the unsigned result.
- unstackSquare() - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Transforms a one-column stacked matrix into a squared matrix (devectorization).
- UNSUPPORTED_EXPANSION_MODE - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNSUPPORTED_EXPANSION_MODE.
- UNSUPPORTED_EXPANSION_MODE - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.UNSUPPORTED_EXPANSION_MODE.
- UNSUPPORTED_OPERATION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
UNSUPPORTED_OPERATION.
- UNSUPPORTED_OPERATION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.UNSUPPORTED_OPERATION.
- updateHighOrderDerivativesPhase1(Array2DRowFieldMatrix<T>) - Method in class org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Update the high order scaled derivatives for Adams integrators (phase 1).
- updateHighOrderDerivativesPhase1(Array2DRowFieldMatrix<T>) - Method in class org.hipparchus.ode.nonstiff.AdamsNordsieckFieldTransformer
-
Update the high order scaled derivatives for Adams integrators (phase 1).
- updateHighOrderDerivativesPhase1(Array2DRowRealMatrix) - Method in class org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Update the high order scaled derivatives for Adams integrators (phase 1).
- updateHighOrderDerivativesPhase1(Array2DRowRealMatrix) - Method in class org.hipparchus.ode.nonstiff.AdamsNordsieckTransformer
-
Update the high order scaled derivatives for Adams integrators (phase 1).
- updateHighOrderDerivativesPhase2(double[], double[], Array2DRowRealMatrix) - Method in class org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Update the high order scaled derivatives Adams integrators (phase 2).
- updateHighOrderDerivativesPhase2(double[], double[], Array2DRowRealMatrix) - Method in class org.hipparchus.ode.nonstiff.AdamsNordsieckTransformer
-
Update the high order scaled derivatives Adams integrators (phase 2).
- updateHighOrderDerivativesPhase2(T[], T[], Array2DRowFieldMatrix<T>) - Method in class org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Update the high order scaled derivatives Adams integrators (phase 2).
- updateHighOrderDerivativesPhase2(T[], T[], Array2DRowFieldMatrix<T>) - Method in class org.hipparchus.ode.nonstiff.AdamsNordsieckFieldTransformer
-
Update the high order scaled derivatives Adams integrators (phase 2).
- updateRho() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPOption
-
Check if weight updating is enabled.
- updateSigmaRho(double, int, double) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.ADMMQPKKT
-
Update steps
- UpdatingMultipleLinearRegression - Interface in org.hipparchus.stat.regression
-
An interface for regression models allowing for dynamic updating of the data.
- upperCumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
For this distribution,
X
, this method returnsP(X >= x)
. - UPSIDE - Enum constant in enum org.hipparchus.stat.descriptive.moment.SemiVariance.Direction
-
The UPSIDE Direction is used to specify that the observations above the cutoff point will be used to calculate SemiVariance
- UPSIDE_VARIANCE - Static variable in class org.hipparchus.stat.descriptive.moment.SemiVariance
-
The UPSIDE Direction is used to specify that the observations above the cutoff point will be used to calculate SemiVariance.
- URL_CONTAINS_NO_DATA - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
URL_CONTAINS_NO_DATA.
- URL_CONTAINS_NO_DATA - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.URL_CONTAINS_NO_DATA.
- useFunHessian() - Method in class org.hipparchus.optim.nonlinear.vector.constrained.SQPOption
-
Check if using direct the function Hessian is enabled or disabled.
- USER_EXCEPTION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
USER_EXCEPTION.
- USER_EXCEPTION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.USER_EXCEPTION.
- UTF8Control - Class in org.hipparchus.exception
-
Control class loading properties in UTF-8 encoding.
- UTF8Control() - Constructor for class org.hipparchus.exception.UTF8Control
-
Empty constructor.
V
- 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.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.FieldPolynomialFunction
-
Compute the value of the function for the given argument.
- value(double) - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
-
Compute the value for the function.
- 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 class org.hipparchus.analysis.polynomials.SmoothStepFactory.FieldSmoothStepFunction
-
Compute the value of the smoothstep for the given argument normalized between edges.
- value(double) - Method in class org.hipparchus.analysis.polynomials.SmoothStepFactory.QuadraticSmoothStepFunction
-
Compute the value of the quadratic smoothstep for the given argument normalized between edges.
- value(double) - Method in class org.hipparchus.analysis.polynomials.SmoothStepFactory.SmoothStepFunction
-
Compute the value of the smoothstep for the given argument normalized between edges.
- 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.FieldTaylorMap
-
Evaluate Taylor expansion of the map at some offset.
- 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 class org.hipparchus.analysis.differentiation.TaylorMap
-
Evaluate Taylor expansion of the map at some offset.
- 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[]) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.LinearBoundedConstraint
-
Returns the value of this function at (x)
- value(double[]) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.TwiceDifferentiableFunction
-
Returns the value of this function at (x)
- value(double[]) - Method in interface org.hipparchus.optim.nonlinear.vector.constrained.VectorDifferentiableFunction
-
Returns the value of this function at (x)
- 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.BilinearInterpolatingFunction
-
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 class org.hipparchus.analysis.polynomials.SmoothStepFactory.QuadraticSmoothStepFunction
-
Compute the value of the smoothstep function for the given edges and argument.
- value(double, double, double) - Method in class org.hipparchus.analysis.polynomials.SmoothStepFactory.SmoothStepFunction
-
Compute the value of the smoothstep function for the given edges and argument.
- value(double, double, double) - Method in interface org.hipparchus.analysis.TrivariateFunction
-
Compute the value for the function.
- value(double, double, T) - Method in class org.hipparchus.analysis.polynomials.SmoothStepFactory.FieldSmoothStepFunction
-
Compute the value of the smoothstep function for the given edges and argument.
- value(int) - Method in class org.hipparchus.util.CombinatoricsUtils.FactorialLog
-
Computes
log(n!)
. - 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(Complex) - Method in class org.hipparchus.samples.complex.ContinuousModuleValue
-
Get value for a complex value.
- value(Complex) - Method in class org.hipparchus.samples.complex.DomainColoring
-
Get value for a complex value.
- value(Complex) - Method in class org.hipparchus.samples.complex.SawToothModuleValue
-
Get value for a complex value.
- value(Complex) - Method in class org.hipparchus.samples.complex.SawToothPhaseModuleValue
-
Get value for a complex value.
- 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 class org.hipparchus.optim.nonlinear.vector.constrained.LinearBoundedConstraint
-
Returns the value of this function at (x)
- value(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.LinearEqualityConstraint
- value(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.LinearInequalityConstraint
- value(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.QuadraticFunction
-
Returns the value of this function at (x)
- value(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.constrained.TwiceDifferentiableFunction
-
Returns the value of this function at (x)
- value(RealVector) - Method in interface org.hipparchus.optim.nonlinear.vector.constrained.VectorDifferentiableFunction
-
Returns the value of this function at (x)
- 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.CalculusFieldUnivariateFunction
-
Compute the value of the function.
- value(T) - Method in interface org.hipparchus.analysis.CalculusFieldUnivariateMatrixFunction
-
Compute the value for the function.
- value(T) - Method in interface org.hipparchus.analysis.CalculusFieldUnivariateVectorFunction
-
Compute the value for the function.
- value(T) - Method in interface org.hipparchus.analysis.differentiation.UnivariateDifferentiableFunction
-
Compute the value for the function.
- value(T) - Method in interface org.hipparchus.analysis.differentiation.UnivariateDifferentiableMatrixFunction
-
Compute the value for the function.
- value(T) - Method in interface org.hipparchus.analysis.differentiation.UnivariateDifferentiableVectorFunction
-
Compute the value for the function.
- 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.function.Abs
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Acos
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Acosh
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Asin
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Asinh
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Atan
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Atanh
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Cbrt
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Ceil
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Constant
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Cos
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Cosh
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Exp
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Expm1
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Floor
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Gaussian
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.HarmonicOscillator
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Identity
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Inverse
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Log
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Log10
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Log1p
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Logistic
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Logit
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Minus
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Power
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Rint
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Sigmoid
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Sin
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Sinc
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Sinh
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Sqrt
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Tan
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.function.Tanh
-
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.interpolation.HermiteInterpolator
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Compute the value of the function for the given argument.
- value(T) - Method in class org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.polynomials.PolynomialSplineFunction
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.polynomials.SmoothStepFactory.FieldSmoothStepFunction
-
Compute the value of the smoothstep for the given argument normalized between edges.
- value(T...) - Method in interface org.hipparchus.analysis.CalculusFieldMultivariateFunction
-
Compute the value of the function.
- value(T...) - Method in interface org.hipparchus.analysis.CalculusFieldMultivariateMatrixFunction
-
Compute the value of the function.
- value(T...) - Method in interface org.hipparchus.analysis.CalculusFieldMultivariateVectorFunction
-
Compute the value of the function.
- value(T...) - Method in class org.hipparchus.analysis.differentiation.FieldTaylorMap
-
Evaluate Taylor expansion of the map at some offset.
- value(T...) - Method in interface org.hipparchus.analysis.FieldMultivariateFunction
-
Compute the value of the function.
- value(T...) - Method in interface org.hipparchus.analysis.FieldMultivariateMatrixFunction
-
Compute the value of the function.
- value(T...) - Method in interface org.hipparchus.analysis.FieldMultivariateVectorFunction
-
Compute the value of the function.
- value(T, T) - Method in interface org.hipparchus.analysis.CalculusFieldBivariateFunction
-
Compute the value for the function.
- value(T, T) - Method in interface org.hipparchus.analysis.FieldBivariateFunction
-
Compute the value for the function.
- value(T, T) - Method in class org.hipparchus.analysis.interpolation.BilinearInterpolatingFunction
-
Compute the value for the function.
- value(T, T) - Method in class org.hipparchus.analysis.interpolation.PiecewiseBicubicSplineInterpolatingFunction
-
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.euclidean.threed.RotationOrder
-
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.linear.DependentVectorsHandler
-
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.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.
- valueOf(T) - Static method in class org.hipparchus.complex.FieldComplex
-
Create a complex number given only the real part.
- valueOf(T, T) - Static method in class org.hipparchus.complex.FieldComplex
-
Create a complex number given the real and imaginary parts.
- 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.euclidean.threed.RotationOrder
-
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.linear.DependentVectorsHandler
-
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.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(Complex) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiTheta
-
Evaluate the Jacobi theta functions.
- values(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiTheta
-
Evaluate the Jacobi theta functions.
- valuesC(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate the three subsidiary Jacobi elliptic functions with pole at point c in Glaisher’s Notation.
- valuesC(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate the three subsidiary Jacobi elliptic functions with pole at point c in Glaisher’s Notation.
- valuesC(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate the three subsidiary Jacobi elliptic functions with pole at point c in Glaisher’s Notation.
- valuesD(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate the three subsidiary Jacobi elliptic functions with pole at point d in Glaisher’s Notation.
- valuesD(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate the three subsidiary Jacobi elliptic functions with pole at point d in Glaisher’s Notation.
- valuesD(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate the three subsidiary Jacobi elliptic functions with pole at point d in Glaisher’s Notation.
- valuesIterator() - Method in class org.hipparchus.stat.Frequency
-
Returns an Iterator over the set of values that have been added.
- valuesN(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate the three principal Jacobi elliptic functions with pole at point n in Glaisher’s Notation.
- valuesN(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate the three principal Jacobi elliptic functions with pole at point n in Glaisher’s Notation.
- valuesN(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate the three principal Jacobi elliptic functions with pole at point n in Glaisher’s Notation.
- valuesS(double) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate the three subsidiary Jacobi elliptic functions with pole at point s in Glaisher’s Notation.
- valuesS(double) - Method in class org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate the three subsidiary Jacobi elliptic functions with pole at point s in Glaisher’s Notation.
- valuesS(T) - Method in class org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate the three subsidiary Jacobi elliptic functions with pole at point s in Glaisher’s Notation.
- variable(int, double) - Method in class org.hipparchus.analysis.differentiation.DSFactory
-
Build a
DerivativeStructure
representing a variable. - variable(int, double) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
Build a
FieldDerivativeStructure
representing a variable. - variable(int, int, double) - Static method in class org.hipparchus.analysis.differentiation.Gradient
-
Build a
Gradient
representing a variable. - variable(int, int, T) - Static method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Build a
Gradient
representing a variable. - variable(int, T) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
Build a
FieldDerivativeStructure
representing a variable. - 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 theoriginal
. - 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.
- Vector<S extends Space,
V extends Vector<S, V>> - 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
-
Key for the exception context.
- VECTOR_LENGTH_MISMATCH - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.VECTOR_LENGTH_MISMATCH.
- VECTOR_LENGTH_MISMATCH - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.VECTOR_LENGTH_MISMATCH.
- VECTOR_MUST_HAVE_AT_LEAST_ONE_ELEMENT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
VECTOR_MUST_HAVE_AT_LEAST_ONE_ELEMENT.
- VECTOR_MUST_HAVE_AT_LEAST_ONE_ELEMENT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.VECTOR_MUST_HAVE_AT_LEAST_ONE_ELEMENT.
- VECTOR_OPERATOR - Enum constant in enum 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.
- VectorDifferentiableFunction - Interface in org.hipparchus.optim.nonlinear.vector.constrained
-
A MultivariateFunction that also has a defined gradient and Hessian.
- VectorFormat<S extends Space,
V extends Vector<S, V>> - 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
-
Uses an independent
StorelessUnivariateStatistic
instance for each component of a 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.
W
- walkInColumnOrder(FieldMatrixChangingVisitor<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Visit (and possibly change) all matrix entries in column order.
- walkInColumnOrder(FieldMatrixChangingVisitor<T>) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Visit (and possibly change) all matrix entries in column order.
- walkInColumnOrder(FieldMatrixChangingVisitor<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Visit (and possibly change) all matrix entries in column order.
- walkInColumnOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Visit (and possibly change) some matrix entries in column order.
- walkInColumnOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Visit (and possibly change) some matrix entries in column order.
- walkInColumnOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Visit (and possibly change) some matrix entries in column order.
- walkInColumnOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Visit (but don't change) all matrix entries in column order.
- walkInColumnOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Visit (but don't change) all matrix entries in column order.
- walkInColumnOrder(FieldMatrixPreservingVisitor<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Visit (but don't change) all matrix entries in column order.
- walkInColumnOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Visit (but don't change) some matrix entries in column order.
- walkInColumnOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Visit (but don't change) some matrix entries in column order.
- walkInColumnOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Visit (but don't change) some matrix entries in column order.
- walkInColumnOrder(RealMatrixChangingVisitor) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Visit (and possibly change) all matrix entries in column order.
- walkInColumnOrder(RealMatrixChangingVisitor) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Visit (and possibly change) all matrix entries in column order.
- walkInColumnOrder(RealMatrixChangingVisitor) - Method in interface org.hipparchus.linear.RealMatrix
-
Visit (and possibly change) all matrix entries in column order.
- walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Visit (and possibly change) some matrix entries in column order.
- walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Visit (and possibly change) some matrix entries in column order.
- walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in interface org.hipparchus.linear.RealMatrix
-
Visit (and possibly change) some matrix entries in column order.
- walkInColumnOrder(RealMatrixPreservingVisitor) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Visit (but don't change) all matrix entries in column order.
- walkInColumnOrder(RealMatrixPreservingVisitor) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Visit (but don't change) all matrix entries in column order.
- walkInColumnOrder(RealMatrixPreservingVisitor) - Method in interface org.hipparchus.linear.RealMatrix
-
Visit (but don't change) all matrix entries in column order.
- walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Visit (but don't change) some matrix entries in column order.
- walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Visit (but don't change) some matrix entries in column order.
- walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in interface org.hipparchus.linear.RealMatrix
-
Visit (but don't change) some matrix entries in column order.
- walkInDefaultOrder(FieldVectorChangingVisitor<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Visits (and possibly alters) all entries of this vector in default order (increasing index).
- walkInDefaultOrder(FieldVectorChangingVisitor<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Visits (and possibly alters) all entries of this vector in default order (increasing index).
- walkInDefaultOrder(FieldVectorChangingVisitor<T>, int, int) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Visits (and possibly alters) some entries of this vector in default order (increasing index).
- walkInDefaultOrder(FieldVectorChangingVisitor<T>, int, int) - Method in class org.hipparchus.linear.SparseFieldVector
-
Visits (and possibly alters) some entries of this vector in default order (increasing index).
- walkInDefaultOrder(FieldVectorPreservingVisitor<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Visits (but does not alter) all entries of this vector in default order (increasing index).
- walkInDefaultOrder(FieldVectorPreservingVisitor<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Visits (but does not alter) all entries of this vector in default order (increasing index).
- walkInDefaultOrder(FieldVectorPreservingVisitor<T>, int, int) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Visits (but does not alter) some entries of this vector in default order (increasing index).
- walkInDefaultOrder(FieldVectorPreservingVisitor<T>, int, int) - Method in class org.hipparchus.linear.SparseFieldVector
-
Visits (but does not alter) some entries of this vector in default order (increasing index).
- walkInDefaultOrder(RealVectorChangingVisitor) - Method in class org.hipparchus.linear.ArrayRealVector
-
Visits (and possibly alters) all entries of this vector in default order (increasing index).
- walkInDefaultOrder(RealVectorChangingVisitor) - Method in class org.hipparchus.linear.RealVector
-
Visits (and possibly alters) all entries of this vector in default order (increasing index).
- walkInDefaultOrder(RealVectorChangingVisitor, int, int) - Method in class org.hipparchus.linear.ArrayRealVector
-
Visits (and possibly alters) some entries of this vector in default order (increasing index).
- walkInDefaultOrder(RealVectorChangingVisitor, int, int) - Method in class org.hipparchus.linear.RealVector
-
Visits (and possibly alters) some entries of this vector in default order (increasing index).
- walkInDefaultOrder(RealVectorPreservingVisitor) - Method in class org.hipparchus.linear.ArrayRealVector
-
Visits (but does not alter) all entries of this vector in default order (increasing index).
- walkInDefaultOrder(RealVectorPreservingVisitor) - Method in class org.hipparchus.linear.RealVector
-
Visits (but does not alter) all entries of this vector in default order (increasing index).
- walkInDefaultOrder(RealVectorPreservingVisitor, int, int) - Method in class org.hipparchus.linear.ArrayRealVector
-
Visits (but does not alter) some entries of this vector in default order (increasing index).
- walkInDefaultOrder(RealVectorPreservingVisitor, int, int) - Method in class org.hipparchus.linear.RealVector
-
Visits (but does not alter) some entries of this vector in default order (increasing index).
- walkInOptimizedOrder(FieldMatrixChangingVisitor<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Visit (and possibly change) all matrix entries using the fastest possible order.
- walkInOptimizedOrder(FieldMatrixChangingVisitor<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Visit (and possibly change) all matrix entries using the fastest possible order.
- walkInOptimizedOrder(FieldMatrixChangingVisitor<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Visit (and possibly change) all matrix entries using the fastest possible order.
- walkInOptimizedOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Visit (and possibly change) some matrix entries using the fastest possible order.
- walkInOptimizedOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Visit (and possibly change) some matrix entries using the fastest possible order.
- walkInOptimizedOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Visit (and possibly change) some matrix entries using the fastest possible order.
- walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Visit (but don't change) all matrix entries using the fastest possible order.
- walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Visit (but don't change) all matrix entries using the fastest possible order.
- walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Visit (but don't change) all matrix entries using the fastest possible order.
- walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Visit (but don't change) some matrix entries using the fastest possible order.
- walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Visit (but don't change) some matrix entries using the fastest possible order.
- walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Visit (but don't change) some matrix entries using the fastest possible order.
- walkInOptimizedOrder(FieldVectorChangingVisitor<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Visits (and possibly alters) all entries of this vector in optimized order.
- walkInOptimizedOrder(FieldVectorChangingVisitor<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Visits (and possibly alters) all entries of this vector in optimized order.
- walkInOptimizedOrder(FieldVectorChangingVisitor<T>, int, int) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Visits (and possibly change) some entries of this vector in optimized order.
- walkInOptimizedOrder(FieldVectorChangingVisitor<T>, int, int) - Method in class org.hipparchus.linear.SparseFieldVector
-
Visits (and possibly change) some entries of this vector in optimized order.
- walkInOptimizedOrder(FieldVectorPreservingVisitor<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Visits (but does not alter) all entries of this vector in optimized order.
- walkInOptimizedOrder(FieldVectorPreservingVisitor<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Visits (but does not alter) all entries of this vector in optimized order.
- walkInOptimizedOrder(FieldVectorPreservingVisitor<T>, int, int) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Visits (but does not alter) some entries of this vector in optimized order.
- walkInOptimizedOrder(FieldVectorPreservingVisitor<T>, int, int) - Method in class org.hipparchus.linear.SparseFieldVector
-
Visits (but does not alter) some entries of this vector in optimized order.
- walkInOptimizedOrder(RealMatrixChangingVisitor) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Visit (and possibly change) all matrix entries using the fastest possible order.
- walkInOptimizedOrder(RealMatrixChangingVisitor) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Visit (and possibly change) all matrix entries using the fastest possible order.
- walkInOptimizedOrder(RealMatrixChangingVisitor) - Method in interface org.hipparchus.linear.RealMatrix
-
Visit (and possibly change) all matrix entries using the fastest possible order.
- walkInOptimizedOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Visit (and possibly change) some matrix entries using the fastest possible order.
- walkInOptimizedOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Visit (and possibly change) some matrix entries using the fastest possible order.
- walkInOptimizedOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in interface org.hipparchus.linear.RealMatrix
-
Visit (and possibly change) some matrix entries using the fastest possible order.
- walkInOptimizedOrder(RealMatrixPreservingVisitor) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Visit (but don't change) all matrix entries using the fastest possible order.
- walkInOptimizedOrder(RealMatrixPreservingVisitor) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Visit (but don't change) all matrix entries using the fastest possible order.
- walkInOptimizedOrder(RealMatrixPreservingVisitor) - Method in interface org.hipparchus.linear.RealMatrix
-
Visit (but don't change) all matrix entries using the fastest possible order.
- walkInOptimizedOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Visit (but don't change) some matrix entries using the fastest possible order.
- walkInOptimizedOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Visit (but don't change) some matrix entries using the fastest possible order.
- walkInOptimizedOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in interface org.hipparchus.linear.RealMatrix
-
Visit (but don't change) some matrix entries using the fastest possible order.
- walkInOptimizedOrder(RealVectorChangingVisitor) - Method in class org.hipparchus.linear.ArrayRealVector
-
Visits (and possibly alters) all entries of this vector in optimized order.
- walkInOptimizedOrder(RealVectorChangingVisitor) - Method in class org.hipparchus.linear.RealVector
-
Visits (and possibly alters) all entries of this vector in optimized order.
- walkInOptimizedOrder(RealVectorChangingVisitor, int, int) - Method in class org.hipparchus.linear.ArrayRealVector
-
Visits (and possibly change) some entries of this vector in optimized order.
- walkInOptimizedOrder(RealVectorChangingVisitor, int, int) - Method in class org.hipparchus.linear.RealVector
-
Visits (and possibly change) some entries of this vector in optimized order.
- walkInOptimizedOrder(RealVectorPreservingVisitor) - Method in class org.hipparchus.linear.ArrayRealVector
-
Visits (but does not alter) all entries of this vector in optimized order.
- walkInOptimizedOrder(RealVectorPreservingVisitor) - Method in class org.hipparchus.linear.RealVector
-
Visits (but does not alter) all entries of this vector in optimized order.
- walkInOptimizedOrder(RealVectorPreservingVisitor, int, int) - Method in class org.hipparchus.linear.ArrayRealVector
-
Visits (but does not alter) some entries of this vector in optimized order.
- walkInOptimizedOrder(RealVectorPreservingVisitor, int, int) - Method in class org.hipparchus.linear.RealVector
-
Visits (but does not alter) some entries of this vector in optimized order.
- walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Visit (and possibly change) all matrix entries in row order.
- walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Visit (and possibly change) all matrix entries in row order.
- walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Visit (and possibly change) all matrix entries in row order.
- walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Visit (and possibly change) all matrix entries in row order.
- walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Visit (and possibly change) some matrix entries in row order.
- walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Visit (and possibly change) some matrix entries in row order.
- walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Visit (and possibly change) some matrix entries in row order.
- walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Visit (and possibly change) some matrix entries in row order.
- walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Visit (but don't change) all matrix entries in row order.
- walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Visit (but don't change) all matrix entries in row order.
- walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Visit (but don't change) all matrix entries in row order.
- walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Visit (but don't change) all matrix entries in row order.
- walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Visit (but don't change) some matrix entries in row order.
- walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Visit (but don't change) some matrix entries in row order.
- walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Visit (but don't change) some matrix entries in row order.
- walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Visit (but don't change) some matrix entries in row order.
- walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Visit (and possibly change) all matrix entries in row order.
- walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Visit (and possibly change) all matrix entries in row order.
- walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Visit (and possibly change) all matrix entries in row order.
- walkInRowOrder(RealMatrixChangingVisitor) - Method in interface org.hipparchus.linear.RealMatrix
-
Visit (and possibly change) all matrix entries in row order.
- walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Visit (and possibly change) some matrix entries in row order.
- walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Visit (and possibly change) some matrix entries in row order.
- walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Visit (and possibly change) some matrix entries in row order.
- walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in interface org.hipparchus.linear.RealMatrix
-
Visit (and possibly change) some matrix entries in row order.
- walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Visit (but don't change) all matrix entries in row order.
- walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Visit (but don't change) all matrix entries in row order.
- walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Visit (but don't change) all matrix entries in row order.
- walkInRowOrder(RealMatrixPreservingVisitor) - Method in interface org.hipparchus.linear.RealMatrix
-
Visit (but don't change) all matrix entries in row order.
- walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Visit (but don't change) some matrix entries in row order.
- walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Visit (but don't change) some matrix entries in row order.
- walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Visit (but don't change) some matrix entries in row order.
- walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in interface org.hipparchus.linear.RealMatrix
-
Visit (but don't change) some matrix entries in row order.
- WeibullDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the Weibull distribution.
- WeibullDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.WeibullDistribution
-
Create a Weibull distribution with the given shape and scale.
- weight(RealMatrix) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the weight matrix.
- WEIGHT_AT_LEAST_ONE_NON_ZERO - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
WEIGHT_AT_LEAST_ONE_NON_ZERO.
- WEIGHT_AT_LEAST_ONE_NON_ZERO - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.WEIGHT_AT_LEAST_ONE_NON_ZERO.
- weightDiagonal(LeastSquaresProblem, RealVector) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
Apply a diagonal weight matrix to the
LeastSquaresProblem
. - WeightedEvaluation - Interface in org.hipparchus.stat.descriptive
-
Weighted evaluation for statistics.
- WeightedObservedPoint - Class in org.hipparchus.fitting
-
This class is a simple container for weighted observed point in
curve fitting
. - WeightedObservedPoint(double, double, double) - Constructor for class org.hipparchus.fitting.WeightedObservedPoint
-
Simple constructor.
- WeightedObservedPoints - Class in org.hipparchus.fitting
-
Simple container for weighted observed points used in
curve fitting
algorithms. - WeightedObservedPoints() - Constructor for class org.hipparchus.fitting.WeightedObservedPoints
-
Simple constructor.
- weightMatrix(LeastSquaresProblem, RealMatrix) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
Apply a dense weight matrix to the
LeastSquaresProblem
. - Well1024a - Class in org.hipparchus.random
-
This class implements the WELL1024a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
- Well1024a() - Constructor for class org.hipparchus.random.Well1024a
-
Creates a new random number generator.
- Well1024a(int) - Constructor for class org.hipparchus.random.Well1024a
-
Creates a new random number generator using a single int seed.
- Well1024a(int[]) - Constructor for class org.hipparchus.random.Well1024a
-
Creates a new random number generator using an int array seed.
- Well1024a(long) - Constructor for class org.hipparchus.random.Well1024a
-
Creates a new random number generator using a single long seed.
- Well19937a - Class in org.hipparchus.random
-
This class implements the WELL19937a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
- Well19937a() - Constructor for class org.hipparchus.random.Well19937a
-
Creates a new random number generator.
- Well19937a(int) - Constructor for class org.hipparchus.random.Well19937a
-
Creates a new random number generator using a single int seed.
- Well19937a(int[]) - Constructor for class org.hipparchus.random.Well19937a
-
Creates a new random number generator using an int array seed.
- Well19937a(long) - Constructor for class org.hipparchus.random.Well19937a
-
Creates a new random number generator using a single long seed.
- Well19937c - Class in org.hipparchus.random
-
This class implements the WELL19937c pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
- Well19937c() - Constructor for class org.hipparchus.random.Well19937c
-
Creates a new random number generator.
- Well19937c(int) - Constructor for class org.hipparchus.random.Well19937c
-
Creates a new random number generator using a single int seed.
- Well19937c(int[]) - Constructor for class org.hipparchus.random.Well19937c
-
Creates a new random number generator using an int array seed.
- Well19937c(long) - Constructor for class org.hipparchus.random.Well19937c
-
Creates a new random number generator using a single long seed.
- Well44497a - Class in org.hipparchus.random
-
This class implements the WELL44497a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
- Well44497a() - Constructor for class org.hipparchus.random.Well44497a
-
Creates a new random number generator.
- Well44497a(int) - Constructor for class org.hipparchus.random.Well44497a
-
Creates a new random number generator using a single int seed.
- Well44497a(int[]) - Constructor for class org.hipparchus.random.Well44497a
-
Creates a new random number generator using an int array seed.
- Well44497a(long) - Constructor for class org.hipparchus.random.Well44497a
-
Creates a new random number generator using a single long seed.
- Well44497b - Class in org.hipparchus.random
-
This class implements the WELL44497b pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
- Well44497b() - Constructor for class org.hipparchus.random.Well44497b
-
Creates a new random number generator.
- Well44497b(int) - Constructor for class org.hipparchus.random.Well44497b
-
Creates a new random number generator using a single int seed.
- Well44497b(int[]) - Constructor for class org.hipparchus.random.Well44497b
-
Creates a new random number generator using an int array seed.
- Well44497b(long) - Constructor for class org.hipparchus.random.Well44497b
-
Creates a new random number generator using a single long seed.
- Well512a - Class in org.hipparchus.random
-
This class implements the WELL512a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
- Well512a() - Constructor for class org.hipparchus.random.Well512a
-
Creates a new random number generator.
- Well512a(int) - Constructor for class org.hipparchus.random.Well512a
-
Creates a new random number generator using a single int seed.
- Well512a(int[]) - Constructor for class org.hipparchus.random.Well512a
-
Creates a new random number generator using an int array seed.
- Well512a(long) - Constructor for class org.hipparchus.random.Well512a
-
Creates a new random number generator using a single long seed.
- WelzlEncloser<S extends Space,
P extends Point<S>> - Class in org.hipparchus.geometry.enclosing -
Class implementing Emo Welzl algorithm to find the smallest enclosing ball in linear time.
- WelzlEncloser(double, SupportBallGenerator<S, P>) - Constructor for class org.hipparchus.geometry.enclosing.WelzlEncloser
-
Simple constructor.
- WHOLE_FORMAT - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
WHOLE_FORMAT.
- WHOLE_FORMAT - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.WHOLE_FORMAT.
- wholeHyperplane() - Method in class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Build a region covering the whole hyperplane.
- wholeHyperplane() - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Build a region covering the whole hyperplane.
- wholeHyperplane() - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Build a sub-hyperplane covering the whole hyperplane.
- wholeHyperplane() - Method in interface org.hipparchus.geometry.partitioning.Hyperplane
-
Build a sub-hyperplane covering the whole hyperplane.
- wholeHyperplane() - Method in class org.hipparchus.geometry.spherical.oned.LimitAngle
-
Build a region covering the whole hyperplane.
- wholeHyperplane() - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Build a sub-hyperplane covering the whole hyperplane.
- wholeLine() - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Build a sub-line covering the whole line.
- wholeSpace() - Method in class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Build a region covering the whole space.
- wholeSpace() - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Build a region covering the whole space.
- wholeSpace() - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Build a region covering the whole space.
- wholeSpace() - Method in interface org.hipparchus.geometry.partitioning.Hyperplane
-
Build a region covering the whole space.
- wholeSpace() - Method in class org.hipparchus.geometry.spherical.oned.LimitAngle
-
Build a region covering the whole space.
- wholeSpace() - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Build a region covering the whole space.
- wilcoxonSignedRank(double[], double[]) - Method in class org.hipparchus.stat.inference.WilcoxonSignedRankTest
-
Computes the Wilcoxon signed ranked statistic comparing means for two related samples or repeated measurements on a single sample.
- wilcoxonSignedRankTest(double[], double[], boolean) - Method in class org.hipparchus.stat.inference.WilcoxonSignedRankTest
-
Returns the observed significance level, or p-value, associated with a Wilcoxon signed ranked statistic comparing mean for two related samples or repeated measurements on a single sample.
- WilcoxonSignedRankTest - Class in org.hipparchus.stat.inference
-
An implementation of the Wilcoxon signed-rank test.
- WilcoxonSignedRankTest() - Constructor for class org.hipparchus.stat.inference.WilcoxonSignedRankTest
-
Create a test instance where NaN's are left in place and ties get the average of applicable ranks.
- WilcoxonSignedRankTest(NaNStrategy, TiesStrategy) - Constructor for class org.hipparchus.stat.inference.WilcoxonSignedRankTest
-
Create a test instance using the given strategies for NaN's and ties.
- withAPrioriData(RealVector, RealMatrix) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
-
Configure from a priori state and covariance.
- withAPrioriData(RealVector, RealMatrix, double, double) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
-
Configure from a priori state and covariance.
- withBiasCorrected(boolean) - Method in class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Returns a copy of this instance with the given biasCorrected setting.
- withBiasCorrection(boolean) - Method in class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Returns a new copy of this standard deviation with the given bias correction setting.
- withBiasCorrection(boolean) - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Returns a new copy of this variance with the given bias correction setting.
- withCache(int) - Method in class org.hipparchus.util.CombinatoricsUtils.FactorialLog
-
Creates an instance with the specified cache size.
- withCallback(Incrementor.MaxCountExceededCallback) - Method in class org.hipparchus.util.Incrementor
-
Creates a new instance with a given callback.
- withCostRelativeTolerance(double) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Build new instance with cost relative tolerance.
- withCount(int) - Method in class org.hipparchus.util.Incrementor
-
Creates a new instance and set the counter to the given value.
- withDecomposer(MatrixDecomposer) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
-
Configure the matrix decomposition algorithm.
- withDecomposer(MatrixDecomposer) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
-
Configure the matrix decomposition algorithm.
- withEstimationType(Percentile.EstimationType) - Method in class org.hipparchus.stat.descriptive.rank.Median
-
Build a new instance similar to the current one except for the
estimation type
. - withEstimationType(Percentile.EstimationType) - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Build a new instance similar to the current one except for the
estimation type
. - withEvaluation(LeastSquaresProblem.Evaluation) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
-
Configure the previous evaluation used by the optimizer.
- withFormNormalEquations(boolean) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
-
Configure if the normal equations should be explicitly formed.
- withFormNormalEquations(boolean) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
-
Configure if the normal equations should be explicitly formed.
- withHandler(FieldODEEventHandler<E>) - Method in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Setup the event handler to call at event occurrences.
- withHandler(ODEEventHandler) - Method in class org.hipparchus.ode.events.AbstractODEDetector
-
Setup the event handler to call at event occurrences.
- withInitialStepBoundFactor(double) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Build new instance with initial step bound factor.
- withKthSelector(KthSelector) - Method in class org.hipparchus.stat.descriptive.rank.Median
-
Build a new instance similar to the current one except for the
kthSelector
instance specifically set. - withKthSelector(KthSelector) - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Build a new instance similar to the current one except for the
kthSelector
instance specifically set. - withMaxCheck(double) - Method in class org.hipparchus.ode.events.AbstractODEDetector
-
Setup the maximum checking interval.
- withMaxCheck(E) - Method in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Setup the maximum checking interval.
- withMaxCheck(AdaptableInterval) - Method in class org.hipparchus.ode.events.AbstractODEDetector
-
Setup the maximum checking interval.
- withMaxCheck(FieldAdaptableInterval<E>) - Method in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Setup the maximum checking interval.
- withMaximalCount(int) - Method in class org.hipparchus.util.Incrementor
-
Creates a new instance with a given maximal count.
- withMaxIter(int) - Method in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Setup the maximum number of iterations in the event time search.
- withMaxIter(int) - Method in class org.hipparchus.ode.events.AbstractODEDetector
-
Setup the maximum number of iterations in the event time search.
- withMaxIterations(int) - Method in class org.hipparchus.fitting.GaussianCurveFitter
-
Configure the maximum number of iterations.
- withMaxIterations(int) - Method in class org.hipparchus.fitting.HarmonicCurveFitter
-
Configure the maximum number of iterations.
- withMaxIterations(int) - Method in class org.hipparchus.fitting.PolynomialCurveFitter
-
Configure the maximum number of iterations.
- withMaxIterations(int) - Method in class org.hipparchus.fitting.SimpleCurveFitter
-
Configure the maximum number of iterations.
- withNaNStrategy(NaNStrategy) - Method in class org.hipparchus.stat.descriptive.rank.Median
-
Build a new instance similar to the current one except for the
NaN handling
strategy. - withNaNStrategy(NaNStrategy) - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Build a new instance similar to the current one except for the
NaN handling
strategy. - withOrthoTolerance(double) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Build new instance with ortho tolerance.
- withParameterRelativeTolerance(double) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Build new instance with parameter relative tolerance.
- withRankingThreshold(double) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Build new instance with ranking threshold.
- withSolver(BracketedRealFieldUnivariateSolver<E>) - Method in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Setup the root-finding algorithm to use to detect state events.
- withSolver(BracketedUnivariateSolver<UnivariateFunction>) - Method in class org.hipparchus.ode.events.AbstractODEDetector
-
Setup the root-finding algorithm to use to detect state events.
- withStartPoint(double[]) - Method in class org.hipparchus.fitting.GaussianCurveFitter
-
Configure the start point (initial guess).
- withStartPoint(double[]) - Method in class org.hipparchus.fitting.HarmonicCurveFitter
-
Configure the start point (initial guess).
- withStartPoint(double[]) - Method in class org.hipparchus.fitting.PolynomialCurveFitter
-
Configure the start point (initial guess).
- withStartPoint(double[]) - Method in class org.hipparchus.fitting.SimpleCurveFitter
-
Configure the start point (initial guess).
- withThreshold(double) - Method in class org.hipparchus.ode.events.AbstractODEDetector
-
Setup the convergence threshold.
- withThreshold(E) - Method in class org.hipparchus.ode.events.AbstractFieldODEDetector
-
Setup the convergence threshold.
- withValue(double) - Method in interface org.hipparchus.analysis.differentiation.Derivative
-
Create a new object with new value (zeroth-order derivative, as passed as input) and same derivatives of order one and above.
- withValue(double) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Create a new object with new value (zeroth-order derivative, as passed as input) and same derivatives of order one and above.
- withValue(double) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Create a new object with new value (zeroth-order derivative, as passed as input) and same derivatives of order one and above.
- withValue(double) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Create a new object with new value (zeroth-order derivative, as passed as input) and same derivatives of order one and above.
- withValue(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Create a new object with new value (zeroth-order derivative, as passed as input) and same derivatives of order one and above.
- withValue(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
- withValue(S) - Method in interface org.hipparchus.analysis.differentiation.FieldDerivative
-
Create a new object with new value (zeroth-order derivative, as passed as input) and same derivatives of order one and above.
- withValue(T) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Create a new object with new value (zeroth-order derivative, as passed as input) and same derivatives of order one and above.
- withValue(T) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Create a new object with new value (zeroth-order derivative, as passed as input) and same derivatives of order one and above.
- withValue(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Create a new object with new value (zeroth-order derivative, as passed as input) and same derivatives of order one and above.
- withValue(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Create a new object with new value (zeroth-order derivative, as passed as input) and same derivatives of order one and above.
- withVarianceDirection(SemiVariance.Direction) - Method in class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Returns a copy of this instance with the given direction setting.
- WRONG_BLOCK_LENGTH - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.WRONG_BLOCK_LENGTH.
- WRONG_BLOCK_LENGTH - Enum constant in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.WRONG_BLOCK_LENGTH.
- WRONG_NUMBER_OF_POINTS - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
WRONG_NUMBER_OF_POINTS.
- WRONG_NUMBER_OF_POINTS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.WRONG_NUMBER_OF_POINTS.
X
- xor(Region<S>, Region<S>) - Method in class org.hipparchus.geometry.partitioning.RegionFactory
-
Compute the symmetric difference (exclusive or) of two regions.
- XYX - Enum constant in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Set of Euler angles.
- XYZ - Enum constant in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Set of Cardan angles.
- XZX - Enum constant in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Set of Euler angles.
- XZY - Enum constant in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Set of Cardan angles.
Y
- YXY - Enum constant in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Set of Euler angles.
- YXZ - Enum constant in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Set of Cardan angles.
- YZX - Enum constant in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Set of Cardan angles.
- YZY - Enum constant in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Set of Euler angles.
Z
- ZERO - Static variable in class org.hipparchus.complex.Complex
-
A complex number representing "0.0 + 0.0i".
- ZERO - Static variable in class org.hipparchus.complex.Quaternion
-
Zero quaternion.
- ZERO - Static variable in class org.hipparchus.fraction.BigFraction
-
A fraction representing "0".
- ZERO - Static variable in class org.hipparchus.fraction.Fraction
-
A fraction representing "0".
- ZERO - Static variable in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Origin (coordinates: 0).
- ZERO - Static variable in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Null vector (coordinates: 0, 0, 0).
- ZERO - Static variable in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Origin (coordinates: 0, 0).
- ZERO - Static variable in class org.hipparchus.util.BigReal
-
A big real representing 0.
- ZERO - Static variable in class org.hipparchus.util.Binary64
-
The constant value of
0d
as aBinary64
. - ZERO_DENOMINATOR - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ZERO_DENOMINATOR.
- ZERO_DENOMINATOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ZERO_DENOMINATOR.
- ZERO_DENOMINATOR_IN_FRACTION - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ZERO_DENOMINATOR_IN_FRACTION.
- ZERO_DENOMINATOR_IN_FRACTION - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ZERO_DENOMINATOR_IN_FRACTION.
- ZERO_FRACTION_TO_DIVIDE_BY - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ZERO_FRACTION_TO_DIVIDE_BY.
- ZERO_FRACTION_TO_DIVIDE_BY - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ZERO_FRACTION_TO_DIVIDE_BY.
- ZERO_NORM - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ZERO_NORM.
- ZERO_NORM - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ZERO_NORM.
- ZERO_NORM_FOR_ROTATION_AXIS - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
ZERO_NORM_FOR_ROTATION_AXIS.
- ZERO_NORM_FOR_ROTATION_AXIS - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ZERO_NORM_FOR_ROTATION_AXIS.
- ZERO_NORM_FOR_ROTATION_DEFINING_VECTOR - Enum constant in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
ZERO_NORM_FOR_ROTATION_DEFINING_VECTOR.
- ZERO_NORM_FOR_ROTATION_DEFINING_VECTOR - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ZERO_NORM_FOR_ROTATION_DEFINING_VECTOR.
- ZERO_NOT_ALLOWED - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ZERO_NOT_ALLOWED.
- ZERO_NOT_ALLOWED - Enum constant in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.ZERO_NOT_ALLOWED.
- ZERO_STATE_SIZE - Enum constant in enum org.hipparchus.exception.LocalizedCoreFormats
-
ZERO_STATE_SIZE.
- ZeroException - Exception in org.hipparchus.migration.exception
-
Deprecated.as of 1.0, this exception is replaced by
MathIllegalArgumentException
- ZeroException() - Constructor for exception org.hipparchus.migration.exception.ZeroException
-
Deprecated.Construct the exception.
- ZeroException(Localizable, Object...) - Constructor for exception org.hipparchus.migration.exception.ZeroException
-
Deprecated.Construct the exception with a specific context.
- ZipfDistribution - Class in org.hipparchus.distribution.discrete
-
Implementation of the Zipf distribution.
- ZipfDistribution(int, double) - Constructor for class org.hipparchus.distribution.discrete.ZipfDistribution
-
Create a new Zipf distribution with the given number of elements and exponent.
- ZXY - Enum constant in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Set of Cardan angles.
- ZXZ - Enum constant in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Set of Euler angles.
- ZYX - Enum constant in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Set of Cardan angles.
- ZYZ - Enum constant in enum org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Set of Euler angles.
All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form
MathIllegalStateException