- Abs - Class in org.apache.commons.math3.analysis.function
-
Absolute value function.
- Abs() - Constructor for class org.apache.commons.math3.analysis.function.Abs
-
- abs() - Method in class org.apache.commons.math3.complex.Complex
-
Return the absolute value of this complex number.
- abs() - Method in class org.apache.commons.math3.dfp.Dfp
-
Get the absolute value of instance.
- abs() - Method in class org.apache.commons.math3.fraction.BigFraction
-
- abs() - Method in class org.apache.commons.math3.fraction.Fraction
-
Returns the absolute value of this fraction.
- abs(int) - Static method in class org.apache.commons.math3.util.FastMath
-
Absolute value.
- abs(long) - Static method in class org.apache.commons.math3.util.FastMath
-
Absolute value.
- abs(float) - Static method in class org.apache.commons.math3.util.FastMath
-
Absolute value.
- abs(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Absolute value.
- AbstractConvergenceChecker<PAIR> - Class in org.apache.commons.math3.optimization
-
Base class for all convergence checker implementations.
- AbstractConvergenceChecker() - Constructor for class org.apache.commons.math3.optimization.AbstractConvergenceChecker
-
Build an instance with default thresholds.
- AbstractConvergenceChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.AbstractConvergenceChecker
-
Build an instance with a specified thresholds.
- AbstractDifferentiableUnivariateSolver - Class in org.apache.commons.math3.analysis.solvers
-
Provide a default implementation for several functions useful to generic
solvers.
- AbstractDifferentiableUnivariateSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractDifferentiableUnivariateSolver
-
Construct a solver with given absolute accuracy.
- AbstractDifferentiableUnivariateSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractDifferentiableUnivariateSolver
-
Construct a solver with given accuracies.
- AbstractFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
-
Basic implementation of
FieldMatrix
methods regardless of the underlying storage.
- AbstractFieldMatrix() - Constructor for class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Constructor for use with Serializable
- AbstractFieldMatrix(Field<T>) - Constructor for class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Creates a matrix with no data
- AbstractFieldMatrix(Field<T>, int, int) - Constructor for class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Create a new FieldMatrix with the supplied row and column dimensions.
- AbstractFormat - Class in org.apache.commons.math3.fraction
-
- AbstractFormat() - Constructor for class org.apache.commons.math3.fraction.AbstractFormat
-
Create an improper formatting instance with the default number format
for the numerator and denominator.
- AbstractFormat(NumberFormat) - Constructor for class org.apache.commons.math3.fraction.AbstractFormat
-
Create an improper formatting instance with a custom number format for
both the numerator and denominator.
- AbstractFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.fraction.AbstractFormat
-
Create an improper formatting instance with a custom number format for
the numerator and a custom number format for the denominator.
- AbstractIntegerDistribution - Class in org.apache.commons.math3.distribution
-
Base class for integer-valued discrete distributions.
- AbstractIntegerDistribution() - Constructor for class org.apache.commons.math3.distribution.AbstractIntegerDistribution
-
Default constructor.
- AbstractIntegrator - Class in org.apache.commons.math3.ode
-
Base class managing common boilerplate for all integrators.
- AbstractIntegrator(String) - Constructor for class org.apache.commons.math3.ode.AbstractIntegrator
-
Build an instance.
- AbstractIntegrator() - Constructor for class org.apache.commons.math3.ode.AbstractIntegrator
-
Build an instance with a null name.
- AbstractLeastSquaresOptimizer - Class in org.apache.commons.math3.optimization.general
-
Base class for implementing least squares optimizers.
- AbstractLeastSquaresOptimizer() - Constructor for class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
-
Simple constructor with default settings.
- AbstractLeastSquaresOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
-
- AbstractLinearOptimizer - Class in org.apache.commons.math3.optimization.linear
-
Base class for implementing linear optimizers.
- AbstractLinearOptimizer() - Constructor for class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
-
Simple constructor with default settings.
- AbstractListChromosome<T> - Class in org.apache.commons.math3.genetics
-
Chromosome represented by an immutable list of a fixed length.
- AbstractListChromosome(List<T>) - Constructor for class org.apache.commons.math3.genetics.AbstractListChromosome
-
Constructor.
- AbstractListChromosome(T[]) - Constructor for class org.apache.commons.math3.genetics.AbstractListChromosome
-
Constructor.
- AbstractMultipleLinearRegression - Class in org.apache.commons.math3.stat.regression
-
Abstract base class for implementations of MultipleLinearRegression.
- AbstractMultipleLinearRegression() - Constructor for class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
- AbstractParameterizable - Class in org.apache.commons.math3.ode
-
This abstract class provides boilerplate parameters list.
- AbstractParameterizable(String...) - Constructor for class org.apache.commons.math3.ode.AbstractParameterizable
-
Simple constructor.
- AbstractParameterizable(Collection<String>) - Constructor for class org.apache.commons.math3.ode.AbstractParameterizable
-
Simple constructor.
- AbstractPolynomialSolver - Class in org.apache.commons.math3.analysis.solvers
-
Base class for solvers.
- AbstractPolynomialSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractPolynomialSolver
-
Construct a solver with given absolute accuracy.
- AbstractPolynomialSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractPolynomialSolver
-
Construct a solver with given accuracies.
- AbstractPolynomialSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractPolynomialSolver
-
Construct a solver with given accuracies.
- AbstractRandomGenerator - Class in org.apache.commons.math3.random
-
- AbstractRandomGenerator() - Constructor for class org.apache.commons.math3.random.AbstractRandomGenerator
-
Construct a RandomGenerator.
- AbstractRealDistribution - Class in org.apache.commons.math3.distribution
-
Base class for probability distributions on the reals.
- AbstractRealDistribution() - Constructor for class org.apache.commons.math3.distribution.AbstractRealDistribution
-
Default constructor.
- AbstractRealMatrix - Class in org.apache.commons.math3.linear
-
Basic implementation of RealMatrix methods regardless of the underlying storage.
- AbstractRealMatrix() - Constructor for class org.apache.commons.math3.linear.AbstractRealMatrix
-
Creates a matrix with no data
- AbstractRealMatrix(int, int) - Constructor for class org.apache.commons.math3.linear.AbstractRealMatrix
-
Create a new RealMatrix with the supplied row and column dimensions.
- AbstractRegion<S extends Space,T extends Space> - Class in org.apache.commons.math3.geometry.partitioning
-
Abstract class for all regions, independently of geometry type or dimension.
- AbstractRegion() - Constructor for class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Build a region representing the whole space.
- AbstractRegion(BSPTree<S>) - Constructor for class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Build a region from an inside/outside BSP tree.
- AbstractRegion(Collection<SubHyperplane<S>>) - Constructor for class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Build a Region from a Boundary REPresentation (B-rep).
- AbstractRegion(Hyperplane<S>[]) - Constructor for class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Build a convex region from an array of bounding hyperplanes.
- AbstractScalarDifferentiableOptimizer - Class in org.apache.commons.math3.optimization.general
-
Base class for implementing optimizers for multivariate scalar
differentiable functions.
- AbstractScalarDifferentiableOptimizer() - Constructor for class org.apache.commons.math3.optimization.general.AbstractScalarDifferentiableOptimizer
-
Simple constructor with default settings.
- AbstractScalarDifferentiableOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.AbstractScalarDifferentiableOptimizer
-
- AbstractSimplex - Class in org.apache.commons.math3.optimization.direct
-
This class implements the simplex concept.
- AbstractSimplex(int) - Constructor for class org.apache.commons.math3.optimization.direct.AbstractSimplex
-
Build a unit hypercube simplex.
- AbstractSimplex(int, double) - Constructor for class org.apache.commons.math3.optimization.direct.AbstractSimplex
-
Build a hypercube simplex with the given side length.
- AbstractSimplex(double[]) - Constructor for class org.apache.commons.math3.optimization.direct.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.apache.commons.math3.optimization.direct.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.
- AbstractStepInterpolator - Class in org.apache.commons.math3.ode.sampling
-
This abstract class represents an interpolator over the last step
during an ODE integration.
- AbstractStepInterpolator() - Constructor for class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Simple constructor.
- AbstractStepInterpolator(double[], boolean, EquationsMapper, EquationsMapper[]) - Constructor for class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Simple constructor.
- AbstractStepInterpolator(AbstractStepInterpolator) - Constructor for class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Copy constructor.
- AbstractStorelessUnivariateStatistic - Class in org.apache.commons.math3.stat.descriptive
-
- AbstractStorelessUnivariateStatistic() - Constructor for class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
-
- AbstractSubHyperplane<S extends Space,T extends Space> - Class in org.apache.commons.math3.geometry.partitioning
-
This class implements the dimension-independent parts of
SubHyperplane
.
- AbstractSubHyperplane(Hyperplane<S>, Region<T>) - Constructor for class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
-
Build a sub-hyperplane from an hyperplane and a region.
- AbstractUnivariateSolver - Class in org.apache.commons.math3.analysis.solvers
-
Base class for solvers.
- AbstractUnivariateSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractUnivariateSolver
-
Construct a solver with given absolute accuracy.
- AbstractUnivariateSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractUnivariateSolver
-
Construct a solver with given accuracies.
- AbstractUnivariateSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractUnivariateSolver
-
Construct a solver with given accuracies.
- AbstractUnivariateStatistic - Class in org.apache.commons.math3.stat.descriptive
-
- AbstractUnivariateStatistic() - Constructor for class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
-
- AbstractWell - Class in org.apache.commons.math3.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, int, int, int) - Constructor for class org.apache.commons.math3.random.AbstractWell
-
Creates a new random number generator.
- AbstractWell(int, int, int, int, int) - Constructor for class org.apache.commons.math3.random.AbstractWell
-
Creates a new random number generator using a single int seed.
- AbstractWell(int, int, int, int, int[]) - Constructor for class org.apache.commons.math3.random.AbstractWell
-
Creates a new random number generator using an int array seed.
- AbstractWell(int, int, int, int, long) - Constructor for class org.apache.commons.math3.random.AbstractWell
-
Creates a new random number generator using a single long seed.
- acceptStep(AbstractStepInterpolator, double[], double[], double) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Accept a step, triggering events and step handlers.
- Acos - Class in org.apache.commons.math3.analysis.function
-
Arc-cosine function.
- Acos() - Constructor for class org.apache.commons.math3.analysis.function.Acos
-
- acos() - Method in class org.apache.commons.math3.complex.Complex
-
- acos(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
computes the arc-cosine of the argument.
- acos(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Compute the arc cosine of a number.
- Acosh - Class in org.apache.commons.math3.analysis.function
-
Hyperbolic arc-cosine function.
- Acosh() - Constructor for class org.apache.commons.math3.analysis.function.Acosh
-
- acosh(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Compute the inverse hyperbolic cosine of a number.
- AdamsBashforthIntegrator - Class in org.apache.commons.math3.ode.nonstiff
-
This class implements explicit Adams-Bashforth integrators for Ordinary
Differential Equations.
- AdamsBashforthIntegrator(int, double, double, double, double) - Constructor for class org.apache.commons.math3.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.apache.commons.math3.ode.nonstiff.AdamsBashforthIntegrator
-
Build an Adams-Bashforth integrator with the given order and step control parameters.
- AdamsIntegrator - Class in org.apache.commons.math3.ode.nonstiff
-
- AdamsIntegrator(String, int, int, double, double, double, double) - Constructor for class org.apache.commons.math3.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.apache.commons.math3.ode.nonstiff.AdamsIntegrator
-
Build an Adams integrator with the given order and step control parameters.
- AdamsMoultonIntegrator - Class in org.apache.commons.math3.ode.nonstiff
-
This class implements implicit Adams-Moulton integrators for Ordinary
Differential Equations.
- AdamsMoultonIntegrator(int, double, double, double, double) - Constructor for class org.apache.commons.math3.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.apache.commons.math3.ode.nonstiff.AdamsMoultonIntegrator
-
Build an Adams-Moulton integrator with the given order and error control parameters.
- AdamsNordsieckTransformer - Class in org.apache.commons.math3.ode.nonstiff
-
Transformer to Nordsieck vectors for Adams integrators.
- AdaptiveStepsizeIntegrator - Class in org.apache.commons.math3.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.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Build an integrator with the given stepsize bounds.
- AdaptiveStepsizeIntegrator(String, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Build an integrator with the given stepsize bounds.
- Add - Class in org.apache.commons.math3.analysis.function
-
Add the two operands.
- Add() - Constructor for class org.apache.commons.math3.analysis.function.Add
-
- add(UnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
-
Add functions.
- add(DifferentiableUnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
-
Add functions.
- add(PolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
-
Add a polynomial to the instance.
- add(Complex) - Method in class org.apache.commons.math3.complex.Complex
-
Returns a Complex
whose value is
(this + addend)
.
- add(double) - Method in class org.apache.commons.math3.complex.Complex
-
Returns a Complex
whose value is (this + addend)
,
with addend
interpreted as a real number.
- add(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
-
Add x to this.
- add(T) - Method in interface org.apache.commons.math3.FieldElement
-
Compute this + a.
- add(BigInteger) - Method in class org.apache.commons.math3.fraction.BigFraction
-
Adds the value of this fraction to the passed
BigInteger
,
returning the result in reduced form.
- add(int) - Method in class org.apache.commons.math3.fraction.BigFraction
-
Adds the value of this fraction to the passed integer, returning
the result in reduced form.
- add(long) - Method in class org.apache.commons.math3.fraction.BigFraction
-
Adds the value of this fraction to the passed long, returning
the result in reduced form.
- add(BigFraction) - Method in class org.apache.commons.math3.fraction.BigFraction
-
Adds the value of this fraction to another, returning the result in
reduced form.
- add(Fraction) - Method in class org.apache.commons.math3.fraction.Fraction
-
Adds the value of this fraction to another, returning the result in reduced form.
- add(int) - Method in class org.apache.commons.math3.fraction.Fraction
-
Add an integer to the fraction.
- add(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Add a vector to the instance.
- add(double, Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Add a scaled vector to the instance.
- add(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Add a vector to the instance.
- add(double, Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Add a scaled vector to the instance.
- add(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Add a vector to the instance.
- add(double, Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Add a scaled vector to the instance.
- add(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
-
Add a vector to the instance.
- add(double, Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
-
Add a scaled vector to the instance.
- add(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Compute the sum of this and m.
- add(RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Compute the sum of this and m.
- add(Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Add m
to this matrix.
- add(Array2DRowRealMatrix) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Compute the sum of this matrix with m
.
- add(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Compute the sum of this and v.
- add(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Compute the sum of this and v.
- add(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Compute the sum of this vector and v
.
- add(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Compute the sum of this and m.
- add(BlockFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Compute the sum of this and m
.
- add(RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Compute the sum of this and m.
- add(BlockRealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Compute the sum of this matrix and m
.
- add(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Compute the sum of this and m.
- add(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
-
Compute the sum of this and v.
- add(OpenMapRealMatrix) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
-
Compute the sum of this matrix and m
.
- add(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Compute the sum of this vector and v
.
- add(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Optimized method to add two OpenMapRealVectors.
- add(RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Compute the sum of this and m.
- add(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
-
Compute the sum of this vector and v
.
- add(SparseFieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Optimized method to add sparse vectors.
- add(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Compute the sum of this and v.
- add(BigReal) - Method in class org.apache.commons.math3.util.BigReal
-
Compute this + a.
- addAndCheck(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Add two integers, checking for overflow.
- addAndCheck(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Add two long integers, checking for overflow.
- addChromosome(Chromosome) - Method in class org.apache.commons.math3.genetics.ListPopulation
-
Add the given chromosome to the population.
- addChromosome(Chromosome) - Method in interface org.apache.commons.math3.genetics.Population
-
Add the given chromosome to the population.
- addData(double, double) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Adds the observation (x,y) to the regression data set.
- addData(double[][]) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Adds the observations represented by the elements in
data
.
- addElement(double) - Method in interface org.apache.commons.math3.util.DoubleArray
-
Adds an element to the end of this expandable array
- addElement(double) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Adds an element to the end of this expandable array.
- addElementRolling(double) - Method in interface org.apache.commons.math3.util.DoubleArray
-
Adds an element to the end of the array and removes the first
element in the array.
- addElementRolling(double) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Adds an element to the end of the array and removes the first
element in the array.
- addElements(double[]) - Method in interface org.apache.commons.math3.util.DoubleArray
-
Adds elements to the end of this expandable array
- addElements(double[]) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Adds several element to the end of this expandable array.
- addEventHandler(EventHandler, double, double, int) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Add an event handler to the integrator.
- addEventHandler(EventHandler, double, double, int, UnivariateSolver) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Add an event handler to the integrator.
- addEventHandler(EventHandler, double, double, int, UnivariateSolver) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
-
Add an event handler to the integrator.
- addEventHandler(EventHandler, double, double, int) - Method in interface org.apache.commons.math3.ode.ODEIntegrator
-
Add an event handler to the integrator.
- addEventHandler(EventHandler, double, double, int, UnivariateSolver) - Method in interface org.apache.commons.math3.ode.ODEIntegrator
-
Add an event handler to the integrator.
- addIterationListener(IterationListener) - Method in class org.apache.commons.math3.util.IterationManager
-
Attaches a listener to this manager.
- ADDITIVE_MODE - Static variable in class org.apache.commons.math3.util.ResizableDoubleArray
-
additive expansion mode
- addMessage(Localizable, Object...) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
-
Adds a message.
- addObservation(double[], double) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
-
Adds an observation to the regression model
- addObservation(double[], double) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Adds one observation to the regression model.
- addObservation(double[], double) - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
-
Adds one observation to the regression model.
- addObservations(double[][], double[]) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
-
Adds multiple observations to the model
- addObservations(double[][], double[]) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Adds a series of observations to the regression model.
- addObservations(double[][], double[]) - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
-
Adds a series of observations to the regression model.
- addObservedPoint(double, double) - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
-
Add an observed (x,y) point to the sample with unit weight.
- addObservedPoint(double, double, double) - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
-
Add an observed weighted (x,y) point to the sample.
- addObservedPoint(WeightedObservedPoint) - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
-
Add an observed weighted (x,y) point to the sample.
- addParameterJacobianProvider(ParameterJacobianProvider) - Method in class org.apache.commons.math3.ode.JacobianMatrices
-
Add a parameter Jacobian provider.
- addPoint(T) - Method in class org.apache.commons.math3.stat.clustering.Cluster
-
Add a point to this cluster.
- addSecondaryEquations(SecondaryEquations) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Add a set of secondary equations to be integrated along with the primary set.
- addStepHandler(StepHandler) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Add a step handler to this integrator.
- addStepHandler(StepHandler) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
-
Add a step handler to this integrator.
- addStepHandler(StepHandler) - Method in interface org.apache.commons.math3.ode.ODEIntegrator
-
Add a step handler to this integrator.
- addToEntry(int, int, T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, T) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Change an entry at the specified index.
- addToEntry(int, int, T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, double) - Method in class org.apache.commons.math3.linear.RealVector
-
Change an entry at the specified index.
- addToEntry(int, int, T) - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
-
Change an entry in the specified row and column.
- addValue(double) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Adds the value to the dataset.
- addValue(double[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Add an n-tuple to the data
- addValue(double) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Add a value to the data
- addValue(double) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
Adds the value to the dataset.
- addValue(double[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Add an n-tuple to the data
- addValue(double) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Add a value to the data
- addValue(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
-
Adds 1 to the frequency count for v.
- addValue(int) - Method in class org.apache.commons.math3.stat.Frequency
-
Adds 1 to the frequency count for v.
- addValue(long) - Method in class org.apache.commons.math3.stat.Frequency
-
Adds 1 to the frequency count for v.
- addValue(char) - Method in class org.apache.commons.math3.stat.Frequency
-
Adds 1 to the frequency count for v.
- advance(RealVector.Entry) - Method in class org.apache.commons.math3.linear.RealVector.SparseEntryIterator
-
Advance an entry up to the next nonzero one.
- advance() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap.Iterator
-
Advance iterator one step further.
- advance() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap.Iterator
-
Advance iterator one step further.
- aggregate(Collection<SummaryStatistics>) - Static method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Computes aggregate summary statistics.
- AggregateSummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
-
An aggregator for SummaryStatistics
from several data sets or
data set partitions.
- AggregateSummaryStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Initializes a new AggregateSummaryStatistics with default statistics
implementations.
- AggregateSummaryStatistics(SummaryStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Initializes a new AggregateSummaryStatistics with the specified statistics
object as a prototype for contributing statistics and for the internal
aggregate statistics.
- AggregateSummaryStatistics(SummaryStatistics, SummaryStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Initializes a new AggregateSummaryStatistics with the specified statistics
object as a prototype for contributing statistics and for the internal
aggregate statistics.
- align(int) - Method in class org.apache.commons.math3.dfp.Dfp
-
Make our exp equal to the supplied one, this may cause rounding.
- AllowedSolution - Enum in org.apache.commons.math3.analysis.solvers
-
- angle(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Compute the angular separation between two vectors.
- anovaFValue(Collection<double[]>) - Method in class org.apache.commons.math3.stat.inference.OneWayAnova
-
Computes the ANOVA F-value for a collection of double[]
arrays.
- anovaPValue(Collection<double[]>) - Method in class org.apache.commons.math3.stat.inference.OneWayAnova
-
Computes the ANOVA P-value for a collection of double[]
arrays.
- anovaTest(Collection<double[]>, double) - Method in class org.apache.commons.math3.stat.inference.OneWayAnova
-
Performs an ANOVA test, evaluating the null hypothesis that there
is no difference among the means of the data categories.
- AnyMatrix - Interface in org.apache.commons.math3.linear
-
Interface defining very basic matrix operations.
- append(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector by appending a vector to this vector.
- append(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector by appending a vector to this vector.
- append(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector by appending a T to this vector.
- append(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a new vector by appending a vector to this vector.
- append(ArrayRealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector by appending a vector to this vector.
- append(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a new vector by appending a double to this vector.
- append(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
-
Construct a vector by appending a vector to this vector.
- append(T) - Method in interface org.apache.commons.math3.linear.FieldVector
-
Construct a vector by appending a T to this vector.
- append(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Optimized method to append a OpenMapRealVector.
- append(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Construct a new vector by appending a vector to this vector.
- append(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Construct a new vector by appending a double to this vector.
- append(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
-
Construct a new vector by appending a vector to this vector.
- append(double) - Method in class org.apache.commons.math3.linear.RealVector
-
Construct a new vector by appending a double to this vector.
- append(SparseFieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Construct a vector by appending a vector to this vector.
- append(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Construct a vector by appending a vector to this vector.
- append(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Construct a vector by appending a T to this vector.
- append(ContinuousOutputModel) - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
-
Append another model at the end of the instance.
- apply(Vector<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Transform
-
Transform a point of a space.
- apply(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Transform
-
Transform an hyperplane of a space.
- apply(SubHyperplane<T>, Hyperplane<S>, Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Transform
-
Transform a sub-hyperplane embedded in an hyperplane.
- apply(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Apply the given statistic to the data associated with this set of statistics.
- apply(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
Apply the given statistic to the data associated with this set of statistics.
- applyInverseTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Apply the inverse of the rotation to a vector.
- applyInverseTo(double[], double[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Apply the inverse of the rotation to a vector stored in an array.
- applyInverseTo(Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Apply the inverse of the instance to another rotation.
- applyTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Apply the rotation to a vector.
- applyTo(double[], double[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Apply the rotation to a vector stored in an array.
- applyTo(Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Apply the instance to another rotation.
- applyTransform(Transform<S, T>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Transform a region.
- applyTransform(Transform<S, T>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
-
Apply a transform to the instance.
- ArgUtils - Class in org.apache.commons.math3.exception.util
-
Utility class for transforming the list of arguments passed to
constructors of exceptions.
- ArithmeticUtils - Class in org.apache.commons.math3.util
-
Some useful, arithmetics related, additions to the built-in functions in
Math
.
- Array2DRowFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
-
Implementation of FieldMatrix
using a FieldElement
[][] array to store entries.
- Array2DRowFieldMatrix(Field<T>) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Creates a matrix with no data
- Array2DRowFieldMatrix(Field<T>, int, int) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix<T>
with the supplied row and column dimensions.
- Array2DRowFieldMatrix(T[][]) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix<T>
using the input array as the underlying
data array.
- Array2DRowFieldMatrix(Field<T>, T[][]) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix<T>
using the input array as the underlying
data array.
- Array2DRowFieldMatrix(T[][], boolean) - Constructor for class org.apache.commons.math3.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.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix<T>
using the input array as the underlying
data array.
- Array2DRowFieldMatrix(T[]) - Constructor for class org.apache.commons.math3.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.apache.commons.math3.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.apache.commons.math3.linear
-
Implementation of
RealMatrix
using a
double[][]
array to
store entries.
- Array2DRowRealMatrix() - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Creates a matrix with no data
- Array2DRowRealMatrix(int, int) - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Create a new RealMatrix with the supplied row and column dimensions.
- Array2DRowRealMatrix(double[][]) - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Create a new RealMatrix
using the input array as the underlying
data array.
- Array2DRowRealMatrix(double[][], boolean) - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Create a new RealMatrix using the input array as the underlying
data array.
- Array2DRowRealMatrix(double[]) - Constructor for class org.apache.commons.math3.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.apache.commons.math3.linear
-
- ArrayFieldVector(Field<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Build a 0-length vector.
- ArrayFieldVector(Field<T>, int) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector of zeroes.
- ArrayFieldVector(int, T) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector with preset values.
- ArrayFieldVector(T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector from an array, copying the input array.
- ArrayFieldVector(Field<T>, T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector from an array, copying the input array.
- ArrayFieldVector(T[], boolean) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Create a new ArrayFieldVector using the input array as the underlying
data array.
- ArrayFieldVector(Field<T>, T[], boolean) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Create a new ArrayFieldVector using the input array as the underlying
data array.
- ArrayFieldVector(T[], int, int) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector from part of a array.
- ArrayFieldVector(Field<T>, T[], int, int) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector from part of a array.
- ArrayFieldVector(FieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector from another vector, using a deep copy.
- ArrayFieldVector(ArrayFieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector from another vector, using a deep copy.
- ArrayFieldVector(ArrayFieldVector<T>, boolean) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector from another vector.
- ArrayFieldVector(ArrayFieldVector<T>, ArrayFieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayFieldVector(ArrayFieldVector<T>, T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayFieldVector(T[], ArrayFieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayFieldVector(T[], T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayFieldVector(Field<T>, T[], T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector - Class in org.apache.commons.math3.linear
-
This class implements the
RealVector
interface with a double array.
- ArrayRealVector() - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Build a 0-length vector.
- ArrayRealVector(int) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector of zeroes.
- ArrayRealVector(int, double) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector with preset values.
- ArrayRealVector(double[]) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector from an array, copying the input array.
- ArrayRealVector(double[], boolean) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Create a new ArrayRealVector using the input array as the underlying
data array.
- ArrayRealVector(double[], int, int) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector from part of a array.
- ArrayRealVector(Double[]) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector from an array.
- ArrayRealVector(Double[], int, int) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector from part of an array.
- ArrayRealVector(RealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector from another vector, using a deep copy.
- ArrayRealVector(ArrayRealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector from another vector, using a deep copy.
- ArrayRealVector(ArrayRealVector, boolean) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector from another vector.
- ArrayRealVector(ArrayRealVector, ArrayRealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(ArrayRealVector, RealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(RealVector, ArrayRealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(ArrayRealVector, double[]) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(double[], ArrayRealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(double[], double[]) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- Asin - Class in org.apache.commons.math3.analysis.function
-
Arc-sine function.
- Asin() - Constructor for class org.apache.commons.math3.analysis.function.Asin
-
- asin() - Method in class org.apache.commons.math3.complex.Complex
-
- asin(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
computes the arc-sine of the argument.
- asin(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Compute the arc sine of a number.
- Asinh - Class in org.apache.commons.math3.analysis.function
-
Hyperbolic arc-sine function.
- Asinh() - Constructor for class org.apache.commons.math3.analysis.function.Asinh
-
- asinh(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Compute the inverse hyperbolic sine of a number.
- asList() - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
-
Build an ordered list of intervals representing the instance.
- Atan - Class in org.apache.commons.math3.analysis.function
-
Arc-tangent function.
- Atan() - Constructor for class org.apache.commons.math3.analysis.function.Atan
-
- atan() - Method in class org.apache.commons.math3.complex.Complex
-
- atan(Dfp) - Static method in class org.apache.commons.math3.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(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Arctangent function
- Atan2 - Class in org.apache.commons.math3.analysis.function
-
Arc-tangent function.
- Atan2() - Constructor for class org.apache.commons.math3.analysis.function.Atan2
-
- atan2(double, double) - Static method in class org.apache.commons.math3.util.FastMath
-
Two arguments arctangent function
- Atanh - Class in org.apache.commons.math3.analysis.function
-
Hyperbolic arc-tangent function.
- Atanh() - Constructor for class org.apache.commons.math3.analysis.function.Atanh
-
- atanh(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Compute the inverse hyperbolic tangent of a number.
- atanInternal(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
computes the arc-tangent of the argument.
- AVLTree<T extends Comparable<T>> - Class in org.apache.commons.math3.geometry.partitioning.utilities
-
This class implements AVL trees.
- AVLTree() - Constructor for class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
-
Build an empty tree.
- AVLTree.Node - Class in org.apache.commons.math3.geometry.partitioning.utilities
-
This class implements AVL trees nodes.
- calculateAdjustedRSquared() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
-
Returns the adjusted R-squared statistic, defined by the formula
- calculateBeta() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
Calculates the beta of multiple linear regression in matrix notation.
- calculateBeta() - Method in class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
-
Calculates beta by GLS.
- calculateBeta() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
-
Calculates the regression coefficients using OLS.
- calculateBetaVariance() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
Calculates the beta variance of multiple linear regression in matrix
notation.
- calculateBetaVariance() - Method in class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
-
Calculates the variance on the beta.
- calculateBetaVariance() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
-
Calculates the variance-covariance matrix of the regression parameters.
- calculateErrorVariance() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
Calculates the variance of the error term.
- calculateErrorVariance() - Method in class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
-
Calculates the estimated variance of the error term using the formula
- calculateHat() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
-
Compute the "hat" matrix.
- calculateNumericalMean() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
- calculateNumericalMean() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
-
- calculateNumericalVariance() - Method in class org.apache.commons.math3.distribution.FDistribution
-
- calculateNumericalVariance() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
-
- calculateNumericalVariance() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
- calculateNumericalVariance() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
-
- calculateResiduals() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
Calculates the residuals of multiple linear regression in matrix
notation.
- calculateResidualSumOfSquares() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
-
Returns the sum of squared residuals.
- calculateRSquared() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
-
Returns the R-Squared statistic, defined by the formula
- calculateTotalSumOfSquares() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
-
Returns the sum of squared deviations of Y from its mean.
- calculateYVariance() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
Calculates the variance of the y values.
- canIncrement() - Method in class org.apache.commons.math3.util.Incrementor
-
Checks whether a single increment is allowed.
- CardanEulerSingularityException - Exception in org.apache.commons.math3.geometry.euclidean.threed
-
This class represents exceptions thrown while extractiong Cardan
or Euler angles from a rotation.
- CardanEulerSingularityException(boolean) - Constructor for exception org.apache.commons.math3.geometry.euclidean.threed.CardanEulerSingularityException
-
Simple constructor.
- CauchyDistribution - Class in org.apache.commons.math3.distribution
-
Implementation of the Cauchy distribution.
- CauchyDistribution() - Constructor for class org.apache.commons.math3.distribution.CauchyDistribution
-
Creates a Cauchy distribution with the median equal to zero and scale
equal to one.
- CauchyDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.CauchyDistribution
-
Creates a Cauchy distribution using the given median and scale.
- CauchyDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.CauchyDistribution
-
Creates a Cauchy distribution using the given median and scale.
- Cbrt - Class in org.apache.commons.math3.analysis.function
-
Cube root function.
- Cbrt() - Constructor for class org.apache.commons.math3.analysis.function.Cbrt
-
- cbrt(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Compute the cubic root of a number.
- cdf(double) - Method in class org.apache.commons.math3.distribution.KolmogorovSmirnovDistribution
-
Calculates P(D_n < d)
using method described in [1] with quick
decisions for extreme values given in [2] (see above).
- cdf(double, boolean) - Method in class org.apache.commons.math3.distribution.KolmogorovSmirnovDistribution
-
Calculates P(D_n < d)
using method described in [1] with quick
decisions for extreme values given in [2] (see above).
- cdfExact(double) - Method in class org.apache.commons.math3.distribution.KolmogorovSmirnovDistribution
-
Calculates P(D_n < d)
using method described in [1] with quick
decisions for extreme values given in [2] (see above).
- Ceil - Class in org.apache.commons.math3.analysis.function
-
ceil
function.
- Ceil() - Constructor for class org.apache.commons.math3.analysis.function.Ceil
-
- ceil() - Method in class org.apache.commons.math3.dfp.Dfp
-
Round to an integer using the round ceil mode.
- ceil(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Get the smallest whole number larger than x.
- centroidOf(Collection<T>) - Method in interface org.apache.commons.math3.stat.clustering.Clusterable
-
Returns the centroid of the given Collection of points.
- centroidOf(Collection<EuclideanIntegerPoint>) - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
-
Returns the centroid of the given Collection of points.
- checkAdditionCompatible(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Check if a matrix is addition compatible with the instance.
- checkAdditionCompatible(AnyMatrix, AnyMatrix) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Check if matrices are addition compatible.
- checkColumnIndex(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Check if a column index is valid.
- checkColumnIndex(AnyMatrix, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Check if a column index is valid.
- checkContractExpand(float, float) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Checks the expansion factor and the contraction criteria and throws an
IllegalArgumentException if the contractionCriteria is less than the
expansionCriteria
- checkFinite(double) - Static method in class org.apache.commons.math3.util.MathUtils
-
Check that the argument is a real number.
- checkFinite(double[]) - Static method in class org.apache.commons.math3.util.MathUtils
-
Check that all the elements are real numbers.
- checkIndex(int) - Method in class org.apache.commons.math3.linear.RealVector
-
Check if an index is valid.
- checkMatrixIndex(AnyMatrix, int, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Check if matrix indices are valid.
- checkMultiplicationCompatible(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Check if a matrix is multiplication compatible with the instance.
- checkMultiplicationCompatible(AnyMatrix, AnyMatrix) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Check if matrices are multiplication compatible
- checkNotNull(Object, Localizable, Object...) - Static method in class org.apache.commons.math3.util.MathUtils
-
Checks that an object is not null.
- checkNotNull(Object) - Static method in class org.apache.commons.math3.util.MathUtils
-
Checks that an object is not null.
- checkOrder(double[], MathArrays.OrderDirection, boolean, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
-
Check that the given array is sorted.
- checkOrder(double[], MathArrays.OrderDirection, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
-
Check that the given array is sorted.
- checkOrder(double[]) - Static method in class org.apache.commons.math3.util.MathArrays
-
Check that the given array is sorted in strictly increasing order.
- checkParameters(RealLinearOperator, RealVector, RealVector) - Static method in class org.apache.commons.math3.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.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
-
Performs all dimension checks on the parameters of
solve
and
solveInPlace
,
and throws an exception if one of the checks fails.
- checkPoint(Vector<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Check a point with respect to the region.
- checkPoint(BSPTree<S>, Vector<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Check a point with respect to the region starting at a given node.
- checkPoint(Vector<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
-
Check a point with respect to the region.
- checkRowIndex(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Check if a row index is valid.
- checkRowIndex(AnyMatrix, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Check if a row index is valid.
- checkSubMatrixIndex(int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Check if submatrix ranges indices are valid.
- checkSubMatrixIndex(int[], int[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Check if submatrix ranges indices are valid.
- checkSubMatrixIndex(AnyMatrix, int, int, int, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Check if submatrix ranges indices are valid.
- checkSubMatrixIndex(AnyMatrix, int[], int[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Check if submatrix ranges indices are valid.
- checkSubtractionCompatible(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Check if a matrix is subtraction compatible with the instance.
- checkSubtractionCompatible(AnyMatrix, AnyMatrix) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Check if matrices are subtraction compatible
- checkValidity(List<T>) - Method in class org.apache.commons.math3.genetics.AbstractListChromosome
-
Asserts that representation
can represent a valid chromosome.
- checkValidity(List<Integer>) - Method in class org.apache.commons.math3.genetics.BinaryChromosome
-
Asserts that representation
can represent a valid chromosome.
- checkValidity(List<Double>) - Method in class org.apache.commons.math3.genetics.RandomKey
-
Asserts that representation
can represent a valid chromosome.
- checkVectorDimensions(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Check if instance and specified vectors have the same dimension.
- checkVectorDimensions(int) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Check if instance dimension is equal to some expected value.
- checkVectorDimensions(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Check if instance and specified vectors have the same dimension.
- checkVectorDimensions(int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Check if instance dimension is equal to some expected value.
- checkVectorDimensions(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
-
Check if instance and specified vectors have the same dimension.
- checkVectorDimensions(int) - Method in class org.apache.commons.math3.linear.RealVector
-
Check if instance dimension is equal to some expected value.
- checkVectorDimensions(int) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Check if instance dimension is equal to some expected value.
- chiSquare(double[], long[]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
-
- chiSquare(long[][]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
-
- chiSquare(double[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
-
- chiSquare(long[][]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
-
- chiSquareDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
-
- chiSquareDataSetsComparison(long[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
-
- ChiSquaredDistribution - Class in org.apache.commons.math3.distribution
-
Implementation of the chi-squared distribution.
- ChiSquaredDistribution(double) - Constructor for class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
Create a Chi-Squared distribution with the given degrees of freedom.
- ChiSquaredDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
Create a Chi-Squared distribution with the given degrees of freedom and
inverse cumulative probability accuracy.
- ChiSquareTest - Class in org.apache.commons.math3.stat.inference
-
Implements Chi-Square test statistics.
- ChiSquareTest() - Constructor for class org.apache.commons.math3.stat.inference.ChiSquareTest
-
Construct a ChiSquareTest
- chiSquareTest(double[], long[]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
-
- chiSquareTest(double[], long[], double) - Method in class org.apache.commons.math3.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.apache.commons.math3.stat.inference.ChiSquareTest
-
- chiSquareTest(long[][], double) - Method in class org.apache.commons.math3.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.apache.commons.math3.stat.inference.TestUtils
-
- chiSquareTest(double[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
-
- chiSquareTest(long[][], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
-
- chiSquareTest(long[][]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
-
- chiSquareTestDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math3.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.apache.commons.math3.stat.inference.ChiSquareTest
-
Performs a Chi-Square two sample test comparing two binned data
sets.
- chiSquareTestDataSetsComparison(long[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
-
- chiSquareTestDataSetsComparison(long[], long[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
-
- CholeskyDecomposition - Class in org.apache.commons.math3.linear
-
Calculates the Cholesky decomposition of a matrix.
- CholeskyDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.CholeskyDecomposition
-
Calculates the Cholesky decomposition of the given matrix.
- CholeskyDecomposition(RealMatrix, double, double) - Constructor for class org.apache.commons.math3.linear.CholeskyDecomposition
-
Calculates the Cholesky decomposition of the given matrix.
- Chromosome - Class in org.apache.commons.math3.genetics
-
Individual in a population.
- Chromosome() - Constructor for class org.apache.commons.math3.genetics.Chromosome
-
- ChromosomePair - Class in org.apache.commons.math3.genetics
-
- ChromosomePair(Chromosome, Chromosome) - Constructor for class org.apache.commons.math3.genetics.ChromosomePair
-
Create a chromosome pair.
- classes() - Method in class org.apache.commons.math3.util.TransformerMap
-
Returns the Set of Classes used as keys in the map.
- ClassicalRungeKuttaIntegrator - Class in org.apache.commons.math3.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.apache.commons.math3.ode.nonstiff.ClassicalRungeKuttaIntegrator
-
Simple constructor.
- classify() - Method in class org.apache.commons.math3.dfp.Dfp
-
Returns the type - one of FINITE, INFINITE, SNAN, QNAN.
- clear() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
-
- clear() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
-
- clear() - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Resets all statistics and storage
- clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Resets all statistics and storage
- clear() - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
-
Clears the internal state of the Statistic
- clear() - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
-
Clears the internal state of the Statistic
- clear() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Resets all statistics and storage
- clear() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
Resets all statistics and storage
- clear() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Resets all statistics and storage
- clear() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Resets all statistics and storage
- clear() - Method in class org.apache.commons.math3.stat.Frequency
-
Clears the frequency table
- clear() - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
-
As the name suggests, clear wipes the internals and reorders everything in the
canonical order.
- clear() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Clears all data from the model.
- clear() - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
-
Clears internal buffers and resets the regression model.
- clear() - Method in interface org.apache.commons.math3.util.DoubleArray
-
Clear the double array
- clear() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Clear the array, reset the size to the initialCapacity and the number
of elements to zero.
- clear() - Method in class org.apache.commons.math3.util.TransformerMap
-
Clears all the Class to Transformer mappings.
- clearEventHandlers() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearEventHandlers() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearIEEEFlags() - Method in class org.apache.commons.math3.dfp.DfpField
-
Clears the IEEE 854 status flags.
- clearObservations() - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
-
Remove all observations.
- clearStepHandlers() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Remove all the step handlers that have been added to the integrator.
- clearStepHandlers() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
-
Remove all the step handlers that have been added to the integrator.
- closeReplayFile() - Method in class org.apache.commons.math3.random.ValueServer
-
Closes valuesFileURL
after use in REPLAY_MODE.
- closestPoint(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
-
Compute the point of the instance closest to another line.
- Cluster<T extends Clusterable<T>> - Class in org.apache.commons.math3.stat.clustering
-
- Cluster(T) - Constructor for class org.apache.commons.math3.stat.clustering.Cluster
-
Build a cluster centered at a specified point.
- cluster(Collection<T>, int, int, int) - Method in class org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer
-
Runs the K-means++ clustering algorithm.
- cluster(Collection<T>, int, int) - Method in class org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer
-
Runs the K-means++ clustering algorithm.
- Clusterable<T> - Interface in org.apache.commons.math3.stat.clustering
-
Interface for points that can be clustered together.
- CMAESOptimizer - Class in org.apache.commons.math3.optimization.direct
-
An implementation of the active Covariance Matrix Adaptation Evolution Strategy (CMA-ES)
for non-linear, non-convex, non-smooth, global function minimization.
- CMAESOptimizer() - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
Default constructor, uses default parameters
- CMAESOptimizer(int) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- CMAESOptimizer(int, double[]) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- CMAESOptimizer(int, double[], int, double, boolean, int, int, RandomGenerator, boolean) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- CMAESOptimizer(int, double[], int, double, boolean, int, int, RandomGenerator, boolean, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- collector(BivariateFunction, UnivariateFunction, double) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
-
Returns a MultivariateFunction h(x[]) defined by
- collector(BivariateFunction, double) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
-
Returns a MultivariateFunction h(x[]) defined by
- cols - Variable in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
-
Number of columns of the jacobian matrix.
- combine(BivariateFunction, UnivariateFunction, UnivariateFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
-
Returns the univariate function
h(x) = combiner(f(x), g(x))
.
- combine(double, double, RealVector) - Method in class org.apache.commons.math3.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.apache.commons.math3.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.apache.commons.math3.linear.ArrayRealVector
-
Updates this
with the linear combination of this
and
y
.
- combineToSelf(double, double, RealVector) - Method in class org.apache.commons.math3.linear.RealVector
-
Updates this
with the linear combination of this
and
y
.
- comparatorPermutation(List<S>, Comparator<S>) - Static method in class org.apache.commons.math3.genetics.RandomKey
-
Generates a representation of a permutation corresponding to the
data
sorted by comparator
.
- compareTo(BigFraction) - Method in class org.apache.commons.math3.fraction.BigFraction
-
Compares this object to another based on size.
- compareTo(Fraction) - Method in class org.apache.commons.math3.fraction.Fraction
-
Compares this object to another based on size.
- compareTo(Chromosome) - Method in class org.apache.commons.math3.genetics.Chromosome
-
Compares two chromosomes based on their fitness.
- compareTo(OrderedTuple) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.OrderedTuple
-
Compares this ordered T-uple with the specified object.
- compareTo(BigReal) - Method in class org.apache.commons.math3.util.BigReal
- compareTo(double, double, double) - Static method in class org.apache.commons.math3.util.Precision
-
Compares two numbers given some amount of allowed error.
- compareTo(double, double, int) - Static method in class org.apache.commons.math3.util.Precision
-
Compares two numbers given some amount of allowed error.
- complainIfNotSupported(String) - Method in class org.apache.commons.math3.ode.AbstractParameterizable
-
Check if a parameter is supported and throw an IllegalArgumentException if not.
- complement(int) - Method in class org.apache.commons.math3.dfp.Dfp
-
Negate the mantissa of this by computing the complement.
- Complex - Class in org.apache.commons.math3.complex
-
Representation of a Complex number, i.e.
- Complex(double) - Constructor for class org.apache.commons.math3.complex.Complex
-
Create a complex number given only the real part.
- Complex(double, double) - Constructor for class org.apache.commons.math3.complex.Complex
-
Create a complex number given the real and imaginary parts.
- ComplexField - Class in org.apache.commons.math3.complex
-
Representation of the complex numbers field.
- ComplexFormat - Class in org.apache.commons.math3.complex
-
Formats a Complex number in cartesian format "Re(c) + Im(c)i".
- ComplexFormat() - Constructor for class org.apache.commons.math3.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.apache.commons.math3.complex.ComplexFormat
-
Create an instance with a custom number format for both real and
imaginary parts.
- ComplexFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.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.apache.commons.math3.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.apache.commons.math3.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.apache.commons.math3.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.
- ComplexUtils - Class in org.apache.commons.math3.complex
-
Static implementations of common
Complex
utilities functions.
- compose(UnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
-
Compose functions.
- compose(DifferentiableUnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
-
Compose functions.
- CompositeFormat - Class in org.apache.commons.math3.util
-
Base class for formatters of composite objects (complex numbers, vectors ...).
- computeCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Calculate the coefficients of Lagrange polynomial from the
interpolation data.
- computeCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
-
Calculate the normal polynomial coefficients given the Newton form.
- computeCorrelationMatrix(RealMatrix) - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
-
Computes the correlation matrix for the columns of the
input matrix.
- computeCorrelationMatrix(double[][]) - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
-
Computes the correlation matrix for the columns of the
input rectangular array.
- computeCorrelationMatrix(RealMatrix) - Method in class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
-
Computes the Spearman's rank correlation matrix for the columns of the
input matrix.
- computeCorrelationMatrix(double[][]) - Method in class org.apache.commons.math3.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.apache.commons.math3.stat.correlation.Covariance
-
Compute a covariance matrix from a matrix whose columns represent
covariates.
- computeCovarianceMatrix(RealMatrix) - Method in class org.apache.commons.math3.stat.correlation.Covariance
-
Create a covariance matrix from a matrix whose columns represent
covariates.
- computeCovarianceMatrix(double[][], boolean) - Method in class org.apache.commons.math3.stat.correlation.Covariance
-
Compute a covariance matrix from a rectangular array whose columns represent
covariates.
- computeCovarianceMatrix(double[][]) - Method in class org.apache.commons.math3.stat.correlation.Covariance
-
Create a covariance matrix from a rectangular array whose columns represent
covariates.
- computeDerivativeObjectiveValue(double) - Method in class org.apache.commons.math3.analysis.solvers.AbstractDifferentiableUnivariateSolver
-
Compute the objective function value.
- computeDerivatives(double, double[], double[]) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Compute the derivatives and check the number of evaluations.
- computeDerivatives(double, double[], double[]) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Get the current time derivative of the complete state vector.
- computeDerivatives(double, double[], double[]) - Method in class org.apache.commons.math3.ode.FirstOrderConverter
-
Get the current time derivative of the state vector.
- computeDerivatives(double, double[], double[]) - Method in interface org.apache.commons.math3.ode.FirstOrderDifferentialEquations
-
Get the current time derivative of the state vector.
- computeDerivatives(double, double[], double[], double[], double[]) - Method in interface org.apache.commons.math3.ode.SecondaryEquations
-
Compute the derivatives related to the secondary state parameters.
- computeDistribution() - Method in class org.apache.commons.math3.random.ValueServer
-
Computes the empirical distribution using values from the file
in valuesFileURL
, using the default number of bins.
- computeDistribution(int) - Method in class org.apache.commons.math3.random.ValueServer
-
Computes the empirical distribution using values from the file
in valuesFileURL
and binCount
bins.
- computeDividedDifference(double[], double[]) - Static method in class org.apache.commons.math3.analysis.interpolation.DividedDifferenceInterpolator
-
Return a copy of the divided difference array.
- computeExp(Dfp, Dfp) - Static method in class org.apache.commons.math3.dfp.DfpField
-
Compute exp(a).
- computeGeometricalProperties() - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
-
Compute some geometrical properties.
- computeGeometricalProperties() - Method in class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
-
Compute some geometrical properties.
- computeGeometricalProperties() - Method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
-
Compute some geometrical properties.
- computeGeometricalProperties() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Compute some geometrical properties.
- computeInterpolatedStateAndDerivatives(double, double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Compute the state and derivatives at the interpolated time.
- computeInterpolatedStateAndDerivatives(double, double) - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
-
Compute the state and derivatives at the interpolated time.
- computeLn(Dfp, Dfp, Dfp) - Static method in class org.apache.commons.math3.dfp.DfpField
-
Compute ln(a).
- computeMainStateJacobian(double, double[], double[], double[][]) - Method in interface org.apache.commons.math3.ode.MainStateJacobianProvider
-
Compute the jacobian matrix of ODE with respect to main state.
- computeObjectiveGradient(double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractScalarDifferentiableOptimizer
-
Compute the gradient vector.
- computeObjectiveValue(double) - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Compute the objective function value.
- computeObjectiveValue(double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Compute the objective function value.
- computeObjectiveValue(double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
-
Compute the objective function value.
- computeObjectiveValue(double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
-
Compute the objective function value.
- computeObjectiveValue(double) - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
-
Compute the objective function value.
- computeParameterJacobian(double, double[], double[], String, double[]) - Method in interface org.apache.commons.math3.ode.ParameterJacobianProvider
-
Compute the Jacobian matrix of ODE with respect to one parameter.
- computeRoots(int) - Method in class org.apache.commons.math3.complex.RootsOfUnity
-
Computes the n
-th roots of unity.
- computeSecondDerivatives(double, double[], double[], double[]) - Method in interface org.apache.commons.math3.ode.SecondOrderDifferentialEquations
-
Get the current time derivative of the state vector.
- computeStepGrowShrinkFactor(double) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
-
Compute step grow/shrink factor according to normalized error.
- conjugate() - Method in class org.apache.commons.math3.complex.Complex
-
Return the conjugate of this complex number.
- ConjugateGradient - Class in org.apache.commons.math3.linear
-
- ConjugateGradient(int, double, boolean) - Constructor for class org.apache.commons.math3.linear.ConjugateGradient
-
- ConjugateGradient(IterationManager, double, boolean) - Constructor for class org.apache.commons.math3.linear.ConjugateGradient
-
- ConjugateGradientFormula - Enum in org.apache.commons.math3.optimization.general
-
- Constant - Class in org.apache.commons.math3.analysis.function
-
Constant function.
- Constant(double) - Constructor for class org.apache.commons.math3.analysis.function.Constant
-
- CONSTANT_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
-
Always return mu
- contains(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
-
Check if the instance contains a point.
- contains(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Check if the instance contains a point.
- contains(Vector2D) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Check if the line contains a point.
- contains(Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Check if the instance entirely contains another region.
- contains(Region<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
-
Check if the instance entirely contains another region.
- containsClass(Class<?>) - Method in class org.apache.commons.math3.util.TransformerMap
-
Tests if a Class is present in the TransformerMap.
- containsKey(int) - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
-
Check if a value is associated with a key.
- containsKey(int) - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
-
Check if a value is associated with a key.
- containsTransformer(NumberTransformer) - Method in class org.apache.commons.math3.util.TransformerMap
-
Tests if a NumberTransformer is present in the TransformerMap.
- ContinuedFraction - Class in org.apache.commons.math3.util
-
Provides a generic means to evaluate continued fractions.
- ContinuedFraction() - Constructor for class org.apache.commons.math3.util.ContinuedFraction
-
Default constructor.
- ContinuousOutputModel - Class in org.apache.commons.math3.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.
- ContinuousOutputModel() - Constructor for class org.apache.commons.math3.ode.ContinuousOutputModel
-
Simple constructor.
- contract() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Contracts the storage array to the (size of the element set) + 1 - to
avoid a zero length array.
- converged(int, PAIR, PAIR) - Method in class org.apache.commons.math3.optimization.AbstractConvergenceChecker
-
Check if the optimization algorithm has converged.
- converged(int, PAIR, PAIR) - Method in interface org.apache.commons.math3.optimization.ConvergenceChecker
-
Check if the optimization algorithm has converged.
- converged(int, PAIR, PAIR) - Method in class org.apache.commons.math3.optimization.SimplePointChecker
-
Check if the optimization algorithm has converged considering the
last two points.
- converged(int, PointValuePair, PointValuePair) - Method in class org.apache.commons.math3.optimization.SimpleValueChecker
-
Check if the optimization algorithm has converged considering the
last two points.
- converged(int, PointVectorValuePair, PointVectorValuePair) - Method in class org.apache.commons.math3.optimization.SimpleVectorValueChecker
-
Check if the optimization algorithm has converged considering the
last two points.
- ConvergenceChecker<PAIR> - Interface in org.apache.commons.math3.optimization
-
This interface specifies how to check if an optimization algorithm has
converged.
- ConvergenceException - Exception in org.apache.commons.math3.exception
-
Error thrown when a numerical computation can not be performed because the
numerical result failed to converge to a finite value.
- ConvergenceException() - Constructor for exception org.apache.commons.math3.exception.ConvergenceException
-
Construct the exception.
- ConvergenceException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.ConvergenceException
-
Construct the exception with a specific context and arguments.
- copy() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Returns a (deep) copy of this.
- copy() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Returns a (deep) copy of this.
- copy() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Returns a (deep) copy of this.
- copy() - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Returns a (deep) copy of this vector.
- copy() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Returns a (deep) copy of this.
- copy() - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in interface org.apache.commons.math3.linear.FieldVector
-
Returns a (deep) copy of this.
- copy() - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
-
Returns a (deep) copy of this.
- copy() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Returns a (deep) copy of this vector.
- copy() - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Returns a (deep) copy of this.
- copy() - Method in class org.apache.commons.math3.linear.RealVector
-
Returns a (deep) copy of this vector.
- copy() - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Returns a (deep) copy of this.
- copy() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Copy the instance.
- copy() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
-
Copy the instance.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns a copy of this DescriptiveStatistics instance with the same internal state.
- copy(DescriptiveStatistics, DescriptiveStatistics) - Static method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
-
Returns a copy of the statistic with the same internal state.
- copy(GeometricMean, GeometricMean) - Static method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
-
Returns a copy of the statistic with the same internal state.
- copy(Kurtosis, Kurtosis) - Static method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
-
Returns a copy of the statistic with the same internal state.
- copy(Mean, Mean) - Static method in class org.apache.commons.math3.stat.descriptive.moment.Mean
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
-
Returns a copy of the statistic with the same internal state.
- copy(SecondMoment, SecondMoment) - Static method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
-
Returns a copy of the statistic with the same internal state.
- copy(SemiVariance, SemiVariance) - Static method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
-
Returns a copy of the statistic with the same internal state.
- copy(Skewness, Skewness) - Static method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
-
Returns a copy of the statistic with the same internal state.
- copy(StandardDeviation, StandardDeviation) - Static method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
-
Returns a copy of the statistic with the same internal state.
- copy(Variance, Variance) - Static method in class org.apache.commons.math3.stat.descriptive.moment.Variance
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
-
Returns a copy of the statistic with the same internal state.
- copy(Max, Max) - Static method in class org.apache.commons.math3.stat.descriptive.rank.Max
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
-
Returns a copy of the statistic with the same internal state.
- copy(Min, Min) - Static method in class org.apache.commons.math3.stat.descriptive.rank.Min
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
-
Returns a copy of the statistic with the same internal state.
- copy(Percentile, Percentile) - Static method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
-
Copies source to dest.
- copy() - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
-
Returns a copy of the statistic with the same internal state.
- copy(Product, Product) - Static method in class org.apache.commons.math3.stat.descriptive.summary.Product
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
-
Returns a copy of the statistic with the same internal state.
- copy(Sum, Sum) - Static method in class org.apache.commons.math3.stat.descriptive.summary.Sum
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
-
Returns a copy of the statistic with the same internal state.
- copy(SumOfLogs, SumOfLogs) - Static method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
-
Returns a copy of the statistic with the same internal state.
- copy(SumOfSquares, SumOfSquares) - Static method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns a copy of this SummaryStatistics instance with the same internal state.
- copy(SummaryStatistics, SummaryStatistics) - Static method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
Returns a copy of this SynchronizedDescriptiveStatistics instance with the
same internal state.
- copy(SynchronizedDescriptiveStatistics, SynchronizedDescriptiveStatistics) - Static method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
Copies source to dest.
- copy() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns a copy of this SynchronizedSummaryStatistics instance with the
same internal state.
- copy(SynchronizedSummaryStatistics, SynchronizedSummaryStatistics) - Static method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Copies source to dest.
- copy() - Method in interface org.apache.commons.math3.stat.descriptive.UnivariateStatistic
-
Returns a copy of the statistic with the same internal state.
- copy(ResizableDoubleArray, ResizableDoubleArray) - Static method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Copies source to dest, copying the underlying data, so dest is
a new, independent copy of source.
- copy() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Returns a copy of the ResizableDoubleArray.
- copyOf(int[]) - Static method in class org.apache.commons.math3.util.MathArrays
-
Creates a copy of the source
array.
- copyOf(double[]) - Static method in class org.apache.commons.math3.util.MathArrays
-
Creates a copy of the source
array.
- copyOf(int[], int) - Static method in class org.apache.commons.math3.util.MathArrays
-
Creates a copy of the source
array.
- copyOf(double[], int) - Static method in class org.apache.commons.math3.util.MathArrays
-
Creates a copy of the source
array.
- copySelf() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
-
Copy the instance.
- copySelf() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Copy the instance.
- copySelf() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Copy the instance.
- copySelf() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Copy the instance.
- copySelf() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
-
Copy the instance.
- copySelf() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
-
Copy the instance.
- copySelf() - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
-
Copy the instance.
- copySelf() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
-
Copy the instance.
- copySelf() - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
-
Copy the instance.
- copysign(Dfp, Dfp) - Static method in class org.apache.commons.math3.dfp.Dfp
-
Creates an instance that is the same as x except that it has the sign of y.
- copySign(double, double) - Static method in class org.apache.commons.math3.util.FastMath
-
Returns the first argument with the sign of the second argument.
- copySign(float, float) - Static method in class org.apache.commons.math3.util.FastMath
-
Returns the first argument with the sign of the second argument.
- copySign(byte, byte) - Static method in class org.apache.commons.math3.util.MathUtils
-
Returns the first argument with the sign of the second argument.
- copySign(short, short) - Static method in class org.apache.commons.math3.util.MathUtils
-
Returns the first argument with the sign of the second argument.
- copySign(int, int) - Static method in class org.apache.commons.math3.util.MathUtils
-
Returns the first argument with the sign of the second argument.
- copySign(long, long) - Static method in class org.apache.commons.math3.util.MathUtils
-
Returns the first argument with the sign of the second argument.
- copySubMatrix(int, int, int, int, T[][]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Copy a submatrix.
- copySubMatrix(int[], int[], T[][]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Copy a submatrix.
- copySubMatrix(int, int, int, int, double[][]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Copy a submatrix.
- copySubMatrix(int[], int[], double[][]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Copy a submatrix.
- copySubMatrix(int, int, int, int, T[][]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Copy a submatrix.
- copySubMatrix(int[], int[], T[][]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Copy a submatrix.
- copySubMatrix(int, int, int, int, double[][]) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Copy a submatrix.
- copySubMatrix(int[], int[], double[][]) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Copy a submatrix.
- correct(double[]) - Method in class org.apache.commons.math3.filter.KalmanFilter
-
Correct the current state estimate with an actual measurement.
- correct(RealVector) - Method in class org.apache.commons.math3.filter.KalmanFilter
-
Correct the current state estimate with an actual measurement.
- CorrelatedRandomVectorGenerator - Class in org.apache.commons.math3.random
-
- CorrelatedRandomVectorGenerator(double[], RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
-
Builds a correlated random vector generator from its mean
vector and covariance matrix.
- CorrelatedRandomVectorGenerator(RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
-
Builds a null mean random correlated vector generator from its
covariance matrix.
- correlation(double[], double[]) - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
-
Computes the Pearson's product-moment correlation coefficient between the two arrays.
- correlation(double[], double[]) - Method in class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
-
Computes the Spearman's rank correlation coefficient between the two arrays.
- Cos - Class in org.apache.commons.math3.analysis.function
-
Cosine function.
- Cos() - Constructor for class org.apache.commons.math3.analysis.function.Cos
-
- cos() - Method in class org.apache.commons.math3.complex.Complex
-
Compute the
cosine
of this complex number.
- cos(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
computes the cosine of the argument.
- cos(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Cosine function
- Cosh - Class in org.apache.commons.math3.analysis.function
-
Hyperbolic cosine function.
- Cosh() - Constructor for class org.apache.commons.math3.analysis.function.Cosh
-
- cosh() - Method in class org.apache.commons.math3.complex.Complex
-
- cosh(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Compute the hyperbolic cosine of a number.
- cosine(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
-
Computes the cosine of the angle between this vector and the
argument.
- cosInternal(Dfp[]) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
Computes cos(a) Used when 0 < a < pi/4.
- cost - Variable in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
-
Cost value (square root of the sum of the residuals).
- Covariance - Class in org.apache.commons.math3.stat.correlation
-
Computes covariances for pairs of arrays or columns of a matrix.
- Covariance() - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
-
Create a Covariance with no data
- Covariance(double[][], boolean) - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
-
Create a Covariance matrix from a rectangular array
whose columns represent covariates.
- Covariance(double[][]) - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
-
Create a Covariance matrix from a rectangular array
whose columns represent covariates.
- Covariance(RealMatrix, boolean) - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
-
Create a covariance matrix from a matrix whose columns
represent covariates.
- Covariance(RealMatrix) - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
-
Create a covariance matrix from a matrix whose columns
represent covariates.
- covariance(double[], double[], boolean) - Method in class org.apache.commons.math3.stat.correlation.Covariance
-
Computes the covariance between the two arrays.
- covariance(double[], double[]) - Method in class org.apache.commons.math3.stat.correlation.Covariance
-
Computes the covariance between the two arrays, using the bias-corrected
formula.
- covarianceToCorrelation(RealMatrix) - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
-
Derives a correlation matrix from a covariance matrix.
- create(RealLinearOperator) - Static method in class org.apache.commons.math3.linear.JacobiPreconditioner
-
Creates a new instance of this class.
- createAdaptor(RandomGenerator) - Static method in class org.apache.commons.math3.random.RandomAdaptor
-
Factory method to create a Random
using the supplied
RandomGenerator
.
- createBlocksLayout(Field<T>, int, int) - Static method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Create a data array in blocks layout.
- createBlocksLayout(int, int) - Static method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Create a data array in blocks layout.
- createChebyshevPolynomial(int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
-
Create a Chebyshev polynomial of the first kind.
- createColumnFieldMatrix(T[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Creates a column
FieldMatrix
using the data from the input
array.
- createColumnRealMatrix(double[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Creates a column
RealMatrix
using the data from the input
array.
- createComplex(double, double) - Method in class org.apache.commons.math3.complex.Complex
-
Create a complex number given the real and imaginary parts.
- createComplexArray(double[][]) - Static method in class org.apache.commons.math3.transform.TransformUtils
-
Builds a new array of
Complex
from the specified two dimensional
array of real and imaginary parts.
- createContributingStatistics() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Creates and returns a SummaryStatistics
whose data will be
aggregated with those of this AggregateSummaryStatistics
.
- createFieldDiagonalMatrix(T[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Returns a diagonal matrix with specified elements.
- createFieldIdentityMatrix(Field<T>, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Returns dimension x dimension
identity matrix.
- createFieldMatrix(Field<T>, int, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
- createFieldMatrix(T[][]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Returns a
FieldMatrix
whose entries are the the values in the
the input array.
- createFieldVector(T[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Creates a
FieldVector
using the data from the input array.
- createHermitePolynomial(int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
-
Create a Hermite polynomial.
- createJacobiPolynomial(int, int, int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
-
Create a Jacobi polynomial.
- createLaguerrePolynomial(int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
-
Create a Laguerre polynomial.
- createLegendrePolynomial(int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
-
Create a Legendre polynomial.
- createMatrix(int, int) - Method in class org.apache.commons.math3.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.apache.commons.math3.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.apache.commons.math3.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.apache.commons.math3.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.apache.commons.math3.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.apache.commons.math3.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 interface org.apache.commons.math3.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.apache.commons.math3.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.apache.commons.math3.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.apache.commons.math3.linear.SparseFieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createRealDiagonalMatrix(double[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Returns a diagonal matrix with specified elements.
- createRealIdentityMatrix(int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Returns dimension x dimension
identity matrix.
- createRealImaginaryArray(Complex[]) - Static method in class org.apache.commons.math3.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.apache.commons.math3.linear.MatrixUtils
-
- createRealMatrix(double[][]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Returns a
RealMatrix
whose entries are the the values in the
the input array.
- createRealVector(double[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Creates a
RealVector
using the data from the input array.
- createRowFieldMatrix(T[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Create a row
FieldMatrix
using the data from the input
array.
- createRowRealMatrix(double[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Create a row
RealMatrix
using the data from the input
array.
- crossover(Chromosome, Chromosome) - Method in interface org.apache.commons.math3.genetics.CrossoverPolicy
-
Perform a crossover operation on the given chromosomes.
- crossover(Chromosome, Chromosome) - Method in class org.apache.commons.math3.genetics.OnePointCrossover
-
Performs one point crossover.
- CrossoverPolicy - Interface in org.apache.commons.math3.genetics
-
Policy used to create a pair of new chromosomes by performing a crossover
operation on a source pair of chromosomes.
- crossProduct(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Compute the cross-product of the instance with another vector.
- crossProduct(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Compute the cross-product of two vectors.
- cumulativeProbability(int, int) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(x0 < X <= x1)
.
- cumulativeProbability(double, double) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(x0 < X <= x1)
.
- cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.BetaDistribution
-
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.apache.commons.math3.distribution.BinomialDistribution
-
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.apache.commons.math3.distribution.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.apache.commons.math3.distribution.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.apache.commons.math3.distribution.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.apache.commons.math3.distribution.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.apache.commons.math3.distribution.GammaDistribution
-
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.apache.commons.math3.distribution.HypergeometricDistribution
-
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.apache.commons.math3.distribution.IntegerDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int, int) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(x0 < X <= x1)
.
- cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double, double) - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(x0 < X <= x1)
.
- cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double, double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(x0 < X <= x1)
.
- cumulativeProbability(int) - Method in class org.apache.commons.math3.distribution.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.apache.commons.math3.distribution.PoissonDistribution
-
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.apache.commons.math3.distribution.RealDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double, double) - Method in interface org.apache.commons.math3.distribution.RealDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(x0 < X <= x1)
.
- cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.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.apache.commons.math3.distribution.TriangularDistribution
-
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.apache.commons.math3.distribution.UniformIntegerDistribution
-
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.apache.commons.math3.distribution.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.apache.commons.math3.distribution.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.apache.commons.math3.distribution.ZipfDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- currentState - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
current state
- CurveFitter - Class in org.apache.commons.math3.optimization.fitting
-
Fitter for parametric univariate real functions y = f(x).
- CurveFitter(DifferentiableMultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.CurveFitter
-
Simple constructor.
- DctNormalization - Enum in org.apache.commons.math3.transform
-
This enumeration defines the various types of normalizations that can be
applied to discrete cosine transforms (DCT).
- decode(List<T>) - Method in interface org.apache.commons.math3.genetics.PermutationChromosome
-
Permutes the sequence
of objects of type T according to the
permutation this chromosome represents.
- decode(List<T>) - Method in class org.apache.commons.math3.genetics.RandomKey
-
Permutes the sequence
of objects of type T according to the
permutation this chromosome represents.
- DecompositionSolver - Interface in org.apache.commons.math3.linear
-
Interface handling decomposition algorithms that can solve A × X = B.
- DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Default absolute accuracy.
- DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
-
Default absolute accuracy.
- DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.analysis.solvers.SecantSolver
-
Default absolute accuracy.
- DEFAULT_ABSOLUTE_POSITIVITY_THRESHOLD - Static variable in class org.apache.commons.math3.linear.CholeskyDecomposition
-
Default threshold below which diagonal elements are considered null
and matrix not positive definite.
- DEFAULT_ACCURACY - Static variable in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
-
Default value for accuracy.
- DEFAULT_BANDWIDTH - Static variable in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
-
Default value of the bandwidth parameter.
- DEFAULT_BIN_COUNT - Static variable in class org.apache.commons.math3.random.EmpiricalDistribution
-
Default bin count
- DEFAULT_BRIGHTNESS_EXPONENT - Static variable in class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator
-
Default exponent used the weights calculation.
- DEFAULT_CHECKFEASABLECOUNT - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- DEFAULT_DIAGONALONLY - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- DEFAULT_EPSILON - Static variable in class org.apache.commons.math3.distribution.PoissonDistribution
-
Default convergence criterion.
- DEFAULT_EXTEND - Static variable in class org.apache.commons.math3.analysis.interpolation.UnivariatePeriodicInterpolator
-
Default number of extension points of the samples array.
- DEFAULT_INITIAL_RADIUS - Static variable in class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
-
- DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.BetaDistribution
-
Default inverse cumulative probability accuracy.
- DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.CauchyDistribution
-
Default inverse cumulative probability accuracy.
- DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
Default inverse cumulative probability accuracy
- DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.ExponentialDistribution
-
Default inverse cumulative probability accuracy.
- DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.FDistribution
-
Default inverse cumulative probability accuracy.
- DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.GammaDistribution
-
Default inverse cumulative probability accuracy.
- DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.LogNormalDistribution
-
Default inverse cumulative probability accuracy.
- DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.NormalDistribution
-
Default inverse cumulative probability accuracy.
- DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.TDistribution
-
Default inverse cumulative probability accuracy.
- DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.UniformRealDistribution
-
Default inverse cumulative probability accuracy.
- DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.WeibullDistribution
-
Default inverse cumulative probability accuracy.
- DEFAULT_ISACTIVECMA - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- DEFAULT_MAX_ITERATIONS - Static variable in class org.apache.commons.math3.distribution.PoissonDistribution
-
Default maximum number of iterations for cumulative probability calculations.
- DEFAULT_MAX_ITERATIONS - Static variable in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
-
Default maximal number of iterations allowed.
- DEFAULT_MAX_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Default maximal iteration count.
- DEFAULT_MAXITERATIONS - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- DEFAULT_MICROSPHERE_ELEMENTS - Static variable in class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator
-
Default number of surface elements that composes the microsphere.
- DEFAULT_MIN_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Default minimal iteration count.
- DEFAULT_NAN_STRATEGY - Static variable in class org.apache.commons.math3.stat.ranking.NaturalRanking
-
default NaN strategy
- DEFAULT_PREFIX - Static variable in class org.apache.commons.math3.geometry.VectorFormat
-
The default prefix: "{".
- DEFAULT_RANDOMGENERATOR - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- DEFAULT_RELATIVE_ACCURACY - Static variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Default relative accuracy.
- DEFAULT_RELATIVE_SYMMETRY_THRESHOLD - Static variable in class org.apache.commons.math3.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.apache.commons.math3.analysis.interpolation.LoessInterpolator
-
Default value of the number of robustness iterations.
- DEFAULT_SEPARATOR - Static variable in class org.apache.commons.math3.geometry.VectorFormat
-
The default separator: ", ".
- DEFAULT_STOPFITNESS - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- DEFAULT_STOPPING_RADIUS - Static variable in class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
-
- DEFAULT_SUFFIX - Static variable in class org.apache.commons.math3.geometry.VectorFormat
-
The default suffix: "}".
- DEFAULT_TIES_STRATEGY - Static variable in class org.apache.commons.math3.stat.ranking.NaturalRanking
-
default ties strategy
- DEFAULT_ZERO_TOLERANCE - Static variable in class org.apache.commons.math3.linear.OpenMapRealVector
-
Default Tolerance for having a value considered zero.
- DefaultFieldMatrixChangingVisitor<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
-
- DefaultFieldMatrixChangingVisitor(T) - Constructor for class org.apache.commons.math3.linear.DefaultFieldMatrixChangingVisitor
-
Build a new instance.
- DefaultFieldMatrixPreservingVisitor<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
-
- DefaultFieldMatrixPreservingVisitor(T) - Constructor for class org.apache.commons.math3.linear.DefaultFieldMatrixPreservingVisitor
-
Build a new instance.
- DefaultIterativeLinearSolverEvent - Class in org.apache.commons.math3.linear
-
- DefaultIterativeLinearSolverEvent(Object, int, RealVector, RealVector, RealVector, double) - Constructor for class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
-
Creates a new instance of this class.
- DefaultIterativeLinearSolverEvent(Object, int, RealVector, RealVector, double) - Constructor for class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
-
Creates a new instance of this class.
- DefaultMeasurementModel - Class in org.apache.commons.math3.filter
-
- DefaultMeasurementModel(double[][], double[][]) - Constructor for class org.apache.commons.math3.filter.DefaultMeasurementModel
-
Create a new
MeasurementModel
, taking double arrays as input
parameters for the respective measurement matrix and noise.
- DefaultMeasurementModel(RealMatrix, RealMatrix) - Constructor for class org.apache.commons.math3.filter.DefaultMeasurementModel
-
- DefaultProcessModel - Class in org.apache.commons.math3.filter
-
- DefaultProcessModel(double[][], double[][], double[][], double[], double[][]) - Constructor for class org.apache.commons.math3.filter.DefaultProcessModel
-
Create a new
ProcessModel
, taking double arrays as input
parameters.
- DefaultProcessModel(double[][], double[][], double[][]) - Constructor for class org.apache.commons.math3.filter.DefaultProcessModel
-
Create a new
ProcessModel
, taking double arrays as input
parameters.
- DefaultProcessModel(RealMatrix, RealMatrix, RealMatrix, RealVector, RealMatrix) - Constructor for class org.apache.commons.math3.filter.DefaultProcessModel
-
Create a new
ProcessModel
, taking double arrays as input
parameters.
- DefaultRealMatrixChangingVisitor - Class in org.apache.commons.math3.linear
-
- DefaultRealMatrixChangingVisitor() - Constructor for class org.apache.commons.math3.linear.DefaultRealMatrixChangingVisitor
-
- DefaultRealMatrixPreservingVisitor - Class in org.apache.commons.math3.linear
-
- DefaultRealMatrixPreservingVisitor() - Constructor for class org.apache.commons.math3.linear.DefaultRealMatrixPreservingVisitor
-
- DefaultTransformer - Class in org.apache.commons.math3.util
-
A Default NumberTransformer for java.lang.Numbers and Numeric Strings.
- DefaultTransformer() - Constructor for class org.apache.commons.math3.util.DefaultTransformer
-
- degree() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
-
Returns the degree of the polynomial.
- degree() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Returns the degree of the polynomial.
- degree() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
-
Returns the degree of the polynomial.
- delete(T) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
-
Delete an element from the tree.
- delete() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree.Node
-
Delete the node from the tree.
- density(double) - Method in class org.apache.commons.math3.distribution.BetaDistribution
-
Returns the probability density function (PDF) of this distribution
evaluated at the specified point x
.
- density(double) - Method in class org.apache.commons.math3.distribution.CauchyDistribution
-
Returns the probability density function (PDF) of this distribution
evaluated at the specified point x
.
- density(double) - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
Returns the probability density function (PDF) of this distribution
evaluated at the specified point x
.
- density(double) - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
-
Returns the probability density function (PDF) of this distribution
evaluated at the specified point x
.
- density(double) - Method in class org.apache.commons.math3.distribution.FDistribution
-
Returns the probability density function (PDF) of this distribution
evaluated at the specified point x
.
- density(double) - Method in class org.apache.commons.math3.distribution.GammaDistribution
-
Returns the probability density function (PDF) of this distribution
evaluated at the specified point x
.
- density(double) - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
Returns the probability density function (PDF) of this distribution
evaluated at the specified point x
.
- density(double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
Returns the probability density function (PDF) of this distribution
evaluated at the specified point x
.
- density(double) - Method in interface org.apache.commons.math3.distribution.RealDistribution
-
Returns the probability density function (PDF) of this distribution
evaluated at the specified point x
.
- density(double) - Method in class org.apache.commons.math3.distribution.TDistribution
-
Returns the probability density function (PDF) of this distribution
evaluated at the specified point x
.
- density(double) - Method in class org.apache.commons.math3.distribution.TriangularDistribution
-
Returns the probability density function (PDF) of this distribution
evaluated at the specified point x
.
- density(double) - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
-
Returns the probability density function (PDF) of this distribution
evaluated at the specified point x
.
- density(double) - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
Returns the probability density function (PDF) of this distribution
evaluated at the specified point x
.
- derivative() - Method in interface org.apache.commons.math3.analysis.DifferentiableUnivariateFunction
-
Returns the derivative of the function
- derivative() - Method in interface org.apache.commons.math3.analysis.DifferentiableUnivariateMatrixFunction
-
Returns the derivative of the function
- derivative() - Method in interface org.apache.commons.math3.analysis.DifferentiableUnivariateVectorFunction
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Acos
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Acosh
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Asin
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Asinh
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Atan
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Atanh
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Cbrt
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Constant
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Cos
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Cosh
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Exp
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Expm1
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Gaussian
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Identity
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Inverse
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Log
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Log10
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Log1p
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Logistic
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Logit
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Minus
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Power
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Sigmoid
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Sin
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Sinc
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Sinh
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Sqrt
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Tan
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.function.Tanh
-
Returns the derivative of the function
- derivative() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
-
- derivative() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
-
Get the derivative of the polynomial spline function.
- DescriptiveStatistics - Class in org.apache.commons.math3.stat.descriptive
-
Maintains a dataset of values of a single variable and computes descriptive
statistics based on stored data.
- DescriptiveStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Construct a DescriptiveStatistics instance with an infinite window
- DescriptiveStatistics(int) - Constructor for class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Construct a DescriptiveStatistics instance with the specified window
- DescriptiveStatistics(double[]) - Constructor for class org.apache.commons.math3.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.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Copy constructor.
- deserializeRealMatrix(Object, String, ObjectInputStream) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
- deserializeRealVector(Object, String, ObjectInputStream) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
- df(double, double, double, double) - Method in class org.apache.commons.math3.stat.inference.TTest
-
Computes approximate degrees of freedom for 2-sample t-test.
- Dfp - Class in org.apache.commons.math3.dfp
-
Decimal floating point library for Java
- Dfp(DfpField) - Constructor for class org.apache.commons.math3.dfp.Dfp
-
Makes an instance with a value of zero.
- Dfp(DfpField, byte) - Constructor for class org.apache.commons.math3.dfp.Dfp
-
Create an instance from a byte value.
- Dfp(DfpField, int) - Constructor for class org.apache.commons.math3.dfp.Dfp
-
Create an instance from an int value.
- Dfp(DfpField, long) - Constructor for class org.apache.commons.math3.dfp.Dfp
-
Create an instance from a long value.
- Dfp(DfpField, double) - Constructor for class org.apache.commons.math3.dfp.Dfp
-
Create an instance from a double value.
- Dfp(Dfp) - Constructor for class org.apache.commons.math3.dfp.Dfp
-
Copy constructor.
- Dfp(DfpField, String) - Constructor for class org.apache.commons.math3.dfp.Dfp
-
Create an instance from a String representation.
- Dfp(DfpField, byte, byte) - Constructor for class org.apache.commons.math3.dfp.Dfp
-
Creates an instance with a non-finite value.
- dfp2sci() - Method in class org.apache.commons.math3.dfp.Dfp
-
Convert an instance to a string using scientific notation.
- dfp2string() - Method in class org.apache.commons.math3.dfp.Dfp
-
Convert an instance to a string using normal notation.
- DfpDec - Class in org.apache.commons.math3.dfp
-
Subclass of
Dfp
which hides the radix-10000 artifacts of the superclass.
- DfpDec(DfpField) - Constructor for class org.apache.commons.math3.dfp.DfpDec
-
Makes an instance with a value of zero.
- DfpDec(DfpField, byte) - Constructor for class org.apache.commons.math3.dfp.DfpDec
-
Create an instance from a byte value.
- DfpDec(DfpField, int) - Constructor for class org.apache.commons.math3.dfp.DfpDec
-
Create an instance from an int value.
- DfpDec(DfpField, long) - Constructor for class org.apache.commons.math3.dfp.DfpDec
-
Create an instance from a long value.
- DfpDec(DfpField, double) - Constructor for class org.apache.commons.math3.dfp.DfpDec
-
Create an instance from a double value.
- DfpDec(Dfp) - Constructor for class org.apache.commons.math3.dfp.DfpDec
-
Copy constructor.
- DfpDec(DfpField, String) - Constructor for class org.apache.commons.math3.dfp.DfpDec
-
Create an instance from a String representation.
- DfpDec(DfpField, byte, byte) - Constructor for class org.apache.commons.math3.dfp.DfpDec
-
Creates an instance with a non-finite value.
- DfpField - Class in org.apache.commons.math3.dfp
-
Field for Decimal floating point instances.
- DfpField(int) - Constructor for class org.apache.commons.math3.dfp.DfpField
-
Create a factory for the specified number of radix digits.
- DfpField.RoundingMode - Enum in org.apache.commons.math3.dfp
-
Enumerate for rounding modes.
- DfpMath - Class in org.apache.commons.math3.dfp
-
Mathematical routines for use with
Dfp
.
- DftNormalization - Enum in org.apache.commons.math3.transform
-
This enumeration defines the various types of normalizations that can be
applied to discrete Fourier transforms (DFT).
- difference(Region<S>, Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
-
Compute the difference of two regions.
- DifferentiableMultivariateFunction - Interface in org.apache.commons.math3.analysis
-
- DifferentiableMultivariateMultiStartOptimizer - Class in org.apache.commons.math3.optimization
-
- DifferentiableMultivariateMultiStartOptimizer(DifferentiableMultivariateOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.DifferentiableMultivariateMultiStartOptimizer
-
Create a multi-start optimizer from a single-start optimizer.
- DifferentiableMultivariateOptimizer - Interface in org.apache.commons.math3.optimization
-
- DifferentiableMultivariateVectorFunction - Interface in org.apache.commons.math3.analysis
-
- DifferentiableMultivariateVectorMultiStartOptimizer - Class in org.apache.commons.math3.optimization
-
- DifferentiableMultivariateVectorMultiStartOptimizer(DifferentiableMultivariateVectorOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.DifferentiableMultivariateVectorMultiStartOptimizer
-
Create a multi-start optimizer from a single-start optimizer.
- DifferentiableMultivariateVectorOptimizer - Interface in org.apache.commons.math3.optimization
-
- DifferentiableUnivariateFunction - Interface in org.apache.commons.math3.analysis
-
- DifferentiableUnivariateMatrixFunction - Interface in org.apache.commons.math3.analysis
-
- DifferentiableUnivariateSolver - Interface in org.apache.commons.math3.analysis.solvers
-
Interface for (univariate real) rootfinding algorithms.
- DifferentiableUnivariateVectorFunction - Interface in org.apache.commons.math3.analysis
-
- differentiate(double[]) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
-
Returns the coefficients of the derivative of the polynomial with the given coefficients.
- digamma(double) - Static method in class org.apache.commons.math3.special.Gamma
-
Computes the digamma function of x.
- DIGEST_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
-
Use empirical distribution.
- DimensionMismatchException - Exception in org.apache.commons.math3.exception
-
Exception to be thrown when two dimensions differ.
- DimensionMismatchException(Localizable, int, int) - Constructor for exception org.apache.commons.math3.exception.DimensionMismatchException
-
Construct an exception from the mismatched dimensions.
- DimensionMismatchException(int, int) - Constructor for exception org.apache.commons.math3.exception.DimensionMismatchException
-
Construct an exception from the mismatched dimensions.
- discardFrontElements(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Discards the i initial elements of the array.
- discardMostRecentElements(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Discards the i last elements of the array.
- distance(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Compute the distance between the instance and another vector according to the L2 norm.
- distance(Vector1D, Vector1D) - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Compute the distance between two vectors according to the L2 norm.
- distance(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
-
Compute the distance between the instance and a point.
- distance(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
-
Compute the shortest distance between the instance and another line.
- distance(Rotation, Rotation) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Compute the distance between two rotations.
- distance(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Compute the distance between the instance and another vector according to the L2 norm.
- distance(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Compute the distance between two vectors according to the L2 norm.
- distance(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Compute the distance between the instance and another vector according to the L2 norm.
- distance(Vector2D, Vector2D) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
-
Compute the distance between the instance and another vector according to the L2 norm.
- distance(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
-
Calculates the L2 (Euclidean) distance between two points.
- distance(int[], int[]) - Static method in class org.apache.commons.math3.util.MathArrays
-
Calculates the L2 (Euclidean) distance between two points.
- distance1(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.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.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Compute the distance between two vectors according to the L1 norm.
- distance1(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
-
Calculates the L1 (sum of abs) distance between two points.
- distance1(int[], int[]) - Static method in class org.apache.commons.math3.util.MathArrays
-
Calculates the L1 (sum of abs) distance between two points.
- distanceFrom(T) - Method in interface org.apache.commons.math3.stat.clustering.Clusterable
-
Returns the distance from the given point.
- distanceFrom(EuclideanIntegerPoint) - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
-
Returns the distance from the given point.
- distanceInf(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.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.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.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.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.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.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
-
Calculates the L∞ (max of abs) distance between two points.
- distanceInf(int[], int[]) - Static method in class org.apache.commons.math3.util.MathArrays
-
Calculates the L∞ (max of abs) distance between two points.
- distanceSq(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector1D, Vector1D) - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector2D, Vector2D) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
-
Compute the square of the distance between the instance and another vector.
- Divide - Class in org.apache.commons.math3.analysis.function
-
Divide the first operand by the second.
- Divide() - Constructor for class org.apache.commons.math3.analysis.function.Divide
-
- divide(Complex) - Method in class org.apache.commons.math3.complex.Complex
-
Returns a Complex
whose value is
(this / divisor)
.
- divide(double) - Method in class org.apache.commons.math3.complex.Complex
-
Returns a Complex
whose value is (this / divisor)
,
with divisor
interpreted as a real number.
- divide(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
-
Divide this by divisor.
- divide(int) - Method in class org.apache.commons.math3.dfp.Dfp
-
Divide by a single digit less than radix.
- divide(T) - Method in interface org.apache.commons.math3.FieldElement
-
Compute this ÷ a.
- divide(BigInteger) - Method in class org.apache.commons.math3.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.apache.commons.math3.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.apache.commons.math3.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.apache.commons.math3.fraction.BigFraction
-
Divide the value of this fraction by another, returning the result in
reduced form.
- divide(Fraction) - Method in class org.apache.commons.math3.fraction.Fraction
-
Divide the value of this fraction by another.
- divide(int) - Method in class org.apache.commons.math3.fraction.Fraction
-
Divide the fraction by an integer.
- divide(BigReal) - Method in class org.apache.commons.math3.util.BigReal
-
Compute this ÷ a.
- DividedDifferenceInterpolator - Class in org.apache.commons.math3.analysis.interpolation
-
- DividedDifferenceInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.DividedDifferenceInterpolator
-
- doCopy() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Really copy the finalized instance.
- doCopy() - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
-
Really copy the finalized instance.
- doFinalize() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Really finalize the step.
- doIntegrate() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Method for implementing actual integration algorithms in derived
classes.
- doIntegrate() - Method in class org.apache.commons.math3.analysis.integration.LegendreGaussIntegrator
-
Method for implementing actual integration algorithms in derived
classes.
- doIntegrate() - Method in class org.apache.commons.math3.analysis.integration.RombergIntegrator
-
Method for implementing actual integration algorithms in derived
classes.
- doIntegrate() - Method in class org.apache.commons.math3.analysis.integration.SimpsonIntegrator
-
Method for implementing actual integration algorithms in derived
classes.
- doIntegrate() - Method in class org.apache.commons.math3.analysis.integration.TrapezoidIntegrator
-
Method for implementing actual integration algorithms in derived
classes.
- doIteration(SimplexTableau) - Method in class org.apache.commons.math3.optimization.linear.SimplexSolver
-
Runs one iteration of the Simplex method on the given model.
- doOptimize() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
-
Perform the bulk of the optimization algorithm.
- doOptimize() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
-
Perform the bulk of the optimization algorithm.
- doOptimize() - Method in class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
-
Perform the bulk of the optimization algorithm.
- doOptimize() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
Perform the bulk of the optimization algorithm.
- doOptimize() - Method in class org.apache.commons.math3.optimization.direct.PowellOptimizer
-
Perform the bulk of the optimization algorithm.
- doOptimize() - Method in class org.apache.commons.math3.optimization.direct.SimplexOptimizer
-
Perform the bulk of the optimization algorithm.
- doOptimize() - Method in class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
-
Perform the bulk of the optimization algorithm.
- doOptimize() - Method in class org.apache.commons.math3.optimization.general.LevenbergMarquardtOptimizer
-
Perform the bulk of the optimization algorithm.
- doOptimize() - Method in class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
-
Perform the bulk of the optimization algorithm.
- doOptimize() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
-
Perform the bulk of optimization algorithm.
- doOptimize() - Method in class org.apache.commons.math3.optimization.linear.SimplexSolver
-
Perform the bulk of optimization algorithm.
- doOptimize() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
-
Method for implementing actual optimization algorithms in derived
classes.
- doOptimize() - Method in class org.apache.commons.math3.optimization.univariate.BrentOptimizer
-
Method for implementing actual optimization algorithms in derived
classes.
- DormandPrince54Integrator - Class in org.apache.commons.math3.ode.nonstiff
-
This class implements the 5(4) Dormand-Prince integrator for Ordinary
Differential Equations.
- DormandPrince54Integrator(double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince54Integrator
-
Simple constructor.
- DormandPrince54Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince54Integrator
-
Simple constructor.
- DormandPrince853Integrator - Class in org.apache.commons.math3.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.apache.commons.math3.ode.nonstiff.DormandPrince853Integrator
-
Simple constructor.
- DormandPrince853Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince853Integrator
-
Simple constructor.
- doSolve() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Method for implementing actual optimization algorithms in derived
classes.
- doSolve() - Method in class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
-
Method for implementing actual optimization algorithms in derived
classes.
- doSolve() - Method in class org.apache.commons.math3.analysis.solvers.BisectionSolver
-
Method for implementing actual optimization algorithms in derived
classes.
- doSolve() - Method in class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
-
Method for implementing actual optimization algorithms in derived
classes.
- doSolve() - Method in class org.apache.commons.math3.analysis.solvers.BrentSolver
-
Method for implementing actual optimization algorithms in derived
classes.
- doSolve() - Method in class org.apache.commons.math3.analysis.solvers.LaguerreSolver
-
Method for implementing actual optimization algorithms in derived
classes.
- doSolve() - Method in class org.apache.commons.math3.analysis.solvers.MullerSolver
-
Method for implementing actual optimization algorithms in derived
classes.
- doSolve() - Method in class org.apache.commons.math3.analysis.solvers.MullerSolver2
-
Method for implementing actual optimization algorithms in derived
classes.
- doSolve() - Method in class org.apache.commons.math3.analysis.solvers.NewtonSolver
-
Method for implementing actual optimization algorithms in derived
classes.
- doSolve() - Method in class org.apache.commons.math3.analysis.solvers.RiddersSolver
-
Method for implementing actual optimization algorithms in derived
classes.
- doSolve() - Method in class org.apache.commons.math3.analysis.solvers.SecantSolver
-
Method for implementing actual optimization algorithms in derived
classes.
- dotProduct(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Compute the dot-product of two vectors.
- dotProduct(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
-
Compute the dot-product of the instance and another vector.
- dotProduct(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Compute the dot product.
- dotProduct(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Compute the dot product.
- dotProduct(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Compute the dot product of this vector with v
.
- dotProduct(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
-
Compute the dot product.
- dotProduct(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Optimized method to compute the dot product with an OpenMapRealVector.
- dotProduct(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Compute the dot product of this vector with v
.
- dotProduct(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
-
Compute the dot product of this vector with v
.
- dotProduct(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Compute the dot product.
- dotrap(int, String, Dfp, Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
-
Raises a trap.
- DoubleArray - Interface in org.apache.commons.math3.util
-
Provides a standard interface for double arrays.
- doubleValue() - Method in class org.apache.commons.math3.fraction.BigFraction
-
Gets the fraction as a double.
- doubleValue() - Method in class org.apache.commons.math3.fraction.Fraction
-
Gets the fraction as a double.
- doubleValue() - Method in class org.apache.commons.math3.util.BigReal
-
Get the double value corresponding to the instance.
- DOWNSIDE_VARIANCE - Static variable in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
-
The DOWNSIDE Direction is used to specify that the observations below
the cutoff point will be used to calculate SemiVariance
- DstNormalization - Enum in org.apache.commons.math3.transform
-
This enumeration defines the various types of normalizations that can be
applied to discrete sine transforms (DST).
- DummyLocalizable - Class in org.apache.commons.math3.exception.util
-
Dummy implementation of the
Localizable
interface, without localization.
- DummyLocalizable(String) - Constructor for class org.apache.commons.math3.exception.util.DummyLocalizable
-
Simple constructor.
- DummyStepHandler - Class in org.apache.commons.math3.ode.sampling
-
This class is a step handler that does nothing.
- g(double, double[]) - Method in interface org.apache.commons.math3.ode.events.EventHandler
-
Compute the value of the switching function.
- Gamma - Class in org.apache.commons.math3.special
-
This is a utility class that provides computation methods related to the
Gamma family of functions.
- GAMMA - Static variable in class org.apache.commons.math3.special.Gamma
-
- GammaDistribution - Class in org.apache.commons.math3.distribution
-
Implementation of the Gamma distribution.
- GammaDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.GammaDistribution
-
Create a new gamma distribution with the given alpha
and
beta
values.
- GammaDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.GammaDistribution
-
Create a new gamma distribution with the given alpha
and
beta
values.
- Gaussian - Class in org.apache.commons.math3.analysis.function
-
- Gaussian(double, double, double) - Constructor for class org.apache.commons.math3.analysis.function.Gaussian
-
Gaussian with given normalization factor, mean and standard deviation.
- Gaussian(double, double) - Constructor for class org.apache.commons.math3.analysis.function.Gaussian
-
Normalized gaussian with given mean and standard deviation.
- Gaussian() - Constructor for class org.apache.commons.math3.analysis.function.Gaussian
-
Normalized gaussian with zero mean and unit standard deviation.
- Gaussian.Parametric - Class in org.apache.commons.math3.analysis.function
-
Parametric function where the input array contains the parameters of
the Gaussian, ordered as follows:
Norm
Mean
Standard deviation
- Gaussian.Parametric() - Constructor for class org.apache.commons.math3.analysis.function.Gaussian.Parametric
-
- GAUSSIAN_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
-
Gaussian random deviates with mean = μ, std dev = σ.
- GaussianFitter - Class in org.apache.commons.math3.optimization.fitting
-
- GaussianFitter(DifferentiableMultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.GaussianFitter
-
Constructs an instance using the specified optimizer.
- GaussianFitter.ParameterGuesser - Class in org.apache.commons.math3.optimization.fitting
-
Guesses the parameters
norm
,
mean
, and
sigma
of a
Gaussian.Parametric
based on the specified observed points.
- GaussianFitter.ParameterGuesser(WeightedObservedPoint[]) - Constructor for class org.apache.commons.math3.optimization.fitting.GaussianFitter.ParameterGuesser
-
Constructs instance with the specified observed points.
- GaussianRandomGenerator - Class in org.apache.commons.math3.random
-
This class is a gaussian normalized random generator for scalars.
- GaussianRandomGenerator(RandomGenerator) - Constructor for class org.apache.commons.math3.random.GaussianRandomGenerator
-
Create a new generator.
- GaussNewtonOptimizer - Class in org.apache.commons.math3.optimization.general
-
Gauss-Newton least-squares solver.
- GaussNewtonOptimizer() - Constructor for class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
-
Simple constructor with default settings.
- GaussNewtonOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
-
Simple constructor with default settings.
- GaussNewtonOptimizer(boolean) - Constructor for class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
-
Simple constructor with default settings.
- GaussNewtonOptimizer(boolean, ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
-
- gcd(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Gets the greatest common divisor of the absolute value of two numbers,
using the "binary gcd" method which avoids division and modulo
operations.
- gcd(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Gets the greatest common divisor of the absolute value of two numbers,
using the "binary gcd" method which avoids division and modulo
operations.
- GeneticAlgorithm - Class in org.apache.commons.math3.genetics
-
Implementation of a genetic algorithm.
- GeneticAlgorithm(CrossoverPolicy, double, MutationPolicy, double, SelectionPolicy) - Constructor for class org.apache.commons.math3.genetics.GeneticAlgorithm
-
- GeometricMean - Class in org.apache.commons.math3.stat.descriptive.moment
-
- GeometricMean() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
-
Create a GeometricMean instance
- GeometricMean(GeometricMean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
-
Copy constructor, creates a new GeometricMean
identical
to the original
- GeometricMean(SumOfLogs) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
-
Create a GeometricMean instance using the given SumOfLogs instance
- geometricMean(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the geometric mean of the entries in the input array, or
Double.NaN
if the array is empty.
- geometricMean(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the geometric mean of the entries in the specified portion of
the input array, or Double.NaN
if the designated subarray
is empty.
- get(int) - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
-
Get the stored value associated with the given key
- get(int) - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
-
Get the stored value associated with the given key
- getA(int, double) - Method in class org.apache.commons.math3.util.ContinuedFraction
-
Access the n-th a coefficient of the continued fraction.
- getA1() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
-
Get the axis of the first rotation.
- getA2() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
-
Get the axis of the second rotation.
- getA3() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
-
Get the axis of the second rotation.
- getAbscissa(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
-
Get the abscissa of a point with respect to the line.
- getAbsoluteAccuracy() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the actual absolute accuracy.
- getAbsoluteAccuracy() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
-
Get the actual absolute accuracy.
- getAbsoluteAccuracy() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Get the absolute accuracy of the solver.
- getAbsoluteAccuracy() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
-
Get the absolute accuracy of the solver.
- getAbsoluteAccuracy() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
-
Get the absolute accuracy.
- getAbsoluteThreshold() - Method in class org.apache.commons.math3.optimization.AbstractConvergenceChecker
-
- getAdjustedRSquared() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
-
Returns the adjusted R-squared statistic, defined by the formula
- getAlpha() - Method in class org.apache.commons.math3.distribution.BetaDistribution
-
Access the first shape parameter, alpha
.
- getAlpha() - Method in class org.apache.commons.math3.distribution.GammaDistribution
-
Access the alpha
shape parameter.
- getAlpha() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Get the azimuth of the vector.
- getAngle() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Get the angle of the rotation.
- getAngle() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Get the angle of the line.
- getAngles(RotationOrder) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Get the Cardan or Euler angles corresponding to the instance.
- getArgument() - Method in class org.apache.commons.math3.complex.Complex
-
Compute the argument of this complex number.
- getArgument() - Method in exception org.apache.commons.math3.exception.MathIllegalNumberException
-
- getArity() - Method in class org.apache.commons.math3.genetics.TournamentSelection
-
Gets the arity (number of chromosomes drawn to the tournament).
- getAttribute() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
-
Get the attribute associated with the instance.
- getAvailableLocales() - Static method in class org.apache.commons.math3.complex.ComplexFormat
-
Get the set of locales for which complex formats are available.
- getAvailableLocales() - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
-
Get the set of locales for which complex formats are available.
- getAvailableLocales() - Static method in class org.apache.commons.math3.fraction.FractionFormat
-
Get the set of locales for which complex formats are available.
- getAvailableLocales() - Static method in class org.apache.commons.math3.geometry.VectorFormat
-
Get the set of locales for which point/vector formats are available.
- getAvailableLocales() - Static method in class org.apache.commons.math3.linear.RealVectorFormat
-
Get the set of locales for which real vectors formats are available.
- getAxis() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Get the normalized axis of the rotation.
- getB(int, double) - Method in class org.apache.commons.math3.util.ContinuedFraction
-
Access the n-th b coefficient of the continued fraction.
- getBarycenter() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Get the barycenter of the instance.
- getBarycenter() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
-
Get the barycenter of the instance.
- getBeta() - Method in class org.apache.commons.math3.distribution.BetaDistribution
-
Access the second shape parameter, beta
.
- getBeta() - Method in class org.apache.commons.math3.distribution.GammaDistribution
-
Access the beta
scale parameter.
- getBinCount() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
-
Returns the number of bins.
- getBinStats() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
-
Returns a List of
SummaryStatistics
instances containing
statistics describing the values in each of the bins.
- getBoundarySize() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Get the size of the boundary.
- getBoundarySize() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
-
Get the size of the boundary.
- getBoundIsAllowed() - Method in exception org.apache.commons.math3.exception.NumberIsTooLargeException
-
- getBoundIsAllowed() - Method in exception org.apache.commons.math3.exception.NumberIsTooSmallException
-
- getCell(Vector<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
-
Get the cell to which a point belongs.
- getCenter() - Method in class org.apache.commons.math3.stat.clustering.Cluster
-
Get the point chosen to be the center of this cluster.
- getCenters() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
-
Returns a copy of the centers array.
- getCheck() - Method in class org.apache.commons.math3.linear.ConjugateGradient
-
Returns true
if positive-definiteness should be checked for both
matrix and preconditioner.
- getCheck() - Method in class org.apache.commons.math3.linear.SymmLQ
-
Returns true
if symmetry of the matrix, and symmetry as well as
positive definiteness of the preconditioner should be checked.
- getChiSquare() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
-
Get a Chi-Square-like value assuming the N residuals follow N
distinct normal distributions centered on 0 and whose variances are
the reciprocal of the weights.
- getChromosomes() - Method in class org.apache.commons.math3.genetics.ListPopulation
-
Access the list of chromosomes.
- getCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
-
Returns a copy of the coefficients array.
- getCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Returns a copy of the coefficients array.
- getCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
-
Returns a copy of the coefficients array.
- getCoefficients() - Method in class org.apache.commons.math3.analysis.solvers.AbstractPolynomialSolver
-
- getCoefficients() - Method in class org.apache.commons.math3.optimization.linear.LinearConstraint
-
Get the coefficients of the constraint (left hand side).
- getCoefficients() - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
-
Get the coefficients of the linear equation being optimized.
- getColumn(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Get the entries in column number col
as an array.
- getColumn(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Get the entries at the given column index as an array.
- getColumn(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Get the entries in column number col
as an array.
- getColumn(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Get the entries at the given column index as an array.
- getColumn(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Get the entries in column number col
as an array.
- getColumn() - Method in exception org.apache.commons.math3.linear.NonPositiveDefiniteMatrixException
-
- getColumn() - Method in exception org.apache.commons.math3.linear.NonSymmetricMatrixException
-
- getColumn(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Get the entries at the given column index as an array.
- getColumnDimension() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Returns the number of columns in the matrix.
- getColumnDimension() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Returns the number of columns of this matrix.
- getColumnDimension() - Method in interface org.apache.commons.math3.linear.AnyMatrix
-
Returns the number of columns in the matrix.
- getColumnDimension() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Returns the number of columns in the matrix.
- getColumnDimension() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Returns the number of columns of this matrix.
- getColumnDimension() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Returns the number of columns in the matrix.
- getColumnDimension() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Returns the number of columns of this matrix.
- getColumnDimension() - Method in class org.apache.commons.math3.linear.JacobiPreconditioner
-
Returns the dimension of the domain of this operator.
- getColumnDimension() - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
-
Returns the number of columns of this matrix.
- getColumnDimension() - Method in class org.apache.commons.math3.linear.RealLinearOperator
-
Returns the dimension of the domain of this operator.
- getColumnDimension() - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
-
Returns the number of columns in the matrix.
- getColumnMatrix(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Get the entries in column number column
as a column matrix.
- getColumnMatrix(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Get the entries at the given column index
as a column matrix.
- getColumnMatrix(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Get the entries in column number column
as a column matrix.
- getColumnMatrix(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Get the entries at the given column index
as a column matrix.
- getColumnMatrix(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Get the entries in column number column
as a column matrix.
- getColumnMatrix(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Get the entries at the given column index
as a column matrix.
- getColumnVector(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Returns the entries in column number column
as a vector.
- getColumnVector(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Get the entries at the given column index
as a vector.
- getColumnVector(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Returns the entries in column number column
as a vector.
- getColumnVector(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Get the entries at the given column index
as a vector.
- getColumnVector(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Returns the entries in column number column
as a vector.
- getColumnVector(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Get the entries at the given column index
as a vector.
- getComplement(Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
-
Get the complement of the region (exchanged interior/exterior).
- getCompleteState() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Get the complete current state.
- getComponents() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.OrderedTuple
-
Get the components array.
- getConditionNumber() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
-
Return the condition number of the matrix.
- getConstantTerm() - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
-
Get the constant of the linear equation being optimized.
- getConstraints() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
-
- getContext() - Method in exception org.apache.commons.math3.exception.MathArithmeticException
-
Gets a reference to the "rich context" data structure that allows to
customize error messages and store key, value pairs in exceptions.
- getContext() - Method in exception org.apache.commons.math3.exception.MathIllegalArgumentException
-
Gets a reference to the "rich context" data structure that allows to
customize error messages and store key, value pairs in exceptions.
- getContext() - Method in exception org.apache.commons.math3.exception.MathIllegalStateException
-
Gets a reference to the "rich context" data structure that allows to
customize error messages and store key, value pairs in exceptions.
- getContext() - Method in exception org.apache.commons.math3.exception.MathUnsupportedOperationException
-
Gets a reference to the "rich context" data structure that allows to
customize error messages and store key, value pairs in exceptions.
- getContext() - Method in interface org.apache.commons.math3.exception.util.ExceptionContextProvider
-
Gets a reference to the "rich context" data structure that allows to
customize error messages and store key, value pairs in exceptions.
- getContractionCriteria() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
The contraction criteria defines when the internal array will contract
to store only the number of elements in the element array.
- getControlMatrix() - Method in class org.apache.commons.math3.filter.DefaultProcessModel
-
Returns the control matrix.
- getControlMatrix() - Method in interface org.apache.commons.math3.filter.ProcessModel
-
Returns the control matrix.
- getConvergence() - Method in class org.apache.commons.math3.ode.events.EventState
-
Get the convergence threshold for event localization.
- getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
-
Get the convergence checker.
- getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
-
Get the convergence checker.
- getConvergenceChecker() - Method in interface org.apache.commons.math3.optimization.BaseOptimizer
-
Get the convergence checker.
- getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
-
Get the convergence checker.
- getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
-
Get the convergence checker.
- getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
-
Get the convergence checker.
- getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
-
Get the convergence checker.
- getCorrelationMatrix() - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
-
Returns the correlation matrix
- getCorrelationMatrix() - Method in class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
-
Calculate the Spearman Rank Correlation Matrix.
- getCorrelationPValues() - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
-
Returns a matrix of p-values associated with the (two-sided) null
hypothesis that the corresponding correlation coefficient is zero.
- getCorrelationStandardErrors() - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
-
Returns a matrix of standard errors associated with the estimates
in the correlation matrix.
getCorrelationStandardErrors().getEntry(i,j)
is the standard
error associated with getCorrelationMatrix.getEntry(i,j)
- getCount(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the number of values = v.
- getCount(int) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the number of values = v.
- getCount(long) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the number of values = v.
- getCount(char) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the number of values = v.
- getCount() - Method in class org.apache.commons.math3.util.Incrementor
-
Gets the current count.
- getCount(int...) - Method in class org.apache.commons.math3.util.MultidimensionalCounter
-
Convert to unidimensional counter.
- getCount() - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
-
Get the current unidimensional counter slot.
- getCount(int) - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
-
Get the current count in the selected dimension.
- getCounts(int) - Method in class org.apache.commons.math3.util.MultidimensionalCounter
-
Convert to multidimensional counter.
- getCounts() - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
-
Get the current multidimensional counter slots.
- getCovariance(double) - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
-
Returns the n × n covariance matrix.
- getCovariance(int, int) - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
-
Get the covariance for an individual element of the covariance matrix.
- getCovariance() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Returns the covariance matrix of the values that have been added.
- getCovariance() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
-
Returns the covariance of the available values.
- getCovariance() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the covariance matrix of the values that have been added.
- getCovarianceMatrix() - Method in class org.apache.commons.math3.stat.correlation.Covariance
-
Returns the covariance matrix
- getCovarianceMatrix() - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
-
Returns the covariance matrix
- getCovarianceOfParameters(int, int) - Method in class org.apache.commons.math3.stat.regression.RegressionResults
-
Returns the covariance between regression parameters i and j.
- getCovariances() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
-
Get the covariance matrix of the optimized parameters.
- getCovariances(double) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
-
Get the covariance matrix of the optimized parameters.
- getCrossoverPolicy() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
-
Returns the crossover policy.
- getCrossoverRate() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
-
Returns the crossover rate.
- getCumFreq(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the cumulative frequency of values less than or equal to v.
- getCumFreq(int) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the cumulative frequency of values less than or equal to v.
- getCumFreq(long) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the cumulative frequency of values less than or equal to v.
- getCumFreq(char) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the cumulative frequency of values less than or equal to v.
- getCumPct(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the cumulative percentage of values less than or equal to v
(as a proportion between 0 and 1).
- getCumPct(int) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the cumulative percentage of values less than or equal to v
(as a proportion between 0 and 1).
- getCumPct(long) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the cumulative percentage of values less than or equal to v
(as a proportion between 0 and 1).
- getCumPct(char) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the cumulative percentage of values less than or equal to v
(as a proportion between 0 and 1).
- getCurrentMainSetJacobian(double[][]) - Method in class org.apache.commons.math3.ode.JacobianMatrices
-
Get the current value of the Jacobian matrix with respect to state.
- getCurrentParameterJacobian(String, double[]) - Method in class org.apache.commons.math3.ode.JacobianMatrices
-
Get the current value of the Jacobian matrix with respect to one parameter.
- getCurrentSignedStepsize() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Get the current signed value of the integration stepsize.
- getCurrentSignedStepsize() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
-
Get the current signed value of the integration stepsize.
- getCurrentStepStart() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Get the current value of the step start time ti.
- getCurrentStepStart() - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Get the current value of the step start time ti.
- getCurrentStepStart() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
-
Get the current value of the step start time ti.
- getCurrentTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Get the current soft grid point time.
- getCurrentTime() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
-
Get the current grid point time.
- getCut() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
-
Get the cut sub-hyperplane.
- getD() - Method in class org.apache.commons.math3.linear.EigenDecomposition
-
Gets the block diagonal matrix D of the decomposition.
- getData() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Returns vector entries as a T array.
- getData() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in interface org.apache.commons.math3.linear.FieldVector
-
Returns vector entries as a T array.
- getData() - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Returns vector entries as a T array.
- getData() - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
-
Return the covariance matrix as two-dimensional array.
- getData() - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
-
Get a copy of the stored data array.
- getDataRef() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Get a reference to the underlying data array.
- getDataRef() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Get a reference to the underlying data array.
- getDataRef() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Returns a reference to the underlying data array.
- getDataRef() - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Get a reference to the underlying data array.
- getDataRef() - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
-
Get a reference to the stored data array.
- getDecimalDigits() - Method in class org.apache.commons.math3.dfp.DfpDec
-
Get the number of decimal digits this class is going to represent.
- getDefaultNumberFormat() - Static method in class org.apache.commons.math3.fraction.AbstractFormat
-
Create a default number format.
- getDefaultNumberFormat(Locale) - Static method in class org.apache.commons.math3.fraction.AbstractFormat
-
Create a default number format.
- getDefaultNumberFormat() - Static method in class org.apache.commons.math3.fraction.FractionFormat
-
Create a default number format.
- getDefaultNumberFormat() - Static method in class org.apache.commons.math3.util.CompositeFormat
-
Create a default number format.
- getDefaultNumberFormat(Locale) - Static method in class org.apache.commons.math3.util.CompositeFormat
-
Create a default number format.
- getDegreesOfFreedom() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
Access the number of degrees of freedom.
- getDegreesOfFreedom() - Method in class org.apache.commons.math3.distribution.TDistribution
-
Access the degrees of freedom.
- getDelta() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Get the elevation of the vector.
- getDenominator() - Method in class org.apache.commons.math3.fraction.BigFraction
-
Access the denominator as a BigInteger
.
- getDenominator() - Method in class org.apache.commons.math3.fraction.Fraction
-
Access the denominator.
- getDenominatorAsInt() - Method in class org.apache.commons.math3.fraction.BigFraction
-
Access the denominator as a int.
- getDenominatorAsLong() - Method in class org.apache.commons.math3.fraction.BigFraction
-
Access the denominator as a long.
- getDenominatorDegreesOfFreedom() - Method in class org.apache.commons.math3.distribution.FDistribution
-
Access the denominator degrees of freedom.
- getDenominatorFormat() - Method in class org.apache.commons.math3.fraction.AbstractFormat
-
Access the denominator format.
- getDeterminant() - Method in class org.apache.commons.math3.linear.CholeskyDecomposition
-
Return the determinant of the matrix
- getDeterminant() - Method in class org.apache.commons.math3.linear.EigenDecomposition
-
Computes the determinant of the matrix.
- getDeterminant() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
-
Return the determinant of the matrix.
- getDeterminant() - Method in class org.apache.commons.math3.linear.LUDecomposition
-
Return the determinant of the matrix
- getDiagonalOfHatMatrix(double[]) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
-
Gets the diagonal of the Hat matrix also known as the leverage matrix.
- getDimension() - Method in exception org.apache.commons.math3.exception.DimensionMismatchException
-
- getDimension() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Euclidean1D
-
Get the dimension of the space.
- getDimension() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Euclidean3D
-
Get the dimension of the space.
- getDimension() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Euclidean2D
-
Get the dimension of the space.
- getDimension() - Method in interface org.apache.commons.math3.geometry.Space
-
Get the dimension of the space.
- getDimension() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Returns the size of the vector.
- getDimension() - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Returns the size of the vector.
- getDimension() - Method in interface org.apache.commons.math3.linear.FieldVector
-
Returns the size of the vector.
- getDimension() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Returns the size of the vector.
- getDimension() - Method in class org.apache.commons.math3.linear.RealVector
-
Returns the size of the vector.
- getDimension() - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Returns the size of the vector.
- getDimension() - Method in class org.apache.commons.math3.ode.EquationsMapper
-
Get the dimension of the secondary state parameters.
- getDimension() - Method in class org.apache.commons.math3.ode.FirstOrderConverter
-
Get the dimension of the problem.
- getDimension() - Method in interface org.apache.commons.math3.ode.FirstOrderDifferentialEquations
-
Get the dimension of the problem.
- getDimension() - Method in interface org.apache.commons.math3.ode.SecondaryEquations
-
Get the dimension of the secondary state parameters.
- getDimension() - Method in interface org.apache.commons.math3.ode.SecondOrderDifferentialEquations
-
Get the dimension of the problem.
- getDimension() - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
-
Get simplex dimension.
- getDimension() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Returns the dimension of the data
- getDimension() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
-
Returns the dimension of the data
- getDimension() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the dimension of the data
- getDimension() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
-
Get the number of dimensions of the multidimensional counter.
- getDirection() - Method in exception org.apache.commons.math3.exception.NonMonotonicSequenceException
-
- getDirection() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
-
Get the normalized direction vector.
- getDistance(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Distance between two vectors.
- getDistance(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Optimized method to compute distance.
- getDistance(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Distance between two vectors.
- getDistance(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
-
Distance between two vectors.
- getE() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant e.
- getEigenvector(int) - Method in class org.apache.commons.math3.linear.EigenDecomposition
-
Gets a copy of the ith eigenvector of the original matrix.
- getElement() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree.Node
-
Get the contained element.
- getElement(int) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the element at the specified index
- getElement(int) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
Returns the element at the specified index
- getElement(int) - Method in interface org.apache.commons.math3.util.DoubleArray
-
Returns the element at the specified index.
- getElement(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Returns the element at the specified index
- getElements() - Method in interface org.apache.commons.math3.util.DoubleArray
-
Returns a double[] array containing the elements of this
DoubleArray
.
- getElements() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Returns a double array containing the elements of this
ResizableArray
.
- getElitismRate() - Method in class org.apache.commons.math3.genetics.ElitisticListPopulation
-
Access the elitism rate.
- getEmpiricalDistribution() - Method in class org.apache.commons.math3.random.ValueServer
-
- getEnd() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Segment
-
Get the end point of the segment.
- getEnd() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Segment
-
Get the end point of the segment.
- getEntry(int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Returns the entry in the specified row and column.
- getEntry(int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Get the entry in the specified row and column.
- getEntry(int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Returns the entry in the specified row and column.
- getEntry(int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Get the entry in the specified row and column.
- getEntry(int) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Returns the entry in the specified index.
- getEntry(int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Return the entry at the specified index.
- getEntry(int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Returns the entry in the specified row and column.
- getEntry(int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Get the entry in the specified row and column.
- getEntry(int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Returns the entry in the specified row and column.
- getEntry(int) - Method in interface org.apache.commons.math3.linear.FieldVector
-
Returns the entry in the specified index.
- getEntry(int, int) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
-
Get the entry in the specified row and column.
- getEntry(int) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Return the entry at the specified index.
- getEntry(int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Get the entry in the specified row and column.
- getEntry(int) - Method in class org.apache.commons.math3.linear.RealVector
-
Return the entry at the specified index.
- getEntry(int, int) - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
-
Returns the entry in the specified row and column.
- getEntry(int) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Returns the entry in the specified index.
- getErrorCovariance() - Method in class org.apache.commons.math3.filter.KalmanFilter
-
Returns the current error covariance matrix.
- getErrorCovarianceMatrix() - Method in class org.apache.commons.math3.filter.KalmanFilter
-
Returns a copy of the current error covariance matrix.
- getErrorSumSquares() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
-
- getESplit() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant e split in two pieces.
- getEvaluations() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the number of function evaluations of the last run of the integrator.
- getEvaluations() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
-
Get the number of function evaluations of the last run of the integrator.
- getEvaluations() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Get the number of evaluations of the differential equations function.
- getEvaluations() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
-
Get the number of evaluations of the differential equations function.
- getEvaluations() - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in interface org.apache.commons.math3.optimization.BaseOptimizer
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
-
- getEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
-
Get the number of evaluations of the objective function.
- getEventHandler() - Method in class org.apache.commons.math3.ode.events.EventState
-
Get the underlying event handler.
- getEventHandlers() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Get all the event handlers that have been added to the integrator.
- getEventHandlers() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
-
Get all the event handlers that have been added to the integrator.
- getEventTime() - Method in class org.apache.commons.math3.ode.events.EventState
-
Get the occurrence time of the event triggered in the current step.
- getExpansionFactor() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
The expansion factor controls the size of a new array when an array
needs to be expanded.
- getExpansionMode() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
The expansionMode
determines whether the internal storage
array grows additively (ADDITIVE_MODE) or multiplicatively
(MULTIPLICATIVE_MODE) when it is expanded.
- getExpectedColumnDimension() - Method in exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
-
- getExpectedDimension(int) - Method in exception org.apache.commons.math3.exception.MultiDimensionMismatchException
-
- getExpectedDimensions() - Method in exception org.apache.commons.math3.exception.MultiDimensionMismatchException
-
- getExpectedRowDimension() - Method in exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
-
- getExponent() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
-
Get the exponent characterizing the distribution.
- getExponent(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Return the exponent of a double number, removing the bias.
- getExponent(float) - Static method in class org.apache.commons.math3.util.FastMath
-
Return the exponent of a float number, removing the bias.
- getFHi() - Method in exception org.apache.commons.math3.exception.NoBracketingException
-
Get the value at the higher end of the interval.
- getFHi() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
-
- getField() - Method in class org.apache.commons.math3.complex.Complex
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.apache.commons.math3.dfp.Dfp
-
- getField() - Method in interface org.apache.commons.math3.FieldElement
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.apache.commons.math3.fraction.BigFraction
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.apache.commons.math3.fraction.Fraction
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Get the type of field elements of the matrix.
- getField() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Get the type of field elements of the vector.
- getField() - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Get the type of field elements of the matrix.
- getField() - Method in interface org.apache.commons.math3.linear.FieldVector
-
Get the type of field elements of the vector.
- getField() - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Get the type of field elements of the vector.
- getField() - Method in class org.apache.commons.math3.util.BigReal
-
Get the
Field
to which the instance belongs.
- getFinalTime() - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
-
Get the final integration time.
- getFirst() - Method in class org.apache.commons.math3.genetics.ChromosomePair
-
Access the first chromosome.
- getFirstIndex() - Method in class org.apache.commons.math3.ode.EquationsMapper
-
Get the index of the first equation element in complete state arrays.
- getFitness() - Method in class org.apache.commons.math3.genetics.Chromosome
-
Access the fitness of this chromosome.
- getFittestChromosome() - Method in class org.apache.commons.math3.genetics.ListPopulation
-
Access the fittest chromosome in this population.
- getFittestChromosome() - Method in interface org.apache.commons.math3.genetics.Population
-
Access the fittest chromosome in this population.
- getFLo() - Method in exception org.apache.commons.math3.exception.NoBracketingException
-
Get the value at the lower end of the interval.
- getFLo() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
-
- getFMid() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
-
- getFormat() - Method in class org.apache.commons.math3.geometry.VectorFormat
-
Get the components format.
- getFormat() - Method in class org.apache.commons.math3.linear.RealVectorFormat
-
Get the components format.
- getFrobeniusNorm() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
- getFrobeniusNorm() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
- getFrobeniusNorm() - Method in interface org.apache.commons.math3.linear.RealMatrix
-
- getFunction() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
-
- getFunctionValueAccuracy() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Get the function value accuracy of the solver.
- getFunctionValueAccuracy() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
-
Get the function value accuracy of the solver.
- getFunctionValueAccuracy() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
-
Get the function accuracy.
- getGenerationsEvolved() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
-
Returns the number of generations evolved to
reach
StoppingCondition
in the last run.
- getGenerator() - Method in class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
-
Get the underlying normalized components generator.
- getGeneratorUpperBounds() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
-
Returns a fresh copy of the array of upper bounds of the subintervals
of [0,1] used in generating data from the empirical distribution.
- getGeoMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured geometric mean implementation
- getGeoMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the currently configured geometric mean implementation
- getGeoMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured geometric mean implementation
- getGeoMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured geometric mean implementation
- getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Returns the geometric mean of all the aggregated data.
- getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
- getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
- getGeometricMean() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
geometric mean of the ith entries of the arrays
that correspond to each multivariate sample
- getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the geometric mean of the values that have been added.
- getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the geometric mean of the values that have been added.
- getGeometricMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured geometric mean implementation.
- getGlobalCurrentTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Get the current global grid point time.
- getGlobalPreviousTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Get the previous global grid point time.
- getGoalType() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
-
- getGoalType() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
-
- getGoalType() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
-
- getH() - Method in class org.apache.commons.math3.linear.QRDecomposition
-
Returns the Householder reflector vectors.
- getHi() - Method in exception org.apache.commons.math3.exception.NoBracketingException
-
Get the higher end of the interval.
- getHi() - Method in exception org.apache.commons.math3.exception.OutOfRangeException
-
- getHi() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
-
- getHyperplane() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
-
Get the underlying hyperplane.
- getHyperplane() - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
-
Get the underlying hyperplane.
- getIEEEFlags() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the IEEE 854 status flags.
- getImagEigenvalue(int) - Method in class org.apache.commons.math3.linear.EigenDecomposition
-
Gets the imaginary part of the ith eigenvalue of the original
matrix.
- getImagEigenvalues() - Method in class org.apache.commons.math3.linear.EigenDecomposition
-
Gets a copy of the imaginary parts of the eigenvalues of the original
matrix.
- getImaginary() - Method in class org.apache.commons.math3.complex.Complex
-
Access the imaginary part.
- getImaginary(int) - Method in class org.apache.commons.math3.complex.RootsOfUnity
-
Get the imaginary part of the k
-th n
-th root of unity.
- getImaginaryCharacter() - Method in class org.apache.commons.math3.complex.ComplexFormat
-
Access the imaginaryCharacter.
- getImaginaryFormat() - Method in class org.apache.commons.math3.complex.ComplexFormat
-
Access the imaginaryFormat.
- getImproperInstance() - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
-
Returns the default complex format for the current locale.
- getImproperInstance(Locale) - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
-
Returns the default complex format for the given locale.
- getImproperInstance() - Static method in class org.apache.commons.math3.fraction.FractionFormat
-
Returns the default complex format for the current locale.
- getImproperInstance(Locale) - Static method in class org.apache.commons.math3.fraction.FractionFormat
-
Returns the default complex format for the given locale.
- getIndex() - Method in exception org.apache.commons.math3.exception.NonMonotonicSequenceException
-
Get the index of the wrong value.
- getIndex() - Method in class org.apache.commons.math3.linear.OpenMapRealVector.OpenMapEntry
-
Get the index of the entry.
- getIndex() - Method in class org.apache.commons.math3.linear.RealVector.Entry
-
Get the index of the entry.
- getInf() - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
-
Get the lowest value belonging to the instance.
- getInitialErrorCovariance() - Method in class org.apache.commons.math3.filter.DefaultProcessModel
-
Returns the initial error covariance matrix.
- getInitialErrorCovariance() - Method in interface org.apache.commons.math3.filter.ProcessModel
-
Returns the initial error covariance matrix.
- getInitialStateEstimate() - Method in class org.apache.commons.math3.filter.DefaultProcessModel
-
Returns the initial state estimation vector.
- getInitialStateEstimate() - Method in interface org.apache.commons.math3.filter.ProcessModel
-
Returns the initial state estimation vector.
- getInitialTime() - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
-
Get the initial integration time.
- getInstance() - Static method in class org.apache.commons.math3.complex.ComplexField
-
Get the unique instance.
- getInstance() - Static method in class org.apache.commons.math3.complex.ComplexFormat
-
Returns the default complex format for the current locale.
- getInstance(Locale) - Static method in class org.apache.commons.math3.complex.ComplexFormat
-
Returns the default complex format for the given locale.
- getInstance(String, Locale) - Static method in class org.apache.commons.math3.complex.ComplexFormat
-
Returns the default complex format for the given locale.
- getInstance() - Static method in class org.apache.commons.math3.fraction.BigFractionField
-
Get the unique instance.
- getInstance() - Static method in class org.apache.commons.math3.fraction.FractionField
-
Get the unique instance.
- getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Euclidean1D
-
Get the unique instance.
- getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
-
Returns the default 1D vector format for the current locale.
- getInstance(Locale) - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
-
Returns the default 1D vector format for the given locale.
- getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Euclidean3D
-
Get the unique instance.
- getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
-
Returns the default 3D vector format for the current locale.
- getInstance(Locale) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
-
Returns the default 3D vector format for the given locale.
- getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Euclidean2D
-
Get the unique instance.
- getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
-
Returns the default 2D vector format for the current locale.
- getInstance(Locale) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
-
Returns the default 2D vector format for the given locale.
- getInstance() - Static method in class org.apache.commons.math3.linear.RealVectorFormat
-
Returns the default real vector format for the current locale.
- getInstance(Locale) - Static method in class org.apache.commons.math3.linear.RealVectorFormat
-
Returns the default real vector format for the given locale.
- getInstance(int) - Static method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
-
Get the Nordsieck transformer for a given number of steps.
- getInstance() - Static method in class org.apache.commons.math3.ode.sampling.DummyStepHandler
-
Get the only instance.
- getInstance() - Static method in class org.apache.commons.math3.util.BigRealField
-
Get the unique instance.
- getIntercept() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
- getInterceptStdErr() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
- getInternalValues() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Returns the internal storage array.
- getInterpolatedDerivatives() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Get the derivatives of the state vector of the interpolated point.
- getInterpolatedDerivatives() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
-
Get the derivatives of the state vector of the interpolated point.
- getInterpolatedSecondaryDerivatives(int) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Get the interpolated secondary derivatives corresponding to the secondary equations.
- getInterpolatedSecondaryDerivatives(int) - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
-
Get the interpolated secondary derivatives corresponding to the secondary equations.
- getInterpolatedSecondaryState(int) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Get the interpolated secondary state corresponding to the secondary equations.
- getInterpolatedSecondaryState(int) - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
-
Get the interpolated secondary state corresponding to the secondary equations.
- getInterpolatedState() - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
-
Get the state vector of the interpolated point.
- getInterpolatedState() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Get the state vector of the interpolated point.
- getInterpolatedState() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
-
Get the state vector of the interpolated point.
- getInterpolatedStateVariation() - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
-
Get the state vector variation from current to interpolated state.
- getInterpolatedTime() - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
-
Get the time of the interpolated point.
- getInterpolatedTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Get the time of the interpolated point.
- getInterpolatedTime() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
-
Get the time of the interpolated point.
- getInterpolatingPoints() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Returns a copy of the interpolating points array.
- getInterpolatingValues() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Returns a copy of the interpolating values array.
- getInverse() - Method in interface org.apache.commons.math3.linear.DecompositionSolver
-
Get the inverse (or pseudo-inverse) of the decomposed matrix.
- getInverse() - Method in interface org.apache.commons.math3.linear.FieldDecompositionSolver
-
Get the inverse (or pseudo-inverse) of the decomposed matrix.
- getInverseConditionNumber() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
-
Computes the inverse of the condition number.
- getIterationManager() - Method in class org.apache.commons.math3.linear.IterativeLinearSolver
-
Returns the iteration manager attached to this solver.
- getIterations() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the number of iterations of the last run of the integrator.
- getIterations() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
-
Get the number of iterations of the last run of the integrator.
- getIterations() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
-
Get the number of iterations realized by the algorithm.
- getIterations() - Method in interface org.apache.commons.math3.optimization.linear.LinearOptimizer
-
Get the number of iterations realized by the algorithm.
- getIterations() - Method in class org.apache.commons.math3.util.IterationEvent
-
Returns the number of iterations performed at the time this
event
is created.
- getIterations() - Method in class org.apache.commons.math3.util.IterationManager
-
Returns the number of iterations of this solver, 0 if no iterations has
been performed yet.
- getJacobianEvaluations() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
-
- getKey() - Method in class org.apache.commons.math3.util.Pair
-
Get the key.
- getKeys() - Method in class org.apache.commons.math3.exception.util.ExceptionContext
-
Gets all the keys stored in the exception
- getKnots() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
-
Get an array copy of the knot points.
- getKurtosis() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the Kurtosis of the available values.
- getKurtosisImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured kurtosis implementation.
- getL() - Method in class org.apache.commons.math3.linear.CholeskyDecomposition
-
Returns the matrix L of the decomposition.
- getL() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
-
Returns the matrix L of the decomposition.
- getL() - Method in class org.apache.commons.math3.linear.LUDecomposition
-
Returns the matrix L of the decomposition.
- getL1Distance(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Distance between two vectors.
- getL1Distance(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Distance between two vectors.
- getL1Distance(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Distance between two vectors.
- getL1Distance(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
-
Distance between two vectors.
- getL1Norm() - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Returns the L1 norm of the vector.
- getL1Norm() - Method in class org.apache.commons.math3.linear.RealVector
-
Returns the L1 norm of the vector.
- getLargest() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
-
Get the node whose element is the largest one in the tree.
- getLength() - Method in class org.apache.commons.math3.genetics.AbstractListChromosome
-
Returns the length of the chromosome.
- getLength() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
-
Get the length of the interval.
- getLine() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Segment
-
Get the line containing the segment.
- getLine() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Segment
-
Get the line containing the segment.
- getLInfDistance(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Distance between two vectors.
- getLInfDistance(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Distance between two vectors.
- getLInfDistance(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
-
Distance between two vectors.
- getLInfNorm() - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Returns the L∞ norm of the vector.
- getLInfNorm() - Method in class org.apache.commons.math3.linear.RealVector
-
Returns the L∞ norm of the vector.
- getLn10() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant ln(10).
- getLn2() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant ln(2).
- getLn2Split() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant ln(2) split in two pieces.
- getLn5() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant ln(5).
- getLn5Split() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant ln(5) split in two pieces.
- getLo() - Method in exception org.apache.commons.math3.exception.NoBracketingException
-
Get the lower end of the interval.
- getLo() - Method in exception org.apache.commons.math3.exception.OutOfRangeException
-
- getLo() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
-
- getLocalizedMessage() - Method in exception org.apache.commons.math3.exception.MathArithmeticException
- getLocalizedMessage() - Method in exception org.apache.commons.math3.exception.MathIllegalArgumentException
- getLocalizedMessage() - Method in exception org.apache.commons.math3.exception.MathIllegalStateException
- getLocalizedMessage() - Method in exception org.apache.commons.math3.exception.MathUnsupportedOperationException
- getLocalizedMessage() - Method in class org.apache.commons.math3.exception.util.ExceptionContext
-
Gets the message in the default locale.
- getLocalizedString(Locale) - Method in class org.apache.commons.math3.exception.util.DummyLocalizable
-
Gets the localized string.
- getLocalizedString(Locale) - Method in interface org.apache.commons.math3.exception.util.Localizable
-
Gets the localized string.
- getLocalizedString(Locale) - Method in enum org.apache.commons.math3.exception.util.LocalizedFormats
-
Gets the localized string.
- getLocation() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
-
Get the hyperplane location on the real line.
- getLower() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
-
Get the lower bound of the interval.
- getLowerBound() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateSimpleBoundsOptimizer
-
- getLT() - Method in class org.apache.commons.math3.linear.CholeskyDecomposition
-
Returns the transpose of the matrix L of the decomposition.
- getMatrix() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Get the 3X3 matrix corresponding to the instance
- getMax() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
- getMax() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
- getMax() - Method in exception org.apache.commons.math3.exception.MaxCountExceededException
-
- getMax() - Method in exception org.apache.commons.math3.exception.NumberIsTooLargeException
-
- getMax() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
-
- getMax() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Returns the maximum of the available values
- getMax() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the maximum of the available values
- getMax() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
- getMax() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
maximum of the ith entries of the arrays
that correspond to each multivariate sample
- getMax() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
-
Returns the maximum of the available values
- getMax() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
-
- getMax() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the maximum of the values that have been added.
- getMax() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getMax() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the maximum of the values that have been added.
- getMaxCheckInterval() - Method in class org.apache.commons.math3.ode.events.EventState
-
Get the maximal time interval between events handler checks.
- getMaxEvaluations() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Get the maximum number of function evaluations.
- getMaxEvaluations() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
-
Get the maximum number of function evaluations.
- getMaxEvaluations() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
-
Get the maximal number of function evaluations.
- getMaxEvaluations() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Get the maximal number of functions evaluations.
- getMaxEvaluations() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
-
Get the maximal number of functions evaluations.
- getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
-
Get the maximal number of function evaluations.
- getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
-
Get the maximal number of function evaluations.
- getMaxEvaluations() - Method in interface org.apache.commons.math3.optimization.BaseOptimizer
-
Get the maximal number of function evaluations.
- getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
-
Get the maximal number of function evaluations.
- getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
-
Get the maximal number of function evaluations.
- getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
-
Get the maximal number of function evaluations.
- getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
-
- getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
-
Get the maximal number of function evaluations.
- getMaxGrowth() - Method in class org.apache.commons.math3.ode.MultistepIntegrator
-
Get the maximal growth factor for stepsize control.
- getMaxGrowth() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Get the maximal growth factor for stepsize control.
- getMaximalCount() - Method in class org.apache.commons.math3.util.Incrementor
-
Gets the upper limit of the counter.
- getMaximalIterationCount() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the upper limit for the number of iterations.
- getMaximalIterationCount() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
-
Get the upper limit for the number of iterations.
- getMaximalOrder() - Method in class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
-
Get the maximal order.
- getMaximalOrder() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
-
Get the maximal order.
- getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured maximum implementation.
- getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured maximum implementation
- getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the currently configured maximum implementation
- getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured maximum implementation
- getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured maximum implementation
- getMaxIndex() - Method in class org.apache.commons.math3.linear.RealVector
-
Get the index of the maximum entry.
- getMaxIterationCount() - Method in class org.apache.commons.math3.ode.events.EventState
-
Get the upper limit in the iteration count for event localization.
- getMaxIterations() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
-
Get the maximal number of iterations of the algorithm.
- getMaxIterations() - Method in interface org.apache.commons.math3.optimization.linear.LinearOptimizer
-
Get the maximal number of iterations of the algorithm.
- getMaxIterations() - Method in class org.apache.commons.math3.util.IterationManager
-
Returns the maximum number of iterations.
- getMaxStep() - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Get the maximal step.
- getMaxValue() - Method in class org.apache.commons.math3.linear.RealVector
-
Get the value of the maximum entry.
- getMean() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
-
Access the mean.
- getMean() - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
Access the mean.
- getMean() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
-
Get the mean for the distribution.
- getMean() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
- getMean() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
- getMean() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
- getMean() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
mean of the ith entries of the arrays
that correspond to each multivariate sample
- getMean() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
-
- getMean() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
-
- getMean() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the mean of the values that have been added.
- getMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the mean of the values that have been added.
- getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured mean implementation.
- getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured mean implementation
- getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the currently configured mean implementation
- getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured mean implementation
- getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured mean implementation
- getMeanSquareError() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
-
Returns the sum of squared errors divided by the degrees of freedom,
usually abbreviated MSE.
- getMeanSquareError() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Returns the sum of squared errors divided by the degrees of freedom,
usually abbreviated MSE.
- getMeasurementDimension() - Method in class org.apache.commons.math3.filter.KalmanFilter
-
Returns the dimension of the measurement vector.
- getMeasurementMatrix() - Method in class org.apache.commons.math3.filter.DefaultMeasurementModel
-
Returns the measurement matrix.
- getMeasurementMatrix() - Method in interface org.apache.commons.math3.filter.MeasurementModel
-
Returns the measurement matrix.
- getMeasurementNoise() - Method in class org.apache.commons.math3.filter.DefaultMeasurementModel
-
Returns the measurement noise matrix.
- getMeasurementNoise() - Method in interface org.apache.commons.math3.filter.MeasurementModel
-
Returns the measurement noise matrix.
- getMedian() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
-
Access the median.
- getMessage() - Method in exception org.apache.commons.math3.exception.MathArithmeticException
- getMessage() - Method in exception org.apache.commons.math3.exception.MathIllegalArgumentException
- getMessage() - Method in exception org.apache.commons.math3.exception.MathIllegalStateException
- getMessage() - Method in exception org.apache.commons.math3.exception.MathUnsupportedOperationException
- getMessage() - Method in class org.apache.commons.math3.exception.util.ExceptionContext
-
Gets the default message.
- getMessage(Locale) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
-
Gets the message in a specified locale.
- getMessage(Locale, String) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
-
Gets the message in a specified locale.
- getMid() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
-
- getMidPoint() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
-
Get the midpoint of the interval.
- getMin() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
- getMin() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
- getMin() - Method in exception org.apache.commons.math3.exception.NumberIsTooSmallException
-
- getMin() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
-
- getMin() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Returns the minimum of the available values
- getMin() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the minimum of the available values
- getMin() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
- getMin() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
minimum of the ith entries of the arrays
that correspond to each multivariate sample
- getMin() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
-
Returns the minimum of the available values
- getMin() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
-
- getMin() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the minimum of the values that have been added.
- getMin() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getMin() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the minimum of the values that have been added.
- getMinimalIterationCount() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the min limit for the number of iterations.
- getMinimalIterationCount() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
-
Get the min limit for the number of iterations.
- getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured minimum implementation.
- getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured minimum implementation
- getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the currently configured minimum implementation
- getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured minimum implementation
- getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured minimum implementation
- getMinIndex() - Method in class org.apache.commons.math3.linear.RealVector
-
Get the index of the minimum entry.
- getMinReduction() - Method in class org.apache.commons.math3.ode.MultistepIntegrator
-
Get the minimal reduction factor for stepsize control.
- getMinReduction() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Get the minimal reduction factor for stepsize control.
- getMinStep() - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Get the minimal step.
- getMinus() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
-
Get the tree on the minus side of the cut hyperplane.
- getMinus() - Method in class org.apache.commons.math3.geometry.partitioning.SubHyperplane.SplitSubHyperplane
-
Get the part of the sub-hyperplane on the minus side of the splitting hyperplane.
- getMinValue() - Method in class org.apache.commons.math3.linear.RealVector
-
Get the value of the minimum entry.
- getMode() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
-
Returns the mode c
of this distribution.
- getMode() - Method in class org.apache.commons.math3.random.ValueServer
-
Returns the data generation mode.
- getMu() - Method in class org.apache.commons.math3.random.ValueServer
-
- getMutationPolicy() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
-
Returns the mutation policy.
- getMutationRate() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
-
Returns the mutation rate.
- getN() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
-
Get the number of spline segments.
- getN() - Method in class org.apache.commons.math3.stat.correlation.Covariance
-
Returns the number of observations (length of covariate vectors)
- getN() - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
-
- getN() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Returns the number of available values
- getN() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the number of available values
- getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
-
Returns the number of values that have been added.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
-
Returns the number of values that have been added.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
-
Returns the number of values that have been added.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
-
Returns the number of values that have been added.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
-
Returns the number of values that have been added.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
-
Returns the number of values that have been added.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
-
Get the number of vectors in the sample.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
-
Get the number of vectors in the sample.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Returns the number of available values
- getN() - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
-
Returns the number of values that have been added.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
-
Returns the number of values that have been added.
- getN() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
-
Returns the number of available values
- getN() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
-
Returns the number of available values
- getN() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
-
- getN() - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
-
Returns the number of values that have been added.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
-
Returns the number of values that have been added.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
-
Returns the number of values that have been added.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
-
Returns the number of values that have been added.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
-
Returns the number of values that have been added.
- getN() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the number of available values
- getN() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
Returns the number of available values
- getN() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the number of available values
- getN() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the number of available values
- getN() - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
-
Gets the number of observations added to the regression model
- getN() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
-
Returns the number of observations added to the regression model.
- getN() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Returns the number of observations that have been added to the model.
- getN() - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
-
Returns the number of observations added to the regression model.
- getName() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Get the name of the method.
- getName() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
-
Get the name of the method.
- getNanStrategy() - Method in class org.apache.commons.math3.stat.ranking.NaturalRanking
-
Return the NaNStrategy
- getNewtonCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
-
Returns a copy of coefficients in Newton form formula.
- getNext() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree.Node
-
Get the node containing the next larger or equal element.
- getNext() - Method in class org.apache.commons.math3.random.ValueServer
-
Returns the next generated value, generated according
to the mode value (see MODE constants).
- getNextValue() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
-
Generates a random value from this distribution.
- getNorm() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Get the L2 norm for the vector.
- getNorm() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Get the L2 norm for the vector.
- getNorm() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Get the L2 norm for the vector.
- getNorm() - Method in interface org.apache.commons.math3.geometry.Vector
-
Get the L2 norm for the vector.
- getNorm() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
- getNorm() - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Returns the L2 norm of the vector.
- getNorm() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
- getNorm() - Method in interface org.apache.commons.math3.linear.RealMatrix
-
- getNorm() - Method in class org.apache.commons.math3.linear.RealVector
-
Returns the L2 norm of the vector.
- getNorm() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
-
Returns the L2 norm of the matrix.
- getNorm1() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Get the L1 norm for the vector.
- getNorm1() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Get the L1 norm for the vector.
- getNorm1() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Get the L1 norm for the vector.
- getNorm1() - Method in interface org.apache.commons.math3.geometry.Vector
-
Get the L1 norm for the vector.
- getNormal() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Get the normalized normal vector.
- getNormInf() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Get the L∞ norm for the vector.
- getNormInf() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Get the L∞ norm for the vector.
- getNormInf() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Get the L∞ norm for the vector.
- getNormInf() - Method in interface org.apache.commons.math3.geometry.Vector
-
Get the L∞ norm for the vector.
- getNormOfResidual() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
-
Returns the norm of the residual.
- getNormOfResidual() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
-
Returns the norm of the residual.
- getNormSq() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Get the square of the norm for the vector.
- getNormSq() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Get the square of the norm for the vector.
- getNormSq() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Get the square of the norm for the vector.
- getNormSq() - Method in interface org.apache.commons.math3.geometry.Vector
-
Get the square of the norm for the vector.
- getNotLarger(T) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
-
Get the node whose element is not larger than the reference object.
- getNotSmaller(T) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
-
Get the node whose element is not smaller than the reference object.
- getNSteps() - Method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
-
Get the number of steps of the method
(excluding the one being computed).
- getNumberOfElements() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
-
Get the number of elements (e.g.
- getNumberOfParameters() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
-
Returns the number of parameters estimated in the model.
- getNumberOfRoots() - Method in class org.apache.commons.math3.complex.RootsOfUnity
-
Returns the number of roots of unity currently stored.
- getNumberOfSuccesses() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
-
Access the number of successes.
- getNumberOfSuccesses() - Method in class org.apache.commons.math3.distribution.PascalDistribution
-
Access the number of successes for this distribution.
- getNumberOfTrials() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
-
Access the number of trials for this distribution.
- getNumElements() - Method in interface org.apache.commons.math3.util.DoubleArray
-
Returns the number of elements currently in the array.
- getNumElements() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Returns the number of elements currently in the array.
- getNumerator() - Method in class org.apache.commons.math3.fraction.BigFraction
-
Access the numerator as a BigInteger
.
- getNumerator() - Method in class org.apache.commons.math3.fraction.Fraction
-
Access the numerator.
- getNumeratorAsInt() - Method in class org.apache.commons.math3.fraction.BigFraction
-
Access the numerator as a int.
- getNumeratorAsLong() - Method in class org.apache.commons.math3.fraction.BigFraction
-
Access the numerator as a long.
- getNumeratorDegreesOfFreedom() - Method in class org.apache.commons.math3.distribution.FDistribution
-
Access the numerator degrees of freedom.
- getNumeratorFormat() - Method in class org.apache.commons.math3.fraction.AbstractFormat
-
Access the numerator format.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.BetaDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.FDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.GammaDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.PascalDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in interface org.apache.commons.math3.distribution.RealDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.TDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.BetaDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.FDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.GammaDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.PascalDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in interface org.apache.commons.math3.distribution.RealDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.TDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumGenerations() - Method in class org.apache.commons.math3.genetics.FixedGenerationCount
-
- getObservations() - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
-
Get the observed points.
- getOffset(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
-
Get the offset (oriented distance) of a point.
- getOffset(Plane) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Get the offset (oriented distance) of a parallel plane.
- getOffset(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Get the offset (oriented distance) of a point.
- getOffset(Line) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Get the offset (oriented distance) of a parallel line.
- getOffset(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Get the offset (oriented distance) of a point.
- getOffset(Vector<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
-
Get the offset (oriented distance) of a point.
- getOmegaInverse() - Method in class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
-
Get the inverse of the covariance.
- getOne() - Method in class org.apache.commons.math3.complex.ComplexField
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.apache.commons.math3.dfp.Dfp
-
Get the constant 1.
- getOne() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant 1.
- getOne() - Method in interface org.apache.commons.math3.Field
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.apache.commons.math3.fraction.BigFractionField
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.apache.commons.math3.fraction.FractionField
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.apache.commons.math3.util.BigRealField
-
Get the multiplicative identity of the field.
- getOptima() - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
-
Get all the optima found during the last call to
optimize
.
- getOptima() - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
-
Get all the optima found during the last call to
optimize
.
- getOptima() - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
-
Get all the optima found during the last call to
optimize
.
- getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince54Integrator
-
Get the order of the method.
- getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince853Integrator
-
Get the order of the method.
- getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Get the order of the method.
- getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.HighamHall54Integrator
-
Get the order of the method.
- getOrderOfRegressors() - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
-
Gets the order of the regressors, useful if some type of reordering
has been called.
- getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
-
Get the line point closest to the origin.
- getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Get the origin point of the plane frame.
- getOriginOffset() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Get the offset of the origin.
- getOutline(PolyhedronsSet) - Method in class org.apache.commons.math3.geometry.euclidean.threed.OutlineExtractor
-
Extract the outline of a polyhedrons set.
- getP() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
-
Returns the P rows permutation matrix.
- getP() - Method in class org.apache.commons.math3.linear.LUDecomposition
-
Returns the P rows permutation matrix.
- getParameter(String) - Method in interface org.apache.commons.math3.ode.ParameterizedODE
-
Get parameter value from its name.
- getParameterEstimate(int) - Method in class org.apache.commons.math3.stat.regression.RegressionResults
-
Returns the parameter estimate for the regressor at the given index.
- getParameterEstimates() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
-
Returns a copy of the regression parameters estimates.
- getParametersNames() - Method in class org.apache.commons.math3.ode.AbstractParameterizable
-
Get the names of the supported parameters.
- getParametersNames() - Method in interface org.apache.commons.math3.ode.Parameterizable
-
Get the names of the supported parameters.
- getParent() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
-
Get the parent node.
- getPartialCorrelations(int) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
-
In the original algorithm only the partial correlations of the regressors
is returned to the user.
- getPct(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the percentage of values that are equal to v
(as a proportion between 0 and 1).
- getPct(int) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the percentage of values that are equal to v
(as a proportion between 0 and 1).
- getPct(long) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the percentage of values that are equal to v
(as a proportion between 0 and 1).
- getPct(char) - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the percentage of values that are equal to v
(as a proportion between 0 and 1).
- getPercentile(double) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns an estimate for the pth percentile of the stored values.
- getPercentileImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured percentile implementation.
- getPi() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant π.
- getPiSplit() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant π split in two pieces.
- getPivot() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
-
Returns the pivot permutation vector.
- getPivot() - Method in class org.apache.commons.math3.linear.LUDecomposition
-
Returns the pivot permutation vector.
- getPlus() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
-
Get the tree on the plus side of the cut hyperplane.
- getPlus() - Method in class org.apache.commons.math3.geometry.partitioning.SubHyperplane.SplitSubHyperplane
-
Get the part of the sub-hyperplane on the plus side of the splitting hyperplane.
- getPlusInside() - Method in class org.apache.commons.math3.geometry.partitioning.BoundaryAttribute
-
Get the part of the node cut sub-hyperplane that belongs to the
boundary and has the inside of the region on the plus side of
its underlying hyperplane.
- getPlusOutside() - Method in class org.apache.commons.math3.geometry.partitioning.BoundaryAttribute
-
Get the part of the node cut sub-hyperplane that belongs to the
boundary and has the outside of the region on the plus side of
its underlying hyperplane.
- getPoint(int) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
-
Get the simplex point stored at the requested index
.
- getPoint() - Method in class org.apache.commons.math3.optimization.PointValuePair
-
Gets the point.
- getPoint() - Method in class org.apache.commons.math3.optimization.PointVectorValuePair
-
Gets the point.
- getPoint() - Method in class org.apache.commons.math3.optimization.univariate.UnivariatePointValuePair
-
Get the point.
- getPoint() - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
-
Get the n-dimensional point in integer space.
- getPointAt(Vector2D, double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Get one point from the 3D-space.
- getPointAt(Vector1D, double) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Get one point from the plane.
- getPointRef() - Method in class org.apache.commons.math3.optimization.PointValuePair
-
Gets a reference to the point.
- getPointRef() - Method in class org.apache.commons.math3.optimization.PointVectorValuePair
-
Gets a reference to the point.
- getPoints() - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
-
Get the points of the simplex.
- getPoints() - Method in class org.apache.commons.math3.stat.clustering.Cluster
-
Get the points contained in the cluster.
- getPolynomials() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
-
Get a copy of the interpolating polynomials array.
- getPopulationLimit() - Method in class org.apache.commons.math3.genetics.ListPopulation
-
Access the maximum population size.
- getPopulationLimit() - Method in interface org.apache.commons.math3.genetics.Population
-
Access the maximum population size.
- getPopulationSize() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
-
Access the population size.
- getPopulationSize() - Method in class org.apache.commons.math3.genetics.ListPopulation
-
Access the current population size.
- getPopulationSize() - Method in interface org.apache.commons.math3.genetics.Population
-
Access the current population size.
- getPopulationVariance() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
- getPopulationVariance() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
- getPopulationVariance() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
- getPrefix() - Method in class org.apache.commons.math3.geometry.VectorFormat
-
Get the format prefix.
- getPrefix() - Method in class org.apache.commons.math3.linear.RealVectorFormat
-
Get the format prefix.
- getPrevious() - Method in exception org.apache.commons.math3.exception.NonMonotonicSequenceException
-
- getPrevious() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree.Node
-
Get the node containing the next smaller or equal element.
- getPreviousTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Get the previous soft grid point time.
- getPreviousTime() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
-
Get the previous grid point time.
- getPrimary() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Get the primary set of differential equations.
- getPrimaryMapper() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Get an equations mapper for the primary equations set.
- getPrimaryState() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Get primary part of the current state.
- getPrimaryStateDot() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Get primary part of the current state derivative.
- getProbabilityOfSuccess() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
-
Access the probability of success for this distribution.
- getProbabilityOfSuccess() - Method in class org.apache.commons.math3.distribution.PascalDistribution
-
Access the probability of success for this distribution.
- getProcessNoise() - Method in class org.apache.commons.math3.filter.DefaultProcessModel
-
Returns the process noise matrix.
- getProcessNoise() - Method in interface org.apache.commons.math3.filter.ProcessModel
-
Returns the process noise matrix.
- getProperInstance() - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
-
Returns the default complex format for the current locale.
- getProperInstance(Locale) - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
-
Returns the default complex format for the given locale.
- getProperInstance() - Static method in class org.apache.commons.math3.fraction.FractionFormat
-
Returns the default complex format for the current locale.
- getProperInstance(Locale) - Static method in class org.apache.commons.math3.fraction.FractionFormat
-
Returns the default complex format for the given locale.
- getQ() - Method in class org.apache.commons.math3.linear.QRDecomposition
-
Returns the matrix Q of the decomposition.
- getQ0() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Get the scalar coordinate of the quaternion.
- getQ1() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Get the first coordinate of the vectorial part of the quaternion.
- getQ2() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Get the second coordinate of the vectorial part of the quaternion.
- getQ3() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Get the third coordinate of the vectorial part of the quaternion.
- getQT() - Method in class org.apache.commons.math3.linear.QRDecomposition
-
Returns the transpose of the matrix Q of the decomposition.
- getQuantile() - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
-
Returns the value of the quantile field (determines what percentile is
computed when evaluate() is called with no quantile argument).
- getR() - Method in class org.apache.commons.math3.linear.QRDecomposition
-
Returns the matrix R of the decomposition.
- getR() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
- getRadixDigits() - Method in class org.apache.commons.math3.dfp.Dfp
-
Get the number of radix digits of the instance.
- getRadixDigits() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the number of radix digits of the
Dfp
instances built by this factory.
- getRandomGenerator() - Static method in class org.apache.commons.math3.genetics.GeneticAlgorithm
-
Returns the (static) random generator.
- getRank() - Method in class org.apache.commons.math3.linear.RectangularCholeskyDecomposition
-
Get the rank of the symmetric positive semidefinite matrix.
- getRank() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
-
Return the effective numerical matrix rank.
- getRank() - Method in class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
-
Get the rank of the covariance matrix.
- getRankCorrelation() - Method in class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
-
- getReal() - Method in class org.apache.commons.math3.complex.Complex
-
Access the real part.
- getReal(int) - Method in class org.apache.commons.math3.complex.RootsOfUnity
-
Get the real part of the k
-th n
-th root of unity.
- getRealEigenvalue(int) - Method in class org.apache.commons.math3.linear.EigenDecomposition
-
Returns the real part of the ith eigenvalue of the original
matrix.
- getRealEigenvalues() - Method in class org.apache.commons.math3.linear.EigenDecomposition
-
Gets a copy of the real parts of the eigenvalues of the original matrix.
- getRealFormat() - Method in class org.apache.commons.math3.complex.ComplexFormat
-
Access the realFormat.
- getReducedFraction(int, int) - Static method in class org.apache.commons.math3.fraction.BigFraction
-
Creates a BigFraction
instance with the 2 parts of a fraction
Y/Z.
- getReducedFraction(int, int) - Static method in class org.apache.commons.math3.fraction.Fraction
-
Creates a Fraction
instance with the 2 parts
of a fraction Y/Z.
- getRegressionSumSquares() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
-
Returns the sum of squared deviations of the predicted y values about
their mean (which equals the mean of y).
- getRegressionSumSquares() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Returns the sum of squared deviations of the predicted y values about
their mean (which equals the mean of y).
- getRelationship() - Method in class org.apache.commons.math3.optimization.linear.LinearConstraint
-
Get the relationship between left and right hand sides.
- getRelativeAccuracy() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the actual relative accuracy.
- getRelativeAccuracy() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
-
Get the actual relative accuracy.
- getRelativeAccuracy() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Get the relative accuracy of the solver.
- getRelativeAccuracy() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
-
Get the relative accuracy of the solver.
- getRelativeAccuracy() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
-
Get the relative accuracy.
- getRelativeThreshold() - Method in class org.apache.commons.math3.optimization.AbstractConvergenceChecker
-
- getRemainingRegion() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
-
Get the remaining region of the hyperplane.
- getRepresentation() - Method in class org.apache.commons.math3.genetics.AbstractListChromosome
-
Returns the (immutable) inner representation of the chromosome.
- getResidual() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
-
Returns the residual.
- getResidual() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
-
Returns the residual.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Returns the current value of the Statistic.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
-
Returns the current value of the Statistic.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
-
Returns the current value of the Statistic.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
-
Returns the current value of the Statistic.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
-
Returns the current value of the Statistic.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
-
Returns the value of the statistic based on the values that have been added.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
-
Returns the current value of the Statistic.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
-
Returns the current value of the Statistic.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
-
Get the covariance matrix.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
-
Get the mean vector.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
-
Returns the current value of the Statistic.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
-
Returns the current value of the Statistic.
- getResult() - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
-
Returns the current value of the Statistic.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
-
Returns the current value of the Statistic.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
-
Returns the current value of the Statistic.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
-
Returns the current value of the Statistic.
- getResult() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
-
Returns the current value of the Statistic.
- getReverse() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Get the reverse of the instance.
- getRightHandSideVector() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
-
Returns the current right-hand side of the linear system to be solved.
- getRightHandSideVector() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
-
Returns the current right-hand side of the linear system to be solved.
- getRMS() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
-
Get the Root Mean Square value.
- getRootMatrix() - Method in class org.apache.commons.math3.linear.RectangularCholeskyDecomposition
-
Get the root of the covariance matrix.
- getRootMatrix() - Method in class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
-
Get the root of the covariance matrix.
- getRoundingMode() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the current rounding mode.
- getRoundingMode() - Method in class org.apache.commons.math3.util.BigReal
-
Gets the rounding mode for division operations
The default is RoundingMode.HALF_UP
- getRow(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Get the entries in row number row
as an array.
- getRow(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Get the entries at the given row index.
- getRow(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Get the entries in row number row
as an array.
- getRow(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Get the entries at the given row index.
- getRow(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Get the entries in row number row
as an array.
- getRow() - Method in exception org.apache.commons.math3.linear.NonPositiveDefiniteMatrixException
-
- getRow() - Method in exception org.apache.commons.math3.linear.NonSymmetricMatrixException
-
- getRow(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Get the entries at the given row index.
- getRowDimension() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Returns the number of rows in the matrix.
- getRowDimension() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Returns the number of rows of this matrix.
- getRowDimension() - Method in interface org.apache.commons.math3.linear.AnyMatrix
-
Returns the number of rows in the matrix.
- getRowDimension() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Returns the number of rows in the matrix.
- getRowDimension() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Returns the number of rows of this matrix.
- getRowDimension() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Returns the number of rows in the matrix.
- getRowDimension() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Returns the number of rows of this matrix.
- getRowDimension() - Method in class org.apache.commons.math3.linear.JacobiPreconditioner
-
Returns the dimension of the codomain of this operator.
- getRowDimension() - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
-
Returns the number of rows of this matrix.
- getRowDimension() - Method in class org.apache.commons.math3.linear.RealLinearOperator
-
Returns the dimension of the codomain of this operator.
- getRowDimension() - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
-
Returns the number of rows in the matrix.
- getRowMatrix(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Get the entries in row number row
as a row matrix.
- getRowMatrix(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Geet the entries at the given row index
as a row matrix.
- getRowMatrix(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Get the entries in row number row
as a row matrix.
- getRowMatrix(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Geet the entries at the given row index
as a row matrix.
- getRowMatrix(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Get the entries in row number row
as a row matrix.
- getRowMatrix(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Geet the entries at the given row index
as a row matrix.
- getRowVector(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Get the entries in row number row
as a vector.
- getRowVector(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Returns the entries in row number row
as a vector.
- getRowVector(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Get the entries in row number row
as a vector.
- getRowVector(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Returns the entries in row number row
as a vector.
- getRowVector(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Get the entries in row number row
as a vector.
- getRowVector(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Returns the entries in row number row
as a vector.
- getRSquare() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
- getRSquared() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
-
- getRuntimeClass() - Method in class org.apache.commons.math3.complex.ComplexField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.apache.commons.math3.dfp.DfpField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in interface org.apache.commons.math3.Field
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.apache.commons.math3.fraction.BigFractionField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.apache.commons.math3.fraction.FractionField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.apache.commons.math3.util.BigRealField
-
Returns the runtime class of the FieldElement.
- getS() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
-
Returns the diagonal matrix Σ of the decomposition.
- getSafety() - Method in class org.apache.commons.math3.ode.MultistepIntegrator
-
Get the safety factor for stepsize control.
- getSafety() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Get the safety factor for stepsize control.
- getSampleSize() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
-
Access the sample size.
- getSampleStats() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
-
- getScale() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
-
Access the scale parameter.
- getScale() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
Returns the scale parameter of this distribution.
- getScale() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
Access the scale parameter, beta
.
- getScale() - Method in class org.apache.commons.math3.util.BigReal
-
Sets the scale for division operations.
- getSecond() - Method in class org.apache.commons.math3.genetics.ChromosomePair
-
Access the second chromosome.
- getSecondaryMappers() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Get the equations mappers for the secondary equations sets.
- getSecondaryState(int) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Get secondary part of the current state.
- getSecondaryStateDot(int) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Get secondary part of the current state derivative.
- getSecondMoment() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Returns a statistic related to the Second Central Moment.
- getSecondMoment() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns a statistic related to the Second Central Moment.
- getSegments() - Method in class org.apache.commons.math3.geometry.euclidean.threed.SubLine
-
Get the endpoints of the sub-line.
- getSegments() - Method in class org.apache.commons.math3.geometry.euclidean.twod.SubLine
-
Get the endpoints of the sub-line.
- getSelectionPolicy() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
-
Returns the selection policy.
- getSeparator() - Method in class org.apache.commons.math3.geometry.VectorFormat
-
Get the format separator between components.
- getSeparator() - Method in class org.apache.commons.math3.linear.RealVectorFormat
-
Get the format separator between components.
- getShape() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
Returns the shape parameter of this distribution.
- getShape() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
Access the shape parameter, alpha
.
- getSigma() - Method in class org.apache.commons.math3.random.ValueServer
-
- getSignificance() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Returns the significance level of the slope (equiv) correlation.
- getSingularValues() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
-
Returns the diagonal elements of the matrix Σ of the decomposition.
- getSize() - Method in class org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
-
Get the size of the instance.
- getSize() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Get the size of the instance.
- getSize() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
-
Get the size of the instance.
- getSize() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
-
Get the size of the instance.
- getSize() - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
-
Get the size of the instance.
- getSize() - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
-
Get simplex size.
- getSize() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
-
Get the total number of elements.
- getSizes() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
-
Get the number of multidimensional counter slots in each dimension.
- getSkewness() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the skewness of the available values.
- getSkewnessImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured skewness implementation.
- getSlope() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Returns the slope of the estimated regression line.
- getSlopeConfidenceInterval() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Returns the half-width of a 95% confidence interval for the slope
estimate.
- getSlopeConfidenceInterval(double) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Returns the half-width of a (100-100*alpha)% confidence interval for
the slope estimate.
- getSlopeStdErr() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
- getSmallest() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
-
Get the node whose element is the smallest one in the tree.
- getSolution() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
-
Returns the current estimate of the solution to the linear system to be
solved.
- getSolution() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
-
Returns the current estimate of the solution to the linear system to be
solved.
- getSolver() - Method in class org.apache.commons.math3.linear.CholeskyDecomposition
-
Get a solver for finding the A × X = B solution in least square sense.
- getSolver() - Method in class org.apache.commons.math3.linear.EigenDecomposition
-
Gets a solver for finding the A × X = B solution in exact
linear sense.
- getSolver() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
-
Get a solver for finding the A × X = B solution in exact linear sense.
- getSolver() - Method in class org.apache.commons.math3.linear.LUDecomposition
-
Get a solver for finding the A × X = B solution in exact linear
sense.
- getSolver() - Method in class org.apache.commons.math3.linear.QRDecomposition
-
Get a solver for finding the A × X = B solution in least square sense.
- getSolver() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
-
Get a solver for finding the A × X = B solution in least square sense.
- getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.BetaDistribution
-
Return the absolute accuracy setting of the solver used to estimate
inverse cumulative probabilities.
- getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.FDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.GammaDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.TDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
Return the absolute accuracy setting of the solver used to estimate
inverse cumulative probabilities.
- getSortedValues() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the current set of values in an array of double primitives,
sorted in ascending order.
- getSourceString() - Method in class org.apache.commons.math3.exception.util.DummyLocalizable
-
Gets the source (non-localized) string.
- getSourceString() - Method in interface org.apache.commons.math3.exception.util.Localizable
-
Gets the source (non-localized) string.
- getSourceString() - Method in enum org.apache.commons.math3.exception.util.LocalizedFormats
-
Gets the source (non-localized) string.
- getSpace() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Get the space to which the vector belongs.
- getSpace() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Get the space to which the vector belongs.
- getSpace() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Get the space to which the vector belongs.
- getSpace() - Method in interface org.apache.commons.math3.geometry.Vector
-
Get the space to which the vector belongs.
- getSparsity() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
- getSqr2() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant √2.
- getSqr2Reciprocal() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant √2 / 2.
- getSqr2Split() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant √2 split in two pieces.
- getSqr3() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant √3.
- getSqr3Reciprocal() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant √3 / 3.
- getStandardDeviation() - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
Access the standard deviation.
- getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Returns the standard deviation of the available values.
- getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the standard deviation of the available values.
- getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
- getStandardDeviation() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
standard deviation of the ith entries of the arrays
that correspond to each multivariate sample
- getStandardDeviation() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
-
Returns the standard deviation of the available values.
- getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
-
- getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the standard deviation of the values that have been added.
- getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
Returns the standard deviation of the available values.
- getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the standard deviation of the values that have been added.
- getStart() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Segment
-
Get the start point of the segment.
- getStart() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Segment
-
Get the start point of the segment.
- getStarterIntegrator() - Method in class org.apache.commons.math3.ode.MultistepIntegrator
-
Get the starter integrator.
- getStartPoint() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
-
- getStartPoint() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
-
- getStartValue() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
- getStartValue() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
-
- getStateDimension() - Method in class org.apache.commons.math3.filter.KalmanFilter
-
Returns the dimension of the state estimation vector.
- getStateEstimation() - Method in class org.apache.commons.math3.filter.KalmanFilter
-
Returns the current state estimation vector.
- getStateEstimationVector() - Method in class org.apache.commons.math3.filter.KalmanFilter
-
Returns a copy of the current state estimation vector.
- getStateTransitionMatrix() - Method in class org.apache.commons.math3.filter.DefaultProcessModel
-
Returns the state transition matrix.
- getStateTransitionMatrix() - Method in interface org.apache.commons.math3.filter.ProcessModel
-
Returns the state transition matrix.
- getStatisticsDHistory() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- getStatisticsFitnessHistory() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- getStatisticsMeanHistory() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- getStatisticsSigmaHistory() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
-
- getStdErrorOfEstimate(int) - Method in class org.apache.commons.math3.stat.regression.RegressionResults
-
- getStdErrorOfEstimates() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
-
- getStepHandlers() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Get all the step handlers that have been added to the integrator.
- getStepHandlers() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
-
Get all the step handlers that have been added to the integrator.
- getStrict() - Method in exception org.apache.commons.math3.exception.NonMonotonicSequenceException
-
- getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Get a submatrix.
- getSubMatrix(int[], int[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Get a submatrix.
- getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Gets a submatrix.
- getSubMatrix(int[], int[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Gets a submatrix.
- getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Get a submatrix.
- getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Gets a submatrix.
- getSubMatrix(int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Get a submatrix.
- getSubMatrix(int[], int[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Get a submatrix.
- getSubMatrix(int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Gets a submatrix.
- getSubMatrix(int[], int[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Gets a submatrix.
- getSubSpace() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Euclidean1D
-
Get the n-1 dimension subspace of this space.
- getSubSpace() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Euclidean3D
-
Get the n-1 dimension subspace of this space.
- getSubSpace() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Euclidean2D
-
Get the n-1 dimension subspace of this space.
- getSubSpace() - Method in interface org.apache.commons.math3.geometry.Space
-
Get the n-1 dimension subspace of this space.
- getSubVector(int, int) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Get a subvector from consecutive elements.
- getSubVector(int, int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Get a subvector from consecutive elements.
- getSubVector(int, int) - Method in interface org.apache.commons.math3.linear.FieldVector
-
Get a subvector from consecutive elements.
- getSubVector(int, int) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Get a subvector from consecutive elements.
- getSubVector(int, int) - Method in class org.apache.commons.math3.linear.RealVector
-
Get a subvector from consecutive elements.
- getSubVector(int, int) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Get a subvector from consecutive elements.
- getSuffix() - Method in class org.apache.commons.math3.geometry.VectorFormat
-
Get the format suffix.
- getSuffix() - Method in class org.apache.commons.math3.linear.RealVectorFormat
-
Get the format suffix.
- getSum() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Returns the sum of the values that have been added to Univariate.
- getSum() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the sum of the values that have been added to Univariate.
- getSum() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
- getSum() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
sum of the ith entries of the arrays
that correspond to each multivariate sample
- getSum() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
-
Returns the sum of the values that have been added to Univariate.
- getSum() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
-
- getSum() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the sum of the values that have been added
- getSum() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getSum() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the sum of the values that have been added
- getSumFreq() - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the sum of all frequencies.
- getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured sum implementation.
- getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured Sum implementation
- getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the currently configured Sum implementation
- getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured Sum implementation
- getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured Sum implementation
- getSumLog() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
- getSumLog() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
sum of logs of the ith entries of the arrays
that correspond to each multivariate sample
- getSumLog() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
-
Returns the currently configured sum of logs implementation
- getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured sum of logs implementation
- getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the currently configured sum of logs implementation
- getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured sum of logs implementation
- getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured sum of logs implementation
- getSummary() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
- getSummary() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
- getSummary() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
- getSumOfCrossProducts() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Returns the sum of crossproducts, xi*yi.
- getSumOfLogs() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Returns the sum of the logs of all the aggregated data.
- getSumOfLogs() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the sum of the logs of the values that have been added.
- getSumsq() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Returns the sum of the squares of all the aggregated data.
- getSumsq() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the sum of the squares of the available values.
- getSumSq() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
- getSumSq() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
sum of squares of the ith entries of the arrays
that correspond to each multivariate sample
- getSumsq() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the sum of the squares of the values that have been added.
- getSumSq() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getSumsq() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the sum of the squares of the values that have been added.
- getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured sum of squares implementation.
- getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured sum of squares implementation
- getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the currently configured sum of squares implementation
- getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured sum of squares implementation
- getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured sum of squares implementation
- getSumSquaredErrors() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
- getSup() - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
-
Get the highest value belonging to the instance.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.BetaDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.FDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.GammaDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.PascalDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in interface org.apache.commons.math3.distribution.RealDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.TDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
-
Access the lower bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.BetaDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.FDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.GammaDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.PascalDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in interface org.apache.commons.math3.distribution.RealDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.TDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
-
Access the upper bound of the support.
- getTargetRef() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
-
- getThreshold() - Method in exception org.apache.commons.math3.linear.NonPositiveDefiniteMatrixException
-
- getThreshold() - Method in exception org.apache.commons.math3.linear.NonSymmetricMatrixException
-
- getThrowable() - Method in class org.apache.commons.math3.exception.util.ExceptionContext
-
Get a reference to the exception to which the context relates.
- getTiesStrategy() - Method in class org.apache.commons.math3.stat.ranking.NaturalRanking
-
Return the TiesStrategy
- getTime() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Get current time.
- getTotalDimension() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Return the dimension of the complete set of equations.
- getTotalSumSquares() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
-
Returns the sum of squared deviations of the y values about their mean.
- getTotalSumSquares() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Returns the sum of squared deviations of the y values about their mean.
- getTrace() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Returns the
trace of the matrix (the sum of the elements on the main diagonal).
- getTrace() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Returns the
trace of the matrix (the sum of the elements on the main diagonal).
- getTrace() - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Returns the
trace of the matrix (the sum of the elements on the main diagonal).
- getTrace() - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Returns the
trace of the matrix (the sum of the elements on the main diagonal).
- getTransform(AffineTransform) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Get a
Transform
embedding an affine transform.
- getTransformer(Class<?>) - Method in class org.apache.commons.math3.util.TransformerMap
-
Returns the Transformer that is mapped to a class
if mapping is not present, this returns null.
- getTree(boolean) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Get the underlying BSP tree.
- getTree(boolean) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
-
Get the underlying BSP tree.
- getTwo() - Method in class org.apache.commons.math3.dfp.Dfp
-
Get the constant 2.
- getTwo() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant 2.
- getU() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Get the plane first canonical vector.
- getU() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
-
Returns the matrix U of the decomposition.
- getU() - Method in class org.apache.commons.math3.linear.LUDecomposition
-
Returns the matrix U of the decomposition.
- getU() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
-
Returns the matrix U of the decomposition.
- getUniqueCount() - Method in class org.apache.commons.math3.stat.Frequency
-
Returns the number of values in the frequency table.
- getUpper() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
-
Get the upper bound of the interval.
- getUpperBound() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateSimpleBoundsOptimizer
-
- getUpperBounds() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
-
Returns a fresh copy of the array of upper bounds for the bins.
- getUT() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
-
Returns the transpose of the matrix U of the decomposition.
- getV() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Get the plane second canonical vector.
- getV() - Method in class org.apache.commons.math3.linear.EigenDecomposition
-
Gets the matrix V of the decomposition.
- getV() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
-
Returns the matrix V of the decomposition.
- getValue(String) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
-
Gets the value associated to the given context key.
- getValue() - Method in class org.apache.commons.math3.linear.OpenMapRealVector.OpenMapEntry
-
Get the value of the entry.
- getValue() - Method in class org.apache.commons.math3.linear.RealVector.Entry
-
Get the value of the entry.
- getValue() - Method in class org.apache.commons.math3.optimization.linear.LinearConstraint
-
Get the value of the constraint (right hand side).
- getValue(double[]) - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
-
Compute the value of the linear equation at the current point
- getValue(RealVector) - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
-
Compute the value of the linear equation at the current point
- getValue() - Method in class org.apache.commons.math3.optimization.PointVectorValuePair
-
Gets the value of the objective function.
- getValue() - Method in class org.apache.commons.math3.optimization.univariate.UnivariatePointValuePair
-
Get the value of the objective function.
- getValue() - Method in class org.apache.commons.math3.util.Pair
-
Get the value.
- getValueRef() - Method in class org.apache.commons.math3.optimization.PointVectorValuePair
-
Gets a reference to the value of the objective function.
- getValues() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the current set of values in an array of double primitives.
- getValues() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
Returns the current set of values in an array of double primitives.
- getValuesFileURL() - Method in class org.apache.commons.math3.random.ValueServer
-
- getVariance() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
-
Returns the variance of the available values.
- getVariance() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the (sample) variance of the available values.
- getVariance() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
-
Returns the variance of the available values.
- getVariance() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
-
- getVariance() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the (sample) variance of the available values.
- getVariance() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the (sample) variance of the available values.
- getVarianceDirection() - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
-
Returns the varianceDirection property.
- getVarianceImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured variance implementation.
- getVarianceImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Returns the currently configured variance implementation
- getVarianceImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured variance implementation
- getVertices() - Method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
-
Get the vertices of the polygon.
- getVT() - Method in class org.apache.commons.math3.linear.EigenDecomposition
-
Gets the transpose of the matrix V of the decomposition.
- getVT() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
-
Returns the transpose of the matrix V of the decomposition.
- getWeight() - Method in class org.apache.commons.math3.optimization.fitting.WeightedObservedPoint
-
Get the weight of the measurement in the fitting process.
- getWeightRef() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
-
- getWholeFormat() - Method in class org.apache.commons.math3.fraction.ProperBigFractionFormat
-
Access the whole format.
- getWholeFormat() - Method in class org.apache.commons.math3.fraction.ProperFractionFormat
-
Access the whole format.
- getWindowSize() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Returns the maximum number of values that can be stored in the
dataset, or INFINITE_WINDOW (-1) if there is no limit.
- getWindowSize() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
Returns the maximum number of values that can be stored in the
dataset, or INFINITE_WINDOW (-1) if there is no limit.
- getWrongColumnDimension() - Method in exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
-
- getWrongDimension(int) - Method in exception org.apache.commons.math3.exception.MultiDimensionMismatchException
-
- getWrongDimensions() - Method in exception org.apache.commons.math3.exception.MultiDimensionMismatchException
-
- getWrongRowDimension() - Method in exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
-
- getX() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Get the abscissa of the vector.
- getX() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Get the abscissa of the vector.
- getX() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Get the abscissa of the vector.
- getX() - Method in class org.apache.commons.math3.optimization.fitting.WeightedObservedPoint
-
Get the abscissa of the point.
- getX() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
- getXSumSquares() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Returns the sum of squared deviations of the x values about their mean.
- getY() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Get the ordinate of the vector.
- getY() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Get the ordinate of the vector.
- getY() - Method in class org.apache.commons.math3.optimization.fitting.WeightedObservedPoint
-
Get the observed value of the function at x.
- getY() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
- getZ() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Get the height of the vector.
- getZero() - Method in class org.apache.commons.math3.complex.ComplexField
-
Get the additive identity of the field.
- getZero() - Method in class org.apache.commons.math3.dfp.Dfp
-
Get the constant 0.
- getZero() - Method in class org.apache.commons.math3.dfp.DfpField
-
Get the constant 0.
- getZero() - Method in interface org.apache.commons.math3.Field
-
Get the additive identity of the field.
- getZero() - Method in class org.apache.commons.math3.fraction.BigFractionField
-
Get the additive identity of the field.
- getZero() - Method in class org.apache.commons.math3.fraction.FractionField
-
Get the additive identity of the field.
- getZero() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Get the null vector of the vectorial space or origin point of the affine space.
- getZero() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Get the null vector of the vectorial space or origin point of the affine space.
- getZero() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Get the null vector of the vectorial space or origin point of the affine space.
- getZero() - Method in interface org.apache.commons.math3.geometry.Vector
-
Get the null vector of the vectorial space or origin point of the affine space.
- getZero() - Method in class org.apache.commons.math3.util.BigRealField
-
Get the additive identity of the field.
- GillIntegrator - Class in org.apache.commons.math3.ode.nonstiff
-
This class implements the Gill fourth order Runge-Kutta
integrator for Ordinary Differential Equations .
- GillIntegrator(double) - Constructor for class org.apache.commons.math3.ode.nonstiff.GillIntegrator
-
Simple constructor.
- GLSMultipleLinearRegression - Class in org.apache.commons.math3.stat.regression
-
The GLS implementation of the multiple linear regression.
- GLSMultipleLinearRegression() - Constructor for class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
-
- GoalType - Enum in org.apache.commons.math3.optimization
-
Goal type for an optimization problem.
- gradient() - Method in interface org.apache.commons.math3.analysis.DifferentiableMultivariateFunction
-
Returns the gradient function.
- gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.Gaussian.Parametric
-
Computes the value of the gradient at x
.
- gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator.Parametric
-
Computes the value of the gradient at x
.
- gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.Logistic.Parametric
-
Computes the value of the gradient at x
.
- gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.Logit.Parametric
-
Computes the value of the gradient at x
.
- gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.Sigmoid.Parametric
-
Computes the value of the gradient at x
.
- gradient(double, double...) - Method in interface org.apache.commons.math3.analysis.ParametricUnivariateFunction
-
Compute the gradient of the function with respect to its parameters.
- gradient(double, double...) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction.Parametric
-
Compute the gradient of the function with respect to its parameters.
- GraggBulirschStoerIntegrator - Class in org.apache.commons.math3.ode.nonstiff
-
This class implements a Gragg-Bulirsch-Stoer integrator for
Ordinary Differential Equations.
- GraggBulirschStoerIntegrator(double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
-
Simple constructor.
- GraggBulirschStoerIntegrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
-
Simple constructor.
- greaterThan(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
-
Check if instance is greater than x.
- guess() - Method in class org.apache.commons.math3.optimization.fitting.GaussianFitter.ParameterGuesser
-
Guesses the parameters based on the observed points.
- guess() - Method in class org.apache.commons.math3.optimization.fitting.HarmonicFitter.ParameterGuesser
-
Estimate a first guess of the coefficients.
- guessParametersErrors() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
-
Guess the errors in optimized parameters.
- I - Static variable in class org.apache.commons.math3.complex.Complex
-
The square root of -1.
- i1 - Variable in class org.apache.commons.math3.random.AbstractWell
-
Index indirection table giving for each index the value index + m1 taking table size into account.
- i2 - Variable in class org.apache.commons.math3.random.AbstractWell
-
Index indirection table giving for each index the value index + m2 taking table size into account.
- i3 - Variable in class org.apache.commons.math3.random.AbstractWell
-
Index indirection table giving for each index the value index + m3 taking table size into account.
- Identity - Class in org.apache.commons.math3.analysis.function
-
Identity function.
- Identity() - Constructor for class org.apache.commons.math3.analysis.function.Identity
-
- IDENTITY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
-
Identity rotation.
- identityPermutation(int) - Static method in class org.apache.commons.math3.genetics.RandomKey
-
Generates a representation corresponding to an identity permutation of
length l which can be passed to the RandomKey constructor.
- IEEEremainder(double, double) - Static method in class org.apache.commons.math3.util.FastMath
-
Computes the remainder as prescribed by the IEEE 754 standard.
- IllConditionedOperatorException - Exception in org.apache.commons.math3.linear
-
- IllConditionedOperatorException(double) - Constructor for exception org.apache.commons.math3.linear.IllConditionedOperatorException
-
Creates a new instance of this class.
- IllinoisSolver - Class in org.apache.commons.math3.analysis.solvers
-
Implements the Illinois method for root-finding (approximating
a zero of a univariate real function).
- IllinoisSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.IllinoisSolver
-
Construct a solver with default accuracy (1e-6).
- IllinoisSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.IllinoisSolver
-
Construct a solver.
- IllinoisSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.IllinoisSolver
-
Construct a solver.
- IllinoisSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.IllinoisSolver
-
Construct a solver.
- incMoment - Variable in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
-
Determines whether or not this statistic can be incremented or cleared.
- incMoment - Variable in class org.apache.commons.math3.stat.descriptive.moment.Mean
-
Determines whether or not this statistic can be incremented or cleared.
- incMoment - Variable in class org.apache.commons.math3.stat.descriptive.moment.Skewness
-
Determines whether or not this statistic can be incremented or cleared.
- incMoment - Variable in class org.apache.commons.math3.stat.descriptive.moment.Variance
-
- increment(double[]) - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
-
Increment the covariance matrix with one row of data.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
-
Add a new vector to the sample.
- increment(double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
-
Add a new vector to the sample.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
-
Updates the internal state of the statistic to reflect the addition of the new value.
- incrementAll(double[]) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
-
- incrementAll(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
-
- incrementAll(double[]) - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
-
Updates the internal state of the statistic to reflect addition of
all values in the values array.
- incrementAll(double[], int, int) - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
-
Updates the internal state of the statistic to reflect addition of
the values in the designated portion of the values array.
- incrementCount(int) - Method in class org.apache.commons.math3.util.Incrementor
-
Performs multiple increments.
- incrementCount() - Method in class org.apache.commons.math3.util.Incrementor
-
Adds one to the current iteration count.
- incrementEvaluationCount() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Increment the evaluation count by one.
- incrementIterationCount() - Method in class org.apache.commons.math3.util.IterationManager
-
Increments the iteration count by one, and throws an exception if the
maximum number of iterations is reached.
- incrementIterationsCounter() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
-
Increment the iterations counter by 1.
- Incrementor - Class in org.apache.commons.math3.util
-
Utility that increments a counter until a maximum is reached, at
which point, the instance will by default throw a
MaxCountExceededException
.
- Incrementor() - Constructor for class org.apache.commons.math3.util.Incrementor
-
Default constructor.
- Incrementor(int) - Constructor for class org.apache.commons.math3.util.Incrementor
-
Defines a maximal count.
- Incrementor(int, Incrementor.MaxCountExceededCallback) - Constructor for class org.apache.commons.math3.util.Incrementor
-
Defines a maximal count and a callback method to be triggered at
counter exhaustion.
- Incrementor.MaxCountExceededCallback - Interface in org.apache.commons.math3.util
-
Defines a method to be called at counter exhaustion.
- index - Variable in class org.apache.commons.math3.random.AbstractWell
-
Current index in the bytes pool.
- inducedPermutation(List<S>, List<S>) - Static method in class org.apache.commons.math3.genetics.RandomKey
-
Generates a representation of a permutation corresponding to a
permutation which yields permutedData
when applied to
originalData
.
- INF - Static variable in class org.apache.commons.math3.complex.Complex
-
A complex number representing "+INF + INFi"
- INFINITE - Static variable in class org.apache.commons.math3.dfp.Dfp
-
Indicator value for Infinity.
- INFINITE_WINDOW - Static variable in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Represents an infinite window size.
- init(double, double[], double) - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
-
Initialize step handler at the start of an ODE integration.
- init(double, double[], double) - Method in interface org.apache.commons.math3.ode.events.EventHandler
-
Initialize event handler at the start of an ODE integration.
- init(double, double[], double) - Method in class org.apache.commons.math3.ode.sampling.DummyStepHandler
-
Initialize step handler at the start of an ODE integration.
- init(double, double[], double) - Method in interface org.apache.commons.math3.ode.sampling.FixedStepHandler
-
Initialize step handler at the start of an ODE integration.
- init(double, double[], double) - Method in interface org.apache.commons.math3.ode.sampling.StepHandler
-
Initialize step handler at the start of an ODE integration.
- init(double, double[], double) - Method in class org.apache.commons.math3.ode.sampling.StepNormalizer
-
Initialize step handler at the start of an ODE integration.
- initializationPerformed(IterationEvent) - Method in interface org.apache.commons.math3.util.IterationListener
-
Invoked after completion of the initial phase of the iterative algorithm
(prior to the main iteration loop).
- initializeHighOrderDerivatives(double, double[], double[][], double[][]) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
-
Initialize the high order scaled derivatives at step start.
- initializeHighOrderDerivatives(double, double[], double[][], double[][]) - Method in interface org.apache.commons.math3.ode.MultistepIntegrator.NordsieckTransformer
-
Initialize the high order scaled derivatives at step start.
- initializeHighOrderDerivatives(double, double[], double[][], double[][]) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsIntegrator
-
Initialize the high order scaled derivatives at step start.
- initializeHighOrderDerivatives(double, double[], double[][], double[][]) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
-
Initialize the high order scaled derivatives at step start.
- initializeStep(boolean, int, double[], double, double[], double[], double[], double[]) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Initialize the integration step.
- initIntegration(double, double[], double) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Prepare the start of an integration.
- insert(T) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
-
Insert an element in the tree.
- insertCut(Hyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
-
Insert a cut sub-hyperplane in a node.
- insertEquationData(double[], double[]) - Method in class org.apache.commons.math3.ode.EquationsMapper
-
Insert equation data into a complete state or derivative array.
- insertInTree(BSPTree<S>, boolean) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
-
Insert the instance into another tree.
- IntegerDistribution - Interface in org.apache.commons.math3.distribution
-
Interface for distributions on the integers.
- integrate(int, UnivariateFunction, double, double) - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Integrate the function in the given interval.
- integrate(int, UnivariateFunction, double, double) - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
-
Integrate the function in the given interval.
- integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Integrate the differential equations up to the given time.
- integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Integrate a set of differential equations up to the given time.
- integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in interface org.apache.commons.math3.ode.FirstOrderIntegrator
-
Integrate the differential equations up to the given time.
- integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsBashforthIntegrator
-
Integrate a set of differential equations up to the given time.
- integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsIntegrator
-
Integrate a set of differential equations up to the given time.
- integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsMoultonIntegrator
-
Integrate a set of differential equations up to the given time.
- integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Integrate a set of differential equations up to the given time.
- integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Integrate a set of differential equations up to the given time.
- integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
-
Integrate a set of differential equations up to the given time.
- integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.RungeKuttaIntegrator
-
Integrate a set of differential equations up to the given time.
- integrate(SecondOrderDifferentialEquations, double, double[], double[], double, double[], double[]) - Method in interface org.apache.commons.math3.ode.SecondOrderIntegrator
-
Integrate the differential equations up to the given time
- interpolate(double[], double[], double[][]) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[], double[][]) - Method in interface org.apache.commons.math3.analysis.interpolation.BivariateGridInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.DividedDifferenceInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.LinearInterpolator
-
Computes a linear interpolating function for the data set.
- interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
-
Compute an interpolating function by performing a loess fit
on the data at the original abscissae and then building a cubic spline
with a
SplineInterpolator
on the resulting fit.
- interpolate(double[][], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator
-
Computes an interpolating function for the data set.
- interpolate(double[][], double[]) - Method in interface org.apache.commons.math3.analysis.interpolation.MultivariateInterpolator
-
Computes an interpolating function for the data set.
- interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.NevilleInterpolator
-
Computes an interpolating function for the data set.
- interpolate(double[], double[], double[][]) - Method in class org.apache.commons.math3.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.SplineInterpolator
-
Computes an interpolating function for the data set.
- interpolate(double[], double[], double[], double[][][]) - Method in class org.apache.commons.math3.analysis.interpolation.TricubicSplineInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[], double[], double[][][]) - Method in interface org.apache.commons.math3.analysis.interpolation.TrivariateGridInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[]) - Method in interface org.apache.commons.math3.analysis.interpolation.UnivariateInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.UnivariatePeriodicInterpolator
-
Compute an interpolating function for the dataset.
- interpolatedDerivatives - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
interpolated derivatives
- interpolatedPrimaryDerivatives - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
interpolated primary derivatives
- interpolatedPrimaryState - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
interpolated primary state
- interpolatedSecondaryDerivatives - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
interpolated secondary derivatives
- interpolatedSecondaryState - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
interpolated secondary state
- interpolatedState - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
interpolated state
- interpolatedTime - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
interpolated time
- intersection(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
-
Get the intersection point of the instance and another line.
- intersection(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Get the intersection of a line with the instance.
- intersection(Plane) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Build the line shared by the instance and another plane.
- intersection(Plane, Plane, Plane) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Get the intersection point of three planes.
- intersection(SubLine, boolean) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SubLine
-
Get the intersection of the instance and another sub-line.
- intersection(Line) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Get the intersection point of the instance and another line.
- intersection(SubLine, boolean) - Method in class org.apache.commons.math3.geometry.euclidean.twod.SubLine
-
Get the intersection of the instance and another sub-line.
- intersection(SubHyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Get the parts of a sub-hyperplane that are contained in the region.
- intersection(SubHyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
-
Get the parts of a sub-hyperplane that are contained in the region.
- intersection(Region<S>, Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
-
Compute the intersection of two regions.
- Interval - Class in org.apache.commons.math3.geometry.euclidean.oned
-
This class represents a 1D interval.
- Interval(double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Interval
-
Simple constructor.
- IntervalsSet - Class in org.apache.commons.math3.geometry.euclidean.oned
-
This class represents a 1D region: a set of intervals.
- IntervalsSet() - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
-
Build an intervals set representing the whole real line.
- IntervalsSet(double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
-
Build an intervals set corresponding to a single interval.
- IntervalsSet(BSPTree<Euclidean1D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
-
Build an intervals set from an inside/outside BSP tree.
- IntervalsSet(Collection<SubHyperplane<Euclidean1D>>) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
-
Build an intervals set from a Boundary REPresentation (B-rep).
- intValue() - Method in class org.apache.commons.math3.dfp.Dfp
-
Convert this to an integer.
- intValue() - Method in class org.apache.commons.math3.fraction.BigFraction
-
Gets the fraction as an int.
- intValue() - Method in class org.apache.commons.math3.fraction.Fraction
-
Gets the fraction as an int.
- InvalidRepresentationException - Exception in org.apache.commons.math3.genetics
-
Exception indicating that the representation of a chromosome is not valid.
- InvalidRepresentationException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.genetics.InvalidRepresentationException
-
Construct an InvalidRepresentationException with a specialized message.
- Inverse - Class in org.apache.commons.math3.analysis.function
-
Inverse function.
- Inverse() - Constructor for class org.apache.commons.math3.analysis.function.Inverse
-
- inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.CauchyDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in interface org.apache.commons.math3.distribution.RealDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.TriangularDistribution
-
- inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
Computes the quantile function of this distribution.
- iRm1 - Variable in class org.apache.commons.math3.random.AbstractWell
-
Index indirection table giving for each index its predecessor taking table size into account.
- iRm2 - Variable in class org.apache.commons.math3.random.AbstractWell
-
Index indirection table giving for each index its second predecessor taking table size into account.
- ISAACRandom - Class in org.apache.commons.math3.random
-
- ISAACRandom() - Constructor for class org.apache.commons.math3.random.ISAACRandom
-
Creates a new ISAAC random number generator.
- ISAACRandom(long) - Constructor for class org.apache.commons.math3.random.ISAACRandom
-
Creates a new ISAAC random number generator using a single long seed.
- ISAACRandom(int[]) - Constructor for class org.apache.commons.math3.random.ISAACRandom
-
Creates a new ISAAC random number generator using an int array seed.
- isBiasCorrected() - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
-
Returns true iff biasCorrected property is set to true.
- isBiasCorrected() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
-
- isBiasCorrected() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
-
- isBracketing(double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Check whether the function takes opposite signs at the endpoints.
- isBracketing(UnivariateFunction, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
-
Check whether the interval bounds bracket a root.
- isCounterClockWise() - Method in class org.apache.commons.math3.complex.RootsOfUnity
-
- isDefaultValue(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Determine if this value is within epsilon of zero.
- isDirect() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
-
Check if the hyperplane orientation is direct.
- isEmpty() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Check if the instance is empty.
- isEmpty(BSPTree<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Check if the sub-tree starting at a given node is empty.
- isEmpty() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
-
Check if the instance is empty.
- isEmpty() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
-
Check if the instance is empty.
- isEmpty(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
-
Check if the sub-tree starting at a given node is empty.
- isEmpty() - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
-
Check if the instance is empty.
- isEmpty() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
-
Check if the tree is empty.
- isForward() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Check if the natural integration direction is forward.
- isForward() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
-
Check if the natural integration direction is forward.
- isInfinite() - Method in class org.apache.commons.math3.complex.Complex
-
Checks whether either the real or imaginary part of this complex number
takes an infinite value (either Double.POSITIVE_INFINITY
or
Double.NEGATIVE_INFINITY
) and neither part
is NaN
.
- isInfinite() - Method in class org.apache.commons.math3.dfp.Dfp
-
Check if instance is infinite.
- isInfinite() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Returns true if any coordinate of this vector is infinite and none are NaN;
false otherwise
- isInfinite() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Returns true if any coordinate of this vector is infinite and none are NaN;
false otherwise
- isInfinite() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Returns true if any coordinate of this vector is infinite and none are NaN;
false otherwise
- isInfinite() - Method in interface org.apache.commons.math3.geometry.Vector
-
Returns true if any coordinate of this vector is infinite and none are NaN;
false otherwise
- isInfinite() - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Check whether any coordinate of this vector is infinite and none
are NaN
.
- isInfinite() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Check whether any coordinate of this vector is infinite and none are NaN
.
- isInfinite() - Method in class org.apache.commons.math3.linear.RealVector
-
Check whether any coordinate of this vector is infinite and none are NaN
.
- isLastStep - Variable in class org.apache.commons.math3.ode.AbstractIntegrator
-
Indicator for last step.
- isLoaded() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
-
Property indicating whether or not the distribution has been loaded.
- isMonotonic(Comparable[], MathArrays.OrderDirection, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
-
Check that an array is monotonically increasing or decreasing.
- isMonotonic(double[], MathArrays.OrderDirection, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
-
Check that an array is monotonically increasing or decreasing.
- isNaN() - Method in class org.apache.commons.math3.complex.Complex
-
Checks whether either or both parts of this complex number is
NaN
.
- isNaN() - Method in class org.apache.commons.math3.dfp.Dfp
-
Check if instance is not a number.
- isNaN() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Returns true if any coordinate of this vector is NaN; false otherwise
- isNaN() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Returns true if any coordinate of this vector is NaN; false otherwise
- isNaN() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Returns true if any coordinate of this vector is NaN; false otherwise
- isNaN() - Method in interface org.apache.commons.math3.geometry.Vector
-
Returns true if any coordinate of this vector is NaN; false otherwise
- isNaN() - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Check if any coordinate of this vector is NaN
.
- isNaN() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Check whether any coordinate of this vector is NaN
.
- isNaN() - Method in class org.apache.commons.math3.linear.RealVector
-
Check whether any coordinate of this vector is NaN
.
- isNoIntercept() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
- isNonSingular() - Method in interface org.apache.commons.math3.linear.DecompositionSolver
-
Check if the decomposed matrix is non-singular.
- isNonSingular() - Method in interface org.apache.commons.math3.linear.FieldDecompositionSolver
-
Check if the decomposed matrix is non-singular.
- isParallelTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Check the instance is parallel to another line.
- isPowerOfTwo(long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Returns true if the argument is a power of two.
- isSame(Chromosome) - Method in class org.apache.commons.math3.genetics.BinaryChromosome
-
Returns true iff another
has the same
representation and therefore the same fitness.
- isSame(Chromosome) - Method in class org.apache.commons.math3.genetics.Chromosome
-
Returns true iff another
has the same
representation and therefore the same fitness.
- isSame(Chromosome) - Method in class org.apache.commons.math3.genetics.RandomKey
-
Returns true
iff another
is a RandomKey and
encodes the same permutation.
- isSatisfied(Population) - Method in class org.apache.commons.math3.genetics.FixedGenerationCount
-
Determine whether or not the given number of generations have passed.
- isSatisfied(Population) - Method in interface org.apache.commons.math3.genetics.StoppingCondition
-
Determine whether or not the given population satisfies the stopping
condition.
- isSequence(double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Check whether the arguments form a (strictly) increasing sequence.
- isSequence(double, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
-
Check whether the arguments form a (strictly) increasing sequence.
- isSimilarTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
-
Check if the instance is similar to another line.
- isSimilarTo(Plane) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Check if the instance is similar to another plane.
- isSquare() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Is this a square matrix?
- isSquare() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Is this a square matrix?
- isSquare() - Method in interface org.apache.commons.math3.linear.AnyMatrix
-
Is this a square matrix?
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.BetaDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.FDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.GammaDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.PascalDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in interface org.apache.commons.math3.distribution.RealDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.TDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupported(String) - Method in class org.apache.commons.math3.ode.AbstractParameterizable
-
Check if a parameter is supported.
- isSupported(String) - Method in interface org.apache.commons.math3.ode.Parameterizable
-
Check if a parameter is supported.
- isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.BetaDistribution
-
Use this method to get information about whether the lower bound
of the support is inclusive or not.
- isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
-
Use this method to get information about whether the lower bound
of the support is inclusive or not.
- isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
Use this method to get information about whether the lower bound
of the support is inclusive or not.
- isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
-
Use this method to get information about whether the lower bound
of the support is inclusive or not.
- isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.FDistribution
-
Use this method to get information about whether the lower bound
of the support is inclusive or not.
- isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.GammaDistribution
-
Use this method to get information about whether the lower bound
of the support is inclusive or not.
- isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
Use this method to get information about whether the lower bound
of the support is inclusive or not.
- isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
Use this method to get information about whether the lower bound
of the support is inclusive or not.
- isSupportLowerBoundInclusive() - Method in interface org.apache.commons.math3.distribution.RealDistribution
-
Use this method to get information about whether the lower bound
of the support is inclusive or not.
- isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.TDistribution
-
Use this method to get information about whether the lower bound
of the support is inclusive or not.
- isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
-
Use this method to get information about whether the lower bound
of the support is inclusive or not.
- isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
-
Use this method to get information about whether the lower bound
of the support is inclusive or not.
- isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
Use this method to get information about whether the lower bound
of the support is inclusive or not.
- isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.BetaDistribution
-
Use this method to get information about whether the upper bound
of the support is inclusive or not.
- isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
-
Use this method to get information about whether the upper bound
of the support is inclusive or not.
- isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
Use this method to get information about whether the upper bound
of the support is inclusive or not.
- isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
-
Use this method to get information about whether the upper bound
of the support is inclusive or not.
- isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.FDistribution
-
Use this method to get information about whether the upper bound
of the support is inclusive or not.
- isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.GammaDistribution
-
Use this method to get information about whether the upper bound
of the support is inclusive or not.
- isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
Use this method to get information about whether the upper bound
of the support is inclusive or not.
- isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
Use this method to get information about whether the upper bound
of the support is inclusive or not.
- isSupportUpperBoundInclusive() - Method in interface org.apache.commons.math3.distribution.RealDistribution
-
Use this method to get information about whether the upper bound
of the support is inclusive or not.
- isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.TDistribution
-
Use this method to get information about whether the upper bound
of the support is inclusive or not.
- isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
-
Use this method to get information about whether the upper bound
of the support is inclusive or not.
- isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
-
Use this method to get information about whether the upper bound
of the support is inclusive or not.
- isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
Use this method to get information about whether the upper bound
of the support is inclusive or not.
- isTransposable() - Method in class org.apache.commons.math3.linear.RealLinearOperator
-
- isZero() - Method in class org.apache.commons.math3.dfp.Dfp
-
Check if instance is equal to zero.
- iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
-
Compute the next simplex of the algorithm.
- iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
-
Compute the next simplex of the algorithm.
- iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
-
Compute the next simplex of the algorithm.
- IterationEvent - Class in org.apache.commons.math3.util
-
The root class from which all events occurring while running an
IterationManager
should be derived.
- IterationEvent(Object, int) - Constructor for class org.apache.commons.math3.util.IterationEvent
-
Creates a new instance of this class.
- IterationListener - Interface in org.apache.commons.math3.util
-
The listener interface for receiving events occurring in an iterative
algorithm.
- IterationManager - Class in org.apache.commons.math3.util
-
This abstract class provides a general framework for managing iterative
algorithms.
- IterationManager(int) - Constructor for class org.apache.commons.math3.util.IterationManager
-
Creates a new instance of this class.
- iterationPerformed(IterationEvent) - Method in interface org.apache.commons.math3.util.IterationListener
-
Invoked each time an iteration is completed (in the main iteration loop).
- iterations - Variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
The iteration count.
- iterationStarted(IterationEvent) - Method in interface org.apache.commons.math3.util.IterationListener
-
Invoked each time a new iteration is completed (in the main iteration
loop).
- IterativeLinearSolver - Class in org.apache.commons.math3.linear
-
This abstract class defines an iterative solver for the linear system A
· x = b.
- IterativeLinearSolver(int) - Constructor for class org.apache.commons.math3.linear.IterativeLinearSolver
-
Creates a new instance of this class, with default iteration manager.
- IterativeLinearSolver(IterationManager) - Constructor for class org.apache.commons.math3.linear.IterativeLinearSolver
-
Creates a new instance of this class, with custom iteration manager.
- IterativeLinearSolverEvent - Class in org.apache.commons.math3.linear
-
- IterativeLinearSolverEvent(Object, int) - Constructor for class org.apache.commons.math3.linear.IterativeLinearSolverEvent
-
Creates a new instance of this class.
- iterator() - Method in class org.apache.commons.math3.genetics.ListPopulation
-
Chromosome list iterator
- iterator() - Method in class org.apache.commons.math3.linear.RealVector
-
Generic dense iterator.
- iterator() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
-
Create an iterator over this counter.
- iterator() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
-
Get an iterator over map elements.
- iterator() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
-
Get an iterator over map elements.
- NaN - Static variable in class org.apache.commons.math3.complex.Complex
-
A complex number representing "NaN + NaNi"
- NaN - Static variable in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
A vector with all coordinates set to NaN.
- NaN - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
A vector with all coordinates set to NaN.
- NaN - Static variable in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
A vector with all coordinates set to NaN.
- nans - Variable in class org.apache.commons.math3.dfp.Dfp
-
Indicator for non-finite / non-number values.
- NaNStrategy - Enum in org.apache.commons.math3.stat.ranking
-
Strategies for handling NaN values in rank transformations.
- NaturalRanking - Class in org.apache.commons.math3.stat.ranking
-
Ranking based on the natural ordering on doubles.
- NaturalRanking() - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
-
Create a NaturalRanking with default strategies for handling ties and NaNs.
- NaturalRanking(TiesStrategy) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
-
Create a NaturalRanking with the given TiesStrategy.
- NaturalRanking(NaNStrategy) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
-
Create a NaturalRanking with the given NaNStrategy.
- NaturalRanking(NaNStrategy, TiesStrategy) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
-
Create a NaturalRanking with the given NaNStrategy and TiesStrategy.
- NaturalRanking(RandomGenerator) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
-
Create a NaturalRanking with TiesStrategy.RANDOM and the given
RandomGenerator as the source of random data.
- NaturalRanking(NaNStrategy, RandomGenerator) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
-
Create a NaturalRanking with the given NaNStrategy, TiesStrategy.RANDOM
and the given source of random data.
- negate() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
-
Negate the instance.
- negate() - Method in class org.apache.commons.math3.complex.Complex
-
Returns a Complex
whose value is (-this)
.
- negate() - Method in class org.apache.commons.math3.dfp.Dfp
-
Returns a number that is this number with the sign bit reversed.
- negate() - Method in interface org.apache.commons.math3.FieldElement
-
Returns the additive inverse of this
element.
- negate() - Method in class org.apache.commons.math3.fraction.BigFraction
-
Return the additive inverse of this fraction, returning the result in
reduced form.
- negate() - Method in class org.apache.commons.math3.fraction.Fraction
-
Return the additive inverse of this fraction.
- negate() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Get the opposite of the instance.
- negate() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Get the opposite of the instance.
- negate() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Get the opposite of the instance.
- negate() - Method in interface org.apache.commons.math3.geometry.Vector
-
Get the opposite of the instance.
- negate() - Method in class org.apache.commons.math3.util.BigReal
-
Returns the additive inverse of this
element.
- NEGATIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
A vector with all coordinates set to negative infinity.
- NEGATIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
A vector with all coordinates set to negative infinity.
- NEGATIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
A vector with all coordinates set to negative infinity.
- negativeOrNull() - Method in class org.apache.commons.math3.dfp.Dfp
-
Check if instance is less than or equal to 0.
- NelderMeadSimplex - Class in org.apache.commons.math3.optimization.direct
-
This class implements the Nelder-Mead simplex algorithm.
- NelderMeadSimplex(int) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
-
Build a Nelder-Mead simplex with default coefficients.
- NelderMeadSimplex(int, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
-
Build a Nelder-Mead simplex with default coefficients.
- NelderMeadSimplex(int, double, double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
-
Build a Nelder-Mead simplex with specified coefficients.
- NelderMeadSimplex(int, double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
-
Build a Nelder-Mead simplex with specified coefficients.
- NelderMeadSimplex(double[]) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
-
Build a Nelder-Mead simplex with default coefficients.
- NelderMeadSimplex(double[], double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
-
Build a Nelder-Mead simplex with specified coefficients.
- NelderMeadSimplex(double[][]) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
-
Build a Nelder-Mead simplex with default coefficients.
- NelderMeadSimplex(double[][], double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
-
Build a Nelder-Mead simplex with specified coefficients.
- NevilleInterpolator - Class in org.apache.commons.math3.analysis.interpolation
-
- NevilleInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.NevilleInterpolator
-
- newCovarianceData(double[][]) - Method in class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
-
Add the covariance data.
- newDfp() - Method in class org.apache.commons.math3.dfp.DfpField
-
Makes a
Dfp
with a value of 0.
- newDfp(byte) - Method in class org.apache.commons.math3.dfp.DfpField
-
Create an instance from a byte value.
- newDfp(int) - Method in class org.apache.commons.math3.dfp.DfpField
-
Create an instance from an int value.
- newDfp(long) - Method in class org.apache.commons.math3.dfp.DfpField
-
Create an instance from a long value.
- newDfp(double) - Method in class org.apache.commons.math3.dfp.DfpField
-
Create an instance from a double value.
- newDfp(Dfp) - Method in class org.apache.commons.math3.dfp.DfpField
-
Copy constructor.
- newDfp(String) - Method in class org.apache.commons.math3.dfp.DfpField
-
Create a
Dfp
given a String representation.
- newDfp(byte, byte) - Method in class org.apache.commons.math3.dfp.DfpField
-
Creates a
Dfp
with a non-finite value.
- newFixedLengthChromosome(List<T>) - Method in class org.apache.commons.math3.genetics.AbstractListChromosome
-
Creates a new instance of the same class as this
is, with a
given arrayRepresentation
.
- newInstance() - Method in class org.apache.commons.math3.dfp.Dfp
-
Create an instance with a value of 0.
- newInstance(byte) - Method in class org.apache.commons.math3.dfp.Dfp
-
Create an instance from a byte value.
- newInstance(int) - Method in class org.apache.commons.math3.dfp.Dfp
-
Create an instance from an int value.
- newInstance(long) - Method in class org.apache.commons.math3.dfp.Dfp
-
Create an instance from a long value.
- newInstance(double) - Method in class org.apache.commons.math3.dfp.Dfp
-
Create an instance from a double value.
- newInstance(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
-
Create an instance by copying an existing one.
- newInstance(String) - Method in class org.apache.commons.math3.dfp.Dfp
-
Create an instance from a String representation.
- newInstance(byte, byte) - Method in class org.apache.commons.math3.dfp.Dfp
-
Creates an instance with a non-finite value.
- newInstance() - Method in class org.apache.commons.math3.dfp.DfpDec
-
Create an instance with a value of 0.
- newInstance(byte) - Method in class org.apache.commons.math3.dfp.DfpDec
-
Create an instance from a byte value.
- newInstance(int) - Method in class org.apache.commons.math3.dfp.DfpDec
-
Create an instance from an int value.
- newInstance(long) - Method in class org.apache.commons.math3.dfp.DfpDec
-
Create an instance from a long value.
- newInstance(double) - Method in class org.apache.commons.math3.dfp.DfpDec
-
Create an instance from a double value.
- newInstance(Dfp) - Method in class org.apache.commons.math3.dfp.DfpDec
-
Create an instance by copying an existing one.
- newInstance(String) - Method in class org.apache.commons.math3.dfp.DfpDec
-
Create an instance from a String representation.
- newInstance(byte, byte) - Method in class org.apache.commons.math3.dfp.DfpDec
-
Creates an instance with a non-finite value.
- newSampleData(double[], int, int) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
Loads model x and y sample data from a flat input array, overriding any previous sample.
- newSampleData(double[], double[][], double[][]) - Method in class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
-
Replace sample data, overriding any previous sample.
- newSampleData(double[], double[][]) - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
-
Loads model x and y sample data, overriding any previous sample.
- newSampleData(double[], int, int) - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
-
Loads model x and y sample data from a flat input array, overriding any previous sample.
- NewtonSolver - Class in org.apache.commons.math3.analysis.solvers
-
- NewtonSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.NewtonSolver
-
Construct a solver.
- NewtonSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.NewtonSolver
-
Construct a solver.
- newXSampleData(double[][]) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
Loads new x sample data, overriding any previous data.
- newXSampleData(double[][]) - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
-
Loads new x sample data, overriding any previous data.
- newYSampleData(double[]) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
Loads new y sample data, overriding any previous data.
- next() - Method in class org.apache.commons.math3.linear.OpenMapRealVector.OpenMapSparseIterator
- next() - Method in class org.apache.commons.math3.linear.RealVector.SparseEntryIterator
- next(int) - Method in class org.apache.commons.math3.random.AbstractWell
-
Generate next pseudorandom number.
- next(int) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
-
Generate next pseudorandom number.
- next(int) - Method in class org.apache.commons.math3.random.ISAACRandom
-
Generate next pseudorandom number.
- next(int) - Method in class org.apache.commons.math3.random.MersenneTwister
-
Generate next pseudorandom number.
- next(int) - Method in class org.apache.commons.math3.random.Well1024a
-
Generate next pseudorandom number.
- next(int) - Method in class org.apache.commons.math3.random.Well19937a
-
Generate next pseudorandom number.
- next(int) - Method in class org.apache.commons.math3.random.Well19937c
-
Generate next pseudorandom number.
- next(int) - Method in class org.apache.commons.math3.random.Well44497a
-
Generate next pseudorandom number.
- next(int) - Method in class org.apache.commons.math3.random.Well44497b
-
Generate next pseudorandom number.
- next(int) - Method in class org.apache.commons.math3.random.Well512a
-
Generate next pseudorandom number.
- next() - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
-
- nextAfter(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
-
Returns the next number greater than this one in the direction of x.
- nextAfter(Dfp) - Method in class org.apache.commons.math3.dfp.DfpDec
-
Returns the next number greater than this one in the direction of x.
- nextAfter(double, double) - Static method in class org.apache.commons.math3.util.FastMath
-
Get the next machine representable number after a number, moving
in the direction of another number.
- nextAfter(float, double) - Static method in class org.apache.commons.math3.util.FastMath
-
Get the next machine representable number after a number, moving
in the direction of another number.
- nextBeta(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
- nextBinomial(int, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
- nextBoolean() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
-
Returns the next pseudorandom, uniformly distributed
boolean
value from this random number generator's
sequence.
- nextBoolean() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
-
Returns the next pseudorandom, uniformly distributed
boolean
value from this random number generator's
sequence.
- nextBoolean() - Method in class org.apache.commons.math3.random.RandomAdaptor
-
Returns the next pseudorandom, uniformly distributed
boolean
value from this random number generator's
sequence.
- nextBoolean() - Method in interface org.apache.commons.math3.random.RandomGenerator
-
Returns the next pseudorandom, uniformly distributed
boolean
value from this random number generator's
sequence.
- nextBytes(byte[]) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
-
Generates random bytes and places them into a user-supplied
byte array.
- nextBytes(byte[]) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
-
Generates random bytes and places them into a user-supplied
byte array.
- nextBytes(byte[]) - Method in class org.apache.commons.math3.random.RandomAdaptor
-
Generates random bytes and places them into a user-supplied
byte array.
- nextBytes(byte[]) - Method in interface org.apache.commons.math3.random.RandomGenerator
-
Generates random bytes and places them into a user-supplied
byte array.
- nextCauchy(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
- nextChiSquare(double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
- nextDouble() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
-
Returns the next pseudorandom, uniformly distributed
double
value between 0.0
and
1.0
from this random number generator's sequence.
- nextDouble() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
-
Returns the next pseudorandom, uniformly distributed
double
value between 0.0
and
1.0
from this random number generator's sequence.
- nextDouble() - Method in class org.apache.commons.math3.random.RandomAdaptor
-
Returns the next pseudorandom, uniformly distributed
double
value between 0.0
and
1.0
from this random number generator's sequence.
- nextDouble() - Method in interface org.apache.commons.math3.random.RandomGenerator
-
Returns the next pseudorandom, uniformly distributed
double
value between 0.0
and
1.0
from this random number generator's sequence.
- nextExponential(double) - Method in interface org.apache.commons.math3.random.RandomData
-
Generates a random value from the exponential distribution
with specified mean.
- nextExponential(double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Generates a random value from the exponential distribution
with specified mean.
- nextF(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
- nextFloat() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
-
Returns the next pseudorandom, uniformly distributed float
value between 0.0
and 1.0
from this random
number generator's sequence.
- nextFloat() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
-
Returns the next pseudorandom, uniformly distributed float
value between 0.0
and 1.0
from this random
number generator's sequence.
- nextFloat() - Method in class org.apache.commons.math3.random.RandomAdaptor
-
Returns the next pseudorandom, uniformly distributed float
value between 0.0
and 1.0
from this random
number generator's sequence.
- nextFloat() - Method in interface org.apache.commons.math3.random.RandomGenerator
-
Returns the next pseudorandom, uniformly distributed float
value between 0.0
and 1.0
from this random
number generator's sequence.
- nextGamma(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
- nextGaussian() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
-
Returns the next pseudorandom, Gaussian ("normally") distributed
double
value with mean 0.0
and standard
deviation 1.0
from this random number generator's sequence.
- nextGaussian() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
-
Returns the next pseudorandom, Gaussian ("normally") distributed
double
value with mean 0.0
and standard
deviation 1.0
from this random number generator's sequence.
- nextGaussian() - Method in class org.apache.commons.math3.random.RandomAdaptor
-
Returns the next pseudorandom, Gaussian ("normally") distributed
double
value with mean 0.0
and standard
deviation 1.0
from this random number generator's sequence.
- nextGaussian(double, double) - Method in interface org.apache.commons.math3.random.RandomData
-
Generates a random value from the Normal (or Gaussian) distribution with
specified mean and standard deviation.
- nextGaussian(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Generates a random value from the Normal (or Gaussian) distribution with
specified mean and standard deviation.
- nextGaussian() - Method in interface org.apache.commons.math3.random.RandomGenerator
-
Returns the next pseudorandom, Gaussian ("normally") distributed
double
value with mean 0.0
and standard
deviation 1.0
from this random number generator's sequence.
- nextGeneration() - Method in class org.apache.commons.math3.genetics.ElitisticListPopulation
-
Start the population for the next generation.
- nextGeneration(Population) - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
-
Evolve the given population into the next generation.
- nextGeneration() - Method in interface org.apache.commons.math3.genetics.Population
-
Start the population for the next generation.
- nextHexString(int) - Method in interface org.apache.commons.math3.random.RandomData
-
Generates a random string of hex characters of length len
.
- nextHexString(int) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Generates a random string of hex characters of length len
.
- nextHypergeometric(int, int, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
- nextInt() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
-
Returns the next pseudorandom, uniformly distributed int
value from this random number generator's sequence.
- nextInt(int) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
-
Returns a pseudorandom, uniformly distributed int
value
between 0 (inclusive) and the specified value (exclusive), drawn from
this random number generator's sequence.
- nextInt() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
-
Returns the next pseudorandom, uniformly distributed int
value from this random number generator's sequence.
- nextInt(int) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
-
Returns a pseudorandom, uniformly distributed int value
between 0 (inclusive) and the specified value (exclusive), drawn from
this random number generator's sequence.
- nextInt() - Method in class org.apache.commons.math3.random.RandomAdaptor
-
Returns the next pseudorandom, uniformly distributed int
value from this random number generator's sequence.
- nextInt(int) - Method in class org.apache.commons.math3.random.RandomAdaptor
-
Returns a pseudorandom, uniformly distributed int value
between 0 (inclusive) and the specified value (exclusive), drawn from
this random number generator's sequence.
- nextInt(int, int) - Method in interface org.apache.commons.math3.random.RandomData
-
Generates a uniformly distributed random integer between lower
and upper
(endpoints included).
- nextInt(int, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Generates a uniformly distributed random integer between lower
and upper
(endpoints included).
- nextInt() - Method in interface org.apache.commons.math3.random.RandomGenerator
-
Returns the next pseudorandom, uniformly distributed int
value from this random number generator's sequence.
- nextInt(int) - Method in interface org.apache.commons.math3.random.RandomGenerator
-
Returns a pseudorandom, uniformly distributed int value
between 0 (inclusive) and the specified value (exclusive), drawn from
this random number generator's sequence.
- nextInversionDeviate(RealDistribution) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
- nextInversionDeviate(IntegerDistribution) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
- nextLong() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
-
Returns the next pseudorandom, uniformly distributed long
value from this random number generator's sequence.
- nextLong() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
-
Returns the next pseudorandom, uniformly distributed long
value from this random number generator's sequence.
- nextLong() - Method in class org.apache.commons.math3.random.RandomAdaptor
-
Returns the next pseudorandom, uniformly distributed long
value from this random number generator's sequence.
- nextLong(long, long) - Method in interface org.apache.commons.math3.random.RandomData
-
Generates a uniformly distributed random long integer between
lower
and upper
(endpoints included).
- nextLong(long, long) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Generates a uniformly distributed random long integer between
lower
and upper
(endpoints included).
- nextLong() - Method in interface org.apache.commons.math3.random.RandomGenerator
-
Returns the next pseudorandom, uniformly distributed long
value from this random number generator's sequence.
- nextNormalizedDouble() - Method in class org.apache.commons.math3.random.GaussianRandomGenerator
-
Generate a random scalar with null mean and unit standard deviation.
- nextNormalizedDouble() - Method in interface org.apache.commons.math3.random.NormalizedRandomGenerator
-
Generate a random scalar with null mean and unit standard deviation.
- nextNormalizedDouble() - Method in class org.apache.commons.math3.random.StableRandomGenerator
-
Generate a random scalar with zero location and unit scale.
- nextNormalizedDouble() - Method in class org.apache.commons.math3.random.UniformRandomGenerator
-
Generate a random scalar with null mean and unit standard deviation.
- nextPascal(int, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
- nextPermutation(int, int) - Method in interface org.apache.commons.math3.random.RandomData
-
Generates an integer array of length k
whose entries are selected
randomly, without repetition, from the integers 0, ..., n - 1
(inclusive).
- nextPermutation(int, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Generates an integer array of length k
whose entries are selected
randomly, without repetition, from the integers 0, ..., n - 1
(inclusive).
- nextPoisson(double) - Method in interface org.apache.commons.math3.random.RandomData
-
Generates a random value from the Poisson distribution with the given
mean.
- nextPoisson(double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Generates a random value from the Poisson distribution with the given
mean.
- nextSample(Collection<?>, int) - Method in interface org.apache.commons.math3.random.RandomData
-
Returns an array of k
objects selected randomly from the
Collection c
.
- nextSample(Collection<?>, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Returns an array of k
objects selected randomly from the
Collection c
.
- nextSecureHexString(int) - Method in interface org.apache.commons.math3.random.RandomData
-
Generates a random string of hex characters from a secure random
sequence.
- nextSecureHexString(int) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Generates a random string of hex characters from a secure random
sequence.
- nextSecureInt(int, int) - Method in interface org.apache.commons.math3.random.RandomData
-
Generates a uniformly distributed random integer between lower
and upper
(endpoints included) from a secure random sequence.
- nextSecureInt(int, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Generates a uniformly distributed random integer between lower
and upper
(endpoints included) from a secure random sequence.
- nextSecureLong(long, long) - Method in interface org.apache.commons.math3.random.RandomData
-
Generates a uniformly distributed random long integer between
lower
and upper
(endpoints included) from a secure random
sequence.
- nextSecureLong(long, long) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Generates a uniformly distributed random long integer between
lower
and upper
(endpoints included) from a secure random
sequence.
- nextT(double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
- nextUniform(double, double) - Method in interface org.apache.commons.math3.random.RandomData
-
Generates a uniformly distributed random value from the open interval
(lower, upper)
(i.e., endpoints excluded).
- nextUniform(double, double, boolean) - Method in interface org.apache.commons.math3.random.RandomData
-
Generates a uniformly distributed random value from the interval
(lower, upper)
or the interval [lower, upper)
.
- nextUniform(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Generates a uniformly distributed random value from the open interval
(lower, upper)
(i.e., endpoints excluded).
- nextUniform(double, double, boolean) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Generates a uniformly distributed random value from the interval
(lower, upper)
or the interval [lower, upper)
.
- nextUp(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Compute next number towards positive infinity.
- nextUp(float) - Static method in class org.apache.commons.math3.util.FastMath
-
Compute next number towards positive infinity.
- nextVector() - Method in class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
-
Generate a correlated random vector.
- nextVector() - Method in interface org.apache.commons.math3.random.RandomVectorGenerator
-
Generate a random vector.
- nextVector() - Method in class org.apache.commons.math3.random.UncorrelatedRandomVectorGenerator
-
Generate an uncorrelated random vector.
- nextVector() - Method in class org.apache.commons.math3.random.UnitSphereRandomVectorGenerator
-
Generate a random vector.
- nextWeibull(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
- nextZipf(int, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
- NoBracketingException - Exception in org.apache.commons.math3.exception
-
Exception to be thrown when function values have the same sign at both
ends of an interval.
- NoBracketingException(double, double, double, double) - Constructor for exception org.apache.commons.math3.exception.NoBracketingException
-
Construct the exception.
- NoBracketingException(Localizable, double, double, double, double, Object...) - Constructor for exception org.apache.commons.math3.exception.NoBracketingException
-
Construct the exception with a specific context.
- NoDataException - Exception in org.apache.commons.math3.exception
-
Exception to be thrown when the required data is missing.
- NoDataException() - Constructor for exception org.apache.commons.math3.exception.NoDataException
-
Construct the exception.
- NoDataException(Localizable) - Constructor for exception org.apache.commons.math3.exception.NoDataException
-
Construct the exception with a specific context.
- NoFeasibleSolutionException - Exception in org.apache.commons.math3.optimization.linear
-
This class represents exceptions thrown by optimizers when no solution
fulfills the constraints.
- NoFeasibleSolutionException() - Constructor for exception org.apache.commons.math3.optimization.linear.NoFeasibleSolutionException
-
Simple constructor using a default message.
- NonLinearConjugateGradientOptimizer - Class in org.apache.commons.math3.optimization.general
-
Non-linear conjugate gradient optimizer.
- NonLinearConjugateGradientOptimizer(ConjugateGradientFormula) - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
-
- NonLinearConjugateGradientOptimizer(ConjugateGradientFormula, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
-
- NonLinearConjugateGradientOptimizer(ConjugateGradientFormula, ConvergenceChecker<PointValuePair>, UnivariateSolver) - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
-
- NonLinearConjugateGradientOptimizer(ConjugateGradientFormula, ConvergenceChecker<PointValuePair>, UnivariateSolver, Preconditioner) - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
-
- NonLinearConjugateGradientOptimizer.IdentityPreconditioner - Class in org.apache.commons.math3.optimization.general
-
Default identity preconditioner.
- NonLinearConjugateGradientOptimizer.IdentityPreconditioner() - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer.IdentityPreconditioner
-
- NonMonotonicSequenceException - Exception in org.apache.commons.math3.exception
-
Exception to be thrown when the a sequence of values is not monotonically
increasing or decreasing.
- NonMonotonicSequenceException(Number, Number, int) - Constructor for exception org.apache.commons.math3.exception.NonMonotonicSequenceException
-
Construct the exception.
- NonMonotonicSequenceException(Number, Number, int, MathArrays.OrderDirection, boolean) - Constructor for exception org.apache.commons.math3.exception.NonMonotonicSequenceException
-
Construct the exception.
- NonPositiveDefiniteMatrixException - Exception in org.apache.commons.math3.linear
-
Exception to be thrown when a positive definite matrix is expected.
- NonPositiveDefiniteMatrixException(double, int, double) - Constructor for exception org.apache.commons.math3.linear.NonPositiveDefiniteMatrixException
-
Construct an exception.
- NonPositiveDefiniteOperatorException - Exception in org.apache.commons.math3.linear
-
Exception to be thrown when a symmetric, definite positive
RealLinearOperator
is expected.
- NonPositiveDefiniteOperatorException() - Constructor for exception org.apache.commons.math3.linear.NonPositiveDefiniteOperatorException
-
Creates a new instance of this class.
- NonSelfAdjointOperatorException - Exception in org.apache.commons.math3.linear
-
- NonSelfAdjointOperatorException() - Constructor for exception org.apache.commons.math3.linear.NonSelfAdjointOperatorException
-
Creates a new instance of this class.
- NonSquareMatrixException - Exception in org.apache.commons.math3.linear
-
Exception to be thrown when a square matrix is expected.
- NonSquareMatrixException(int, int) - Constructor for exception org.apache.commons.math3.linear.NonSquareMatrixException
-
Construct an exception from the mismatched dimensions.
- NonSquareOperatorException - Exception in org.apache.commons.math3.linear
-
Exception to be thrown when a square linear operator is expected.
- NonSquareOperatorException(int, int) - Constructor for exception org.apache.commons.math3.linear.NonSquareOperatorException
-
Construct an exception from the mismatched dimensions.
- NonSymmetricMatrixException - Exception in org.apache.commons.math3.linear
-
Exception to be thrown when a symmetric matrix is expected.
- NonSymmetricMatrixException(int, int, double) - Constructor for exception org.apache.commons.math3.linear.NonSymmetricMatrixException
-
Construct an exception.
- nordsieck - Variable in class org.apache.commons.math3.ode.MultistepIntegrator
-
Nordsieck matrix of the higher scaled derivatives.
- NordsieckStepInterpolator - Class in org.apache.commons.math3.ode.sampling
-
This class implements an interpolator for integrators using Nordsieck representation.
- NordsieckStepInterpolator() - Constructor for class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
-
Simple constructor.
- NordsieckStepInterpolator(NordsieckStepInterpolator) - Constructor for class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
-
Copy constructor.
- normalApproximateProbability(int) - Method in class org.apache.commons.math3.distribution.PoissonDistribution
-
Calculates the Poisson distribution function using a normal
approximation.
- NormalDistribution - Class in org.apache.commons.math3.distribution
-
Implementation of the normal (gaussian) distribution.
- NormalDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.NormalDistribution
-
Create a normal distribution using the given mean and standard deviation.
- NormalDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.NormalDistribution
-
Create a normal distribution using the given mean, standard deviation and
inverse cumulative distribution accuracy.
- NormalDistribution() - Constructor for class org.apache.commons.math3.distribution.NormalDistribution
-
Create a normal distribution with mean equal to zero and standard
deviation equal to one.
- normalize() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Get a normalized vector aligned with the instance.
- normalize() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Get a normalized vector aligned with the instance.
- normalize() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Get a normalized vector aligned with the instance.
- normalize() - Method in interface org.apache.commons.math3.geometry.Vector
-
Get a normalized vector aligned with the instance.
- normalize(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Normalize (standardize) the series, so in the end it is having a mean of 0 and a standard deviation of 1.
- normalizeAngle(double, double) - Static method in class org.apache.commons.math3.util.MathUtils
-
Normalize an angle in a 2&pi wide interval around a center value.
- normalizeArray(double[], double) - Static method in class org.apache.commons.math3.util.MathArrays
-
Normalizes an array to make it sum to a specified value.
- NormalizedRandomGenerator - Interface in org.apache.commons.math3.random
-
This interface represent a normalized random generator for
scalars.
- NotARotationMatrixException - Exception in org.apache.commons.math3.geometry.euclidean.threed
-
This class represents exceptions thrown while building rotations
from matrices.
- NotARotationMatrixException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.geometry.euclidean.threed.NotARotationMatrixException
-
Simple constructor.
- NotFiniteNumberException - Exception in org.apache.commons.math3.exception
-
Exception to be thrown when a number is not finite.
- NotFiniteNumberException(Number, Object...) - Constructor for exception org.apache.commons.math3.exception.NotFiniteNumberException
-
Construct the exception.
- NotFiniteNumberException(Localizable, Number, Object...) - Constructor for exception org.apache.commons.math3.exception.NotFiniteNumberException
-
Construct the exception with a specific context.
- NotPositiveException - Exception in org.apache.commons.math3.exception
-
Exception to be thrown when the argument is negative.
- NotPositiveException(Number) - Constructor for exception org.apache.commons.math3.exception.NotPositiveException
-
Construct the exception.
- NotPositiveException(Localizable, Number) - Constructor for exception org.apache.commons.math3.exception.NotPositiveException
-
Construct the exception with a specific context.
- NotStrictlyPositiveException - Exception in org.apache.commons.math3.exception
-
Exception to be thrown when the argument is negative.
- NotStrictlyPositiveException(Number) - Constructor for exception org.apache.commons.math3.exception.NotStrictlyPositiveException
-
Construct the exception.
- NotStrictlyPositiveException(Localizable, Number) - Constructor for exception org.apache.commons.math3.exception.NotStrictlyPositiveException
-
Construct the exception with a specific context.
- nthRoot(int) - Method in class org.apache.commons.math3.complex.Complex
-
Computes the n-th roots of this complex number.
- NullArgumentException - Exception in org.apache.commons.math3.exception
-
All conditions checks that fail due to a null
argument must throw
this exception.
- NullArgumentException() - Constructor for exception org.apache.commons.math3.exception.NullArgumentException
-
Default constructor.
- NullArgumentException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.NullArgumentException
-
- NumberIsTooLargeException - Exception in org.apache.commons.math3.exception
-
Exception to be thrown when a number is too large.
- NumberIsTooLargeException(Number, Number, boolean) - Constructor for exception org.apache.commons.math3.exception.NumberIsTooLargeException
-
Construct the exception.
- NumberIsTooLargeException(Localizable, Number, Number, boolean) - Constructor for exception org.apache.commons.math3.exception.NumberIsTooLargeException
-
Construct the exception with a specific context.
- NumberIsTooSmallException - Exception in org.apache.commons.math3.exception
-
Exception to be thrown when a number is too small.
- NumberIsTooSmallException(Number, Number, boolean) - Constructor for exception org.apache.commons.math3.exception.NumberIsTooSmallException
-
Construct the exception.
- NumberIsTooSmallException(Localizable, Number, Number, boolean) - Constructor for exception org.apache.commons.math3.exception.NumberIsTooSmallException
-
Construct the exception with a specific context.
- NumberTransformer - Interface in org.apache.commons.math3.util
-
Subclasses implementing this interface can transform Objects to doubles.
- Pair<K,V> - Class in org.apache.commons.math3.util
-
Generic pair.
- Pair(K, V) - Constructor for class org.apache.commons.math3.util.Pair
-
Create an entry representing a mapping from the specified key to the
specified value.
- Pair(Pair<? extends K, ? extends V>) - Constructor for class org.apache.commons.math3.util.Pair
-
Create an entry representing the same mapping as the specified entry.
- pairedT(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
-
- pairedT(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
-
Computes a paired, 2-sample t-statistic based on the data in the input
arrays.
- pairedTTest(double[], double[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
-
- pairedTTest(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
-
- pairedTTest(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
-
Returns the observed significance level, or
p-value, associated with a paired, two-sample, two-tailed t-test
based on the data in the input arrays.
- pairedTTest(double[], double[], double) - Method in class org.apache.commons.math3.stat.inference.TTest
-
Performs a paired t-test evaluating the null hypothesis that the
mean of the paired differences between sample1
and
sample2
is 0 in favor of the two-sided alternative that the
mean paired difference is not equal to 0, with significance level
alpha
.
- Parameterizable - Interface in org.apache.commons.math3.ode
-
This interface enables to process any parameterizable object.
- ParameterizedODE - Interface in org.apache.commons.math3.ode
-
- ParameterJacobianProvider - Interface in org.apache.commons.math3.ode
-
- ParametricUnivariateFunction - Interface in org.apache.commons.math3.analysis
-
An interface representing a real function that depends on one independent
variable plus some extra parameters.
- parse(String) - Method in class org.apache.commons.math3.complex.ComplexFormat
-
Parses a string to produce a
Complex
object.
- parse(String, ParsePosition) - Method in class org.apache.commons.math3.complex.ComplexFormat
-
Parses a string to produce a
Complex
object.
- parse(String) - Method in class org.apache.commons.math3.fraction.BigFractionFormat
-
- parse(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.BigFractionFormat
-
- parse(String) - Method in class org.apache.commons.math3.fraction.FractionFormat
-
Parses a string to produce a
Fraction
object.
- parse(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.FractionFormat
-
Parses a string to produce a
Fraction
object.
- parse(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.ProperBigFractionFormat
-
- parse(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.ProperFractionFormat
-
Parses a string to produce a
Fraction
object.
- parse(String) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
-
Parses a string to produce a
Vector
object.
- parse(String, ParsePosition) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
-
Parses a string to produce a
Vector
object.
- parse(String) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
-
Parses a string to produce a
Vector3D
object.
- parse(String, ParsePosition) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
-
Parses a string to produce a
Vector3D
object.
- parse(String) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
-
Parses a string to produce a
Vector
object.
- parse(String, ParsePosition) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
-
Parses a string to produce a
Vector
object.
- parse(String) - Method in class org.apache.commons.math3.geometry.VectorFormat
-
Parses a string to produce a
Vector
object.
- parse(String, ParsePosition) - Method in class org.apache.commons.math3.geometry.VectorFormat
-
Parses a string to produce a
Vector
object.
- parse(String) - Method in class org.apache.commons.math3.linear.RealVectorFormat
-
- parse(String, ParsePosition) - Method in class org.apache.commons.math3.linear.RealVectorFormat
-
- parseAndIgnoreWhitespace(String, ParsePosition) - Static method in class org.apache.commons.math3.fraction.AbstractFormat
-
Parses source
until a non-whitespace character is found.
- parseAndIgnoreWhitespace(String, ParsePosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
-
Parses source
until a non-whitespace character is found.
- parseCoordinates(int, String, ParsePosition) - Method in class org.apache.commons.math3.geometry.VectorFormat
-
Parses a string to produce an array of coordinates.
- parseFixedstring(String, String, ParsePosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
-
Parse source
for an expected fixed string.
- parseNextBigInteger(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.BigFractionFormat
-
Parses a string to produce a BigInteger
.
- parseNextCharacter(String, ParsePosition) - Static method in class org.apache.commons.math3.fraction.AbstractFormat
-
Parses source
until a non-whitespace character is found.
- parseNextCharacter(String, ParsePosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
-
Parses source
until a non-whitespace character is found.
- parseNumber(String, NumberFormat, ParsePosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
-
Parses source
for a number.
- partialDerivative(int) - Method in interface org.apache.commons.math3.analysis.DifferentiableMultivariateFunction
-
Returns the partial derivative of the function with respect to a point coordinate.
- partialDerivativeX(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
-
- partialDerivativeXX(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
-
- partialDerivativeXY(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
-
- partialDerivativeY(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
-
- partialDerivativeYY(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
-
- PascalDistribution - Class in org.apache.commons.math3.distribution
-
Implementation of the Pascal distribution.
- PascalDistribution(int, double) - Constructor for class org.apache.commons.math3.distribution.PascalDistribution
-
Create a Pascal distribution with the given number of successes and
probability of success.
- PearsonsCorrelation - Class in org.apache.commons.math3.stat.correlation
-
Computes Pearson's product-moment correlation coefficients for pairs of arrays
or columns of a matrix.
- PearsonsCorrelation() - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
-
Create a PearsonsCorrelation instance without data
- PearsonsCorrelation(double[][]) - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
-
Create a PearsonsCorrelation from a rectangular array
whose columns represent values of variables to be correlated.
- PearsonsCorrelation(RealMatrix) - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
-
Create a PearsonsCorrelation from a RealMatrix whose columns
represent variables to be correlated.
- PearsonsCorrelation(Covariance) - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
-
- PearsonsCorrelation(RealMatrix, int) - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
-
Create a PearsonsCorrelation from a covariance matrix.
- PegasusSolver - Class in org.apache.commons.math3.analysis.solvers
-
Implements the Pegasus method for root-finding (approximating
a zero of a univariate real function).
- PegasusSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.PegasusSolver
-
Construct a solver with default accuracy (1e-6).
- PegasusSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.PegasusSolver
-
Construct a solver.
- PegasusSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.PegasusSolver
-
Construct a solver.
- PegasusSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.PegasusSolver
-
Construct a solver.
- percentageValue() - Method in class org.apache.commons.math3.fraction.BigFraction
-
Gets the fraction percentage as a double.
- percentageValue() - Method in class org.apache.commons.math3.fraction.Fraction
-
Gets the fraction percentage as a double.
- Percentile - Class in org.apache.commons.math3.stat.descriptive.rank
-
Provides percentile computation.
- Percentile() - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Percentile
-
Constructs a Percentile with a default quantile
value of 50.0.
- Percentile(double) - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Percentile
-
Constructs a Percentile with the specific quantile value.
- Percentile(Percentile) - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Percentile
-
Copy constructor, creates a new Percentile
identical
to the original
- percentile(double[], double) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns an estimate of the p
th percentile of the values
in the values
array.
- percentile(double[], int, int, double) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns an estimate of the p
th percentile of the values
in the values
array, starting with the element in (0-based)
position begin
in the array and including length
values.
- PermutationChromosome<T> - Interface in org.apache.commons.math3.genetics
-
Interface indicating that the chromosome represents a permutation of objects.
- PI - Static variable in class org.apache.commons.math3.util.FastMath
-
Archimede's constant PI, ratio of circle circumference to diameter.
- Plane - Class in org.apache.commons.math3.geometry.euclidean.threed
-
The class represent planes in a three dimensional space.
- Plane(Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Build a plane normal to a given direction and containing the origin.
- Plane(Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Build a plane from a point and a normal.
- Plane(Vector3D, Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Build a plane from three points.
- Plane(Plane) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Copy constructor.
- PLUS_I - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
First canonical vector (coordinates: 1, 0, 0).
- PLUS_J - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Second canonical vector (coordinates: 0, 1, 0).
- PLUS_K - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Third canonical vector (coordinates: 0, 0, 1).
- point - Variable in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
-
Current point.
- pointAt(double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
-
Get one point from the line.
- PointValuePair - Class in org.apache.commons.math3.optimization
-
This class holds a point and the value of an objective function at
that point.
- PointValuePair(double[], double) - Constructor for class org.apache.commons.math3.optimization.PointValuePair
-
Builds a point/objective function value pair.
- PointValuePair(double[], double, boolean) - Constructor for class org.apache.commons.math3.optimization.PointValuePair
-
Builds a point/objective function value pair.
- PointVectorValuePair - Class in org.apache.commons.math3.optimization
-
This class holds a point and the vectorial value of an objective function at
that point.
- PointVectorValuePair(double[], double[]) - Constructor for class org.apache.commons.math3.optimization.PointVectorValuePair
-
Builds a point/objective function value pair.
- PointVectorValuePair(double[], double[], boolean) - Constructor for class org.apache.commons.math3.optimization.PointVectorValuePair
-
Build a point/objective function value pair.
- PoissonDistribution - Class in org.apache.commons.math3.distribution
-
Implementation of the Poisson distribution.
- PoissonDistribution(double) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
-
Creates a new Poisson distribution with specified mean.
- PoissonDistribution(double, double, int) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
-
Creates a new Poisson distribution with specified mean, convergence
criterion and maximum number of iterations.
- PoissonDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
-
Creates a new Poisson distribution with the specified mean and
convergence criterion.
- PoissonDistribution(double, int) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
-
Creates a new Poisson distribution with the specified mean and maximum
number of iterations.
- polar2Complex(double, double) - Static method in class org.apache.commons.math3.complex.ComplexUtils
-
Creates a complex number from the given polar representation.
- PolygonsSet - Class in org.apache.commons.math3.geometry.euclidean.twod
-
This class represents a 2D region: a set of polygons.
- PolygonsSet() - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
-
Build a polygons set representing the whole real line.
- PolygonsSet(BSPTree<Euclidean2D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
-
Build a polygons set from a BSP tree.
- PolygonsSet(Collection<SubHyperplane<Euclidean2D>>) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
-
Build a polygons set from a Boundary REPresentation (B-rep).
- PolygonsSet(double, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
-
Build a parallellepipedic box.
- PolyhedronsSet - Class in org.apache.commons.math3.geometry.euclidean.threed
-
This class represents a 3D region: a set of polyhedrons.
- PolyhedronsSet() - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
-
Build a polyhedrons set representing the whole real line.
- PolyhedronsSet(BSPTree<Euclidean3D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
-
Build a polyhedrons set from a BSP tree.
- PolyhedronsSet(Collection<SubHyperplane<Euclidean3D>>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
-
Build a polyhedrons set from a Boundary REPresentation (B-rep).
- PolyhedronsSet(double, double, double, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
-
Build a parallellepipedic box.
- polynomialDerivative() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
-
- PolynomialFitter - Class in org.apache.commons.math3.optimization.fitting
-
This class implements a curve fitting specialized for polynomials.
- PolynomialFitter(int, DifferentiableMultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.PolynomialFitter
-
Simple constructor.
- PolynomialFunction - Class in org.apache.commons.math3.analysis.polynomials
-
Immutable representation of a real polynomial function with real coefficients.
- PolynomialFunction(double[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
-
Construct a polynomial with the given coefficients.
- PolynomialFunction.Parametric - Class in org.apache.commons.math3.analysis.polynomials
-
Dedicated parametric polynomial class.
- PolynomialFunction.Parametric() - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialFunction.Parametric
-
- PolynomialFunctionLagrangeForm - Class in org.apache.commons.math3.analysis.polynomials
-
Implements the representation of a real polynomial function in
Lagrange Form.
- PolynomialFunctionLagrangeForm(double[], double[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Construct a Lagrange polynomial with the given abscissas and function
values.
- PolynomialFunctionNewtonForm - Class in org.apache.commons.math3.analysis.polynomials
-
Implements the representation of a real polynomial function in
Newton Form.
- PolynomialFunctionNewtonForm(double[], double[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
-
Construct a Newton polynomial with the given a[] and c[].
- PolynomialSolver - Interface in org.apache.commons.math3.analysis.solvers
-
Interface for (polynomial) root-finding algorithms.
- polynomialSplineDerivative() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
-
Get the derivative of the polynomial spline function.
- PolynomialSplineFunction - Class in org.apache.commons.math3.analysis.polynomials
-
Represents a polynomial spline function.
- PolynomialSplineFunction(double[], PolynomialFunction[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
-
Construct a polynomial spline function with the given segment delimiters
and interpolating polynomials.
- PolynomialsUtils - Class in org.apache.commons.math3.analysis.polynomials
-
A collection of static methods that operate on or return polynomials.
- Population - Interface in org.apache.commons.math3.genetics
-
A collection of chromosomes that facilitates generational evolution.
- populationVariance(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the
population variance of the entries in the input array, or
Double.NaN
if the array is empty.
- populationVariance(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the
population variance of the entries in the specified portion of
the input array, or
Double.NaN
if the designated subarray
is empty.
- populationVariance(double[], double, int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the
population variance of the entries in the specified portion of
the input array, using the precomputed mean value.
- populationVariance(double[], double) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the
population variance of the entries in the input array, using the
precomputed mean value.
- POSITIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
A vector with all coordinates set to positive infinity.
- POSITIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
A vector with all coordinates set to positive infinity.
- POSITIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
A vector with all coordinates set to positive infinity.
- positiveOrNull() - Method in class org.apache.commons.math3.dfp.Dfp
-
Check if instance is greater than or equal to 0.
- Pow - Class in org.apache.commons.math3.analysis.function
-
Power function.
- Pow() - Constructor for class org.apache.commons.math3.analysis.function.Pow
-
- pow(Complex) - Method in class org.apache.commons.math3.complex.Complex
-
Returns of value of this complex number raised to the power of x
.
- pow(double) - Method in class org.apache.commons.math3.complex.Complex
-
Returns of value of this complex number raised to the power of x
.
- pow(Dfp, int) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
Raises base to the power a by successive squaring.
- pow(Dfp, Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
Computes x to the y power.
- pow(int) - Method in class org.apache.commons.math3.fraction.BigFraction
-
Returns a BigFraction
whose value is
(this<sup>exponent</sup>)
, returning the result in reduced form.
- pow(long) - Method in class org.apache.commons.math3.fraction.BigFraction
-
Returns a BigFraction
whose value is
(thisexponent), returning the result in reduced form.
- pow(BigInteger) - Method in class org.apache.commons.math3.fraction.BigFraction
-
Returns a BigFraction
whose value is
(thisexponent), returning the result in reduced form.
- pow(double) - Method in class org.apache.commons.math3.fraction.BigFraction
-
Returns a double
whose value is
(thisexponent), returning the result in reduced form.
- pow(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Raise an int to an int power.
- pow(int, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Raise an int to a long power.
- pow(long, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Raise a long to an int power.
- pow(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Raise a long to a long power.
- pow(BigInteger, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Raise a BigInteger to an int power.
- pow(BigInteger, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Raise a BigInteger to a long power.
- pow(BigInteger, BigInteger) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Raise a BigInteger to a BigInteger power.
- pow(double, double) - Static method in class org.apache.commons.math3.util.FastMath
-
Power function.
- PowellOptimizer - Class in org.apache.commons.math3.optimization.direct
-
Powell algorithm.
- PowellOptimizer(double, double, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.PowellOptimizer
-
This constructor allows to specify a user-defined convergence checker,
in addition to the parameters that control the default convergence
checking procedure and the line search tolerances.
- PowellOptimizer(double, double) - Constructor for class org.apache.commons.math3.optimization.direct.PowellOptimizer
-
The parameters control the default convergence checking procedure, and
the line search tolerances.
- Power - Class in org.apache.commons.math3.analysis.function
-
Power function.
- Power(double) - Constructor for class org.apache.commons.math3.analysis.function.Power
-
- power(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Returns the result multiplying this with itself p
times.
- power(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Returns the result multiplying this with itself p
times.
- power(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Returns the result multiplying this with itself p
times.
- power(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Returns the result multiplying this with itself p
times.
- power10(int) - Method in class org.apache.commons.math3.dfp.Dfp
-
Return the specified power of 10.
- power10K(int) - Method in class org.apache.commons.math3.dfp.Dfp
-
Get the specified power of 10000.
- Precision - Class in org.apache.commons.math3.util
-
Utilities for comparing numbers.
- precondition(double[], double[]) - Method in class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer.IdentityPreconditioner
-
Precondition a search direction.
- precondition(double[], double[]) - Method in interface org.apache.commons.math3.optimization.general.Preconditioner
-
Precondition a search direction.
- PreconditionedIterativeLinearSolver - Class in org.apache.commons.math3.linear
-
This abstract class defines preconditioned iterative solvers.
- PreconditionedIterativeLinearSolver(int) - Constructor for class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
-
Creates a new instance of this class, with default iteration manager.
- PreconditionedIterativeLinearSolver(IterationManager) - Constructor for class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
-
Creates a new instance of this class, with custom iteration manager.
- Preconditioner - Interface in org.apache.commons.math3.optimization.general
-
This interface represents a preconditioner for differentiable scalar
objective function optimizers.
- predict() - Method in class org.apache.commons.math3.filter.KalmanFilter
-
Predict the internal state estimation one time step ahead.
- predict(double[]) - Method in class org.apache.commons.math3.filter.KalmanFilter
-
Predict the internal state estimation one time step ahead.
- predict(RealVector) - Method in class org.apache.commons.math3.filter.KalmanFilter
-
Predict the internal state estimation one time step ahead.
- predict(double) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
-
Returns the "predicted" y
value associated with the
supplied x
value, based on the data that has been
added to the model when this method is activated.
- preMultiply(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Premultiply this matrix by m
.
- preMultiply(T[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Returns the (row) vector result of premultiplying this by the vector v
.
- preMultiply(FieldVector<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Returns the (row) vector result of premultiplying this by the vector v
.
- preMultiply(RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Returns the result premultiplying this by m
.
- preMultiply(double[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Returns the (row) vector result of premultiplying this by the vector v
.
- preMultiply(RealVector) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Returns the (row) vector result of premultiplying this by the vector v
.
- preMultiply(T[]) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Returns the (row) vector result of premultiplying this by the vector v
.
- preMultiply(double[]) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Returns the (row) vector result of premultiplying this by the vector v
.
- preMultiply(T[]) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Returns the (row) vector result of premultiplying this by the vector v
.
- preMultiply(double[]) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Returns the (row) vector result of premultiplying this by the vector v
.
- preMultiply(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Premultiply this matrix by m
.
- preMultiply(T[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Returns the (row) vector result of premultiplying this by the vector v
.
- preMultiply(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Returns the (row) vector result of premultiplying this by the vector v
.
- preMultiply(RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Returns the result premultiplying this by m
.
- preMultiply(double[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Returns the (row) vector result of premultiplying this by the vector v
.
- preMultiply(RealVector) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Returns the (row) vector result of premultiplying this by the vector v
.
- probability(double) - Method in class org.apache.commons.math3.distribution.BetaDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(int) - Method in class org.apache.commons.math3.distribution.BinomialDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(double) - Method in class org.apache.commons.math3.distribution.CauchyDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(double) - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(double) - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(double) - Method in class org.apache.commons.math3.distribution.FDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(double) - Method in class org.apache.commons.math3.distribution.GammaDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(int) - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(int) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(double) - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(int) - Method in class org.apache.commons.math3.distribution.PascalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(int) - Method in class org.apache.commons.math3.distribution.PoissonDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(double) - Method in interface org.apache.commons.math3.distribution.RealDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(double) - Method in class org.apache.commons.math3.distribution.TDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(double) - Method in class org.apache.commons.math3.distribution.TriangularDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(int) - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(double) - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(double) - Method in class org.apache.commons.math3.distribution.WeibullDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- probability(int) - Method in class org.apache.commons.math3.distribution.ZipfDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X = x)
.
- ProcessModel - Interface in org.apache.commons.math3.filter
-
Defines the process dynamics model for the use with a
KalmanFilter
.
- Product - Class in org.apache.commons.math3.stat.descriptive.summary
-
Returns the product of the available values.
- Product() - Constructor for class org.apache.commons.math3.stat.descriptive.summary.Product
-
Create a Product instance
- Product(Product) - Constructor for class org.apache.commons.math3.stat.descriptive.summary.Product
-
Copy constructor, creates a new Product
identical
to the original
- product(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the product of the entries in the input array, or
Double.NaN
if the array is empty.
- product(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the product of the entries in the specified portion of
the input array, or Double.NaN
if the designated subarray
is empty.
- projection(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Find the orthogonal projection of this vector onto another vector.
- projection(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Find the orthogonal projection of this vector onto another vector.
- projection(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Find the orthogonal projection of this vector onto another vector.
- projection(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
-
Find the orthogonal projection of this vector onto another vector.
- projection(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Find the orthogonal projection of this vector onto another vector.
- projection(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
-
Find the orthogonal projection of this vector onto another vector.
- projection(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Find the orthogonal projection of this vector onto another vector.
- ProperBigFractionFormat - Class in org.apache.commons.math3.fraction
-
Formats a BigFraction number in proper format.
- ProperBigFractionFormat() - Constructor for class org.apache.commons.math3.fraction.ProperBigFractionFormat
-
Create a proper formatting instance with the default number format for
the whole, numerator, and denominator.
- ProperBigFractionFormat(NumberFormat) - Constructor for class org.apache.commons.math3.fraction.ProperBigFractionFormat
-
Create a proper formatting instance with a custom number format for the
whole, numerator, and denominator.
- ProperBigFractionFormat(NumberFormat, NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.fraction.ProperBigFractionFormat
-
Create a proper formatting instance with a custom number format for each
of the whole, numerator, and denominator.
- ProperFractionFormat - Class in org.apache.commons.math3.fraction
-
Formats a Fraction number in proper format.
- ProperFractionFormat() - Constructor for class org.apache.commons.math3.fraction.ProperFractionFormat
-
Create a proper formatting instance with the default number format for
the whole, numerator, and denominator.
- ProperFractionFormat(NumberFormat) - Constructor for class org.apache.commons.math3.fraction.ProperFractionFormat
-
Create a proper formatting instance with a custom number format for the
whole, numerator, and denominator.
- ProperFractionFormat(NumberFormat, NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.fraction.ProperFractionFormat
-
Create a proper formatting instance with a custom number format for each
of the whole, numerator, and denominator.
- providesResidual() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
-
- providesResidual() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
-
- put(int, double) - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
-
Put a value associated with a key in the map.
- put(int, T) - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
-
Put a value associated with a key in the map.
- putTransformer(Class<?>, NumberTransformer) - Method in class org.apache.commons.math3.util.TransformerMap
-
Sets a Class to Transformer Mapping in the Map.
- SAFE_MIN - Static variable in class org.apache.commons.math3.util.Precision
-
Safe minimum, such that 1 / SAFE_MIN
does not overflow.
- safeNorm(double[]) - Static method in class org.apache.commons.math3.util.MathArrays
-
Returns the Cartesian norm (2-norm), handling both overflow and underflow.
- sameOrientationAs(Hyperplane<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
-
Check if the instance has the same orientation as another hyperplane.
- sameOrientationAs(Hyperplane<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
-
Check if the instance has the same orientation as another hyperplane.
- sameOrientationAs(Hyperplane<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Check if the instance has the same orientation as another hyperplane.
- sameOrientationAs(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
-
Check if the instance has the same orientation as another hyperplane.
- sample(UnivariateFunction, double, double, int) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
-
Samples the specified univariate real function on the specified interval.
- sample() - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
-
Generate a random value sampled from this distribution.
- sample(int) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
-
Generate a random sample from the distribution.
- sample() - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
-
Generate a random value sampled from this distribution.
- sample(int) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
-
Generate a random sample from the distribution.
- sample() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
-
Generate a random value sampled from this distribution.
- sample() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
-
Generate a random value sampled from this distribution.
- sample(int) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
-
Generate a random sample from the distribution.
- sample() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
-
Generate a random value sampled from this distribution.
- sample() - Method in class org.apache.commons.math3.distribution.NormalDistribution
-
Generate a random value sampled from this distribution.
- sample() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
-
Generate a random value sampled from this distribution.
- sample() - Method in interface org.apache.commons.math3.distribution.RealDistribution
-
Generate a random value sampled from this distribution.
- sample(int) - Method in interface org.apache.commons.math3.distribution.RealDistribution
-
Generate a random sample from the distribution.
- sample() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
-
Generate a random value sampled from this distribution.
- sample() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
-
Generate a random value sampled from this distribution.
- sanityChecks(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Check the integration span.
- sanityChecks(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Check the integration span.
- scalAbsoluteTolerance - Variable in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Allowed absolute scalar error.
- scalarAdd(T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Increment each entry of this matrix.
- scalarAdd(double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Returns the result of adding d to each entry of this.
- scalarAdd(T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Increment each entry of this matrix.
- scalarAdd(double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Returns the result of adding d to each entry of this.
- scalarAdd(T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Increment each entry of this matrix.
- scalarAdd(double) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Returns the result of adding d to each entry of this.
- scalarMultiply(double) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Multiply the instance by a scalar.
- scalarMultiply(double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Multiply the instance by a scalar.
- scalarMultiply(double) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Multiply the instance by a scalar.
- scalarMultiply(double) - Method in interface org.apache.commons.math3.geometry.Vector
-
Multiply the instance by a scalar.
- scalarMultiply(T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Multiply each entry by d
.
- scalarMultiply(double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Returns the result multiplying each entry of this by d.
- scalarMultiply(T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Multiply each entry by d
.
- scalarMultiply(double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Returns the result multiplying each entry of this by d.
- scalarMultiply(T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Multiply each entry by d
.
- scalarMultiply(double) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Returns the result multiplying each entry of this by d.
- scalb(double, int) - Static method in class org.apache.commons.math3.util.FastMath
-
Multiply a double number by a power of 2.
- scalb(float, int) - Static method in class org.apache.commons.math3.util.FastMath
-
Multiply a float number by a power of 2.
- scaleArray(double[], double) - Static method in class org.apache.commons.math3.transform.TransformUtils
-
Multiply every component in the given real array by the
given real number.
- scaleArray(Complex[], double) - Static method in class org.apache.commons.math3.transform.TransformUtils
-
Multiply every component in the given complex array by the
given real number.
- scaled - Variable in class org.apache.commons.math3.ode.MultistepIntegrator
-
First scaled derivative (h y').
- scalRelativeTolerance - Variable in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Allowed relative scalar error.
- search(UnivariateFunction, GoalType, double, double) - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
-
Search new points that bracket a local optimum of the function.
- searchForFitnessUpdate(Population) - Method in class org.apache.commons.math3.genetics.Chromosome
-
Searches the population for a chromosome representing the same solution,
and if it finds one, updates the fitness to its value.
- SecantSolver - Class in org.apache.commons.math3.analysis.solvers
-
Implements the Secant method for root-finding (approximating a
zero of a univariate real function).
- SecantSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.SecantSolver
-
Construct a solver with default accuracy (1e-6).
- SecantSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.SecantSolver
-
Construct a solver.
- SecantSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.SecantSolver
-
Construct a solver.
- SecondaryEquations - Interface in org.apache.commons.math3.ode
-
This interface allows users to add secondary differential equations to a primary
set of differential equations.
- SecondMoment - Class in org.apache.commons.math3.stat.descriptive.moment
-
Computes a statistic related to the Second Central Moment.
- SecondMoment() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
-
Create a SecondMoment instance
- SecondMoment(SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
-
Copy constructor, creates a new SecondMoment
identical
to the original
- SecondOrderDifferentialEquations - Interface in org.apache.commons.math3.ode
-
This interface represents a second order differential equations set.
- SecondOrderIntegrator - Interface in org.apache.commons.math3.ode
-
This interface represents a second order integrator for
differential equations.
- Segment - Class in org.apache.commons.math3.geometry.euclidean.threed
-
Simple container for a two-points segment.
- Segment(Vector3D, Vector3D, Line) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Segment
-
Build a segment.
- Segment - Class in org.apache.commons.math3.geometry.euclidean.twod
-
Simple container for a two-points segment.
- Segment(Vector2D, Vector2D, Line) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Segment
-
Build a segment.
- select(Population) - Method in interface org.apache.commons.math3.genetics.SelectionPolicy
-
Select two chromosomes from the population.
- select(Population) - Method in class org.apache.commons.math3.genetics.TournamentSelection
-
Select two chromosomes from the population.
- SelectionPolicy - Interface in org.apache.commons.math3.genetics
-
Algorithm used to select a chromosome pair from a population.
- SemiVariance - Class in org.apache.commons.math3.stat.descriptive.moment
-
Computes the semivariance of a set of values with respect to a given cutoff value.
- SemiVariance() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
-
Constructs a SemiVariance with default (true) biasCorrected
property and default (Downside) varianceDirection
property.
- SemiVariance(boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
-
Constructs a SemiVariance with the specified biasCorrected
property and default (Downside) varianceDirection
property.
- SemiVariance(SemiVariance.Direction) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
-
Constructs a SemiVariance with the specified Direction
property
and default (true) biasCorrected
property
- SemiVariance(boolean, SemiVariance.Direction) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
-
Constructs a SemiVariance with the specified isBiasCorrected
property and the specified Direction
property.
- SemiVariance(SemiVariance) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
-
Copy constructor, creates a new SemiVariance
identical
to the original
- SemiVariance.Direction - Enum in org.apache.commons.math3.stat.descriptive.moment
-
The direction of the semivariance - either upside or downside.
- serializeRealMatrix(RealMatrix, ObjectOutputStream) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
- serializeRealVector(RealVector, ObjectOutputStream) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
- set(int, ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Set a set of consecutive elements.
- set(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Set all elements to a single value.
- set(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Set all elements to a single value.
- set(T) - Method in interface org.apache.commons.math3.linear.FieldVector
-
Set all elements to a single value.
- set(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Set all elements to a single value.
- set(double) - Method in class org.apache.commons.math3.linear.RealVector
-
Set all elements to a single value.
- set(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Set all elements to a single value.
- setAngle(double) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Set the angle of the line.
- setArity(int) - Method in class org.apache.commons.math3.genetics.TournamentSelection
-
Sets the arity (number of chromosomes drawn to the tournament).
- setAttribute(Object) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
-
Associate an attribute with the instance.
- setBarycenter(Vector<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Set the barycenter of the instance.
- setBiasCorrected(boolean) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
-
Sets the biasCorrected property.
- setBiasCorrected(boolean) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
-
- setBiasCorrected(boolean) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
-
- setChromosomes(List<Chromosome>) - Method in class org.apache.commons.math3.genetics.ListPopulation
-
Sets the list of chromosomes.
- setColumn(int, T[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Set the entries in column number column
as a column matrix.
- setColumn(int, double[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Set the entries at the given column index
as a column matrix array.
- setColumn(int, T[]) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Set the entries in column number column
as a column matrix.
- setColumn(int, double[]) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Set the entries at the given column index
as a column matrix array.
- setColumn(int, T[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Set the entries in column number column
as a column matrix.
- setColumn(int, double[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Set the entries at the given column index
as a column matrix array.
- setColumnMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Set the entries in column number column
as a column matrix.
- setColumnMatrix(int, RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Set the entries at the given column index
as a column matrix.
- setColumnMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Set the entries in column number column
as a column matrix.
- setColumnMatrix(int, RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Set the entries at the given column index
as a column matrix.
- setColumnMatrix(int, FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Set the entries in column number column
as a column matrix.
- setColumnMatrix(int, RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Set the entries at the given column index
as a column matrix.
- setColumnVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Set the entries in column number column
as a vector.
- setColumnVector(int, RealVector) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Set the entries at the given column index
as a vector.
- setColumnVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Set the entries in column number column
as a vector.
- setColumnVector(int, RealVector) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Set the entries at the given column index
as a vector.
- setColumnVector(int, FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Set the entries in column number column
as a vector.
- setColumnVector(int, RealVector) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Set the entries at the given column index
as a vector.
- setCompleteState(double[]) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Set the complete current state.
- setContractionCriteria(float) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Sets the contraction criteria for this ExpandContractDoubleArray.
- setControlFactors(double, double, double, double) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
-
Set the step size control factors.
- setData(double[]) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
-
Set the data array.
- setData(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
-
Set the data array.
- setData(double[]) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
-
Set the data array.
- setData(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
-
Set the data array.
- setDenominatorFormat(NumberFormat) - Method in class org.apache.commons.math3.fraction.AbstractFormat
-
Modify the denominator format.
- setElement(int, double) - Method in interface org.apache.commons.math3.util.DoubleArray
-
Sets the element at the specified index.
- setElement(int, double) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Sets the element at the specified index.
- setElitismRate(double) - Method in class org.apache.commons.math3.genetics.ElitisticListPopulation
-
Sets the elitism rate, i.e.
- setEntry(int, int, T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, T) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Set the entry in the specified row and column.
- setEntry(int, T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Set a single element.
- setEntry(int, double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Set a single element.
- setEntry(int, int, T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, T) - Method in interface org.apache.commons.math3.linear.FieldVector
-
Set a single element.
- setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
-
Set the entry in the specified row and column.
- setEntry(int, double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Set a single element.
- setEntry(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Set the entry in the specified row and column.
- setEntry(int, double) - Method in class org.apache.commons.math3.linear.RealVector
-
Set a single element.
- setEntry(int, int, T) - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Set a single element.
- setEquations(ExpandableStatefulODE) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Set the equations.
- setExpansionFactor(float) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Sets the expansionFactor.
- setExpansionMode(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Sets the expansionMode
.
- setGeoMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the geometric mean.
- setGeoMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Sets the implementation for the geometric mean.
- setGeoMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the geometric mean.
- setGeoMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the geometric mean.
- setGeometricMeanImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the gemoetric mean.
- setIEEEFlags(int) - Method in class org.apache.commons.math3.dfp.DfpField
-
Sets the IEEE 854 status flags.
- setIEEEFlagsBits(int) - Method in class org.apache.commons.math3.dfp.DfpField
-
Sets some bits in the IEEE 854 status flags, without changing the already set bits.
- setIndex(int) - Method in class org.apache.commons.math3.linear.RealVector.Entry
-
Set the index of the entry.
- setInitialCapacity(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Sets the initial capacity.
- setInitialMainStateJacobian(double[][]) - Method in class org.apache.commons.math3.ode.JacobianMatrices
-
Set the initial value of the Jacobian matrix with respect to state.
- setInitialParameterJacobian(String, double[]) - Method in class org.apache.commons.math3.ode.JacobianMatrices
-
Set the initial value of a column of the Jacobian matrix with respect to one parameter.
- setInitialStep(double) - Method in class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
-
Set the initial step used to bracket the optimum in line search.
- setInitialStepSize(double) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Set the initial step size.
- setInterpolatedTime(double) - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
-
Set the time of the interpolated point.
- setInterpolatedTime(double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Set the time of the interpolated point.
- setInterpolatedTime(double) - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
-
Set the time of the interpolated point.
- setInterpolationControl(boolean, int) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
-
Set the interpolation order control parameter.
- setKurtosisImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the kurtosis.
- setMaxEvaluations(int) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Set the maximal number of differential equations function evaluations.
- setMaxEvaluations(int) - Method in interface org.apache.commons.math3.ode.ODEIntegrator
-
Set the maximal number of differential equations function evaluations.
- setMaxGrowth(double) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
-
Set the maximal growth factor for stepsize control.
- setMaxGrowth(double) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Set the maximal growth factor for stepsize control.
- setMaximalCount(int) - Method in class org.apache.commons.math3.util.Incrementor
-
Sets the upper limit for the counter.
- setMaxImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the maximum.
- setMaxImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the maximum.
- setMaxImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Sets the implementation for the maximum.
- setMaxImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the maximum.
- setMaxImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the maximum.
- setMaxIterations(int) - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
-
Set the maximal number of iterations of the algorithm.
- setMaxIterations(int) - Method in interface org.apache.commons.math3.optimization.linear.LinearOptimizer
-
Set the maximal number of iterations of the algorithm.
- setMeanImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the mean.
- setMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the mean.
- setMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Sets the implementation for the mean.
- setMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the mean.
- setMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the mean.
- setMinImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the minimum.
- setMinImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the minimum.
- setMinImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Sets the implementation for the minimum.
- setMinImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the minimum.
- setMinImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the minimum.
- setMinReduction(double) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
-
Set the minimal reduction factor for stepsize control.
- setMinReduction(double) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Set the minimal reduction factor for stepsize control.
- setMode(int) - Method in class org.apache.commons.math3.random.ValueServer
-
Sets the data generation mode.
- setMu(double) - Method in class org.apache.commons.math3.random.ValueServer
-
Sets the
mean
used in data generation.
- setNoIntercept(boolean) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
- setNumElements(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
This function allows you to control the number of elements contained
in this array, and can be used to "throw out" the last n values in an
array.
- setNumeratorFormat(NumberFormat) - Method in class org.apache.commons.math3.fraction.AbstractFormat
-
Modify the numerator format.
- setOrderControl(int, double, double) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
-
Set the order control parameters.
- setOriginOffset(double) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
-
Set the offset of the origin.
- setParameter(String, double) - Method in interface org.apache.commons.math3.ode.ParameterizedODE
-
Set the value for a given parameter.
- setParameterizedODE(ParameterizedODE) - Method in class org.apache.commons.math3.ode.JacobianMatrices
-
Add a parameter Jacobian provider.
- setParameterStep(String, double) - Method in class org.apache.commons.math3.ode.JacobianMatrices
-
Set the step associated to a parameter in order to compute by finite
difference the Jacobian matrix.
- setPercentileImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
- setPoint(int, PointValuePair) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
-
Store a new point at location index
.
- setPoints(PointValuePair[]) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
-
Replace all points.
- setPopulationLimit(int) - Method in class org.apache.commons.math3.genetics.ListPopulation
-
Sets the maximal population size.
- setPrimaryState(double[]) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Set primary part of the current state.
- setQuantile(double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
-
Sets the value of the quantile field (determines what percentile is
computed when evaluate() is called with no quantile argument).
- setRandomGenerator(RandomGenerator) - Static method in class org.apache.commons.math3.genetics.GeneticAlgorithm
-
Set the (static) random generator.
- setRoundingMode(DfpField.RoundingMode) - Method in class org.apache.commons.math3.dfp.DfpField
-
Set the rounding mode.
- setRoundingMode(RoundingMode) - Method in class org.apache.commons.math3.util.BigReal
-
Sets the rounding mode for decimal divisions.
- setRow(int, T[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Set the entries in row number row
as a row matrix.
- setRow(int, double[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Set the entries at the given row index
as a row matrix.
- setRow(int, T[]) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Set the entries in row number row
as a row matrix.
- setRow(int, double[]) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Set the entries at the given row index
as a row matrix.
- setRow(int, T[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Set the entries in row number row
as a row matrix.
- setRow(int, double[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Set the entries at the given row index
as a row matrix.
- setRowMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Set the entries in row number row
as a row matrix.
- setRowMatrix(int, RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Set the entries at the given row index
as a row matrix.
- setRowMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Set the entries in row number row
as a row matrix.
- setRowMatrix(int, BlockFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Sets the entries in row number row
as a row matrix.
- setRowMatrix(int, RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Set the entries at the given row index
as a row matrix.
- setRowMatrix(int, BlockRealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Sets the entries in row number row
as a row matrix.
- setRowMatrix(int, FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Set the entries in row number row
as a row matrix.
- setRowMatrix(int, RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Set the entries at the given row index
as a row matrix.
- setRowVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Set the entries in row number row
as a vector.
- setRowVector(int, RealVector) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Set the entries at the given row index.
- setRowVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Set the entries in row number row
as a vector.
- setRowVector(int, RealVector) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Set the entries at the given row index.
- setRowVector(int, FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Set the entries in row number row
as a vector.
- setRowVector(int, RealVector) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Set the entries at the given row index.
- setSafety(double) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
-
Set the safety factor for stepsize control.
- setSafety(double) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Set the safety factor for stepsize control.
- setScale(int) - Method in class org.apache.commons.math3.util.BigReal
-
Sets the scale for division operations.
- setSecondaryState(int, double[]) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Set secondary part of the current state.
- setSecureAlgorithm(String, String) - Method in class org.apache.commons.math3.random.RandomDataImpl
-
Sets the PRNG algorithm for the underlying SecureRandom instance using
the Security Provider API.
- setSeed(int) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
-
Sets the seed of the underlying random number generator using an
int
seed.
- setSeed(int[]) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
-
Sets the seed of the underlying random number generator using an
int
array seed.
- setSeed(long) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
-
Sets the seed of the underlying random number generator using a
long
seed.
- setSeed(int) - Method in class org.apache.commons.math3.random.AbstractWell
-
Reinitialize the generator as if just built with the given int seed.
- setSeed(int[]) - Method in class org.apache.commons.math3.random.AbstractWell
-
Reinitialize the generator as if just built with the given int array seed.
- setSeed(long) - Method in class org.apache.commons.math3.random.AbstractWell
-
Reinitialize the generator as if just built with the given long seed.
- setSeed(int) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
-
Sets the seed of the underlying random number generator using an
int
seed.
- setSeed(int[]) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
-
Sets the seed of the underlying random number generator using an
int
array seed.
- setSeed(long) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
-
Sets the seed of the underlying random number generator using a
long
seed.
- setSeed(int) - Method in class org.apache.commons.math3.random.ISAACRandom
-
Sets the seed of the underlying random number generator using an
int
seed.
- setSeed(long) - Method in class org.apache.commons.math3.random.ISAACRandom
-
Sets the seed of the underlying random number generator using a
long
seed.
- setSeed(int[]) - Method in class org.apache.commons.math3.random.ISAACRandom
-
Sets the seed of the underlying random number generator using an
int
array seed.
- setSeed(int) - Method in class org.apache.commons.math3.random.JDKRandomGenerator
-
Sets the seed of the underlying random number generator using an
int
seed.
- setSeed(int[]) - Method in class org.apache.commons.math3.random.JDKRandomGenerator
-
Sets the seed of the underlying random number generator using an
int
array seed.
- setSeed(int) - Method in class org.apache.commons.math3.random.MersenneTwister
-
Reinitialize the generator as if just built with the given int seed.
- setSeed(int[]) - Method in class org.apache.commons.math3.random.MersenneTwister
-
Reinitialize the generator as if just built with the given int array seed.
- setSeed(long) - Method in class org.apache.commons.math3.random.MersenneTwister
-
Reinitialize the generator as if just built with the given long seed.
- setSeed(int) - Method in class org.apache.commons.math3.random.RandomAdaptor
-
Sets the seed of the underlying random number generator using an
int
seed.
- setSeed(int[]) - Method in class org.apache.commons.math3.random.RandomAdaptor
-
Sets the seed of the underlying random number generator using an
int
array seed.
- setSeed(long) - Method in class org.apache.commons.math3.random.RandomAdaptor
-
Sets the seed of the underlying random number generator using a
long
seed.
- setSeed(int) - Method in interface org.apache.commons.math3.random.RandomGenerator
-
Sets the seed of the underlying random number generator using an
int
seed.
- setSeed(int[]) - Method in interface org.apache.commons.math3.random.RandomGenerator
-
Sets the seed of the underlying random number generator using an
int
array seed.
- setSeed(long) - Method in interface org.apache.commons.math3.random.RandomGenerator
-
Sets the seed of the underlying random number generator using a
long
seed.
- setSigma(double) - Method in class org.apache.commons.math3.random.ValueServer
-
- setSimplex(AbstractSimplex) - Method in class org.apache.commons.math3.optimization.direct.SimplexOptimizer
-
Set the simplex algorithm.
- setSize(double) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Set the size of the instance.
- setSkewnessImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the skewness.
- setSoftCurrentTime(double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Restrict step range to a limited part of the global step.
- setSoftPreviousTime(double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Restrict step range to a limited part of the global step.
- setStabilityCheck(boolean, int, int, double) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
-
Set the stability check controls.
- setStarterIntegrator(FirstOrderIntegrator) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
-
Set the starter integrator.
- setStateInitialized(boolean) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
-
Set the stateInitialized flag.
- setStepSizeControl(double, double, double, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Set the adaptive step size control parameters.
- setStepSizeControl(double, double, double[], double[]) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Set the adaptive step size control parameters.
- setSubMatrix(T[][], int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Replace the submatrix starting at (row, column)
using data in
the input subMatrix
array.
- setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Replace the submatrix starting at row, column
using data in
the input subMatrix
array.
- setSubMatrix(T[][], int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Replace the submatrix starting at (row, column)
using data in
the input subMatrix
array.
- setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Replace the submatrix starting at row, column
using data in
the input subMatrix
array.
- setSubMatrix(T[][], int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Replace the submatrix starting at (row, column)
using data in
the input subMatrix
array.
- setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Replace the submatrix starting at row, column
using data in
the input subMatrix
array.
- setSubMatrix(T[][], int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Replace the submatrix starting at (row, column)
using data in
the input subMatrix
array.
- setSubMatrix(double[][], int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Replace the submatrix starting at row, column
using data in
the input subMatrix
array.
- setSubVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Set a set of consecutive elements.
- setSubVector(int, RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Set a sequence of consecutive elements.
- setSubVector(int, double[]) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Set a set of consecutive elements.
- setSubVector(int, FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
-
Set a set of consecutive elements.
- setSubVector(int, RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Set a sequence of consecutive elements.
- setSubVector(int, RealVector) - Method in class org.apache.commons.math3.linear.RealVector
-
Set a sequence of consecutive elements.
- setSubVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Set a set of consecutive elements.
- setSumImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the sum.
- setSumImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the Sum.
- setSumImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Sets the implementation for the Sum.
- setSumImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the Sum.
- setSumImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the Sum.
- setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
-
Sets the implementation for the sum of logs.
- setSumLogImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the sum of logs.
- setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Sets the implementation for the sum of logs.
- setSumLogImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the sum of logs.
- setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the sum of logs.
- setSumsqImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the sum of squares.
- setSumsqImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the sum of squares.
- setSumsqImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Sets the implementation for the sum of squares.
- setSumsqImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the sum of squares.
- setSumsqImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the sum of squares.
- setTime(double) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
-
Set current time.
- setup(int, UnivariateFunction, double, double) - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
-
Prepare for computation.
- setup(int, DifferentiableUnivariateFunction, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.AbstractDifferentiableUnivariateSolver
-
Prepare for computation.
- setup(int, PolynomialFunction, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.AbstractPolynomialSolver
-
Prepare for computation.
- setup(int, FUNC, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Prepare for computation.
- setValue(String, Object) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
-
Sets the context (key, value) pair.
- setValue(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector.OpenMapEntry
-
Set the value of the entry.
- setValue(double) - Method in class org.apache.commons.math3.linear.RealVector.Entry
-
Set the value of the entry.
- setValuesFileURL(String) - Method in class org.apache.commons.math3.random.ValueServer
-
- setValuesFileURL(URL) - Method in class org.apache.commons.math3.random.ValueServer
-
- setVarianceDirection(SemiVariance.Direction) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
-
Sets the variance direction
- setVarianceImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the variance.
- setVarianceImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Sets the implementation for the variance.
- setVarianceImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the variance.
- setWholeFormat(NumberFormat) - Method in class org.apache.commons.math3.fraction.ProperBigFractionFormat
-
Modify the whole format.
- setWholeFormat(NumberFormat) - Method in class org.apache.commons.math3.fraction.ProperFractionFormat
-
Modify the whole format.
- setWindowSize(int) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
-
WindowSize controls the number of values which contribute
to the reported statistics.
- setWindowSize(int) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
WindowSize controls the number of values which contribute
to the reported statistics.
- shift(double[], double) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
-
Compute the coefficients of the polynomial Ps(x)
whose values at point x
will be the same as the those from the
original polynomial P(x)
when computed at x + shift
.
- shift() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Shift one step forward.
- shiftLeft() - Method in class org.apache.commons.math3.dfp.Dfp
-
Shift the mantissa left, and adjust the exponent to compensate.
- shiftRight() - Method in class org.apache.commons.math3.dfp.Dfp
-
Shift the mantissa right, and adjust the exponent to compensate.
- side(Hyperplane<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
-
Compute the relative position of the instance with respect
to an hyperplane.
- side(Hyperplane<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SubPlane
-
Compute the relative position of the instance with respect
to an hyperplane.
- side(Hyperplane<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.SubLine
-
Compute the relative position of the instance with respect
to an hyperplane.
- side(Hyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
-
Compute the relative position of the instance with respect to an
hyperplane.
- side(Hyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
-
Compute the relative position of the instance with respect
to an hyperplane.
- side(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
-
Compute the relative position of the instance with respect to an
hyperplane.
- Side - Enum in org.apache.commons.math3.geometry.partitioning
-
Enumerate representing the location of an element with respect to an
hyperplane
of a space.
- side(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
-
Compute the relative position of the instance with respect
to an hyperplane.
- Sigmoid - Class in org.apache.commons.math3.analysis.function
-
- Sigmoid() - Constructor for class org.apache.commons.math3.analysis.function.Sigmoid
-
Usual sigmoid function, where the lower asymptote is 0 and the higher
asymptote is 1.
- Sigmoid(double, double) - Constructor for class org.apache.commons.math3.analysis.function.Sigmoid
-
Sigmoid function.
- Sigmoid.Parametric - Class in org.apache.commons.math3.analysis.function
-
Parametric function where the input array contains the parameters of
the logit function, ordered as follows:
Lower asymptote
Higher asymptote
- Sigmoid.Parametric() - Constructor for class org.apache.commons.math3.analysis.function.Sigmoid.Parametric
-
- sign - Variable in class org.apache.commons.math3.dfp.Dfp
-
Sign bit: 1 for positive, -1 for negative.
- Signum - Class in org.apache.commons.math3.analysis.function
-
signum
function.
- Signum() - Constructor for class org.apache.commons.math3.analysis.function.Signum
-
- signum(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Compute the signum of a number.
- signum(float) - Static method in class org.apache.commons.math3.util.FastMath
-
Compute the signum of a number.
- SimplePointChecker<PAIR extends Pair<double[],? extends Object>> - Class in org.apache.commons.math3.optimization
-
- SimplePointChecker() - Constructor for class org.apache.commons.math3.optimization.SimplePointChecker
-
Build an instance with default threshold.
- SimplePointChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.SimplePointChecker
-
Build an instance with specified thresholds.
- SimpleRegression - Class in org.apache.commons.math3.stat.regression
-
Estimates an ordinary least squares regression model
with one independent variable.
- SimpleRegression() - Constructor for class org.apache.commons.math3.stat.regression.SimpleRegression
-
Create an empty SimpleRegression instance
- SimpleRegression(boolean) - Constructor for class org.apache.commons.math3.stat.regression.SimpleRegression
-
Create a SimpleRegression instance, specifying whether or not to estimate
an intercept.
- SimpleValueChecker - Class in org.apache.commons.math3.optimization
-
Simple implementation of the
ConvergenceChecker
interface using
only objective function values.
- SimpleValueChecker() - Constructor for class org.apache.commons.math3.optimization.SimpleValueChecker
-
Build an instance with default thresholds.
- SimpleValueChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.SimpleValueChecker
-
Build an instance with specified thresholds.
- SimpleVectorValueChecker - Class in org.apache.commons.math3.optimization
-
Simple implementation of the
ConvergenceChecker
interface using
only objective function values.
- SimpleVectorValueChecker() - Constructor for class org.apache.commons.math3.optimization.SimpleVectorValueChecker
-
Build an instance with default thresholds.
- SimpleVectorValueChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.SimpleVectorValueChecker
-
Build an instance with specified thresholds.
- SimplexOptimizer - Class in org.apache.commons.math3.optimization.direct
-
This class implements simplex-based direct search optimization.
- SimplexOptimizer() - Constructor for class org.apache.commons.math3.optimization.direct.SimplexOptimizer
-
- SimplexOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.SimplexOptimizer
-
- SimplexOptimizer(double, double) - Constructor for class org.apache.commons.math3.optimization.direct.SimplexOptimizer
-
- SimplexSolver - Class in org.apache.commons.math3.optimization.linear
-
Solves a linear problem using the Two-Phase Simplex Method.
- SimplexSolver() - Constructor for class org.apache.commons.math3.optimization.linear.SimplexSolver
-
Build a simplex solver with default settings.
- SimplexSolver(double, int) - Constructor for class org.apache.commons.math3.optimization.linear.SimplexSolver
-
Build a simplex solver with a specified accepted amount of error
- SIMPSON_MAX_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.SimpsonIntegrator
-
Maximal number of iterations for Simpson.
- SimpsonIntegrator - Class in org.apache.commons.math3.analysis.integration
-
Implements
Simpson's Rule for integration of real univariate functions.
- SimpsonIntegrator(double, double, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.SimpsonIntegrator
-
Build a Simpson integrator with given accuracies and iterations counts.
- SimpsonIntegrator(int, int) - Constructor for class org.apache.commons.math3.analysis.integration.SimpsonIntegrator
-
Build a Simpson integrator with given iteration counts.
- SimpsonIntegrator() - Constructor for class org.apache.commons.math3.analysis.integration.SimpsonIntegrator
-
Construct an integrator with default settings.
- Sin - Class in org.apache.commons.math3.analysis.function
-
Sine function.
- Sin() - Constructor for class org.apache.commons.math3.analysis.function.Sin
-
- sin() - Method in class org.apache.commons.math3.complex.Complex
-
Compute the
sine
of this complex number.
- sin(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
computes the sine of the argument.
- sin(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Sine function.
- Sinc - Class in org.apache.commons.math3.analysis.function
-
Sinc function,
defined by
- Sinc() - Constructor for class org.apache.commons.math3.analysis.function.Sinc
-
The sinc function, sin(x) / x
.
- Sinc(boolean) - Constructor for class org.apache.commons.math3.analysis.function.Sinc
-
Instantiates the sinc function.
- SingularMatrixException - Exception in org.apache.commons.math3.linear
-
Exception to be thrown when a non-singular matrix is expected.
- SingularMatrixException() - Constructor for exception org.apache.commons.math3.linear.SingularMatrixException
-
Construct an exception.
- SingularOperatorException - Exception in org.apache.commons.math3.linear
-
Exception to be thrown when trying to invert a singular operator.
- SingularOperatorException() - Constructor for exception org.apache.commons.math3.linear.SingularOperatorException
-
Creates a new instance of this class.
- SingularValueDecomposition - Class in org.apache.commons.math3.linear
-
Calculates the compact Singular Value Decomposition of a matrix.
- SingularValueDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.SingularValueDecomposition
-
Calculates the compact Singular Value Decomposition of the given matrix.
- Sinh - Class in org.apache.commons.math3.analysis.function
-
Hyperbolic sine function.
- Sinh() - Constructor for class org.apache.commons.math3.analysis.function.Sinh
-
- sinh() - Method in class org.apache.commons.math3.complex.Complex
-
- sinh(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Compute the hyperbolic sine of a number.
- sinInternal(Dfp[]) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
Computes sin(a) Used when 0 < a < pi/4.
- size() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
-
Get the number of elements of the tree.
- size() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
-
Get the number of elements stored in the map.
- size() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
-
Get the number of elements stored in the map.
- Skewness - Class in org.apache.commons.math3.stat.descriptive.moment
-
Computes the skewness of the available values.
- Skewness() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Skewness
-
Constructs a Skewness
- Skewness(ThirdMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Skewness
-
Constructs a Skewness with an external moment
- Skewness(Skewness) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Skewness
-
Copy constructor, creates a new Skewness
identical
to the original
- smooth(double[], double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
-
Compute a weighted loess fit on the data at the original abscissae.
- smooth(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
-
Compute a loess fit on the data at the original abscissae.
- SmoothingPolynomialBicubicSplineInterpolator - Class in org.apache.commons.math3.analysis.interpolation
-
Generates a bicubic interpolation function.
- SmoothingPolynomialBicubicSplineInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
-
Default constructor.
- SmoothingPolynomialBicubicSplineInterpolator(int) - Constructor for class org.apache.commons.math3.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
-
- SmoothingPolynomialBicubicSplineInterpolator(int, int) - Constructor for class org.apache.commons.math3.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
-
- SNAN - Static variable in class org.apache.commons.math3.dfp.Dfp
-
Indicator value for signaling NaN.
- solve(int, FUNC, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, FUNC, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Solve for a zero root in the given interval.
- solve(int, FUNC, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Solve for a zero in the vicinity of startValue
.
- solve(int, UnivariateFunction, double, double, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
-
Solve for a zero in the given interval.
- solve(int, UnivariateFunction, double, double, double, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, UnivariateFunction, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, FUNC, double, double) - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
-
Solve for a zero root in the given interval.
- solve(int, FUNC, double, double, double) - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, FUNC, double) - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
-
Solve for a zero in the vicinity of startValue
.
- solve(int, FUNC, double, double, AllowedSolution) - Method in interface org.apache.commons.math3.analysis.solvers.BracketedUnivariateSolver
-
Solve for a zero in the given interval.
- solve(int, FUNC, double, double, double, AllowedSolution) - Method in interface org.apache.commons.math3.analysis.solvers.BracketedUnivariateSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, UnivariateFunction, double, double, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
-
Solve for a zero in the given interval.
- solve(int, UnivariateFunction, double, double, double, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, DifferentiableUnivariateFunction, double, double) - Method in class org.apache.commons.math3.analysis.solvers.NewtonSolver
-
Find a zero near the midpoint of min
and max
.
- solve(UnivariateFunction, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
-
Convenience method to find a zero of a univariate real function.
- solve(UnivariateFunction, double, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
-
Convenience method to find a zero of a univariate real function.
- solve(int, UnivariateDfpFunction, Dfp, Dfp, AllowedSolution) - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
-
Solve for a zero in the given interval.
- solve(int, UnivariateDfpFunction, Dfp, Dfp, Dfp, AllowedSolution) - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
-
Solve for a zero in the given interval, start at startValue
.
- solve(RealVector) - Method in interface org.apache.commons.math3.linear.DecompositionSolver
-
Solve the linear equation A × X = B for matrices A.
- solve(RealMatrix) - Method in interface org.apache.commons.math3.linear.DecompositionSolver
-
Solve the linear equation A × X = B for matrices A.
- solve(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldDecompositionSolver
-
Solve the linear equation A × X = B for matrices A.
- solve(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldDecompositionSolver
-
Solve the linear equation A × X = B for matrices A.
- solve(RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.IterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.IterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealLinearOperator, RealVector, boolean, double) - Method in class org.apache.commons.math3.linear.SymmLQ
-
Returns an estimate of the solution to the linear system (A - shift
· I) · x = b.
- solve(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector, boolean, double) - Method in class org.apache.commons.math3.linear.SymmLQ
-
Returns the solution to the system (A - shift · I) · x = b.
- solve(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.ConjugateGradient
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.IterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector, boolean, double) - Method in class org.apache.commons.math3.linear.SymmLQ
-
Returns an estimate of the solution to the linear system (A - shift
· I) · x = b.
- solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInverseCumulativeProbability(double, int, int) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
-
- solveLowerTriangularSystem(RealMatrix, RealVector) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Solve a system of composed of a Lower Triangular Matrix
RealMatrix
.
- solvePhase1(SimplexTableau) - Method in class org.apache.commons.math3.optimization.linear.SimplexSolver
-
Solves Phase 1 of the Simplex method.
- SOLVER_DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.AbstractRealDistribution
-
Default accuracy.
- solveUpperTriangularSystem(RealMatrix, RealVector) - Static method in class org.apache.commons.math3.linear.MatrixUtils
-
Solver a system composed of an Upper Triangular Matrix
RealMatrix
.
- sortInPlace(double[], double[]...) - Static method in class org.apache.commons.math3.util.MathArrays
-
Sort an array in ascending order in place and perform the same reordering
of entries on other arrays.
- sortInPlace(double[], MathArrays.OrderDirection, double[]...) - Static method in class org.apache.commons.math3.util.MathArrays
-
Sort an array in place and perform the same reordering of entries on
other arrays.
- Space - Interface in org.apache.commons.math3.geometry
-
This interface represents a generic space, with affine and vectorial counterparts.
- SparseFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
-
Sparse matrix implementation based on an open addressed map.
- SparseFieldMatrix(Field<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldMatrix
-
Create a matrix with no data.
- SparseFieldMatrix(Field<T>, int, int) - Constructor for class org.apache.commons.math3.linear.SparseFieldMatrix
-
Create a new SparseFieldMatrix with the supplied row and column
dimensions.
- SparseFieldMatrix(SparseFieldMatrix<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldMatrix
-
Copy constructor.
- SparseFieldMatrix(FieldMatrix<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldMatrix
-
Generic copy constructor.
- SparseFieldVector<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
-
- SparseFieldVector(Field<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
-
Build a 0-length vector.
- SparseFieldVector(Field<T>, int) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
-
Construct a vector of zeroes.
- SparseFieldVector(SparseFieldVector<T>, int) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
-
Build a resized vector, for use with append.
- SparseFieldVector(Field<T>, int, int) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
-
Build a vector with known the sparseness (for advanced use only).
- SparseFieldVector(Field<T>, T[]) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
-
Create from a Field array.
- SparseFieldVector(SparseFieldVector<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
-
Copy constructor.
- sparseIterator() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Create a sparse iterator over the vector, which may omit some entries.
- sparseIterator() - Method in class org.apache.commons.math3.linear.RealVector
-
Create a sparse iterator over the vector, which may omit some entries.
- SparseRealMatrix - Interface in org.apache.commons.math3.linear
-
Marker interface for
RealMatrix
implementations that require sparse backing storage
- SparseRealVector - Class in org.apache.commons.math3.linear
-
Marker class for RealVectors that require sparse backing storage
- SparseRealVector() - Constructor for class org.apache.commons.math3.linear.SparseRealVector
-
- SpearmansCorrelation - Class in org.apache.commons.math3.stat.correlation
-
Spearman's rank correlation.
- SpearmansCorrelation(RealMatrix, RankingAlgorithm) - Constructor for class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
-
Create a SpearmansCorrelation with the given input data matrix
and ranking algorithm.
- SpearmansCorrelation(RealMatrix) - Constructor for class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
-
Create a SpearmansCorrelation from the given data matrix.
- SpearmansCorrelation() - Constructor for class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
-
Create a SpearmansCorrelation without data.
- SplineInterpolator - Class in org.apache.commons.math3.analysis.interpolation
-
Computes a natural (also known as "free", "unclamped") cubic spline interpolation for the data set.
- SplineInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.SplineInterpolator
-
- split(DfpField, String) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
Breaks a string representation up into two dfp's.
- split(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
Splits a
Dfp
into 2
Dfp
's such that their sum is equal to the input
Dfp
.
- split(Hyperplane<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
-
Split the instance in two parts by an hyperplane.
- split(Hyperplane<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SubPlane
-
Split the instance in two parts by an hyperplane.
- split(Hyperplane<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.SubLine
-
Split the instance in two parts by an hyperplane.
- split(Hyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
-
Split the instance in two parts by an hyperplane.
- split(SubHyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
-
Split a BSP tree by an external sub-hyperplane.
- split(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
-
Split the instance in two parts by an hyperplane.
- splitDiv(Dfp[], Dfp[]) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
Divide two numbers that are split in to two pieces that are meant to be added together.
- splitMult(Dfp[], Dfp[]) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
Multiply two numbers that are split in to two pieces that are
meant to be added together.
- splitPow(Dfp[], int) - Static method in class org.apache.commons.math3.dfp.DfpMath
-
Raise a split base to the a power.
- Sqrt - Class in org.apache.commons.math3.analysis.function
-
Square-root function.
- Sqrt() - Constructor for class org.apache.commons.math3.analysis.function.Sqrt
-
- sqrt() - Method in class org.apache.commons.math3.complex.Complex
-
- sqrt() - Method in class org.apache.commons.math3.dfp.Dfp
-
Compute the square root.
- sqrt(double) - Static method in class org.apache.commons.math3.util.FastMath
-
Compute the square root of a number.
- sqrt1z() - Method in class org.apache.commons.math3.complex.Complex
-
Compute the
square root of
1 - this2
for this complex
number.
- StableRandomGenerator - Class in org.apache.commons.math3.random
-
This class provides a stable normalized random generator.
- StableRandomGenerator(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.random.StableRandomGenerator
-
Create a new generator.
- StandardDeviation - Class in org.apache.commons.math3.stat.descriptive.moment
-
Computes the sample standard deviation.
- StandardDeviation() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
-
Constructs a StandardDeviation.
- StandardDeviation(SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
-
Constructs a StandardDeviation from an external second moment.
- StandardDeviation(StandardDeviation) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
-
Copy constructor, creates a new StandardDeviation
identical
to the original
- StandardDeviation(boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
-
Contructs a StandardDeviation with the specified value for the
isBiasCorrected
property.
- StandardDeviation(boolean, SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
-
Contructs a StandardDeviation with the specified value for the
isBiasCorrected
property and the supplied external moment.
- start(int, int, int, int, int, int) - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixChangingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixPreservingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in class org.apache.commons.math3.linear.DefaultRealMatrixChangingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in class org.apache.commons.math3.linear.DefaultRealMatrixPreservingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrixChangingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrixPreservingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrixChangingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrixPreservingVisitor
-
Start visiting a matrix.
- start(double, double[], double) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
-
Start the integration.
- start() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Returns the starting index of the internal array.
- stateVariation - Variable in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
-
State variation.
- StatisticalMultivariateSummary - Interface in org.apache.commons.math3.stat.descriptive
-
Reporting interface for basic multivariate statistics.
- StatisticalSummary - Interface in org.apache.commons.math3.stat.descriptive
-
Reporting interface for basic univariate statistics.
- StatisticalSummaryValues - Class in org.apache.commons.math3.stat.descriptive
-
Value object representing the results of a univariate statistical summary.
- StatisticalSummaryValues(double, double, long, double, double, double) - Constructor for class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
-
Constructor
- StatUtils - Class in org.apache.commons.math3.stat
-
StatUtils provides static methods for computing statistics based on data
stored in double[] arrays.
- stepAccepted(double, double[]) - Method in class org.apache.commons.math3.ode.events.EventState
-
Acknowledge the fact the step has been accepted by the integrator.
- StepFunction - Class in org.apache.commons.math3.analysis.function
-
- StepFunction(double[], double[]) - Constructor for class org.apache.commons.math3.analysis.function.StepFunction
-
Builds a step function from a list of arguments and the corresponding
values.
- StepHandler - Interface in org.apache.commons.math3.ode.sampling
-
This interface represents a handler that should be called after
each successful step.
- stepHandlers - Variable in class org.apache.commons.math3.ode.AbstractIntegrator
-
Step handler.
- StepInterpolator - Interface in org.apache.commons.math3.ode.sampling
-
This interface represents an interpolator over the last step
during an ODE integration.
- StepNormalizer - Class in org.apache.commons.math3.ode.sampling
-
- StepNormalizer(double, FixedStepHandler) - Constructor for class org.apache.commons.math3.ode.sampling.StepNormalizer
-
Simple constructor.
- StepNormalizer(double, FixedStepHandler, StepNormalizerMode) - Constructor for class org.apache.commons.math3.ode.sampling.StepNormalizer
-
Simple constructor.
- StepNormalizer(double, FixedStepHandler, StepNormalizerBounds) - Constructor for class org.apache.commons.math3.ode.sampling.StepNormalizer
-
Simple constructor.
- StepNormalizer(double, FixedStepHandler, StepNormalizerMode, StepNormalizerBounds) - Constructor for class org.apache.commons.math3.ode.sampling.StepNormalizer
-
Simple constructor.
- StepNormalizerBounds - Enum in org.apache.commons.math3.ode.sampling
-
- StepNormalizerMode - Enum in org.apache.commons.math3.ode.sampling
-
- stepSize - Variable in class org.apache.commons.math3.ode.AbstractIntegrator
-
Current stepsize.
- stepStart - Variable in class org.apache.commons.math3.ode.AbstractIntegrator
-
Current step start time.
- stop() - Method in class org.apache.commons.math3.ode.events.EventState
-
Check if the integration should be stopped at the end of the
current step.
- StoppingCondition - Interface in org.apache.commons.math3.genetics
-
Algorithm used to determine when to stop evolution.
- StorelessCovariance - Class in org.apache.commons.math3.stat.correlation
-
Covariance implementation that does not require input data to be
stored in memory.
- StorelessCovariance(int) - Constructor for class org.apache.commons.math3.stat.correlation.StorelessCovariance
-
Create a bias corrected covariance matrix with a given dimension.
- StorelessCovariance(int, boolean) - Constructor for class org.apache.commons.math3.stat.correlation.StorelessCovariance
-
Create a covariance matrix with a given number of rows and columns and the
indicated bias correction.
- StorelessUnivariateStatistic - Interface in org.apache.commons.math3.stat.descriptive
-
- storeTime(double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
-
Store the current step time.
- strictlyNegative() - Method in class org.apache.commons.math3.dfp.Dfp
-
Check if instance is strictly less than 0.
- strictlyPositive() - Method in class org.apache.commons.math3.dfp.Dfp
-
Check if instance is strictly greater than 0.
- subAndCheck(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Subtract two integers, checking for overflow.
- subAndCheck(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
-
Subtract two long integers, checking for overflow.
- SubHyperplane<S extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
-
This interface represents the remaining parts of an hyperplane after
other parts have been chopped off.
- SubHyperplane.SplitSubHyperplane<U extends Space> - Class in org.apache.commons.math3.geometry.partitioning
-
Class holding the results of the
split
method.
- SubHyperplane.SplitSubHyperplane(SubHyperplane<U>, SubHyperplane<U>) - Constructor for class org.apache.commons.math3.geometry.partitioning.SubHyperplane.SplitSubHyperplane
-
Build a SplitSubHyperplane from its parts.
- SubLine - Class in org.apache.commons.math3.geometry.euclidean.threed
-
This class represents a subset of a
Line
.
- SubLine(Line, IntervalsSet) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SubLine
-
Simple constructor.
- SubLine(Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SubLine
-
Create a sub-line from two endpoints.
- SubLine(Segment) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SubLine
-
Create a sub-line from a segment.
- SubLine - Class in org.apache.commons.math3.geometry.euclidean.twod
-
This class represents a sub-hyperplane for
Line
.
- SubLine(Hyperplane<Euclidean2D>, Region<Euclidean1D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.SubLine
-
Simple constructor.
- SubLine(Vector2D, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.SubLine
-
Create a sub-line from two endpoints.
- SubLine(Segment) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.SubLine
-
Create a sub-line from a segment.
- SubOrientedPoint - Class in org.apache.commons.math3.geometry.euclidean.oned
-
- SubOrientedPoint(Hyperplane<Euclidean1D>, Region<Euclidean1D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
-
Simple constructor.
- SubPlane - Class in org.apache.commons.math3.geometry.euclidean.threed
-
This class represents a sub-hyperplane for
Plane
.
- SubPlane(Hyperplane<Euclidean3D>, Region<Euclidean2D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SubPlane
-
Simple constructor.
- substituteMostRecentElement(double) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
-
Substitutes value
for the most recently added value.
- Subtract - Class in org.apache.commons.math3.analysis.function
-
Subtract the second operand from the first.
- Subtract() - Constructor for class org.apache.commons.math3.analysis.function.Subtract
-
- subtract(PolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
-
Subtract a polynomial from the instance.
- subtract(Complex) - Method in class org.apache.commons.math3.complex.Complex
-
Returns a Complex
whose value is
(this - subtrahend)
.
- subtract(double) - Method in class org.apache.commons.math3.complex.Complex
-
Returns a Complex
whose value is
(this - subtrahend)
.
- subtract(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
-
Subtract x from this.
- subtract(T) - Method in interface org.apache.commons.math3.FieldElement
-
Compute this - a.
- subtract(BigInteger) - Method in class org.apache.commons.math3.fraction.BigFraction
-
Subtracts the value of an
BigInteger
from the value of this
BigFraction
, returning the result in reduced form.
- subtract(int) - Method in class org.apache.commons.math3.fraction.BigFraction
-
Subtracts the value of an integer
from the value of this
BigFraction
, returning the result in reduced form.
- subtract(long) - Method in class org.apache.commons.math3.fraction.BigFraction
-
Subtracts the value of a long
from the value of this
BigFraction
, returning the result in reduced form.
- subtract(BigFraction) - Method in class org.apache.commons.math3.fraction.BigFraction
-
Subtracts the value of another fraction from the value of this one,
returning the result in reduced form.
- subtract(Fraction) - Method in class org.apache.commons.math3.fraction.Fraction
-
Subtracts the value of another fraction from the value of this one,
returning the result in reduced form.
- subtract(int) - Method in class org.apache.commons.math3.fraction.Fraction
-
Subtract an integer from the fraction.
- subtract(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Subtract a vector from the instance.
- subtract(double, Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Subtract a scaled vector from the instance.
- subtract(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Subtract a vector from the instance.
- subtract(double, Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Subtract a scaled vector from the instance.
- subtract(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Subtract a vector from the instance.
- subtract(double, Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Subtract a scaled vector from the instance.
- subtract(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
-
Subtract a vector from the instance.
- subtract(double, Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
-
Subtract a scaled vector from the instance.
- subtract(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
-
Subtract m
from this matrix.
- subtract(RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
-
Compute this minus m.
- subtract(Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
-
Subtract m
from this matrix.
- subtract(Array2DRowRealMatrix) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
-
Subtract m
from this matrix.
- subtract(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Compute this minus v.
- subtract(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
-
Compute this minus v.
- subtract(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
-
Subtract v
from this vector.
- subtract(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Subtract m
from this matrix.
- subtract(BlockFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
-
Compute this minus m
.
- subtract(RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Compute this minus m.
- subtract(BlockRealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
-
Subtract m
from this matrix.
- subtract(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
-
Subtract m
from this matrix.
- subtract(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
-
Compute this minus v.
- subtract(RealMatrix) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
-
Compute this minus m.
- subtract(OpenMapRealMatrix) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
-
Subtract m
from this matrix.
- subtract(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Optimized method to subtract OpenMapRealVectors.
- subtract(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
-
Subtract v
from this vector.
- subtract(RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
-
Compute this minus m.
- subtract(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
-
Subtract v
from this vector.
- subtract(SparseFieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Optimized method to subtract SparseRealVectors.
- subtract(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
-
Compute this minus v.
- subtract(BigReal) - Method in class org.apache.commons.math3.util.BigReal
-
Compute this - a.
- Sum - Class in org.apache.commons.math3.stat.descriptive.summary
-
Returns the sum of the available values.
- Sum() - Constructor for class org.apache.commons.math3.stat.descriptive.summary.Sum
-
Create a Sum instance
- Sum(Sum) - Constructor for class org.apache.commons.math3.stat.descriptive.summary.Sum
-
Copy constructor, creates a new Sum
identical
to the original
- sum(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the sum of the values in the input array, or
Double.NaN
if the array is empty.
- sum(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the sum of the entries in the specified portion of
the input array, or Double.NaN
if the designated subarray
is empty.
- sumDifference(double[], double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the sum of the (signed) differences between corresponding elements of the
input arrays -- i.e., sum(sample1[i] - sample2[i]).
- sumLog(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the sum of the natural logs of the entries in the input array, or
Double.NaN
if the array is empty.
- sumLog(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the sum of the natural logs of the entries in the specified portion of
the input array, or Double.NaN
if the designated subarray
is empty.
- SummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
-
Computes summary statistics for a stream of data values added using the
addValue
method.
- SummaryStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
Construct a SummaryStatistics instance
- SummaryStatistics(SummaryStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.SummaryStatistics
-
A copy constructor.
- SumOfLogs - Class in org.apache.commons.math3.stat.descriptive.summary
-
Returns the sum of the natural logs for this collection of values.
- SumOfLogs() - Constructor for class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
-
Create a SumOfLogs instance
- SumOfLogs(SumOfLogs) - Constructor for class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
-
Copy constructor, creates a new SumOfLogs
identical
to the original
- SumOfSquares - Class in org.apache.commons.math3.stat.descriptive.summary
-
Returns the sum of the squares of the available values.
- SumOfSquares() - Constructor for class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
-
Create a SumOfSquares instance
- SumOfSquares(SumOfSquares) - Constructor for class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
-
Copy constructor, creates a new SumOfSquares
identical
to the original
- sumSq(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the sum of the squares of the entries in the input array, or
Double.NaN
if the array is empty.
- sumSq(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the sum of the squares of the entries in the specified portion of
the input array, or Double.NaN
if the designated subarray
is empty.
- SymmLQ - Class in org.apache.commons.math3.linear
-
- SymmLQ(int, double, boolean) - Constructor for class org.apache.commons.math3.linear.SymmLQ
-
- SymmLQ(IterationManager, double, boolean) - Constructor for class org.apache.commons.math3.linear.SymmLQ
-
- SynchronizedDescriptiveStatistics - Class in org.apache.commons.math3.stat.descriptive
-
- SynchronizedDescriptiveStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
Construct an instance with infinite window
- SynchronizedDescriptiveStatistics(int) - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
Construct an instance with finite window
- SynchronizedDescriptiveStatistics(SynchronizedDescriptiveStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
-
A copy constructor.
- SynchronizedMultivariateSummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
-
- SynchronizedMultivariateSummaryStatistics(int, boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Construct a SynchronizedMultivariateSummaryStatistics instance
- SynchronizedSummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
-
Implementation of
SummaryStatistics
that
is safe to use in a multithreaded environment.
- SynchronizedSummaryStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
Construct a SynchronizedSummaryStatistics instance
- SynchronizedSummaryStatistics(SynchronizedSummaryStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
-
A copy constructor.
- v - Variable in class org.apache.commons.math3.random.AbstractWell
-
Bytes pool.
- validateCovarianceData(double[][], double[][]) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
Validates that the x data and covariance matrix have the same
number of rows and that the covariance matrix is square.
- validateSampleData(double[][], double[]) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
-
Validates sample data.
- value(double, double) - Method in interface org.apache.commons.math3.analysis.BivariateFunction
-
Compute the value for the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Abs
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Acos
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Acosh
-
Compute the value of the function.
- value(double, double) - Method in class org.apache.commons.math3.analysis.function.Add
-
Compute the value for the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Asin
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Asinh
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Atan
-
Compute the value of the function.
- value(double, double) - Method in class org.apache.commons.math3.analysis.function.Atan2
-
Compute the value for the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Atanh
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Cbrt
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Ceil
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Constant
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Cos
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Cosh
-
Compute the value of the function.
- value(double, double) - Method in class org.apache.commons.math3.analysis.function.Divide
-
Compute the value for the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Exp
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Expm1
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Floor
-
Compute the value of the function.
- value(double, double...) - Method in class org.apache.commons.math3.analysis.function.Gaussian.Parametric
-
Computes the value of the Gaussian at x
.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Gaussian
-
Compute the value of the function.
- value(double, double...) - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator.Parametric
-
Computes the value of the harmonic oscillator at x
.
- value(double) - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Identity
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Inverse
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Log
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Log10
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Log1p
-
Compute the value of the function.
- value(double, double...) - Method in class org.apache.commons.math3.analysis.function.Logistic.Parametric
-
Computes the value of the sigmoid at x
.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Logistic
-
Compute the value of the function.
- value(double, double...) - Method in class org.apache.commons.math3.analysis.function.Logit.Parametric
-
Computes the value of the logit at x
.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Logit
-
Compute the value of the function.
- value(double, double) - Method in class org.apache.commons.math3.analysis.function.Max
-
Compute the value for the function.
- value(double, double) - Method in class org.apache.commons.math3.analysis.function.Min
-
Compute the value for the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Minus
-
Compute the value of the function.
- value(double, double) - Method in class org.apache.commons.math3.analysis.function.Multiply
-
Compute the value for the function.
- value(double, double) - Method in class org.apache.commons.math3.analysis.function.Pow
-
Compute the value for the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Power
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Rint
-
Compute the value of the function.
- value(double, double...) - Method in class org.apache.commons.math3.analysis.function.Sigmoid.Parametric
-
Computes the value of the sigmoid at x
.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Sigmoid
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Signum
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Sin
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Sinc
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Sinh
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Sqrt
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.StepFunction
-
Compute the value of the function.
- value(double, double) - Method in class org.apache.commons.math3.analysis.function.Subtract
-
Compute the value for the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Tan
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Tanh
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.function.Ulp
-
Compute the value of the function.
- value(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
-
Compute the value for the function.
- value(double[]) - Method in class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolatingFunction
-
- value(double, double, double) - Method in class org.apache.commons.math3.analysis.interpolation.TricubicSplineInterpolatingFunction
-
Compute the value for the function.
- value(double[]) - Method in interface org.apache.commons.math3.analysis.MultivariateFunction
-
Compute the value for the function at the given point.
- value(double[]) - Method in interface org.apache.commons.math3.analysis.MultivariateMatrixFunction
-
Compute the value for the function at the given point.
- value(double[]) - Method in interface org.apache.commons.math3.analysis.MultivariateVectorFunction
-
Compute the value for the function at the given point.
- value(double, double...) - Method in interface org.apache.commons.math3.analysis.ParametricUnivariateFunction
-
Compute the value of the function.
- value(double, double...) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction.Parametric
-
Compute the value of the function.
- value(double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
-
Compute the value of the function for the given argument.
- value(double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Calculate the function value at the given point.
- value(double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
-
Calculate the function value at the given point.
- value(double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
-
Compute the value for the function.
- value(double, double, double) - Method in interface org.apache.commons.math3.analysis.TrivariateFunction
-
Compute the value for the function.
- value(double) - Method in interface org.apache.commons.math3.analysis.UnivariateFunction
-
Compute the value of the function.
- value(double) - Method in interface org.apache.commons.math3.analysis.UnivariateMatrixFunction
-
Compute the value for the function.
- value(double) - Method in interface org.apache.commons.math3.analysis.UnivariateVectorFunction
-
Compute the value for the function.
- value(Dfp) - Method in interface org.apache.commons.math3.dfp.UnivariateDfpFunction
-
Compute the value of the function.
- value(double[]) - Method in class org.apache.commons.math3.optimization.direct.MultivariateFunctionMappingAdapter
-
Compute the underlying function value from an unbounded point.
- value(double[]) - Method in class org.apache.commons.math3.optimization.direct.MultivariateFunctionPenaltyAdapter
-
Compute the underlying function value from an unbounded point.
- value(double[]) - Method in class org.apache.commons.math3.optimization.LeastSquaresConverter
-
Compute the value for the function at the given point.
- value() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap.Iterator
-
Get the value of current entry.
- value() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap.Iterator
-
Get the value of current entry.
- valueOf(String) - Static method in enum org.apache.commons.math3.analysis.solvers.AllowedSolution
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.analysis.solvers.BaseSecantSolver.Method
-
Returns the enum constant of this type with the specified name.
- valueOf(double, double) - Static method in class org.apache.commons.math3.complex.Complex
-
Create a complex number given the real and imaginary parts.
- valueOf(double) - Static method in class org.apache.commons.math3.complex.Complex
-
Create a complex number given only the real part.
- valueOf(String) - Static method in enum org.apache.commons.math3.dfp.DfpField.RoundingMode
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.exception.util.LocalizedFormats
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor.Order
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.geometry.partitioning.Region.Location
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.geometry.partitioning.Side
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.ode.events.EventHandler.Action
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.ode.sampling.StepNormalizerBounds
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.ode.sampling.StepNormalizerMode
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.optimization.general.ConjugateGradientFormula
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.optimization.GoalType
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.optimization.linear.Relationship
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.stat.descriptive.moment.SemiVariance.Direction
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.stat.ranking.NaNStrategy
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.stat.ranking.TiesStrategy
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.transform.DctNormalization
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.transform.DftNormalization
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.transform.DstNormalization
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.transform.TransformType
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.apache.commons.math3.util.MathArrays.OrderDirection
-
Returns the enum constant of this type with the specified name.
- values() - Static method in enum org.apache.commons.math3.analysis.solvers.AllowedSolution
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.analysis.solvers.BaseSecantSolver.Method
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.dfp.DfpField.RoundingMode
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.exception.util.LocalizedFormats
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor.Order
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.geometry.partitioning.Region.Location
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.geometry.partitioning.Side
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.ode.events.EventHandler.Action
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.ode.sampling.StepNormalizerBounds
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.ode.sampling.StepNormalizerMode
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.optimization.general.ConjugateGradientFormula
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.optimization.GoalType
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.optimization.linear.Relationship
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.stat.descriptive.moment.SemiVariance.Direction
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.stat.ranking.NaNStrategy
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.stat.ranking.TiesStrategy
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.transform.DctNormalization
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.transform.DftNormalization
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.transform.DstNormalization
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.transform.TransformType
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.apache.commons.math3.util.MathArrays.OrderDirection
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- ValueServer - Class in org.apache.commons.math3.random
-
Generates values for use in simulation applications.
- ValueServer() - Constructor for class org.apache.commons.math3.random.ValueServer
-
Creates new ValueServer
- ValueServer(RandomDataImpl) - Constructor for class org.apache.commons.math3.random.ValueServer
-
Construct a ValueServer instance using a RandomDataImpl as its source
of random data.
- valuesIterator() - Method in class org.apache.commons.math3.stat.Frequency
-
Returns an Iterator over the set of values that have been added.
- Variance - Class in org.apache.commons.math3.stat.descriptive.moment
-
Computes the variance of the available values.
- Variance() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
-
Constructs a Variance with default (true) isBiasCorrected
property.
- Variance(SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
-
Constructs a Variance based on an external second moment.
- Variance(boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
-
Constructs a Variance with the specified isBiasCorrected
property
- Variance(boolean, SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
-
Constructs a Variance with the specified isBiasCorrected
property and the supplied external second moment.
- Variance(Variance) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
-
Copy constructor, creates a new Variance
identical
to the original
- variance(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the variance of the entries in the input array, or
Double.NaN
if the array is empty.
- variance(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the variance of the entries in the specified portion of
the input array, or Double.NaN
if the designated subarray
is empty.
- variance(double[], double, int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the variance of the entries in the specified portion of
the input array, using the precomputed mean value.
- variance(double[], double) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the variance of the entries in the input array, using the
precomputed mean value.
- varianceDifference(double[], double[], double) - Static method in class org.apache.commons.math3.stat.StatUtils
-
Returns the variance of the (signed) differences between corresponding elements of the
input arrays -- i.e., var(sample1[i] - sample2[i]).
- vecAbsoluteTolerance - Variable in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Allowed absolute vectorial error.
- vecRelativeTolerance - Variable in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Allowed relative vectorial error.
- Vector<S extends Space> - Interface in org.apache.commons.math3.geometry
-
This interface represents a generic vector in a vectorial space or a point in an affine space.
- VECTOR - Static variable in class org.apache.commons.math3.linear.ConjugateGradient
-
- Vector1D - Class in org.apache.commons.math3.geometry.euclidean.oned
-
This class represents a 1D vector.
- Vector1D(double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Simple constructor.
- Vector1D(double, Vector1D) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Multiplicative constructor
Build a vector from another one and a scale factor.
- Vector1D(double, Vector1D, double, Vector1D) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Linear constructor
Build a vector from two other ones and corresponding scale factors.
- Vector1D(double, Vector1D, double, Vector1D, double, Vector1D) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Linear constructor
Build a vector from three other ones and corresponding scale factors.
- Vector1D(double, Vector1D, double, Vector1D, double, Vector1D, double, Vector1D) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
-
Linear constructor
Build a vector from four other ones and corresponding scale factors.
- Vector1DFormat - Class in org.apache.commons.math3.geometry.euclidean.oned
-
Formats a 1D vector in components list format "{x}".
- Vector1DFormat() - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
-
Create an instance with default settings.
- Vector1DFormat(NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
-
Create an instance with a custom number format for components.
- Vector1DFormat(String, String) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
-
Create an instance with custom prefix, suffix and separator.
- Vector1DFormat(String, String, NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
-
Create an instance with custom prefix, suffix, separator and format
for components.
- Vector2D - Class in org.apache.commons.math3.geometry.euclidean.twod
-
This class represents a 2D vector.
- Vector2D(double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Simple constructor.
- Vector2D(double[]) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Simple constructor.
- Vector2D(double, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Multiplicative constructor
Build a vector from another one and a scale factor.
- Vector2D(double, Vector2D, double, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Linear constructor
Build a vector from two other ones and corresponding scale factors.
- Vector2D(double, Vector2D, double, Vector2D, double, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Linear constructor
Build a vector from three other ones and corresponding scale factors.
- Vector2D(double, Vector2D, double, Vector2D, double, Vector2D, double, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
-
Linear constructor
Build a vector from four other ones and corresponding scale factors.
- Vector2DFormat - Class in org.apache.commons.math3.geometry.euclidean.twod
-
Formats a 2D vector in components list format "{x; y}".
- Vector2DFormat() - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
-
Create an instance with default settings.
- Vector2DFormat(NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
-
Create an instance with a custom number format for components.
- Vector2DFormat(String, String, String) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
-
Create an instance with custom prefix, suffix and separator.
- Vector2DFormat(String, String, String, NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
-
Create an instance with custom prefix, suffix, separator and format
for components.
- Vector3D - Class in org.apache.commons.math3.geometry.euclidean.threed
-
This class implements vectors in a three-dimensional space.
- Vector3D(double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Simple constructor.
- Vector3D(double[]) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Simple constructor.
- Vector3D(double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Simple constructor.
- Vector3D(double, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Multiplicative constructor
Build a vector from another one and a scale factor.
- Vector3D(double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Linear constructor
Build a vector from two other ones and corresponding scale factors.
- Vector3D(double, Vector3D, double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Linear constructor
Build a vector from three other ones and corresponding scale factors.
- Vector3D(double, Vector3D, double, Vector3D, double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
-
Linear constructor
Build a vector from four other ones and corresponding scale factors.
- Vector3DFormat - Class in org.apache.commons.math3.geometry.euclidean.threed
-
Formats a 3D vector in components list format "{x; y; z}".
- Vector3DFormat() - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
-
Create an instance with default settings.
- Vector3DFormat(NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
-
Create an instance with a custom number format for components.
- Vector3DFormat(String, String, String) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
-
Create an instance with custom prefix, suffix and separator.
- Vector3DFormat(String, String, String, NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
-
Create an instance with custom prefix, suffix, separator and format
for components.
- VectorFormat<S extends Space> - Class in org.apache.commons.math3.geometry
-
Formats a vector in components list format "{x; y; ...}".
- VectorFormat() - Constructor for class org.apache.commons.math3.geometry.VectorFormat
-
Create an instance with default settings.
- VectorFormat(NumberFormat) - Constructor for class org.apache.commons.math3.geometry.VectorFormat
-
Create an instance with a custom number format for components.
- VectorFormat(String, String, String) - Constructor for class org.apache.commons.math3.geometry.VectorFormat
-
Create an instance with custom prefix, suffix and separator.
- VectorFormat(String, String, String, NumberFormat) - Constructor for class org.apache.commons.math3.geometry.VectorFormat
-
Create an instance with custom prefix, suffix, separator and format
for components.
- VectorialCovariance - Class in org.apache.commons.math3.stat.descriptive.moment
-
Returns the covariance matrix of the available vectors.
- VectorialCovariance(int, boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
-
Constructs a VectorialCovariance.
- VectorialMean - Class in org.apache.commons.math3.stat.descriptive.moment
-
Returns the arithmetic mean of the available vectors.
- VectorialMean(int) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
-
Constructs a VectorialMean.
- verifyBracketing(double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Check that the endpoints specify an interval and the function takes
opposite signs at the endpoints.
- verifyBracketing(UnivariateFunction, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
-
Check that the endpoints specify an interval and the end points
bracket a root.
- verifyInputArray(double[], double[]) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
-
Verifies that the input arrays are valid.
- verifyInterpolationArray(double[], double[], boolean) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Check that the interpolation arrays are valid.
- verifyInterval(double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Check that the endpoints specify an interval.
- verifyInterval(double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
-
Check that the endpoints specify an interval.
- verifySequence(double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
-
Check that lower < initial < upper
.
- verifySequence(double, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
-
Check that lower < initial < upper
.
- visit(BSPTreeVisitor<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
-
Visit the BSP tree nodes.
- visit(int, int, T) - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixChangingVisitor
-
Visit one matrix entry.
- visit(int, int, T) - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixPreservingVisitor
-
Visit one matrix entry.
- visit(int, int, double) - Method in class org.apache.commons.math3.linear.DefaultRealMatrixChangingVisitor
-
Visit one matrix entry.
- visit(int, int, double) - Method in class org.apache.commons.math3.linear.DefaultRealMatrixPreservingVisitor
-
Visit one matrix entry.
- visit(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrixChangingVisitor
-
Visit one matrix entry.
- visit(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrixPreservingVisitor
-
Visit one matrix entry.
- visit(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrixChangingVisitor
-
Visit one matrix entry.
- visit(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrixPreservingVisitor
-
Visit one matrix entry.
- visitInternalNode(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor
-
Visit a BSP tree node node having a non-null sub-hyperplane.
- visitLeafNode(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor
-
Visit a leaf BSP tree node node having a null sub-hyperplane.
- visitOrder(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor
-
Determine the visit order for this node.