- 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 - Class in org.hipparchus.analysis.function
-
Absolute value function.
- Abs() - Constructor for class org.hipparchus.analysis.function.Abs
-
- 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
-
- abs() - Method in class org.hipparchus.fraction.Fraction
-
Returns the absolute value of this fraction.
- abs() - Method in class org.hipparchus.util.Decimal64
-
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(float) - Static method in class org.hipparchus.util.FastMath
-
Absolute value.
- abs(double) - Static method in class org.hipparchus.util.FastMath
-
Absolute value.
- abs(T) - Static method in class org.hipparchus.util.FastMath
-
Absolute value.
- abs() - Method in class org.hipparchus.util.FieldTuple
-
absolute value.
- abs() - Method in class org.hipparchus.util.Tuple
-
absolute value.
- 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)
, where x
is
the independent variable and the pi
are the
parameters.
- AbstractCurveFitter() - Constructor for class org.hipparchus.fitting.AbstractCurveFitter
-
- AbstractCurveFitter.TheoreticalValuesFunction - Class in org.hipparchus.fitting
-
Vector function for computing function theoretical values.
- AbstractEvaluation - Class in org.hipparchus.optim.nonlinear.vector.leastsquares
-
- 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.
- 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
-
- AbstractIntegrator - Class in org.hipparchus.ode
-
Base class managing common boilerplate for all integrators.
- AbstractIntegrator(String) - Constructor for class org.hipparchus.ode.AbstractIntegrator
-
Build an instance.
- AbstractKalmanFilter<T extends Measurement> - Class in org.hipparchus.filtering.kalman
-
Shared parts between linear and non-linear Kalman filters.
- AbstractKalmanFilter(MatrixDecomposer, ProcessEstimate) - Constructor for class org.hipparchus.filtering.kalman.AbstractKalmanFilter
-
Simple constructor.
- AbstractMultipleLinearRegression - Class in org.hipparchus.stat.regression
-
Abstract base class for implementations of MultipleLinearRegression.
- AbstractMultipleLinearRegression() - Constructor for class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
- AbstractMultivariateRealDistribution - Class in org.hipparchus.distribution.multivariate
-
Base class for multivariate probability distributions.
- AbstractMultivariateRealDistribution(RandomGenerator, int) - Constructor for class org.hipparchus.distribution.multivariate.AbstractMultivariateRealDistribution
-
- AbstractODEStateInterpolator - Class in org.hipparchus.ode.sampling
-
This abstract class represents an interpolator over the last step
during an ODE integration.
- AbstractODEStateInterpolator(boolean, ODEStateAndDerivative, ODEStateAndDerivative, ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Constructor for class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Simple constructor.
- AbstractOptimizationProblem<P> - Class in org.hipparchus.optim
-
Base class for implementing optimization problems.
- AbstractOptimizationProblem(int, int, ConvergenceChecker<P>) - Constructor for class org.hipparchus.optim.AbstractOptimizationProblem
-
- AbstractParameterizable - Class in org.hipparchus.ode
-
This abstract class provides boilerplate parameters list.
- AbstractParameterizable(String...) - Constructor for class org.hipparchus.ode.AbstractParameterizable
-
Simple constructor.
- AbstractParameterizable(Collection<String>) - Constructor for class org.hipparchus.ode.AbstractParameterizable
-
Simple constructor.
- AbstractPolynomialSolver - Class in org.hipparchus.analysis.solvers
-
Base class for solvers.
- AbstractPolynomialSolver(double) - Constructor for class org.hipparchus.analysis.solvers.AbstractPolynomialSolver
-
Construct a solver with given absolute accuracy.
- AbstractPolynomialSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.AbstractPolynomialSolver
-
Construct a solver with given accuracies.
- AbstractPolynomialSolver(double, double, double) - Constructor for class org.hipparchus.analysis.solvers.AbstractPolynomialSolver
-
Construct a solver with given accuracies.
- AbstractRealDistribution - Class in org.hipparchus.distribution.continuous
-
Base class for probability distributions on the reals.
- AbstractRealDistribution(double) - Constructor for class org.hipparchus.distribution.continuous.AbstractRealDistribution
-
- AbstractRealDistribution() - Constructor for class org.hipparchus.distribution.continuous.AbstractRealDistribution
-
Create a real distribution with default solver absolute accuracy.
- 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(BSPTree<S>, double) - Constructor for class org.hipparchus.geometry.partitioning.AbstractRegion
-
Build a region from an inside/outside BSP tree.
- AbstractRegion(Collection<SubHyperplane<S>>, double) - Constructor for class org.hipparchus.geometry.partitioning.AbstractRegion
-
Build a Region from a Boundary REPresentation (B-rep).
- 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
-
- AbstractSimplex - Class in org.hipparchus.optim.nonlinear.scalar.noderiv
-
This class implements the simplex concept.
- 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.
- 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.
- AbstractStorelessUnivariateStatistic - Class in org.hipparchus.stat.descriptive
-
- AbstractStorelessUnivariateStatistic() - Constructor for class org.hipparchus.stat.descriptive.AbstractStorelessUnivariateStatistic
-
- AbstractSubHyperplane<S extends Space,T extends Space> - Class in org.hipparchus.geometry.partitioning
-
This class implements the dimension-independent parts of
SubHyperplane
.
- AbstractSubHyperplane(Hyperplane<S>, Region<T>) - Constructor for class org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Build a sub-hyperplane from an hyperplane and a region.
- AbstractUnivariateDifferentiableSolver - Class in org.hipparchus.analysis.solvers
-
Provide a default implementation for several functions useful to generic
solvers.
- AbstractUnivariateDifferentiableSolver(double) - Constructor for class org.hipparchus.analysis.solvers.AbstractUnivariateDifferentiableSolver
-
Construct a solver with given absolute accuracy.
- AbstractUnivariateDifferentiableSolver(double, double, double) - Constructor for class org.hipparchus.analysis.solvers.AbstractUnivariateDifferentiableSolver
-
Construct a solver with given accuracies.
- AbstractUnivariateSolver - Class in org.hipparchus.analysis.solvers
-
Base class for solvers.
- AbstractUnivariateSolver(double) - Constructor for class org.hipparchus.analysis.solvers.AbstractUnivariateSolver
-
Construct a solver with given absolute accuracy.
- AbstractUnivariateSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.AbstractUnivariateSolver
-
Construct a solver with given accuracies.
- AbstractUnivariateSolver(double, double, double) - Constructor for class org.hipparchus.analysis.solvers.AbstractUnivariateSolver
-
Construct a solver with given accuracies.
- AbstractUnivariateStatistic - Class in org.hipparchus.stat.descriptive
-
- AbstractUnivariateStatistic() - Constructor for class org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Default constructor.
- AbstractUnivariateStatistic(AbstractUnivariateStatistic) - Constructor for class org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Copy constructor, creates an identical copy
of the original
.
- AbstractWell - Class in org.hipparchus.random
-
This abstract class implements the WELL class of pseudo-random number generator
from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
- AbstractWell(int) - Constructor for class org.hipparchus.random.AbstractWell
-
Creates a new random number generator.
- AbstractWell(int, int) - Constructor for class org.hipparchus.random.AbstractWell
-
Creates a new random number generator using a single int seed.
- AbstractWell(int, int[]) - Constructor for class org.hipparchus.random.AbstractWell
-
Creates a new random number generator using an int array seed.
- AbstractWell(int, long) - Constructor for class org.hipparchus.random.AbstractWell
-
Creates a new random number generator using a single long seed.
- AbstractWell.IndexTable - Class in org.hipparchus.random
-
Inner class used to store the indirection index table which is fixed
for a given type of WELL class of pseudo-random number generator.
- accept(double) - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
- accept(double) - Method in interface org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
- accept(double) - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
- acceptStep(AbstractFieldODEStateInterpolator<T>, T) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Accept a step, triggering events and step handlers.
- acceptStep(AbstractODEStateInterpolator, double) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Accept a step, triggering events and step handlers.
- acos() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Arc cosine operation.
- acos(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc cosine of a derivative structure.
- acos(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc cosine of a derivative structure.
- acos() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Arc cosine operation.
- Acos - Class in org.hipparchus.analysis.function
-
Arc-cosine function.
- Acos() - Constructor for class org.hipparchus.analysis.function.Acos
-
- acos() - Method in interface org.hipparchus.CalculusFieldElement
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.complex.Complex
-
- acos() - Method in class org.hipparchus.complex.FieldComplex
-
- acos() - Method in class org.hipparchus.dfp.Dfp
-
Arc cosine operation.
- acos(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
computes the arc-cosine of the argument.
- acos() - Method in class org.hipparchus.util.Decimal64
-
Arc cosine operation.
- acos(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the arc cosine of a number.
- acos(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the arc cosine of a number.
- acos() - Method in class org.hipparchus.util.FieldTuple
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.util.Tuple
-
Arc cosine operation.
- acosh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Inverse hyperbolic cosine operation.
- acosh(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic cosine of a derivative structure.
- acosh(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic cosine of a derivative structure.
- acosh() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
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.Gradient
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Inverse hyperbolic cosine operation.
- Acosh - Class in org.hipparchus.analysis.function
-
Hyperbolic arc-cosine function.
- Acosh() - Constructor for class org.hipparchus.analysis.function.Acosh
-
- 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.Decimal64
-
Inverse hyperbolic cosine operation.
- acosh(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic cosine of a number.
- acosh(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic cosine of a number.
- acosh() - Method in class org.hipparchus.util.FieldTuple
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.util.Tuple
-
Inverse hyperbolic cosine operation.
- 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
-
- AdamsFieldIntegrator(Field<T>, String, int, int, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Build an Adams integrator with the given order and step control parameters.
- AdamsFieldIntegrator(Field<T>, String, int, int, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Build an Adams integrator with the given order and step control parameters.
- AdamsIntegrator - Class in org.hipparchus.ode.nonstiff
-
- AdamsIntegrator(String, int, int, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Build an Adams integrator with the given order and step control parameters.
- AdamsIntegrator(String, int, int, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Build an Adams integrator with the given order and step control parameters.
- AdamsMoultonFieldIntegrator<T extends 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.
- 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 class org.hipparchus.analysis.differentiation.DerivativeStructure
-
'+' operator.
- add(DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute this + a.
- add(double[], int, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform addition of two derivative structures.
- add(T[], int, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform addition of two derivative structures.
- add(T) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'+' operator.
- add(double) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'+' operator.
- add(FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute this + a.
- add(T) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
'+' operator.
- add(double) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
'+' operator.
- add(FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute this + a.
- add(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'+' operator.
- add(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'+' operator.
- add(FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute this + a.
- add(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'+' operator.
- add(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'+' operator.
- add(FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute this + a.
- add(double) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
'+' operator.
- 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(double) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
'+' operator.
- add(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
'+' operator.
- add(UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute this + a.
- add(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
'+' operator.
- add(UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute this + a.
- Add - Class in org.hipparchus.analysis.function
-
Add the two operands.
- Add() - Constructor for class org.hipparchus.analysis.function.Add
-
- add(UnivariateFunction...) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Adds functions.
- add(UnivariateDifferentiableFunction...) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Adds functions.
- add(double[], boolean) - Method in class org.hipparchus.analysis.interpolation.InterpolatingMicrosphere
-
Replace i
-th facet of the microsphere.
- 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(double) - Method in interface org.hipparchus.CalculusFieldElement
-
'+' operator.
- add(Complex) - Method in class org.hipparchus.complex.Complex
-
Returns a Complex
whose value is
(this + addend)
.
- add(double) - Method in class org.hipparchus.complex.Complex
-
Returns a Complex
whose value is (this + addend)
,
with addend
interpreted as a real number.
- add(FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a Complex
whose value is
(this + addend)
.
- add(T) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a Complex
whose value is (this + addend)
,
with addend
interpreted as a real number.
- add(double) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a Complex
whose value is (this + addend)
,
with addend
interpreted as a real number.
- add(Quaternion, Quaternion) - Static method in class org.hipparchus.complex.Quaternion
-
Computes the sum of two quaternions.
- add(Quaternion) - Method in class org.hipparchus.complex.Quaternion
-
Computes the sum of the instance and another quaternion.
- add(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Add x to this.
- add(double) - Method in class org.hipparchus.dfp.Dfp
-
'+' operator.
- add(T) - Method in interface org.hipparchus.FieldElement
-
Compute this + a.
- 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(WeightedObservedPoint) - Method in class org.hipparchus.fitting.WeightedObservedPoints
-
Adds a point to the sample.
- 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(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(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(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(int) - Method in class org.hipparchus.fraction.Fraction
-
Add an integer to the fraction.
- add(Vector<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Add a vector to the instance.
- add(double, Vector<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Add a scaled vector to the instance.
- add(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(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(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(Vector<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Add a vector to the instance.
- add(double, Vector<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Add a scaled vector to the instance.
- add(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(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(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(Vector<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Add a vector to the instance.
- add(double, Vector<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Add a scaled vector to the instance.
- add(BSPTree<S>) - Method in class org.hipparchus.geometry.partitioning.NodesSet
-
Add a node if not already known.
- add(Vector<S>) - Method in interface org.hipparchus.geometry.Vector
-
Add a vector to the instance.
- add(double, Vector<S>) - Method in interface org.hipparchus.geometry.Vector
-
Add a scaled vector to the instance.
- add(FieldMatrix<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Compute the sum of this and m.
- add(RealMatrix) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the sum of this
and m
.
- add(Array2DRowFieldMatrix<T>) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Add m
to this matrix.
- add(Array2DRowRealMatrix) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Compute the sum of this
and m
.
- add(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute the sum of this
and v
.
- add(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute the sum of this
and v
.
- add(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Compute the sum of this vector and v
.
- add(FieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Compute the sum of this and m.
- add(BlockFieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Compute the sum of this
and m
.
- add(RealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the sum of this
and m
.
- add(BlockRealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Compute the sum of this matrix and m
.
- add(DiagonalMatrix) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Compute the sum of this
and m
.
- add(FieldMatrix<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Compute the sum of this and m.
- add(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Compute the sum of this
and v
.
- add(OpenMapRealMatrix) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Compute the sum of this matrix and m
.
- add(RealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Compute the sum of this vector and v
.
- add(OpenMapRealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Optimized method to add two OpenMapRealVectors.
- add(RealMatrix) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the sum of this
and m
.
- 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(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Compute the sum of this
and v
.
- add(BigReal) - Method in class org.hipparchus.util.BigReal
-
Compute this + a.
- add(Decimal64) - Method in class org.hipparchus.util.Decimal64
-
Compute this + a.
- add(double) - Method in class org.hipparchus.util.Decimal64
-
'+' operator.
- add(FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Compute this + a.
- add(double) - Method in class org.hipparchus.util.FieldTuple
-
'+' operator.
- add(Tuple) - Method in class org.hipparchus.util.Tuple
-
Compute this + a.
- add(double) - Method in class org.hipparchus.util.Tuple
-
'+' operator.
- addAll(Iterable<BSPTree<S>>) - Method in class org.hipparchus.geometry.partitioning.NodesSet
-
Add nodes if they are not already known.
- addAndCheck(int, int) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Add two integers, checking for overflow.
- addAndCheck(long, long) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Add two long integers, checking for overflow.
- addCDFSeries(Chart, IntegerDistribution, String, int, int) - Static method in class org.hipparchus.samples.IntegerDistributionComparison
-
- addCDFSeries(Chart, RealDistribution, String, int, int) - Static method in class org.hipparchus.samples.RealDistributionComparison
-
- addData(double, double) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Adds the observation (x,y) to the regression data set.
- addData(double[][]) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Adds the observations represented by the elements in
data
.
- addElement(double) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Adds an element to the end of this expandable array.
- addElementRolling(double) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Adds an element to the end of the array and removes the first
element in the array.
- addElements(double[]) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Adds several element to the end of this expandable array.
- addEventHandler(FieldODEEventHandler<T>, double, double, int) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Add an event handler to the integrator.
- addEventHandler(FieldODEEventHandler<T>, double, double, int, BracketedRealFieldUnivariateSolver<T>) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Add an event handler to the integrator.
- addEventHandler(ODEEventHandler, double, double, int) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Add an event handler to the integrator.
- addEventHandler(ODEEventHandler, double, double, int, BracketedUnivariateSolver<UnivariateFunction>) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Add an event handler to the integrator.
- addEventHandler(FieldODEEventHandler<T>, double, double, int) - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Add an event handler to the integrator.
- addEventHandler(FieldODEEventHandler<T>, double, double, int, BracketedRealFieldUnivariateSolver<T>) - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Add an event handler to the integrator.
- addEventHandler(ODEEventHandler, double, double, int) - Method in interface org.hipparchus.ode.ODEIntegrator
-
Add an event handler to the integrator.
- addEventHandler(ODEEventHandler, double, double, int, BracketedUnivariateSolver<UnivariateFunction>) - Method in interface org.hipparchus.ode.ODEIntegrator
-
Add an event handler to the integrator.
- addExact(int, int) - Static method in class org.hipparchus.util.FastMath
-
Add two numbers, detecting overflows.
- addExact(long, long) - Static method in class org.hipparchus.util.FastMath
-
Add two numbers, detecting overflows.
- addInPlace(SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Add in place.
- addIterationListener(IterationListener) - Method in class org.hipparchus.util.IterationManager
-
Attaches a listener to this manager.
- addObservation(double[], double) - Method in class org.hipparchus.stat.regression.MillerUpdatingRegression
-
Adds an observation to the regression model.
- addObservation(double[], double) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Adds one observation to the regression model.
- addObservation(double[], double) - Method in interface org.hipparchus.stat.regression.UpdatingMultipleLinearRegression
-
Adds one observation to the regression model.
- addObservations(double[][], double[]) - Method in class org.hipparchus.stat.regression.MillerUpdatingRegression
-
Adds multiple observations to the model.
- addObservations(double[][], double[]) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Adds a series of observations to the regression model.
- addObservations(double[][], double[]) - Method in interface org.hipparchus.stat.regression.UpdatingMultipleLinearRegression
-
Adds a series of observations to the regression model.
- addParameterJacobianProvider(NamedParameterJacobianProvider) - Method in class org.hipparchus.migration.ode.JacobianMatrices
-
Deprecated.
Add a parameter Jacobian provider.
- addPDFSeries(Chart, IntegerDistribution, String, int, int) - Static method in class org.hipparchus.samples.IntegerDistributionComparison
-
- addPDFSeries(Chart, RealDistribution, String, int, int) - Static method in class org.hipparchus.samples.RealDistributionComparison
-
- addPoint(T) - Method in class org.hipparchus.clustering.Cluster
-
Add a point to this cluster.
- addSamplePoint(T, T[]...) - Method in class org.hipparchus.analysis.interpolation.FieldHermiteInterpolator
-
Add a sample point.
- addSamplePoint(double, double[]...) - Method in class org.hipparchus.analysis.interpolation.HermiteInterpolator
-
Add a sample point.
- addSecondaryEquations(SecondaryODE) - Method in class org.hipparchus.ode.ExpandableODE
-
Add a set of secondary equations to be integrated along with the primary set.
- addSecondaryEquations(FieldSecondaryODE<T>) - Method in class org.hipparchus.ode.FieldExpandableODE
-
Add a set of secondary equations to be integrated along with the primary set.
- addStepHandler(FieldODEStepHandler<T>) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Add a step handler to this integrator.
- addStepHandler(ODEStepHandler) - Method in class org.hipparchus.ode.AbstractIntegrator
-
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 interface org.hipparchus.ode.ODEIntegrator
-
Add a step handler to this integrator.
- addToEntry(int, int, T) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Change an entry in the specified row and column.
- 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, T) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Change an entry in the specified row and column.
- 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, double) - Method in class org.hipparchus.linear.ArrayRealVector
-
Change an entry at the specified index.
- addToEntry(int, int, T) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Change an entry in the specified row and column.
- 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, T) - Method in interface org.hipparchus.linear.FieldMatrix
-
Change an entry in the specified row and column.
- 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, double) - Method in class org.hipparchus.linear.RealVector
-
Change an entry at the specified index.
- 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.MultivariateSummaryStatistics
-
Add an n-tuple to the data
- addValue(double) - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Add a value to the data
- addValue(T) - Method in class org.hipparchus.stat.Frequency
-
Adds 1 to the frequency count for v.
- addValue(int) - Method in class org.hipparchus.stat.LongFrequency
-
Adds 1 to the frequency count for v.
- advance(RealVector.Entry) - Method in class org.hipparchus.linear.RealVector.SparseEntryIterator
-
Advance an entry up to the next nonzero one.
- advance() - Method in class org.hipparchus.util.OpenIntToDoubleHashMap.Iterator
-
Advance iterator one step further.
- advance() - Method in class org.hipparchus.util.OpenIntToFieldHashMap.Iterator
-
Advance iterator one step further.
- AggregatableStatistic<T> - Interface in org.hipparchus.stat.descriptive
-
An interface for statistics that can aggregate results.
- 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.
- aggregate(Iterable<T>) - Method in interface org.hipparchus.stat.descriptive.AggregatableStatistic
-
Aggregates the results from the provided instances into this instance.
- aggregate(GeometricMean) - Method in class org.hipparchus.stat.descriptive.moment.GeometricMean
-
Aggregates the provided instance into this instance.
- aggregate(Mean) - Method in class org.hipparchus.stat.descriptive.moment.Mean
-
Aggregates the provided instance into this instance.
- aggregate(SecondMoment) - Method in class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Aggregates the provided instance into this instance.
- aggregate(Variance) - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Aggregates the provided instance into this instance.
- aggregate(Max) - Method in class org.hipparchus.stat.descriptive.rank.Max
-
Aggregates the provided instance into this instance.
- aggregate(Min) - Method in class org.hipparchus.stat.descriptive.rank.Min
-
Aggregates the provided instance into this instance.
- aggregate(RandomPercentile) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Aggregates the provided instance into this instance.
- aggregate(StatisticalSummary...) - Static method in interface org.hipparchus.stat.descriptive.StatisticalSummary
-
Computes aggregated statistical summaries.
- aggregate(Iterable<? extends 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.
- 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
-
- 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
-
- 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.
- AnyMatrix - Interface in org.hipparchus.linear
-
Interface defining very basic matrix operations.
- append(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending a vector to this vector.
- append(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending a vector to this vector.
- append(T) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending a T to this vector.
- append(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Construct a new 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(double) - Method in class org.hipparchus.linear.ArrayRealVector
-
Construct a new vector by appending a double to this vector.
- append(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Construct a vector by appending a vector to this vector.
- append(T) - Method in interface org.hipparchus.linear.FieldVector
-
Construct a vector by appending a T 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.OpenMapRealVector
-
Construct a new vector by appending a vector to this vector.
- append(double) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Construct a new vector by appending a double to this vector.
- append(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Construct a new vector by appending a vector to this vector.
- append(double) - Method in class org.hipparchus.linear.RealVector
-
Construct a new vector by appending a double to this vector.
- append(SparseFieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
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(T) - Method in class org.hipparchus.linear.SparseFieldVector
-
Construct a vector by appending a T to this vector.
- append(DenseOutputModel) - Method in class org.hipparchus.ode.DenseOutputModel
-
Append another model at the end of the instance.
- append(FieldDenseOutputModel<T>) - Method in class org.hipparchus.ode.FieldDenseOutputModel
-
Append another model at the end of the instance.
- append(StorelessCovariance) - Method in class org.hipparchus.stat.correlation.StorelessCovariance
-
Appends sc
to this, effectively aggregating the computations in sc
with this.
- append(SimpleRegression) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Appends data from another regression calculation to this one.
- apply(Point<S>) - Method in interface org.hipparchus.geometry.partitioning.Transform
-
Transform a point of a space.
- 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(UnivariateStatistic) - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Apply the given statistic to the data associated with this set of statistics.
- applyInverseTo(FieldVector3D<T>) - 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.FieldRotation
-
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.
- 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(Rotation, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of a rotation to a vector.
- applyInverseTo(FieldRotation<T>) - 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.FieldRotation
-
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(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the inverse of the rotation to a vector.
- 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(Rotation) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the inverse of the instance to another rotation.
- applyTo(FieldVector3D<T>) - 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.FieldRotation
-
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.
- applyTo(double[], T[]) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the rotation to a vector stored in an array.
- applyTo(Rotation, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply a rotation to a vector.
- applyTo(FieldRotation<T>) - 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.FieldRotation
-
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(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the rotation to a vector.
- applyTo(double[], double[]) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the rotation to a vector stored in an array.
- applyTo(Rotation) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the instance to another rotation.
- applyTransform(Transform<S, T>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Transform a region.
- applyTransform(Transform<S, T>) - Method in class org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Apply a transform to the instance.
- approximateP(double, int, int) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- approximateP(double, int, int) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Uses the Kolmogorov-Smirnov distribution to approximate \(P(D_{n,m} > d)\) where \(D_{n,m}\)
is the 2-sample Kolmogorov-Smirnov statistic.
- Arc - Class in org.hipparchus.geometry.spherical.oned
-
This class represents an arc on a circle.
- Arc(double, double, double) - Constructor for class org.hipparchus.geometry.spherical.oned.Arc
-
Simple constructor.
- arccd(T) - 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.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.
- arccn(T) - 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.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.
- arccs(T) - 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.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.
- arcdc(T) - 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.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.
- arcdn(T) - 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.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.
- arcds(T) - 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.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.
- arcnc(T) - 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.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.
- arcnd(T) - 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.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.
- arcns(T) - 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.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.
- arcsc(T) - 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.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.
- arcsd(T) - 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.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.
- arcsn(T) - 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.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.
- 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(BSPTree<Sphere1D>, double) - Constructor for class org.hipparchus.geometry.spherical.oned.ArcsSet
-
Build an arcs set from an inside/outside BSP tree.
- 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.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.
- ArithmeticUtils - Class in org.hipparchus.util
-
Some useful, arithmetics related, additions to the built-in functions in
Math
.
- Array2DRowFieldMatrix<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
Implementation of FieldMatrix
using a FieldElement
[][] array to store entries.
- Array2DRowFieldMatrix(Field<T>) - Constructor for class org.hipparchus.linear.Array2DRowFieldMatrix
-
Creates a matrix with no data
- Array2DRowFieldMatrix(Field<T>, int, int) - Constructor for class org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix<T>
with the supplied row and column dimensions.
- Array2DRowFieldMatrix(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[][]) - 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.
- Array2DRowFieldMatrix(Field<T>, T[][], boolean) - Constructor for class org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix<T>
using the input array as the underlying
data array.
- Array2DRowFieldMatrix(T[]) - Constructor for class org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new (column) FieldMatrix<T>
using v
as the
data for the unique column of the created matrix.
- Array2DRowFieldMatrix(Field<T>, T[]) - Constructor for class org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new (column) FieldMatrix<T>
using v
as the
data for the unique column of the created matrix.
- Array2DRowRealMatrix - Class in org.hipparchus.linear
-
Implementation of
RealMatrix
using a
double[][]
array to
store entries.
- Array2DRowRealMatrix() - Constructor for class org.hipparchus.linear.Array2DRowRealMatrix
-
Creates a matrix with no data
- Array2DRowRealMatrix(int, int) - Constructor for class org.hipparchus.linear.Array2DRowRealMatrix
-
Create a new RealMatrix with the supplied row and column dimensions.
- 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(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.
- ArrayFieldVector<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
- 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(int, T) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector with preset values.
- ArrayFieldVector(T[]) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from an array, copying the input array.
- ArrayFieldVector(Field<T>, 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(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(T[], int, int) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from part of a array.
- ArrayFieldVector(Field<T>, T[], int, int) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from part of a array.
- ArrayFieldVector(FieldVector<T>) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from another vector, using a deep copy.
- 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>, 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[], 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.
- ArrayFieldVector(Field<T>, 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(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, 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[], int, int) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector from part of a array.
- 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(RealVector) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector from another vector, using a deep copy.
- 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, 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, ArrayRealVector) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(ArrayRealVector, double[]) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(double[], ArrayRealVector) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(double[], double[]) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- asin() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Arc sine operation.
- asin(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc sine of a derivative structure.
- asin(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc sine of a derivative structure.
- asin() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Arc sine operation.
- asin() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Arc sine operation.
- asin() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Arc sine operation.
- asin() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Arc sine operation.
- asin() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Arc sine operation.
- asin() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Arc sine operation.
- asin() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Arc sine operation.
- asin() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Arc sine operation.
- Asin - Class in org.hipparchus.analysis.function
-
Arc-sine function.
- Asin() - Constructor for class org.hipparchus.analysis.function.Asin
-
- asin() - Method in interface org.hipparchus.CalculusFieldElement
-
Arc sine operation.
- asin() - Method in class org.hipparchus.complex.Complex
-
- asin() - Method in class org.hipparchus.complex.FieldComplex
-
- asin() - Method in class org.hipparchus.dfp.Dfp
-
Arc sine operation.
- asin(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
computes the arc-sine of the argument.
- asin() - Method in class org.hipparchus.util.Decimal64
-
Arc sine operation.
- asin(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the arc sine of a number.
- asin(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the arc sine of a number.
- asin() - Method in class org.hipparchus.util.FieldTuple
-
Arc sine operation.
- asin() - Method in class org.hipparchus.util.Tuple
-
Arc sine operation.
- asinh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Inverse hyperbolic sine operation.
- asinh(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic sine of a derivative structure.
- asinh(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic sine of a derivative structure.
- asinh() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
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.Gradient
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Inverse hyperbolic sine operation.
- Asinh - Class in org.hipparchus.analysis.function
-
Hyperbolic arc-sine function.
- Asinh() - Constructor for class org.hipparchus.analysis.function.Asinh
-
- 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.Decimal64
-
Inverse hyperbolic sine operation.
- asinh(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic sine of a number.
- asinh(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic sine of a number.
- asinh() - Method in class org.hipparchus.util.FieldTuple
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.util.Tuple
-
Inverse hyperbolic sine operation.
- 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.
- atan() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Arc tangent operation.
- atan(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc tangent of a derivative structure.
- atan(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc tangent of a derivative structure.
- atan() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Arc tangent operation.
- Atan - Class in org.hipparchus.analysis.function
-
Arc-tangent function.
- Atan() - Constructor for class org.hipparchus.analysis.function.Atan
-
- atan() - Method in interface org.hipparchus.CalculusFieldElement
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.complex.Complex
-
- atan() - Method in class org.hipparchus.complex.FieldComplex
-
- atan() - Method in class org.hipparchus.dfp.Dfp
-
Arc tangent operation.
- 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() - Method in class org.hipparchus.util.Decimal64
-
Arc tangent operation.
- atan(double) - Static method in class org.hipparchus.util.FastMath
-
Arctangent function
- atan(T) - Static method in class org.hipparchus.util.FastMath
-
Arctangent function
- atan() - Method in class org.hipparchus.util.FieldTuple
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.util.Tuple
-
Arc tangent operation.
- 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(double[], int, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute two arguments arc tangent of a derivative structure.
- 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(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 - Class in org.hipparchus.analysis.function
-
Arc-tangent function.
- Atan2() - Constructor for class org.hipparchus.analysis.function.Atan2
-
- atan2(T) - Method in interface org.hipparchus.CalculusFieldElement
-
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(Decimal64) - Method in class org.hipparchus.util.Decimal64
-
Two arguments arc tangent operation.
- atan2(double, double) - Static method in class org.hipparchus.util.FastMath
-
Two arguments arctangent function
- atan2(T, T) - Static method in class org.hipparchus.util.FastMath
-
Two arguments arctangent function
- 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.
- atanh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Inverse hyperbolic tangent operation.
- atanh(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic tangent of a derivative structure.
- atanh(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic tangent of a derivative structure.
- atanh() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
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.Gradient
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Inverse hyperbolic tangent operation.
- Atanh - Class in org.hipparchus.analysis.function
-
Hyperbolic arc-tangent function.
- Atanh() - Constructor for class org.hipparchus.analysis.function.Atanh
-
- 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.Decimal64
-
Inverse hyperbolic tangent operation.
- atanh(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic tangent of a number.
- atanh(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic tangent of a number.
- atanh() - Method in class org.hipparchus.util.FieldTuple
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.util.Tuple
-
Inverse hyperbolic tangent operation.
- atanInternal(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
computes the arc-tangent of the argument.
- ballOnSupport(List<P>) - Method in interface org.hipparchus.geometry.enclosing.SupportBallGenerator
-
Create a ball whose boundary lies on prescribed support points.
- 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.
- BaseAbstractFieldUnivariateIntegrator<T extends CalculusFieldElement<T>> - Class in org.hipparchus.analysis.integration
-
Provide a default implementation for several generic functions.
- 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>, double, double) - Constructor for class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Construct an integrator with given accuracies.
- 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, int, int) - Constructor for class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Construct an integrator with given accuracies and iteration counts.
- BaseAbstractUnivariateIntegrator(double, double) - Constructor for class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Construct an integrator with given accuracies.
- 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.
- 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
-
- BaseOptimizer<P> - Class in org.hipparchus.optim
-
Base class for implementing optimizers.
- BaseOptimizer(ConvergenceChecker<P>) - Constructor for class org.hipparchus.optim.BaseOptimizer
-
- BaseOptimizer(ConvergenceChecker<P>, int, int) - Constructor for class org.hipparchus.optim.BaseOptimizer
-
- 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, 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, double, 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.
- 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
-
- 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
-
- BicubicInterpolatingFunction(double[], double[], double[][], double[][], double[][], double[][]) - Constructor for class org.hipparchus.analysis.interpolation.BicubicInterpolatingFunction
-
- BicubicInterpolator - Class in org.hipparchus.analysis.interpolation
-
- BicubicInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.BicubicInterpolator
-
- 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(T) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral D(m) = [K(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(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(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(T, T) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete elliptic integral D(φ, m) = [F(φ, 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>, FieldComplex<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(int) - Method in class org.hipparchus.fraction.BigFraction
-
Gets the fraction as a BigDecimal
following the passed
rounding mode.
- bigDecimalValue(int, int) - Method in class org.hipparchus.fraction.BigFraction
-
Gets the fraction as a BigDecimal
following the passed scale
and rounding mode.
- bigDecimalValue() - Method in class org.hipparchus.util.BigReal
-
Get the BigDecimal value corresponding to the instance.
- bigE(double) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete 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(Complex) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete elliptic integral of the second kind E(m).
- 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(double, double) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the incomplete 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).
- 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>, 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).
- 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(T, T) - 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).
- BigFraction - Class in org.hipparchus.fraction
-
Representation of a rational number without any overflow.
- BigFraction(BigInteger) - Constructor for class org.hipparchus.fraction.BigFraction
-
Create a
BigFraction
equivalent to the passed
BigInteger
, ie
"num / 1".
- BigFraction(BigInteger, BigInteger) - Constructor for class org.hipparchus.fraction.BigFraction
-
Create a
BigFraction
given the numerator and denominator as
BigInteger
.
- 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 passed
int
, ie
"num / 1".
- BigFraction(int, int) - Constructor for class org.hipparchus.fraction.BigFraction
-
Create a
BigFraction
given the numerator and denominator as simple
int
.
- 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 simple
long
.
- 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(T) - 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).
- bigKPrime(double) - 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).
- 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).
- 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(T, T) - Static method in class org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegral
-
Get the complete 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(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(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(T, T, T) - 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) - 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>, 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).
- BigReal - Class in org.hipparchus.util
-
Arbitrary precision decimal number.
- 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.
- 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.
- 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
-
- binomialCoefficient(int, int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Returns an exact representation of the
Binomial
Coefficient, "
n choose k
", the number of
k
-element subsets that can be selected from an
n
-element set.
- binomialCoefficientDouble(int, int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Returns a
double
representation of the
Binomial
Coefficient, "
n choose k
", the number of
k
-element subsets that can be selected from an
n
-element set.
- binomialCoefficientLog(int, int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Returns the natural
log
of the
Binomial
Coefficient, "
n choose k
", the number of
k
-element subsets that can be selected from an
n
-element set.
- BinomialDistribution - Class in org.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 - Class in org.hipparchus.stat.inference
-
Implements binomial test statistics.
- BinomialTest() - Constructor for class org.hipparchus.stat.inference.BinomialTest
-
- 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(int, int, double, AlternativeHypothesis) - Method in class org.hipparchus.stat.inference.BinomialTest
-
- BisectionSolver - Class in org.hipparchus.analysis.solvers
-
- 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.
- 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(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.
- BlockFieldMatrix(int, int, T[][], boolean) - Constructor for class org.hipparchus.linear.BlockFieldMatrix
-
Create a new dense matrix copying entries from block 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(int, int) - Constructor for class org.hipparchus.linear.BlockRealMatrix
-
Create a new matrix with the supplied row and column dimensions.
- BlockRealMatrix(double[][]) - Constructor for class org.hipparchus.linear.BlockRealMatrix
-
Create a new dense matrix copying entries from raw layout data.
- BlockRealMatrix(int, int, double[][], boolean) - Constructor for class org.hipparchus.linear.BlockRealMatrix
-
Create a new dense matrix copying entries from block layout data.
- 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
-
- BOBYQAOptimizer(int, double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
-
- 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
and
y
are samples drawn from the same
probability distribution.
- bootstrap(double[], double[], int) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Computes bootstrap(x, y, iterations, true)
.
- 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.
- boundedToUnbounded(double[]) - Method in class org.hipparchus.optim.nonlinear.scalar.MultivariateFunctionMappingAdapter
-
Maps an array from bounded to unbounded.
- bracket(UnivariateFunction, double, double, double) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
- bracket(UnivariateFunction, double, double, double, int) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
- 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
If f
is continuous on [a,b]
, this means that a
and b
bracket a root of f
.
- bracket(CalculusFieldUnivariateFunction<T>, T, T, T) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
- bracket(CalculusFieldUnivariateFunction<T>, T, T, T, int) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
- 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
If f
is continuous on [a,b]
, this means that a
and b
bracket a root of f
.
- BracketedRealFieldUnivariateSolver<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.analysis.solvers
-
- 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
-
- 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
-
- BracketFinder(double, int) - Constructor for class org.hipparchus.optim.univariate.BracketFinder
-
Create a bracketing interval finder.
- BracketingNthOrderBrentSolver - Class in org.hipparchus.analysis.solvers
-
- 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, 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, double, 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 approximation x
to the point at which the function
attains its minimum.
- 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.
- 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.
- 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(double...) - Method in class org.hipparchus.analysis.differentiation.DSFactory
-
- build(T...) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
- build(double...) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
- build(double[]) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Build an initial simplex.
- build() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
- build(double) - 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(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() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics.StreamingStatisticsBuilder
-
Builds a StreamingStatistics instance with currently defined properties.
- 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
-
- buildNew(BSPTree<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.IntervalsSet
-
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(BSPTree<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Build a region using the instance as a prototype.
- 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(BSPTree<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.PolygonsSet
-
Build a region using the instance as a prototype.
- 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(BSPTree<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Build a region using the instance as a prototype.
- buildNew(Hyperplane<S>, Region<T>) - Method in class org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Build a sub-hyperplane from an hyperplane and a region.
- buildNew(BSPTree<S>) - Method in interface org.hipparchus.geometry.partitioning.Region
-
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(Hyperplane<Sphere1D>, Region<Sphere1D>) - Method in class org.hipparchus.geometry.spherical.oned.SubLimitAngle
-
Build a sub-hyperplane from an hyperplane and a region.
- buildNew(BSPTree<Sphere2D>) - Method in class org.hipparchus.geometry.spherical.twod.SphericalPolygonsSet
-
Build a region using the instance as a prototype.
- buildNew(Hyperplane<Sphere2D>, Region<Sphere1D>) - Method in class org.hipparchus.geometry.spherical.twod.SubCircle
-
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.Decimal64
-
The current implementation performs casting to a byte
.
- calculateAdjustedRSquared() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Returns the adjusted R-squared statistic, defined by the formula
- calculateBeta() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Calculates the beta of multiple linear regression in matrix notation.
- calculateBeta() - Method in class org.hipparchus.stat.regression.GLSMultipleLinearRegression
-
Calculates beta by GLS.
- calculateBeta() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Calculates the regression coefficients using OLS.
- calculateBetaVariance() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Calculates the beta variance of multiple linear regression in matrix
notation.
- calculateBetaVariance() - Method in class org.hipparchus.stat.regression.GLSMultipleLinearRegression
-
Calculates the variance on the beta.
- calculateBetaVariance() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Calculates the variance-covariance matrix of the regression parameters.
- calculateErrorVariance() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Calculates the variance of the error term.
- calculateErrorVariance() - Method in class org.hipparchus.stat.regression.GLSMultipleLinearRegression
-
Calculates the estimated variance of the error term using the formula
- calculateHat() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Compute the "hat" matrix.
- calculateNumericalMean() - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
- calculateNumericalVariance() - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
- calculateResiduals() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Calculates the residuals of multiple linear regression in matrix
notation.
- calculateResidualSumOfSquares() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Returns the sum of squared residuals.
- calculateRSquared() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Returns the R-Squared statistic, defined by the formula
- calculateTotalSumOfSquares() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Returns the sum of squared deviations of Y from its mean.
- calculateYVariance() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Calculates the variance of the y values.
- 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, ...).
- 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
-
- 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.
- CardanEulerSingularityException - Exception in org.hipparchus.migration.geometry.euclidean
-
- 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 class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Cubic root.
- cbrt() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Cubic root.
- cbrt() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Cubic root.
- cbrt() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Cubic root.
- cbrt() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Cubic root.
- cbrt() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Cubic root.
- cbrt() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Cubic root.
- cbrt() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Cubic root.
- cbrt() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Cubic root.
- Cbrt - Class in org.hipparchus.analysis.function
-
Cube root function.
- Cbrt() - Constructor for class org.hipparchus.analysis.function.Cbrt
-
- 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.dfp.Dfp
-
Cubic root.
- cbrt() - Method in class org.hipparchus.util.Decimal64
-
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() - Method in class org.hipparchus.util.FieldTuple
-
Cubic root.
- cbrt() - Method in class org.hipparchus.util.Tuple
-
Cubic root.
- 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 class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Get the smallest whole number larger than instance.
- Ceil - Class in org.hipparchus.analysis.function
-
ceil
function.
- Ceil() - Constructor for class org.hipparchus.analysis.function.Ceil
-
- 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.Decimal64
-
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() - 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.
- CentroidCluster<T extends Clusterable> - Class in org.hipparchus.clustering
-
A Cluster used by centroid-based clustering algorithms.
- CentroidCluster(Clusterable) - Constructor for class org.hipparchus.clustering.CentroidCluster
-
Build a cluster centered at a specified point.
- centroidOf(Cluster<T>) - Method in class org.hipparchus.clustering.evaluation.ClusterEvaluator
-
Computes the centroid for a cluster.
- ChebyshevDistance - Class in org.hipparchus.clustering.distance
-
Calculates the L∞ (max of abs) distance between two points.
- ChebyshevDistance() - Constructor for class org.hipparchus.clustering.distance.ChebyshevDistance
-
- checkAdditionCompatible(FieldMatrix<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Check if a matrix is addition compatible with the instance.
- checkAdditionCompatible(AnyMatrix, AnyMatrix) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if matrices are addition compatible.
- checkAndNormalize(double[]) - Static method in class org.hipparchus.distribution.EnumeratedDistribution
-
Checks to make sure that weights is neither null nor empty and contains only non-negative, finite,
non-NaN values and if necessary normalizes it to sum to 1.
- checkBinomial(int, int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Check binomial preconditions.
- checkColumnIndex(int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Check if a column index is valid.
- checkColumnIndex(AnyMatrix, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if a column index is valid.
- checkCompatibility(DSCompiler) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Check rules set compatibility.
- checkContractExpand(double, double) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Checks the expansion factor and the contraction criterion and raises
an exception if the contraction criterion is smaller than the
expansion criterion.
- checkDefinition(RealMatrix) - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Check definition of the decomposition in runtime.
- checkDimension(int, int) - Static method in class org.hipparchus.util.MathUtils
-
Checks that the given dimensions match.
- checkEqualLength(double[], double[], boolean) - Static method in class org.hipparchus.util.MathArrays
-
Check that both arrays have the same length.
- checkEqualLength(double[], double[]) - 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.
- checkEqualLength(T[], T[]) - 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(int[], int[]) - Static method in class org.hipparchus.util.MathArrays
-
Check that both arrays have the same length.
- checker(ConvergenceChecker<LeastSquaresProblem.Evaluation>) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the convergence checker.
- checkerPair(ConvergenceChecker<PointVectorValuePair>) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the convergence checker.
- checkFinite(double) - Static method in class org.hipparchus.util.MathUtils
-
Check that the argument is a real number.
- checkFinite(double[]) - Static method in class org.hipparchus.util.MathUtils
-
Check that all the elements are real numbers.
- checkIndex(int) - Method in class org.hipparchus.linear.RealVector
-
Check if an index is valid.
- checkIndices(int, int) - Method in class org.hipparchus.linear.RealVector
-
Checks that the indices of a subvector are valid.
- checkMatrixIndex(AnyMatrix, int, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if matrix indices are valid.
- checkMultiplicationCompatible(FieldMatrix<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Check if a matrix is multiplication compatible with the instance.
- checkMultiplicationCompatible(AnyMatrix, AnyMatrix) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if matrices are multiplication compatible
- 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, Localizable, Object...) - Static method in class org.hipparchus.util.MathUtils
-
Checks that an object is not null.
- checkNotNull(Object) - Static method in class org.hipparchus.util.MathUtils
-
Checks that an object is not null.
- checkOrder(double[], MathArrays.OrderDirection, boolean, boolean) - Static method in class org.hipparchus.util.MathArrays
-
Check that the given array is sorted.
- checkOrder(double[], MathArrays.OrderDirection, boolean) - Static method in class org.hipparchus.util.MathArrays
-
Check that the given array is sorted.
- checkOrder(double[]) - Static method in class org.hipparchus.util.MathArrays
-
Check that the given array is sorted in strictly increasing order.
- checkOrder(T[], MathArrays.OrderDirection, boolean, boolean) - Static method in class org.hipparchus.util.MathArrays
-
Check that the given array is sorted.
- checkOrder(T[], MathArrays.OrderDirection, 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.
- checkParameters(RealLinearOperator, RealVector, RealVector) - Static method in class org.hipparchus.linear.IterativeLinearSolver
-
Performs all dimension checks on the parameters of
solve
and
solveInPlace
,
and throws an exception if one of the checks fails.
- checkParameters(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Static method in class org.hipparchus.linear.PreconditionedIterativeLinearSolver
-
Performs all dimension checks on the parameters of
solve
and
solveInPlace
,
and throws an exception if one of the checks fails.
- checkPoint(double, double) - Method in class org.hipparchus.geometry.euclidean.oned.Interval
-
Check a point with respect to the interval.
- checkPoint(Vector<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Check a point with respect to the region.
- checkPoint(Point<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Check a point with respect to the region.
- checkPoint(BSPTree<S>, Vector<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Check a point with respect to the region starting at a given node.
- checkPoint(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(Point<S>) - Method in interface org.hipparchus.geometry.partitioning.Region
-
Check a point with respect to the region.
- checkPoint(double) - Method in class org.hipparchus.geometry.spherical.oned.Arc
-
Check a point with respect to the arc.
- checkPositive(double[]) - Static method in class org.hipparchus.util.MathArrays
-
Check that all entries of the input array are strictly positive.
- checkRangeInclusive(long, long, long) - Static method in class org.hipparchus.util.MathUtils
-
Checks that the given value is strictly within the range [lo, hi].
- checkRangeInclusive(double, double, double) - 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, int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Check if submatrix ranges indices are valid.
- checkSubMatrixIndex(int[], int[]) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
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.
- checkSubMatrixIndex(AnyMatrix, int[], int[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if submatrix ranges indices are valid.
- checkSubtractionCompatible(FieldMatrix<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Check if a matrix is subtraction compatible with the instance.
- checkSubtractionCompatible(AnyMatrix, AnyMatrix) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if matrices are subtraction compatible
- 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
-
- checkTolerance(double) - Static method in class org.hipparchus.geometry.spherical.twod.Sphere2D
-
- checkVectorDimensions(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Check if instance and specified vectors have the same dimension.
- checkVectorDimensions(int) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Check if instance dimension is equal to some expected value.
- checkVectorDimensions(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Check if instance and specified vectors have the same dimension.
- checkVectorDimensions(int) - Method in class org.hipparchus.linear.ArrayRealVector
-
Check if instance dimension is equal to some expected value.
- checkVectorDimensions(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Check if instance and specified vectors have the same dimension.
- 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.
- chiSquare(double[], long[]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
- chiSquare(long[][]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
- chiSquare(double[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- chiSquare(long[][]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- chiSquareDataSetsComparison(long[], long[]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
- chiSquareDataSetsComparison(long[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- ChiSquaredDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the chi-squared distribution.
- ChiSquaredDistribution(double) - Constructor for class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
Create a Chi-Squared distribution with the given degrees of freedom.
- ChiSquaredDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
Create a Chi-Squared distribution with the given degrees of freedom and
inverse cumulative probability accuracy.
- ChiSquareTest - Class in org.hipparchus.stat.inference
-
Implements Chi-Square test statistics.
- ChiSquareTest() - Constructor for class org.hipparchus.stat.inference.ChiSquareTest
-
- chiSquareTest(double[], long[]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
- 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(long[][]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
- 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(double[], long[], double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- chiSquareTest(double[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- chiSquareTest(long[][], double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- chiSquareTest(long[][]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- chiSquareTestDataSetsComparison(long[], long[]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
Returns the
observed significance level, or
p-value, associated with a Chi-Square two sample test comparing
bin frequency counts in
observed1
and
observed2
.
- chiSquareTestDataSetsComparison(long[], long[], double) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
Performs a Chi-Square two sample test comparing two binned data
sets.
- chiSquareTestDataSetsComparison(long[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- chiSquareTestDataSetsComparison(long[], long[], double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- 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(S2Point, S2Point, double) - Constructor for class org.hipparchus.geometry.spherical.twod.Circle
-
Build a great circle from two non-aligned points.
- Circle(Circle) - Constructor for class org.hipparchus.geometry.spherical.twod.Circle
-
Copy constructor.
- 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.
- clearEventHandlers() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearEventHandlers() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearEventHandlers() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearEventHandlers() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearIEEEFlags() - Method in class org.hipparchus.dfp.DfpField
-
Clears the IEEE 854 status flags.
- clearStepHandlers() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Remove all the step handlers that have been added to the integrator.
- clearStepHandlers() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Remove all the step handlers that have been added to the integrator.
- clearStepHandlers() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Remove all the step handlers that have been added to the integrator.
- clearStepHandlers() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Remove all the step handlers that have been added to the integrator.
- 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<T extends Clusterable> - Class in org.hipparchus.clustering
-
- Cluster() - Constructor for class org.hipparchus.clustering.Cluster
-
Build a cluster centered at a specified point.
- 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.
- Clusterable - Interface in org.hipparchus.clustering
-
Interface for n-dimensional points that can be clustered together.
- ClusterAlgorithmComparison - Class in org.hipparchus.samples
-
Plots clustering results for various algorithms and datasets.
- ClusterAlgorithmComparison() - Constructor for class org.hipparchus.samples.ClusterAlgorithmComparison
-
- ClusterAlgorithmComparison.ClusterPlot - Class in org.hipparchus.samples
-
- ClusterAlgorithmComparison.Display - Class in org.hipparchus.samples
-
- Clusterer<T extends Clusterable> - Class in org.hipparchus.clustering
-
Base class for clustering algorithms.
- Clusterer(DistanceMeasure) - Constructor for class org.hipparchus.clustering.Clusterer
-
- ClusterEvaluator<T extends Clusterable> - Class in org.hipparchus.clustering.evaluation
-
Base class for cluster evaluation methods.
- ClusterEvaluator() - Constructor for class org.hipparchus.clustering.evaluation.ClusterEvaluator
-
- ClusterEvaluator(DistanceMeasure) - Constructor for class org.hipparchus.clustering.evaluation.ClusterEvaluator
-
Creates a new cluster evaluator with the given distance measure.
- ClusterPlot(List<? extends Cluster<DoublePoint>>, long) - Constructor for class org.hipparchus.samples.ClusterAlgorithmComparison.ClusterPlot
-
- CMAESOptimizer - Class in org.hipparchus.optim.nonlinear.scalar.noderiv
-
An implementation of the active Covariance Matrix Adaptation Evolution Strategy (CMA-ES)
for non-linear, non-convex, non-smooth, global function minimization.
- CMAESOptimizer(int, double, boolean, int, int, RandomGenerator, boolean, ConvergenceChecker<PointValuePair>) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
- CMAESOptimizer.PopulationSize - Class in org.hipparchus.optim.nonlinear.scalar.noderiv
-
Population size.
- CMAESOptimizer.Sigma - Class in org.hipparchus.optim.nonlinear.scalar.noderiv
-
Input sigma values.
- 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, UnivariateFunction, double) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Returns a MultivariateFunction h(x[]) defined by
- collector(BivariateFunction, double) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Returns a MultivariateFunction h(x[]) defined by
- Combinations - Class in org.hipparchus.util
-
Utility to create combinations (n, k)
of k
elements
in a set of n
elements.
- Combinations(int, int) - Constructor for class org.hipparchus.util.Combinations
-
Creates an instance whose range is the k-element subsets of
{0, ..., n - 1} represented as int[]
arrays.
- combinationsIterator(int, int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Returns an iterator whose range is the k-element subsets of {0, ..., n - 1}
represented as int[]
arrays.
- CombinatoricsUtils - Class in org.hipparchus.util
-
Combinatorial utilities.
- CombinatoricsUtils.FactorialLog - Class in org.hipparchus.util
-
Class for computing the natural logarithm of the factorial of n
.
- combine(BivariateFunction, UnivariateFunction, UnivariateFunction) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Returns the univariate function
h(x) = combiner(f(x), g(x)).
- combine(double, double, RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Returns a new vector representing a * this + b * y
, the linear
combination of this
and y
.
- combine(double, double, RealVector) - Method in class org.hipparchus.linear.RealVector
-
Returns a new vector representing a * this + b * y
, the linear
combination of this
and y
.
- combineToSelf(double, double, RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Updates this
with the linear combination of this
and
y
.
- combineToSelf(double, double, RealVector) - Method in class org.hipparchus.linear.RealVector
-
Updates this
with the linear combination of this
and
y
.
- comparator() - Method in class org.hipparchus.util.Combinations
-
Defines a lexicographic ordering of combinations.
- compare(Complex, Complex) - Method in class org.hipparchus.complex.ComplexComparator
-
Compare two complex numbers, using real ordering as the primary sort order and
imaginary ordering as the secondary sort order.
- compareTo(BigFraction) - Method in class org.hipparchus.fraction.BigFraction
-
Compares this object to another based on size.
- compareTo(Fraction) - Method in class org.hipparchus.fraction.Fraction
-
Compares this object to another based on size.
- compareTo(BigReal) - Method in class org.hipparchus.util.BigReal
- compareTo(Decimal64) - Method in class org.hipparchus.util.Decimal64
-
The current implementation returns the same value as
new Double(this.doubleValue()).compareTo(new
Double(o.doubleValue()))
- 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.
- 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.
- ComplexComparator - Class in org.hipparchus.complex
-
Comparator for Complex Numbers.
- ComplexComparator() - Constructor for class org.hipparchus.complex.ComplexComparator
-
- ComplexEigenDecomposition - Class in org.hipparchus.linear
-
Given a matrix A, it computes a complex eigen decomposition 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(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.
- 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.
- ComplexODEConverter - Class in org.hipparchus.ode
-
- ComplexODEConverter() - Constructor for class org.hipparchus.ode.ComplexODEConverter
-
- 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[], int, double[], double[], 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[], int, double[], T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute composition of a derivative structure by a function.
- compose(T...) - 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.FieldDerivativeStructure
-
Compute composition of the instance by a univariate 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.
- 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(UnivariateFunction...) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Composes functions.
- compose(UnivariateDifferentiableFunction...) - 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.
- 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(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(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(RealMatrix) - Method in class org.hipparchus.stat.correlation.PearsonsCorrelation
-
- computeCorrelationMatrix(double[][]) - Method in class org.hipparchus.stat.correlation.PearsonsCorrelation
-
Computes the correlation matrix for the columns of the
input rectangular array.
- computeCorrelationMatrix(RealMatrix) - Method in class org.hipparchus.stat.correlation.SpearmansCorrelation
-
Computes the Spearman's rank correlation matrix for the columns of the
input matrix.
- 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.
- computeCovarianceMatrix(RealMatrix, boolean) - Method in class org.hipparchus.stat.correlation.Covariance
-
Compute a covariance matrix from a matrix 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(double[][], boolean) - Method in class org.hipparchus.stat.correlation.Covariance
-
Compute a covariance matrix from a rectangular array whose columns represent covariates.
- computeCovarianceMatrix(double[][]) - Method in class org.hipparchus.stat.correlation.Covariance
-
Create a covariance matrix from a rectangular array 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[], 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[], double[]) - Method in interface org.hipparchus.migration.ode.SecondaryEquations
-
Deprecated.
Compute the derivatives related to the secondary state parameters.
- computeDerivatives(T, T[]) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Compute the derivatives and check the number of evaluations.
- computeDerivatives(double, double[]) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Compute the derivatives and check the number of evaluations.
- 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(double, double[]) - Method in class org.hipparchus.ode.ExpandableODE
-
Get the current time derivative of the complete state vector.
- 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.
- 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[], double[]) - Method in interface org.hipparchus.ode.SecondaryODE
-
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(FieldEquationsMapper<T>, T, T, T, T) - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Compute the state and derivatives at the interpolated time.
- computeInterpolatedStateAndDerivatives(EquationsMapper, double, double, double, double) - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
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(T) - Method in class org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Compute the objective function value.
- 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.nonlinear.scalar.MultivariateOptimizer
-
Computes the objective function value.
- computeObjectiveValue(double) - Method in class org.hipparchus.optim.univariate.UnivariateOptimizer
-
Computes the objective function value.
- computeObjectiveValueAndDerivative(double) - Method in class org.hipparchus.analysis.solvers.AbstractUnivariateDifferentiableSolver
-
Compute the objective function value.
- computeParameterJacobian(double, double[], double[], String) - Method in interface org.hipparchus.migration.ode.ParameterJacobianProvider
-
Deprecated.
Compute the Jacobian matrix of ODE with respect to one parameter.
- computeParameterJacobian(double, double[], double[], String, double[]) - 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.
- 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[], 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.
- 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
-
- ConjugateGradient(int, double, boolean) - Constructor for class org.hipparchus.linear.ConjugateGradient
-
- ConjugateGradient(IterationManager, double, boolean) - Constructor for class org.hipparchus.linear.ConjugateGradient
-
- constant(double) - Method in class org.hipparchus.analysis.differentiation.DSFactory
-
- constant(double) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
- constant(T) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
- constant(int, T) - Static method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Build an instance corresponding to a constant value.
- constant(int, double) - Static method in class org.hipparchus.analysis.differentiation.Gradient
-
Build an instance corresponding to a constant value.
- Constant - Class in org.hipparchus.analysis.function
-
Constant function.
- Constant(double) - Constructor for class org.hipparchus.analysis.function.Constant
-
- ConstantRealDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the constant real distribution.
- ConstantRealDistribution(double) - Constructor for class org.hipparchus.distribution.continuous.ConstantRealDistribution
-
Create a constant real distribution with the given value.
- 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.
- 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.
- containsKey(int) - Method in class org.hipparchus.util.OpenIntToDoubleHashMap
-
Check if a value is associated with a key.
- containsKey(int) - Method in class org.hipparchus.util.OpenIntToFieldHashMap
-
Check if a value is associated with a key.
- 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
-
- ContinuousOutputModel() - Constructor for class org.hipparchus.migration.ode.ContinuousOutputModel
-
Deprecated.
- contract() - Method in class org.hipparchus.util.ResizableDoubleArray
-
Contracts the storage array to the (size of the element set) + 1 - to avoid
a zero length array.
- 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, LeastSquaresProblem.Evaluation, LeastSquaresProblem.Evaluation) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.EvaluationRmsChecker
-
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.
- 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.
- 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
-
- ConvergenceCheckerAndMultiplexer(List<ConvergenceChecker<P>>) - Constructor for class org.hipparchus.optim.ConvergenceCheckerAndMultiplexer
-
Simple constructor.
- ConvergenceCheckerOrMultiplexer<P> - Class in org.hipparchus.optim
-
- ConvergenceCheckerOrMultiplexer(List<ConvergenceChecker<P>>) - Constructor for class org.hipparchus.optim.ConvergenceCheckerOrMultiplexer
-
Simple constructor.
- ConvergenceException - Exception in org.hipparchus.migration.exception
-
- ConvergenceException() - Constructor for exception org.hipparchus.migration.exception.ConvergenceException
-
Deprecated.
Construct the exception.
- ConvergenceException(Localizable, Object...) - Constructor for exception org.hipparchus.migration.exception.ConvergenceException
-
Deprecated.
Construct the exception with a specific context and arguments.
- 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
-
- 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(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.
- copy(double[][]) - Method in class org.hipparchus.ode.ODEState
-
Copy a two-dimensions array.
- 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.
- 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(DerivativeStructure) - 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.DerivativeStructure
-
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(double) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
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(T) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
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(double) - 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(FieldUnivariateDerivative1<T>) - 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.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(FieldUnivariateDerivative2<T>) - 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.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(double) - 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(double) - 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(double) - 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(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
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(double) - Method in interface org.hipparchus.CalculusFieldElement
-
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(double) - 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(double) - Method in class org.hipparchus.complex.FieldComplex
-
Returns the instance with the sign of the argument.
- 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(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
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(Decimal64) - Method in class org.hipparchus.util.Decimal64
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class org.hipparchus.util.Decimal64
-
Returns the instance with the sign of the argument.
- copySign(double, 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(T, T) - Static method in class org.hipparchus.util.FastMath
-
Returns the first argument with the sign of the second argument.
- copySign(T, double) - Static method in class org.hipparchus.util.FastMath
-
Returns the first argument with the sign of the second argument.
- copySign(FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
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(byte, byte) - 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(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(Tuple) - Method in class org.hipparchus.util.Tuple
-
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.
- copySubMatrix(int, int, int, int, T[][]) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Copy a submatrix.
- copySubMatrix(int[], int[], T[][]) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Copy a submatrix.
- copySubMatrix(int, int, int, int, double[][]) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Copy a submatrix.
- copySubMatrix(int[], int[], double[][]) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Copy a submatrix.
- copySubMatrix(int, int, int, int, T[][]) - Method in interface org.hipparchus.linear.FieldMatrix
-
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 interface org.hipparchus.linear.RealMatrix
-
Copy a submatrix.
- copySubMatrix(int[], int[], double[][]) - Method in interface org.hipparchus.linear.RealMatrix
-
Copy a submatrix.
- correct(T, RealMatrix, RealVector, RealMatrix, RealMatrix) - Method in class org.hipparchus.filtering.kalman.AbstractKalmanFilter
-
Perform correction step.
- CorrelatedRandomVectorGenerator - Class in org.hipparchus.random
-
- CorrelatedRandomVectorGenerator(double[], RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.hipparchus.random.CorrelatedRandomVectorGenerator
-
Builds a correlated random vector generator from its mean
vector and covariance matrix.
- CorrelatedRandomVectorGenerator(RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.hipparchus.random.CorrelatedRandomVectorGenerator
-
Builds a null mean random correlated vector generator from its
covariance matrix.
- correlation(double[], double[]) - Method in class org.hipparchus.stat.correlation.KendallsCorrelation
-
Computes the Kendall's Tau rank correlation coefficient between the two arrays.
- correlation(double[], double[]) - Method in class org.hipparchus.stat.correlation.PearsonsCorrelation
-
Computes the Pearson's product-moment correlation coefficient between two arrays.
- correlation(double[], double[]) - Method in class org.hipparchus.stat.correlation.SpearmansCorrelation
-
Computes the Spearman's rank correlation coefficient between the two arrays.
- cos() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Cosine operation.
- cos(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute cosine of a derivative structure.
- cos(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute cosine of a derivative structure.
- cos() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Cosine operation.
- cos() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Cosine operation.
- cos() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Cosine operation.
- cos() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Cosine operation.
- cos() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Cosine operation.
- cos() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Cosine operation.
- cos() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Cosine operation.
- cos() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Cosine operation.
- Cos - Class in org.hipparchus.analysis.function
-
Cosine function.
- Cos() - Constructor for class org.hipparchus.analysis.function.Cos
-
- 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(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
computes the cosine of the argument.
- cos() - Method in class org.hipparchus.util.Decimal64
-
Cosine operation.
- cos(double) - Static method in class org.hipparchus.util.FastMath
-
Cosine function.
- cos(T) - Static method in class org.hipparchus.util.FastMath
-
Cosine function.
- 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.
- cosAngle(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Calculates the cosine of the angle between two vectors.
- cosh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Hyperbolic cosine operation.
- cosh(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute hyperbolic cosine of a derivative structure.
- cosh(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute hyperbolic cosine of a derivative structure.
- cosh() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.analysis.differentiation.Gradient
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Hyperbolic cosine operation.
- Cosh - Class in org.hipparchus.analysis.function
-
Hyperbolic cosine function.
- Cosh() - Constructor for class org.hipparchus.analysis.function.Cosh
-
- cosh() - Method in interface org.hipparchus.CalculusFieldElement
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.complex.Complex
-
- cosh() - Method in class org.hipparchus.complex.FieldComplex
-
- cosh() - Method in class org.hipparchus.dfp.Dfp
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.util.Decimal64
-
Hyperbolic cosine operation.
- cosh(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the hyperbolic cosine of a number.
- cosh(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the hyperbolic cosine of a number.
- 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.
- 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 - 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[][], boolean) - Constructor for class org.hipparchus.stat.correlation.Covariance
-
Create a Covariance matrix from a rectangular array
whose columns represent covariates.
- Covariance(double[][]) - Constructor for class org.hipparchus.stat.correlation.Covariance
-
Create a Covariance matrix from a rectangular array
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(RealMatrix) - Constructor for class org.hipparchus.stat.correlation.Covariance
-
Create a covariance matrix from a matrix whose columns
represent covariates.
- covariance(double[], double[], boolean) - Method in class org.hipparchus.stat.correlation.Covariance
-
Computes the covariance between the two arrays.
- covariance(double[], double[]) - Method in class org.hipparchus.stat.correlation.Covariance
-
Computes the covariance between the two arrays, using the bias-corrected
formula.
- 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(int) - Static method in class org.hipparchus.fitting.PolynomialCurveFitter
-
Creates a default curve fitter.
- 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(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(MultivariateJacobianFunction, RealVector, RealVector, RealMatrix, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int, boolean, ParameterValidator) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
- create(MultivariateJacobianFunction, RealVector, RealVector, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
- create(MultivariateJacobianFunction, RealVector, RealVector, RealMatrix, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
- create(MultivariateVectorFunction, MultivariateMatrixFunction, double[], double[], RealMatrix, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
- create() - Static method in class org.hipparchus.util.CombinatoricsUtils.FactorialLog
-
Creates an instance with no precomputed values.
- create(K, V) - Static method in class org.hipparchus.util.Pair
-
- createBlocksLayout(Field<T>, int, int) - Static method in class org.hipparchus.linear.BlockFieldMatrix
-
Create a data array in blocks layout.
- createBlocksLayout(int, int) - Static method in class org.hipparchus.linear.BlockRealMatrix
-
Create a data array in blocks layout.
- createCanvas() - Static method in class org.hipparchus.samples.geometry.GeometryExample
-
- createChart(String, int, int, StyleManager.LegendPosition) - Static method in class org.hipparchus.samples.IntegerDistributionComparison
-
- createChart(String, int, int, StyleManager.LegendPosition) - Static method in class org.hipparchus.samples.RealDistributionComparison
-
- createChebyshevPolynomial(int) - Static method in class org.hipparchus.analysis.polynomials.PolynomialsUtils
-
Create a Chebyshev polynomial of the first kind.
- createCircle(int) - Static method in class org.hipparchus.samples.geometry.GeometryExample
-
- createColumnFieldMatrix(T[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Creates a column
FieldMatrix
using the data from the input
array.
- createColumnRealMatrix(double[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Creates a column
RealMatrix
using the data from the input
array.
- createComplex(double, double) - Method in class org.hipparchus.complex.Complex
-
Create a complex number given the real and imaginary parts.
- 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
-
- createComponent(String, int, int, String[], RealDistribution...) - Static method in class org.hipparchus.samples.RealDistributionComparison
-
- createConstant(double) - Static method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Factory method creating a constant.
- createCross() - Static method in class org.hipparchus.samples.geometry.GeometryExample
-
- createFieldDiagonalMatrix(T[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Returns a diagonal matrix with specified elements.
- createFieldIdentityMatrix(Field<T>, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
Returns dimension x dimension
identity matrix.
- createFieldMatrix(Field<T>, int, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
- createFieldMatrix(T[][]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Returns a
FieldMatrix
whose entries are the the values in the
the input array.
- createFieldVector(T[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Creates a
FieldVector
using the data from the input array.
- createFieldVector(Field<T>, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
- 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, T[][], FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
-
Create an interpolator.
- createInterpolator(boolean, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaIntegrator
-
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, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
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, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
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, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
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, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.EulerIntegrator
-
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, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.GillIntegrator
-
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, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.HighamHall54Integrator
-
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, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.LutherIntegrator
-
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, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.MidpointIntegrator
-
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, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.RungeKuttaIntegrator
-
Create an interpolator.
- createInterpolator(boolean, T[][], FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.ThreeEighthesFieldIntegrator
-
Create an interpolator.
- createInterpolator(boolean, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.ThreeEighthesIntegrator
-
Create an interpolator.
- createJacobiPolynomial(int, int, int) - Static method in class org.hipparchus.analysis.polynomials.PolynomialsUtils
-
Create a Jacobi polynomial.
- createLaguerrePolynomial(int) - Static method in class org.hipparchus.analysis.polynomials.PolynomialsUtils
-
Create a Laguerre polynomial.
- createLegendrePolynomial(int) - Static method in class org.hipparchus.analysis.polynomials.PolynomialsUtils
-
Create a Legendre polynomial.
- createMatrix(int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Create a new RealMatrix of the same type as the instance with the
supplied
row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Create a new RealMatrix of the same type as the instance with the
supplied
row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Create a new RealMatrix of the same type as the instance with the
supplied
row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Create a new RealMatrix of the same type as the instance with the
supplied
row and column dimensions.
- createMatrix(int, int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Create a new RealMatrix of the same type as the instance with the
supplied
row and column dimensions.
- createMatrix(int, int) - Method in interface org.hipparchus.linear.RealMatrix
-
Create a new RealMatrix of the same type as the instance with the
supplied
row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.SparseFieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createRandomPoints(int) - Static method in class org.hipparchus.samples.geometry.GeometryExample
-
- createRealDiagonalMatrix(double[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Returns a diagonal matrix with specified elements.
- createRealIdentityMatrix(int) - Static method in class org.hipparchus.linear.MatrixUtils
-
Returns dimension x dimension
identity matrix.
- createRealImaginaryArray(Complex[]) - Static method in class org.hipparchus.transform.TransformUtils
-
Builds a new two dimensional array of
double
filled with the real
and imaginary parts of the specified
Complex
numbers.
- createRealMatrix(int, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
- createRealMatrix(double[][]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Returns a
RealMatrix
whose entries are the the values in the
the input array.
- createRealVector(double[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Creates a
RealVector
using the data from the input array.
- createRealVector(int) - Static method in class org.hipparchus.linear.MatrixUtils
-
- createRegion() - Method in class org.hipparchus.geometry.euclidean.twod.hull.ConvexHull2D
-
Returns a new region that is enclosed by the convex hull.
- createRegion() - Method in interface org.hipparchus.geometry.hull.ConvexHull
-
Returns a new region that is enclosed by the convex hull.
- createRowFieldMatrix(T[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Create a row
FieldMatrix
using the data from the input
array.
- createRowRealMatrix(double[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Create a row
RealMatrix
using the data from the input
array.
- createVariable(int, double) - Static method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Factory method creating an independent variable.
- crossProduct(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the cross-product of the instance with another vector.
- crossProduct(Vector3D) - 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, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the cross-product of two vectors.
- crossProduct(Vector<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the cross-product of the instance with another vector.
- 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.
- 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.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.BetaDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.CauchyDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.ConstantRealDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.ExponentialDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.FDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.GammaDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.GumbelDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.LaplaceDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.LevyDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.LogisticDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.LogNormalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.NakagamiDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.NormalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.ParetoDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.TDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.TriangularDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.UniformRealDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.WeibullDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.BinomialDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.GeometricDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.PascalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.PoissonDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.UniformIntegerDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in interface org.hipparchus.distribution.IntegerDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in interface org.hipparchus.distribution.RealDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- 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).
- Decimal64 - Class in org.hipparchus.util
-
This class wraps a double
value in an object.
- Decimal64(double) - Constructor for class org.hipparchus.util.Decimal64
-
Creates a new instance of this class.
- Decimal64Field - Class in org.hipparchus.util
-
The field of double precision floating-point numbers.
- decompose(RealMatrix) - Method in class org.hipparchus.linear.CholeskyDecomposer
-
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.
- 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(double[][]) - Method in class org.hipparchus.linear.QRDecomposition
-
Decompose matrix.
- decompose(double[][]) - Method in class org.hipparchus.linear.RRQRDecomposition
-
Decompose matrix.
- decompose(RealMatrix) - Method in class org.hipparchus.linear.SingularValueDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- DecompositionSolver - Interface in org.hipparchus.linear
-
Interface handling decomposition algorithms that can solve A × X = B.
- 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_BANDWIDTH - Static variable in class org.hipparchus.analysis.interpolation.LoessInterpolator
-
Default value of the bandwidth parameter.
- DEFAULT_BIN_COUNT - Static variable in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Default bin count
- 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_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.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_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
-
- 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_LOW_EXP - Static variable in class org.hipparchus.util.RyuDouble
-
Default low switch level to scientific notation.
- 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_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_NAN_STRATEGY - Static variable in class org.hipparchus.stat.ranking.NaturalRanking
-
default NaN strategy
- DEFAULT_PREFIX - Static variable in class org.hipparchus.geometry.VectorFormat
-
The default prefix: "{".
- 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_ROBUSTNESS_ITERS - Static variable in class org.hipparchus.analysis.interpolation.LoessInterpolator
-
Default value of the number of robustness iterations.
- DEFAULT_SEPARATOR - Static variable in class org.hipparchus.geometry.VectorFormat
-
The default separator: ", ".
- 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_SUFFIX - Static variable in class org.hipparchus.geometry.VectorFormat
-
The default suffix: "}".
- DEFAULT_TIES_STRATEGY - Static variable in class org.hipparchus.stat.ranking.NaturalRanking
-
default ties strategy
- 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
-
- DefaultFieldMatrixChangingVisitor(T) - Constructor for class org.hipparchus.linear.DefaultFieldMatrixChangingVisitor
-
Build a new instance.
- DefaultFieldMatrixPreservingVisitor<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
- DefaultFieldMatrixPreservingVisitor(T) - Constructor for class org.hipparchus.linear.DefaultFieldMatrixPreservingVisitor
-
Build a new instance.
- DefaultIterativeLinearSolverEvent - Class in org.hipparchus.linear
-
- DefaultIterativeLinearSolverEvent(Object, int, RealVector, RealVector, RealVector, double) - Constructor for class org.hipparchus.linear.DefaultIterativeLinearSolverEvent
-
Creates a new instance of this class.
- DefaultIterativeLinearSolverEvent(Object, int, RealVector, RealVector, double) - Constructor for class org.hipparchus.linear.DefaultIterativeLinearSolverEvent
-
Creates a new instance of this class.
- DefaultRealMatrixChangingVisitor - Class in org.hipparchus.linear
-
- DefaultRealMatrixChangingVisitor() - Constructor for class org.hipparchus.linear.DefaultRealMatrixChangingVisitor
-
- DefaultRealMatrixPreservingVisitor - Class in org.hipparchus.linear
-
- DefaultRealMatrixPreservingVisitor() - Constructor for class org.hipparchus.linear.DefaultRealMatrixPreservingVisitor
-
- 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.
- delegate() - Method in class org.hipparchus.random.RandomDataGenerator
-
Returns the backing delegate instance that methods are forwarded to.
- 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 returns P(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 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
.
- 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
.
- DependentVectorsHandler - Enum in org.hipparchus.linear
-
- Derivative<T extends CalculusFieldElement<T>> - Interface in org.hipparchus.analysis.differentiation
-
Interface representing both the value and the differentials of a function.
- derivative(UnivariateDifferentiableFunction, int) - Static method in class org.hipparchus.analysis.FunctionUtils
-
- derivative(MultivariateDifferentiableFunction, int[]) - Static method in class org.hipparchus.analysis.FunctionUtils
-
- derivatives(T, int) - Method in class org.hipparchus.analysis.interpolation.FieldHermiteInterpolator
-
Interpolate value and first derivatives at a specified abscissa.
- derivatives(double, int) - Method in class org.hipparchus.analysis.interpolation.HermiteInterpolator
-
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(int) - Constructor for class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Construct a DescriptiveStatistics instance with the specified 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(DescriptiveStatistics) - Constructor for class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Copy constructor.
- deserializeRealMatrix(Object, String, ObjectInputStream) - Static method in class org.hipparchus.linear.MatrixUtils
-
- deserializeRealVector(Object, String, ObjectInputStream) - Static method in class org.hipparchus.linear.MatrixUtils
-
- 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(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, 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, double) - Constructor for class org.hipparchus.dfp.Dfp
-
Create an instance from a double value.
- Dfp(Dfp) - Constructor for class org.hipparchus.dfp.Dfp
-
Copy constructor.
- Dfp(DfpField, String) - Constructor for class org.hipparchus.dfp.Dfp
-
Create an instance from a String representation.
- Dfp(DfpField, byte, byte) - Constructor for class org.hipparchus.dfp.Dfp
-
Creates an instance with a non-finite value.
- 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(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, 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, double) - Constructor for class org.hipparchus.dfp.DfpDec
-
Create an instance from a double value.
- DfpDec(Dfp) - Constructor for class org.hipparchus.dfp.DfpDec
-
Copy constructor.
- DfpDec(DfpField, String) - Constructor for class org.hipparchus.dfp.DfpDec
-
Create an instance from a String representation.
- DfpDec(DfpField, byte, byte) - Constructor for class org.hipparchus.dfp.DfpDec
-
Creates an instance with a non-finite value.
- 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(int) - Constructor for class org.hipparchus.linear.DiagonalMatrix
-
Creates a matrix with the supplied dimension.
- 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.
- 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.
- differentiate(UnivariateFunction) - Method in class org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
- differentiate(UnivariateVectorFunction) - Method in class org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
- differentiate(UnivariateMatrixFunction) - Method in class org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
- differentiate(UnivariateFunction) - Method in interface org.hipparchus.analysis.differentiation.UnivariateFunctionDifferentiator
-
- differentiate(UnivariateMatrixFunction) - Method in interface org.hipparchus.analysis.differentiation.UnivariateMatrixFunctionDifferentiator
-
- differentiate(UnivariateVectorFunction) - Method in interface org.hipparchus.analysis.differentiation.UnivariateVectorFunctionDifferentiator
-
- differentiate(T[]) - Static method in class org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Returns the coefficients of the derivative of the polynomial with the given coefficients.
- differentiate(double[]) - Static method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
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.
- DimensionMismatchException - Exception in org.hipparchus.migration.exception
-
- DimensionMismatchException(Localizable, int, int) - Constructor for exception org.hipparchus.migration.exception.DimensionMismatchException
-
Deprecated.
Construct an exception from the mismatched dimensions.
- DimensionMismatchException(int, int) - Constructor for exception org.hipparchus.migration.exception.DimensionMismatchException
-
Deprecated.
Construct an exception from the mismatched dimensions.
- 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.
- 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
-
- Display() - Constructor for class org.hipparchus.samples.ClusterAlgorithmComparison.Display
-
- Display() - Constructor for class org.hipparchus.samples.clustering.ImageClusteringExample.Display
-
- Display() - Constructor for class org.hipparchus.samples.geometry.GeometryExample.Display
-
- Display() - Constructor for class org.hipparchus.samples.IntegerDistributionComparison.Display
-
- Display() - Constructor for class org.hipparchus.samples.LowDiscrepancyGeneratorComparison.Display
-
- Display() - Constructor for class org.hipparchus.samples.RealDistributionComparison.Display
-
- distance(Clusterable, Clusterable) - Method in class org.hipparchus.clustering.Clusterer
-
- distance(Clusterable, Clusterable) - Method in class org.hipparchus.clustering.evaluation.ClusterEvaluator
-
- distance(Point<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the distance between the instance and another point.
- 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(FieldVector3D<T>) - 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.FieldLine
-
Compute the distance between the instance and a point.
- 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.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.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(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) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Compute the distance between the instance and a point.
- 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(Point<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between the instance and another point.
- 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(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(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, 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) - 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(Point<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between the instance and another point.
- 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<S>) - Method in interface org.hipparchus.geometry.Point
-
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(S1Point, S1Point) - Static method in class org.hipparchus.geometry.spherical.oned.S1Point
-
Compute the distance (angular separation) between two points.
- distance(Point<Sphere2D>) - Method in class org.hipparchus.geometry.spherical.twod.S2Point
-
Compute the distance between the instance and another point.
- distance(S2Point, S2Point) - Static method in class org.hipparchus.geometry.spherical.twod.S2Point
-
Compute the distance (angular separation) between two points.
- 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.
- distance1(Vector<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between the instance and another vector 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(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, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L1 norm.
- distance1(Vector<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(Vector3D, Vector3D) - Static method in class org.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(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(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, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance1(Vector<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between the instance and another vector according to the L1 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<S>) - Method in interface org.hipparchus.geometry.Vector
-
Compute the distance between the instance and another vector according to the L1 norm.
- 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.
- distanceInf(Vector<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(Vector1D, Vector1D) - Static method in class org.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(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(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, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(Vector3D, Vector3D) - Static method in class org.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(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(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, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(Vector2D, Vector2D) - Static method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector<S>) - Method in interface org.hipparchus.geometry.Vector
-
Compute the distance between the instance and another vector according to the L∞ 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.
- DistanceMeasure - Interface in org.hipparchus.clustering.distance
-
Interface for distance measures of n-dimensional vectors.
- distanceSq(Vector<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the square of the distance between the instance and another vector.
- 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(Vector3D) - 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, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the square of the distance between the instance and another vector.
- 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(Vector2D) - 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, FieldVector2D<T>) - Static method in class org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector2D, Vector2D) - Static method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector<S>) - Method in interface org.hipparchus.geometry.Vector
-
Compute the square of the distance between the instance and another vector.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
'÷' operator.
- divide(DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute this ÷ a.
- divide(double[], int, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform division of two derivative structures.
- divide(T[], int, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform division of two derivative structures.
- divide(T) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'÷' operator.
- divide(FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute this ÷ a.
- divide(T) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
'÷' operator.
- divide(FieldGradient<T>) - Method in class org.hipparchus.analysis.differentiation.FieldGradient
-
Compute this ÷ a.
- divide(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'÷' operator.
- divide(FieldUnivariateDerivative1<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute this ÷ a.
- divide(T) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'÷' operator.
- divide(FieldUnivariateDerivative2<T>) - Method in class org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute this ÷ a.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.Gradient
-
'÷' operator.
- 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(double) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
'÷' operator.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
'÷' operator.
- divide(UnivariateDerivative1) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute this ÷ a.
- divide(double) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
'÷' operator.
- divide(UnivariateDerivative2) - Method in class org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute this ÷ a.
- Divide - Class in org.hipparchus.analysis.function
-
Divide the first operand by the second.
- Divide() - Constructor for class org.hipparchus.analysis.function.Divide
-
- divide(double) - Method in interface org.hipparchus.CalculusFieldElement
-
'÷' operator.
- divide(Complex) - Method in class org.hipparchus.complex.Complex
-
Returns a Complex
whose value is
(this / divisor)
.
- divide(double) - Method in class org.hipparchus.complex.Complex
-
Returns a Complex
whose value is (this / divisor)
,
with divisor
interpreted as a real number.
- divide(FieldComplex<T>) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a Complex
whose value is
(this / divisor)
.
- divide(T) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a Complex
whose value is (this / divisor)
,
with divisor
interpreted as a real number.
- divide(double) - Method in class org.hipparchus.complex.FieldComplex
-
Returns a Complex
whose value is (this / divisor)
,
with divisor
interpreted as a real number.
- divide(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Divide this by divisor.
- divide(int) - Method in class org.hipparchus.dfp.Dfp
-
Divide by a single digit less than radix.
- divide(double) - Method in class org.hipparchus.dfp.Dfp
-
'÷' operator.
- divide(T) - Method in interface org.hipparchus.FieldElement
-
Compute this ÷ a.
- divide(BigInteger) - Method in class org.hipparchus.fraction.BigFraction
-
Divide the value of this fraction by the passed BigInteger
,
ie this * 1 / bg
, returning the result in reduced form.
- divide(int) - Method in class org.hipparchus.fraction.BigFraction
-
Divide the value of this fraction by the passed int
, ie
this * 1 / i
, returning the result in reduced form.
- divide(long) - Method in class org.hipparchus.fraction.BigFraction
-
Divide the value of this fraction by the passed long
, ie
this * 1 / l
, returning the result in reduced form.
- divide(BigFraction) - Method in class org.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(int) - Method in class org.hipparchus.fraction.Fraction
-
Divide the fraction by an integer.
- divide(BigReal) - Method in class org.hipparchus.util.BigReal
-
Compute this ÷ a.
- divide(Decimal64) - Method in class org.hipparchus.util.Decimal64
-
Compute this ÷ a.
- divide(double) - Method in class org.hipparchus.util.Decimal64
-
'÷' operator.
- divide(FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Compute this ÷ a.
- divide(double) - Method in class org.hipparchus.util.FieldTuple
-
'÷' operator.
- divide(Tuple) - Method in class org.hipparchus.util.Tuple
-
Compute this ÷ a.
- divide(double) - Method in class org.hipparchus.util.Tuple
-
'÷' operator.
- DividedDifferenceInterpolator - Class in org.hipparchus.analysis.interpolation
-
- DividedDifferenceInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.DividedDifferenceInterpolator
-
- 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(ODEStateAndDerivative) - Method in class org.hipparchus.ode.events.EventState
-
Notify the user's listener of the event.
- doEvent(FieldODEStateAndDerivative<T>) - Method in class org.hipparchus.ode.events.FieldEventState
-
Notify the user's listener of the event.
- 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.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.
- 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, Quaternion) - Static method in class org.hipparchus.complex.Quaternion
-
Computes the dot-product of two quaternions.
- dotProduct(Quaternion) - Method in class org.hipparchus.complex.Quaternion
-
Computes the dot-product of the instance by a quaternion.
- dotProduct(Vector<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the dot-product of the instance and another vector.
- dotProduct(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector3D) - 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, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the dot-product of two vectors.
- dotProduct(Vector<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the dot-product of the instance and another vector.
- 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<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector<S>) - Method in interface org.hipparchus.geometry.Vector
-
Compute the dot-product of the instance and another vector.
- dotProduct(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute the dot product.
- dotProduct(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute the dot product.
- dotProduct(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Compute the dot product of this vector with v
.
- dotProduct(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Compute the dot product.
- dotProduct(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Compute the dot product of this vector with v
.
- dotProduct(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Compute the dot product.
- 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.Decimal64
- 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
-
- 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
-
- 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
-
- 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(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Element-by-element division.
- ebeDivide(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Element-by-element division.
- ebeDivide(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Element-by-element division.
- ebeDivide(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
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.
- ebeDivide(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Element-by-element division.
- 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.
- ebeMultiply(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Element-by-element multiplication.
- ebeMultiply(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Element-by-element multiplication.
- ebeMultiply(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Element-by-element multiplication.
- ebeMultiply(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
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.
- ebeMultiply(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Element-by-element multiplication.
- 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.
- 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.
- EigenDecomposition - Class in org.hipparchus.linear
-
Calculates the eigen decomposition of a real matrix.
- EigenDecomposition(RealMatrix) - Constructor for class org.hipparchus.linear.EigenDecomposition
-
Calculates the eigen decomposition of the given real matrix.
- EigenDecomposition(RealMatrix, double) - Constructor for class org.hipparchus.linear.EigenDecomposition
-
Calculates the eigen decomposition of the given real matrix.
- EigenDecomposition(double[], double[]) - Constructor for class org.hipparchus.linear.EigenDecomposition
-
Calculates the eigen decomposition of the symmetric tridiagonal
matrix.
- EigenDecomposition(double[], double[], double) - Constructor for class org.hipparchus.linear.EigenDecomposition
-
Calculates the eigen decomposition of the symmetric tridiagonal
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.
- 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.
- 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
-
- 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
-
- EnumeratedIntegerDistribution(int[], double[]) - Constructor for class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
Create a discrete distribution using the given probability mass function
definition.
- EnumeratedIntegerDistribution(int[]) - Constructor for class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
Create a discrete integer-valued distribution from the input data.
- EnumeratedRealDistribution - Class in org.hipparchus.distribution.continuous
-
- 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.
- 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.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(Complex, Complex, int) - Static method in class org.hipparchus.complex.Complex
-
Test for the floating-point equality between Complex objects.
- equals(Complex, Complex) - Static method in class org.hipparchus.complex.Complex
-
- 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(Object) - Method in class org.hipparchus.complex.ComplexField
- equals(Object) - Method in class org.hipparchus.complex.FieldComplex
-
Test for equality with another object.
- equals(FieldComplex<T>, FieldComplex<T>, int) - Static method in class org.hipparchus.complex.FieldComplex
-
Test for the floating-point equality between Complex objects.
- equals(FieldComplex<T>, FieldComplex<T>) - Static method in class org.hipparchus.complex.FieldComplex
-
- 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(Object) - Method in class org.hipparchus.complex.FieldComplexField
- equals(Object) - Method in class org.hipparchus.complex.Quaternion
- equals(Quaternion, double) - Method in class org.hipparchus.complex.Quaternion
-
Checks whether this instance is equal to another quaternion
within a given tolerance.
- 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 a
FieldMatrix
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 a
RealMatrix
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 of
StorelessUnivariateStatistic
(the object's class equals this
instance) returning the same values as this for
getResult()
and
getN()
.
- equals(Object) - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns true iff object
is a MultivariateSummaryStatistics
instance and all statistics have the same values as this.
- equals(Object) - Method in class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
Returns true iff o
is a PSquarePercentile
returning the
same values as this for getResult()
and getN()
and also
having equal markers
- equals(Object) - Method in class org.hipparchus.stat.descriptive.StatisticalSummaryValues
-
Returns true iff object
is a
StatisticalSummary
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 a StreamingStatistics
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.Decimal64
- equals(Object) - Method in class org.hipparchus.util.Decimal64Field
- equals(Object) - Method in class org.hipparchus.util.FieldTuple
- equals(float[], float[]) - Static method in class org.hipparchus.util.MathArrays
-
- equals(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
- equals(long[], long[]) - Static method in class org.hipparchus.util.MathArrays
-
Returns true
if both arguments are null
or have same
dimensions and all their elements are equals.
- equals(int[], int[]) - Static method in class org.hipparchus.util.MathArrays
-
Returns true
if both arguments are null
or have same
dimensions and all their elements are equals.
- equals(byte[], byte[]) - Static method in class org.hipparchus.util.MathArrays
-
Returns true
if both arguments are null
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 are null
or have same
dimensions and all their elements are equals.
- equals(double, double) - Static method in class org.hipparchus.util.MathUtils
-
- equals(Object) - Method in class org.hipparchus.util.Pair
-
Compare the specified object with this entry for equality.
- equals(float, float) - Static method in class org.hipparchus.util.Precision
-
- 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(double, double) - Static method in class org.hipparchus.util.Precision
-
- 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(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
- 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(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(double[], double[]) - 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
-
- 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
-
- 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.
- 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.
- EquationsMapper - Class in org.hipparchus.ode
-
Class mapping the part of a complete state or derivative that pertains
to a specific differential equation.
- Erf - Class in org.hipparchus.special
-
This is a utility class that provides computation methods related to the
error functions.
- 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).
- erfc(double) - 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.
- erfInv(double) - 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
- errorEstimation(T[], T, T[], T[], FieldMatrix<T>) - Method in class org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegrator
-
Estimate error.
- errorEstimation(double[], double, double[], double[], RealMatrix) - Method in class org.hipparchus.ode.nonstiff.AdamsBashforthIntegrator
-
Estimate error.
- errorEstimation(T[], T, T[], T[], FieldMatrix<T>) - Method in class org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Estimate error.
- errorEstimation(double[], double, double[], double[], RealMatrix) - Method in class org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Estimate error.
- errorEstimation(T[], T, T[], T[], FieldMatrix<T>) - Method in class org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegrator
-
Estimate error.
- errorEstimation(double[], double, double[], double[], RealMatrix) - Method in class org.hipparchus.ode.nonstiff.AdamsMoultonIntegrator
-
Estimate error.
- 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
- estimate(double[][], int) - Static method in class org.hipparchus.stat.fitting.MultivariateNormalMixtureExpectationMaximization
-
- estimateError(T[][], T[], T[], T) - Method in class org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
-
Compute the error ratio.
- estimateError(double[][], double[], double[], double) - Method in class org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
Compute the error ratio.
- estimateError(T[][], T[], T[], T) - Method in class org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
-
Compute the error ratio.
- estimateError(double[][], double[], double[], double) - Method in class org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
Compute the error ratio.
- estimateError(T[][], T[], T[], T) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Compute the error ratio.
- estimateError(double[][], double[], double[], double) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Compute the error ratio.
- estimateError(T[][], T[], T[], T) - Method in class org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
-
Compute the error ratio.
- estimateError(double[][], double[], double[], double) - Method in class org.hipparchus.ode.nonstiff.HighamHall54Integrator
-
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).
- estimateRegre