All Classes Interface Summary Class Summary Enum Summary Exception Summary
Class |
Description |
Abs |
Absolute value function.
|
AbstractFieldMatrix<T extends FieldElement<T>> |
Basic implementation of FieldMatrix methods regardless of the underlying storage.
|
AbstractIntegerDistribution |
Base class for integer-valued discrete distributions.
|
AbstractMultivariateRealDistribution |
Base class for multivariate probability distributions.
|
AbstractOpenIntHashMap |
Base class for open addressed map from int.
|
AbstractOpenIntHashMap.InsertionHolder |
Holder for handling values insertion.
|
AbstractOpenIntHashMap.ValueCopier |
Interface for copying values.
|
AbstractPolynomialSolver |
Base class for solvers.
|
AbstractRealDistribution |
Base class for probability distributions on the reals.
|
AbstractRealMatrix |
Basic implementation of RealMatrix methods regardless of the underlying storage.
|
AbstractRuleFactory |
Base class for rules that determines the integration nodes and their
weights.
|
AbstractUnivariateDifferentiableSolver |
Provide a default implementation for several functions useful to generic
solvers.
|
AbstractUnivariateSolver |
Base class for solvers.
|
AbstractUnscentedTransform |
Base class for unscented transform providers.
|
AbstractWell |
This abstract class implements the WELL class of pseudo-random number generator
from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
|
AbstractWell.IndexTable |
Inner class used to store the indirection index table which is fixed
for a given type of WELL class of pseudo-random number generator.
|
Acos |
Arc-cosine function.
|
Acosh |
Hyperbolic arc-cosine function.
|
Add |
Add the two operands.
|
AkimaSplineInterpolator |
|
AllowedSolution |
|
AnyMatrix |
Interface defining very basic matrix operations.
|
ArithmeticUtils |
Some useful, arithmetics related, additions to the built-in functions in
Math .
|
Array2DRowFieldMatrix<T extends FieldElement<T>> |
|
Array2DRowRealMatrix |
Implementation of RealMatrix using a double[][] array to
store entries.
|
ArrayFieldVector<T extends FieldElement<T>> |
|
ArrayRealVector |
This class implements the RealVector interface with a double array.
|
Asin |
Arc-sine function.
|
Asinh |
Hyperbolic arc-sine function.
|
Atan |
Arc-tangent function.
|
Atan2 |
Arc-tangent function.
|
Atanh |
Hyperbolic arc-tangent function.
|
BaseAbstractFieldUnivariateIntegrator<T extends CalculusFieldElement<T>> |
Provide a default implementation for several generic functions.
|
BaseAbstractUnivariateIntegrator |
Provide a default implementation for several generic functions.
|
BaseAbstractUnivariateSolver<F extends UnivariateFunction> |
Provide a default implementation for several functions useful to generic
solvers.
|
BaseSecantSolver |
Base class for all bracketing Secant-based methods for root-finding
(approximating a zero of a univariate real function).
|
BaseSecantSolver.Method |
Secant-based root-finding methods.
|
BaseUnivariateSolver<F extends UnivariateFunction> |
Interface for (univariate real) rootfinding algorithms.
|
BesselJ |
This class provides computation methods related to Bessel
functions of the first kind.
|
BesselJ.BesselJResult |
|
Beta |
This is a utility class that provides computation methods related to the
Beta family of functions.
|
BetaDistribution |
Implements the Beta distribution.
|
BicubicInterpolatingFunction |
|
BicubicInterpolator |
|
BigFraction |
Representation of a rational number without any overflow.
|
BigFraction.ConvergenceTest |
A test to determine if a series of fractions has converged.
|
BigFractionField |
Representation of the fractional numbers without any overflow field.
|
BigFractionFormat |
Formats a BigFraction number in proper format or improper format.
|
BigReal |
Arbitrary precision decimal number.
|
BigRealField |
Representation of real numbers with arbitrary precision field.
|
BilinearInterpolatingFunction |
Interpolate grid data using bi-linear interpolation.
|
BilinearInterpolator |
Interpolate grid data using bi-linear interpolation.
|
Binary64 |
This class wraps a double value in an object.
|
Binary64Field |
|
BinomialDistribution |
Implementation of the binomial distribution.
|
BisectionSolver |
|
BivariateFunction |
An interface representing a bivariate real function.
|
BivariateGridInterpolator |
Interface representing a bivariate real interpolating function where the
sample points must be specified on a regular grid.
|
Blendable<B> |
Interface representing classes that can blend with other instances of themselves using a given blending value.
|
BlockFieldMatrix<T extends FieldElement<T>> |
Cache-friendly implementation of FieldMatrix using a flat arrays to store
square blocks of the matrix.
|
BlockRealMatrix |
Cache-friendly implementation of RealMatrix using a flat arrays to store
square blocks of the matrix.
|
BracketedRealFieldUnivariateSolver<T extends CalculusFieldElement<T>> |
|
BracketedRealFieldUnivariateSolver.Interval<T extends CalculusFieldElement<T>> |
An interval of a function that brackets a root.
|
BracketedUnivariateSolver<F extends UnivariateFunction> |
|
BracketedUnivariateSolver.Interval |
An interval of a function that brackets a root.
|
BracketingNthOrderBrentSolver |
|
BrentSolver |
This class implements the
Brent algorithm for finding zeros of real univariate functions.
|
CalculusFieldBivariateFunction<T extends CalculusFieldElement<T>> |
An interface representing a bivariate field function.
|
CalculusFieldElement<T extends FieldElement<T>> |
Interface representing a field
with calculus capabilities (sin, cos, ...).
|
CalculusFieldMultivariateFunction<T extends CalculusFieldElement<T>> |
An interface representing a scalar multivariate function.
|
CalculusFieldMultivariateMatrixFunction<T extends CalculusFieldElement<T>> |
An interface representing a matrix multivariate function.
|
CalculusFieldMultivariateVectorFunction<T extends CalculusFieldElement<T>> |
An interface representing a vector multivariate function.
|
CalculusFieldUnivariateFunction<T extends CalculusFieldElement<T>> |
An interface representing a univariate real function.
|
CalculusFieldUnivariateMatrixFunction<T extends CalculusFieldElement<T>> |
An interface representing a univariate matrix function.
|
CalculusFieldUnivariateVectorFunction<T extends CalculusFieldElement<T>> |
An interface representing a univariate vectorial function for any field type.
|
CarlsonEllipticIntegral |
Elliptic integrals in Carlson symmetric form.
|
CauchyDistribution |
Implementation of the Cauchy distribution.
|
Cbrt |
Cube root function.
|
Ceil |
ceil function.
|
ChiSquaredDistribution |
Implementation of the chi-squared distribution.
|
CholeskyDecomposer |
Matrix decomposer using Cholseky decomposition.
|
CholeskyDecomposition |
Calculates the Cholesky decomposition of a matrix.
|
Combinations |
Utility to create combinations (n, k) of k elements
in a set of n elements.
|
CombinatoricsUtils |
Combinatorial utilities.
|
CombinatoricsUtils.FactorialLog |
Class for computing the natural logarithm of the factorial of n .
|
Complex |
Representation of a Complex number, i.e. a number which has both a
real and imaginary part.
|
ComplexComparator |
Comparator for Complex Numbers.
|
ComplexEigenDecomposition |
Given a matrix A, it computes a complex eigen decomposition AV = VD.
|
ComplexField |
Representation of the complex numbers field.
|
ComplexFormat |
Formats a Complex number in cartesian format "Re(c) + Im(c)i".
|
ComplexUnivariateIntegrator |
Wrapper to perform univariate complex integration using an underlying real integration algorithms.
|
ComplexUtils |
Static implementations of common Complex utilities functions.
|
CompositeFormat |
Base class for formatters of composite objects (complex numbers, vectors ...).
|
ConjugateGradient |
|
Constant |
Constant function.
|
ConstantRealDistribution |
Implementation of the constant real distribution.
|
ContinuedFraction |
Provides a generic means to evaluate continued fractions.
|
ConvertingRuleFactory<T extends FieldElement<T>> |
|
CopolarC |
Copolar trio with pole at point c in Glaisher’s Notation.
|
CopolarD |
Copolar trio with pole at point d in Glaisher’s Notation.
|
CopolarN |
Copolar trio with pole at point n in Glaisher’s Notation.
|
CopolarS |
Copolar trio with pole at point s in Glaisher’s Notation.
|
CorrelatedRandomVectorGenerator |
|
Cos |
Cosine function.
|
Cosh |
Hyperbolic cosine function.
|
DecompositionSolver |
Interface handling decomposition algorithms that can solve A × X = B.
|
DefaultFieldMatrixChangingVisitor<T extends FieldElement<T>> |
|
DefaultFieldMatrixPreservingVisitor<T extends FieldElement<T>> |
|
DefaultIterativeLinearSolverEvent |
|
DefaultRealMatrixChangingVisitor |
|
DefaultRealMatrixPreservingVisitor |
|
DependentVectorsHandler |
|
Derivative<T extends CalculusFieldElement<T>> |
Interface representing both the value and the differentials of a function.
|
Derivative1<T extends CalculusFieldElement<T>> |
Interface representing an object holding partial derivatives up to first order.
|
DerivativeStructure |
Class representing both the value and the differentials of a function.
|
Dfp |
Decimal floating point library for Java
|
DfpDec |
Subclass of Dfp which hides the radix-10000 artifacts of the superclass.
|
DfpField |
Field for Decimal floating point instances.
|
DfpField.RoundingMode |
Enumerate for rounding modes.
|
DfpMath |
Mathematical routines for use with Dfp .
|
DiagonalMatrix |
Implementation of a diagonal matrix.
|
DifferentialAlgebra |
Interface representing an object holding partial derivatives.
|
Divide |
Divide the first operand by the second.
|
DividedDifferenceInterpolator |
|
DSCompiler |
Class holding "compiled" computation rules for derivative structures.
|
DSFactory |
|
DSFactory.DSField |
Field for {link DerivativeStructure} instances.
|
DummyLocalizable |
Dummy implementation of the Localizable interface, without localization.
|
EigenDecompositionNonSymmetric |
Calculates the eigen decomposition of a non-symmetric real matrix.
|
EigenDecompositionSymmetric |
Calculates the eigen decomposition of a symmetric real matrix.
|
EnumeratedDistribution<T> |
|
EnumeratedIntegerDistribution |
|
EnumeratedRealDistribution |
|
Erf |
This is a utility class that provides computation methods related to the
error functions.
|
Exp |
Exponential function.
|
Expm1 |
ex-1 function.
|
ExponentialDistribution |
Implementation of the exponential distribution.
|
FastMath |
Faster, more accurate, portable alternative to Math and
StrictMath for large scale computation.
|
FDistribution |
Implementation of the F-distribution.
|
FDSFactory<T extends CalculusFieldElement<T>> |
|
FDSFactory.DerivativeField<T extends CalculusFieldElement<T>> |
Field for {link FieldDerivativeStructure} instances.
|
Field<T extends FieldElement<T>> |
Interface representing a field.
|
FieldAbstractRuleFactory<T extends CalculusFieldElement<T>> |
Base class for rules that determines the integration nodes and their
weights.
|
FieldBilinearInterpolatingFunction<T extends CalculusFieldElement<T>> |
Interpolate grid data using bi-linear interpolation.
|
FieldBilinearInterpolator<T extends CalculusFieldElement<T>> |
Interpolate grid data using bi-linear interpolation.
|
FieldBivariateFunction |
An interface representing a bivariate field function.
|
FieldBivariateGridInterpolator<T extends CalculusFieldElement<T>> |
Interface representing a bivariate field interpolating function where the
sample points must be specified on a regular grid.
|
FieldBlendable<B,T extends FieldElement<T>> |
Interface representing classes that can blend with other instances of themselves using a given blending value.
|
FieldBracketingNthOrderBrentSolver<T extends CalculusFieldElement<T>> |
|
FieldComplex<T extends CalculusFieldElement<T>> |
Representation of a Complex number, i.e. a number which has both a
real and imaginary part.
|
FieldComplexField<T extends CalculusFieldElement<T>> |
Representation of the complex numbers field.
|
FieldComplexUnivariateIntegrator<T extends CalculusFieldElement<T>> |
Wrapper to perform univariate complex integration using an underlying real integration algorithms.
|
FieldContinuedFraction |
Provides a generic means to evaluate continued fractions.
|
FieldCopolarC<T extends CalculusFieldElement<T>> |
Copolar trio with pole at point c in Glaisher’s Notation.
|
FieldCopolarD<T extends CalculusFieldElement<T>> |
Copolar trio with pole at point d in Glaisher’s Notation.
|
FieldCopolarN<T extends CalculusFieldElement<T>> |
Copolar trio with pole at point n in Glaisher’s Notation.
|
FieldCopolarS<T extends CalculusFieldElement<T>> |
Copolar trio with pole at point s in Glaisher’s Notation.
|
FieldDecompositionSolver<T extends FieldElement<T>> |
Interface handling decomposition algorithms that can solve A × X = B.
|
FieldDerivative<S extends CalculusFieldElement<S>,T extends FieldDerivative<S,T>> |
Interface representing both the value and the differentials of a function.
|
FieldDerivative1<S extends CalculusFieldElement<S>,T extends FieldDerivative<S,T>> |
Interface representing a Field object holding partial derivatives up to first order.
|
FieldDerivativeStructure<T extends CalculusFieldElement<T>> |
Class representing both the value and the differentials of a function.
|
FieldElement<T extends FieldElement<T>> |
Interface representing field elements.
|
FieldGaussIntegrator<T extends CalculusFieldElement<T>> |
Class that implements the Gaussian rule for
integrating a weighted
function.
|
FieldGaussIntegratorFactory<T extends CalculusFieldElement<T>> |
|
FieldGradient<T extends CalculusFieldElement<T>> |
Class representing both the value and the differentials of a function.
|
FieldGradientField<T extends CalculusFieldElement<T>> |
|
FieldGridAxis<T extends CalculusFieldElement<T>> |
Helper for finding interpolation nodes along one axis of grid data.
|
FieldHermiteInterpolator<T extends FieldElement<T>> |
Polynomial interpolator using both sample values and sample derivatives.
|
FieldHermiteRuleFactory<T extends CalculusFieldElement<T>> |
|
FieldJacobiElliptic<T extends CalculusFieldElement<T>> |
Computation of Jacobi elliptic functions.
|
FieldJacobiTheta<T extends CalculusFieldElement<T>> |
Algorithm computing Jacobi theta functions.
|
FieldLaguerreRuleFactory<T extends CalculusFieldElement<T>> |
Factory that creates Gauss-type quadrature rule using Laguerre polynomials.
|
FieldLegendreRuleFactory<T extends CalculusFieldElement<T>> |
Factory that creates Gauss-type quadrature rule using Legendre polynomials.
|
FieldLUDecomposer<T extends FieldElement<T>> |
Matrix decomposer using LU-decomposition.
|
FieldLUDecomposition<T extends FieldElement<T>> |
Calculates the LUP-decomposition of a square matrix.
|
FieldMatrix<T extends FieldElement<T>> |
Interface defining field-valued matrix with basic algebraic operations.
|
FieldMatrixChangingVisitor<T extends FieldElement<?>> |
Interface defining a visitor for matrix entries.
|
FieldMatrixDecomposer<T extends FieldElement<T>> |
Interface for all algorithms providing matrix decomposition.
|
FieldMatrixPreservingVisitor<T extends FieldElement<?>> |
Interface defining a visitor for matrix entries.
|
FieldMidPointIntegrator<T extends CalculusFieldElement<T>> |
Implements the
Midpoint Rule for integration of real univariate functions.
|
FieldMultivariateFunction |
An interface representing a scalar multivariate function for any field type.
|
FieldMultivariateMatrixFunction |
An interface representing a matrix multivariate function for any field type.
|
FieldMultivariateVectorFunction |
An interface representing a vector multivariate function for any field type.
|
FieldPolynomialFunction<T extends CalculusFieldElement<T>> |
Immutable representation of a real polynomial function with real coefficients.
|
FieldPolynomialFunctionLagrangeForm<T extends CalculusFieldElement<T>> |
Implements the representation of a real polynomial function in
Lagrange Form.
|
FieldPolynomialSplineFunction<T extends CalculusFieldElement<T>> |
Represents a polynomial spline function.
|
FieldQRDecomposer<T extends CalculusFieldElement<T>> |
Matrix decomposer using QR-decomposition.
|
FieldQRDecomposition<T extends CalculusFieldElement<T>> |
Calculates the QR-decomposition of a field matrix.
|
FieldRombergIntegrator<T extends CalculusFieldElement<T>> |
|
FieldRuleFactory<T extends FieldElement<T>> |
Interface for rules that determines the integration nodes and their weights.
|
FieldSimpsonIntegrator<T extends CalculusFieldElement<T>> |
Implements
Simpson's Rule for integration of real univariate functions.
|
FieldSinCos<T> |
Holder for both sine and cosine values.
|
FieldSinhCosh<T> |
Holder for both hyperbolic sine and hyperbolic cosine values.
|
FieldTaylorMap<T extends CalculusFieldElement<T>> |
Container for a Taylor map.
|
FieldTheta<T extends CalculusFieldElement<T>> |
|
FieldTrapezoidIntegrator<T extends CalculusFieldElement<T>> |
Implements the
Trapezoid Rule for integration of real univariate functions.
|
FieldTuple<T extends CalculusFieldElement<T>> |
This class allows to perform the same computation of all components of a Tuple at once.
|
FieldUnivariateDerivative<S extends CalculusFieldElement<S>,T extends FieldUnivariateDerivative<S,T>> |
Abstract class representing both the value and the differentials of a function.
|
FieldUnivariateDerivative1<T extends CalculusFieldElement<T>> |
Class representing both the value and the differentials of a function.
|
FieldUnivariateDerivative1Field<T extends CalculusFieldElement<T>> |
|
FieldUnivariateDerivative2<T extends CalculusFieldElement<T>> |
Class representing both the value and the differentials of a function.
|
FieldUnivariateDerivative2Field<T extends CalculusFieldElement<T>> |
|
FieldUnivariateFunction |
An interface representing a univariate real function for any field type.
|
FieldUnivariateIntegrator<T extends CalculusFieldElement<T>> |
Interface for univariate real integration algorithms.
|
FieldUnivariateInterpolator |
Interface representing a univariate field interpolating function.
|
FieldUnivariateMatrixFunction |
An interface representing a univariate matrix function for any field type.
|
FieldUnivariateVectorFunction |
An interface representing a univariate vectorial function for any field type.
|
FieldVector<T extends FieldElement<T>> |
Interface defining a field-valued vector with basic algebraic operations.
|
FieldVectorChangingVisitor<T extends FieldElement<?>> |
This interface defines a visitor for the entries of a vector.
|
FieldVectorPreservingVisitor<T extends FieldElement<?>> |
This interface defines a visitor for the entries of a vector.
|
FiniteDifferencesDifferentiator |
Univariate functions differentiator using finite differences.
|
Floor |
floor function.
|
Fraction |
Representation of a rational number.
|
Fraction.ConvergenceTest |
A test to determine if a series of fractions has converged.
|
FractionField |
Representation of the fractional numbers field.
|
FractionFormat |
Formats a Fraction number in proper format or improper format.
|
FunctionUtils |
Utilities for manipulating function objects.
|
Gamma |
This is a utility class that provides computation methods related to the
Γ (Gamma) family of functions.
|
GammaDistribution |
Implementation of the Gamma distribution.
|
Gaussian |
|
Gaussian.Parametric |
Parametric function where the input array contains the parameters of
the Gaussian, ordered as follows:
Norm
Mean
Standard deviation
|
GaussianRandomGenerator |
This class is a gaussian normalized random generator for scalars.
|
GaussIntegrator |
Class that implements the Gaussian rule for
integrating a weighted
function.
|
GaussIntegratorFactory |
|
GaussMarkovGenerator |
This class is a Gauss-Markov order 1 autoregressive process generator for scalars.
|
GeometricDistribution |
Implementation of the geometric distribution.
|
Gradient |
Class representing both the value and the differentials of a function.
|
GradientField |
|
GradientFunction |
Class representing the gradient of a multivariate function.
|
GridAxis |
Helper for finding interpolation nodes along one axis of grid data.
|
GumbelDistribution |
This class implements the Gumbel distribution.
|
HaltonSequenceGenerator |
Implementation of a Halton sequence.
|
HarmonicOscillator |
|
HarmonicOscillator.Parametric |
Parametric function where the input array contains the parameters of
the harmonic oscillator function, ordered as follows:
Amplitude
Angular frequency
Phase
|
HermiteInterpolator |
Polynomial interpolator using both sample values and sample derivatives.
|
HermiteRuleFactory |
|
HessenbergTransformer |
Class transforming a general real matrix to Hessenberg form.
|
HypergeometricDistribution |
Implementation of the hypergeometric distribution.
|
Identity |
Identity function.
|
IllinoisSolver |
Implements the Illinois method for root-finding (approximating
a zero of a univariate real function).
|
Incrementor |
Utility that increments a counter until a maximum is reached, at
which point, the instance will by default throw a
MathIllegalStateException .
|
Incrementor.MaxCountExceededCallback |
Defines a method to be called at counter exhaustion.
|
IntegerDistribution |
Interface for discrete distributions.
|
InterpolatingMicrosphere |
|
InterpolatingMicrosphere2D |
|
Inverse |
Inverse function.
|
ISAACRandom |
A fast cryptographic pseudo-random number generator.
|
IterationEvent |
The root class from which all events occurring while running an
IterationManager should be derived.
|
IterationListener |
The listener interface for receiving events occurring in an iterative
algorithm.
|
IterationManager |
This abstract class provides a general framework for managing iterative
algorithms.
|
IterativeLegendreFieldGaussIntegrator<T extends CalculusFieldElement<T>> |
This algorithm divides the integration interval into equally-sized
sub-interval and on each of them performs a
Legendre-Gauss quadrature.
|
IterativeLegendreGaussIntegrator |
This algorithm divides the integration interval into equally-sized
sub-interval and on each of them performs a
Legendre-Gauss quadrature.
|
IterativeLinearSolver |
This abstract class defines an iterative solver for the linear system A
· x = b.
|
IterativeLinearSolverEvent |
|
JacobianFunction |
Class representing the Jacobian of a multivariate vector function.
|
JacobiElliptic |
Algorithm computing Jacobi elliptic functions.
|
JacobiEllipticBuilder |
Builder for algorithms compmuting Jacobi elliptic functions.
|
JacobiKey |
Class for handling Jacobi polynomials keys.
|
JacobiPreconditioner |
This class implements the standard Jacobi (diagonal) preconditioner.
|
JacobiTheta |
Algorithm computing Jacobi theta functions.
|
JDKRandomGenerator |
|
JulierUnscentedTransform |
Unscented transform as defined by Julier and Uhlmann.
|
KthSelector |
A Simple Kth selector implementation to pick up the
Kth ordered element from a work array containing the
input numbers.
|
LaguerreRuleFactory |
Factory that creates Gauss-type quadrature rule using Laguerre polynomials.
|
LaguerreSolver |
|
LaplaceDistribution |
This class implements the Laplace distribution.
|
LegendreEllipticIntegral |
Complete and incomplete elliptic integrals in Legendre form.
|
LegendreRuleFactory |
Factory that creates Gauss-type quadrature rule using Legendre polynomials.
|
LevyDistribution |
|
LinearInterpolator |
Implements a linear function for interpolation of real univariate functions.
|
Localizable |
Interface for localizable strings.
|
LocalizedCoreFormats |
Enumeration for localized messages formats used in exceptions messages.
|
LocalizedException |
This interface specified methods implemented by localized exception classes.
|
LoessInterpolator |
|
Log |
Natural logarithm function.
|
Log10 |
Base 10 logarithm function.
|
Log1p |
log(1 + p) function.
|
Logistic |
|
Logistic.Parametric |
Parametric function where the input array contains the parameters of
the logistic function , ordered as follows:
k
m
b
q
a
n
|
LogisticDistribution |
This class implements the Logistic distribution.
|
Logit |
|
Logit.Parametric |
Parametric function where the input array contains the parameters of
the logit function, ordered as follows:
Lower bound
Higher bound
|
LogNormalDistribution |
Implementation of the log-normal (gaussian) distribution.
|
LUDecomposer |
Matrix decomposer using LU-decomposition.
|
LUDecomposition |
Calculates the LUP-decomposition of a square matrix.
|
MathArrays |
Arrays utilities.
|
MathArrays.Function |
Real-valued function that operates on an array or a part of it.
|
MathArrays.OrderDirection |
Specification of ordering direction.
|
MathArrays.Position |
Specification for indicating that some operation applies
before or after a given index.
|
MathIllegalArgumentException |
Base class for all preconditions violation exceptions.
|
MathIllegalStateException |
Base class for all exceptions that signal that the process
throwing the exception is in a state that does not comply with
the set of states that it is designed to be in.
|
MathRuntimeException |
All exceptions thrown by the Hipparchus code inherit from this class.
|
MathUtils |
Miscellaneous utility functions.
|
MathUtils.FieldSumAndResidual<T extends FieldElement<T>> |
|
MathUtils.SumAndResidual |
|
MatrixDecomposer |
Interface for all algorithms providing matrix decomposition.
|
MatrixUtils |
A collection of static methods that operate on or return matrices.
|
Max |
Maximum function.
|
MersenneTwister |
This class implements a powerful pseudo-random number generator
developed by Makoto Matsumoto and Takuji Nishimura during
1996-1997.
|
MerweUnscentedTransform |
Unscented transform as defined by Merwe and Wan.
|
MicrosphereProjectionInterpolator |
Interpolator that implements the algorithm described in
William Dudziak's
MS thesis.
|
MidPointIntegrator |
Implements the
Midpoint Rule for integration of real univariate functions.
|
Min |
Minimum function.
|
Minus |
Minus function.
|
MixtureMultivariateNormalDistribution |
Multivariate normal mixture distribution.
|
MixtureMultivariateRealDistribution<T extends MultivariateRealDistribution> |
|
MullerSolver |
This class implements the
Muller's Method for root finding of real univariate functions.
|
MullerSolver2 |
This class implements the
Muller's Method for root finding of real univariate functions.
|
MultidimensionalCounter |
Converter between unidimensional storage structure and multidimensional
conceptual structure.
|
Multiply |
Multiply the two operands.
|
MultivariateDifferentiableFunction |
|
MultivariateDifferentiableVectorFunction |
|
MultivariateFunction |
An interface representing a multivariate real function.
|
MultivariateInterpolator |
Interface representing a univariate real interpolating function.
|
MultivariateMatrixFunction |
An interface representing a multivariate matrix function.
|
MultivariateNormalDistribution |
Implementation of the multivariate normal (Gaussian) distribution.
|
MultivariateRealDistribution |
Base interface for multivariate continuous distributions.
|
MultivariateVectorFunction |
An interface representing a multivariate vectorial function.
|
NakagamiDistribution |
This class implements the Nakagami distribution.
|
NevilleInterpolator |
|
NewtonRaphsonSolver |
Implements
Newton's Method for finding zeros of real univariate differentiable
functions.
|
NormalDistribution |
Implementation of the normal (gaussian) distribution.
|
NormalizedRandomGenerator |
This interface represent a normalized random generator for
scalars.
|
NullArgumentException |
All conditions checks that fail due to a null argument must throw
this exception.
|
OpenIntToDoubleHashMap |
Open addressed map from int to double.
|
OpenIntToFieldHashMap<T extends FieldElement<T>> |
Open addressed map from int to FieldElement.
|
OpenMapRealMatrix |
Sparse matrix implementation based on an open addressed map.
|
OpenMapRealVector |
|
OrderedComplexEigenDecomposition |
Given a matrix A, it computes a complex eigen decomposition A = VDV^{T}.
|
Pair<K,V> |
Generic pair.
|
ParametricUnivariateFunction |
An interface representing a real function that depends on one independent
variable plus some extra parameters.
|
ParetoDistribution |
Implementation of the Pareto distribution.
|
PascalDistribution |
Implementation of the Pascal distribution.
|
PegasusSolver |
Implements the Pegasus method for root-finding (approximating
a zero of a univariate real function).
|
PiecewiseBicubicSplineInterpolatingFunction |
|
PiecewiseBicubicSplineInterpolator |
Generates a piecewise-bicubic interpolating function.
|
PivotingStrategy |
A strategy to pick a pivoting index of an array for doing partitioning.
|
PoissonDistribution |
Implementation of the Poisson distribution.
|
PolynomialFunction |
Immutable representation of a real polynomial function with real coefficients.
|
PolynomialFunction.Parametric |
Dedicated parametric polynomial class.
|
PolynomialFunctionLagrangeForm |
Implements the representation of a real polynomial function in
Lagrange Form.
|
PolynomialFunctionNewtonForm |
Implements the representation of a real polynomial function in
Newton Form.
|
PolynomialSolver |
Interface for (polynomial) root-finding algorithms.
|
PolynomialSplineFunction |
Represents a polynomial spline function.
|
PolynomialsUtils |
A collection of static methods that operate on or return polynomials.
|
Pow |
Power function.
|
Power |
Power function.
|
Precision |
Utilities for comparing numbers.
|
PreconditionedIterativeLinearSolver |
This abstract class defines preconditioned iterative solvers.
|
ProperBigFractionFormat |
Formats a BigFraction number in proper format.
|
ProperFractionFormat |
Formats a Fraction number in proper format.
|
QRDecomposer |
Matrix decomposer using QR-decomposition.
|
QRDecomposition |
Calculates the QR-decomposition of a matrix.
|
Quaternion |
This class implements
quaternions (Hamilton's hypercomplex numbers).
|
RandomAdaptor |
|
RandomDataGenerator |
A class for generating random data.
|
RandomGenerator |
Interface for generators of random number sequences.
|
RandomVectorGenerator |
This interface represents a random generator for whole vectors.
|
RealDistribution |
Base interface for continuous distributions.
|
RealLinearOperator |
This class defines a linear operator operating on real (double )
vector spaces.
|
RealMatrix |
Interface defining a real-valued matrix with basic algebraic operations.
|
RealMatrixChangingVisitor |
Interface defining a visitor for matrix entries.
|
RealMatrixFormat |
Formats a nxm matrix in components list format
"{{a00,a01, ...,
a0m-1},{a10,
a11, ..., a1m-1},{...},{
an-10, an-11, ...,
an-1m-1}}".
|
RealMatrixPreservingVisitor |
Interface defining a visitor for matrix entries.
|
RealVector |
Class defining a real-valued vector with basic algebraic operations.
|
RealVectorChangingVisitor |
This interface defines a visitor for the entries of a vector.
|
RealVectorFormat |
Formats a vector in components list format "{v0; v1; ...; vk-1}".
|
RealVectorPreservingVisitor |
This interface defines a visitor for the entries of a vector.
|
RectangularCholeskyDecomposition |
Calculates the rectangular Cholesky decomposition of a matrix.
|
RegulaFalsiSolver |
Implements the Regula Falsi or False position method for
root-finding (approximating a zero of a univariate real function).
|
ResizableDoubleArray |
A variable length primitive double array implementation that automatically
handles expanding and contracting its internal storage array as elements
are added and removed.
|
ResizableDoubleArray.ExpansionMode |
Specification of expansion algorithm.
|
RiccatiEquationSolver |
An algebraic Riccati equation is a type of nonlinear equation that arises in
the context of infinite-horizon optimal control problems in continuous time
or discrete time.
|
RiccatiEquationSolverImpl |
This solver computes the solution using the following approach:
1.
|
RiddersSolver |
Implements the
Ridders' Method for root finding of real univariate functions.
|
Rint |
rint function.
|
RombergIntegrator |
|
RootsOfUnity |
A helper class for the computation and caching of the n -th roots
of unity.
|
RosenNumberPartitionIterator |
An iterator that generates all partitions of n elements, into k parts
containing the number of elements in each part, based on Rosen's algorithm.
|
RRQRDecomposition |
Calculates the rank-revealing QR-decomposition of a matrix, with column pivoting.
|
RuleFactory |
Interface for rules that determines the integration nodes and their weights.
|
RyuDouble |
An implementation of Ryū for double.
|
SchurTransformer |
Class transforming a general real matrix to Schur form.
|
SecantSolver |
Implements the Secant method for root-finding (approximating a
zero of a univariate real function).
|
SemiDefinitePositiveCholeskyDecomposition |
Calculates the Cholesky decomposition of a positive semidefinite matrix.
|
Sigmoid |
|
Sigmoid.Parametric |
Parametric function where the input array contains the parameters of
the sigmoid function , ordered
as follows:
Lower asymptote
Higher asymptote
|
SimpsonIntegrator |
Implements
Simpson's Rule for integration of real univariate functions.
|
Sin |
Sine function.
|
Sinc |
Sinc function,
defined by
|
SinCos |
Holder for both sine and cosine values.
|
SingularValueDecomposer |
Matrix decomposer using Singular Value Decomposition.
|
SingularValueDecomposition |
Calculates the compact Singular Value Decomposition of a matrix.
|
Sinh |
Hyperbolic sine function.
|
SinhCosh |
Holder for both hyperbolic sine and hyperbolic cosine values.
|
SmoothStepFactory |
Smoothstep function factory.
|
SmoothStepFactory.FieldSmoothStepFunction<T extends CalculusFieldElement<T>> |
Smoothstep function as defined here.
|
SmoothStepFactory.QuadraticSmoothStepFunction |
|
SmoothStepFactory.SmoothStepFunction |
Smoothstep function as defined here.
|
SobolSequenceGenerator |
Implementation of a Sobol sequence.
|
SparseFieldMatrix<T extends FieldElement<T>> |
Sparse matrix implementation based on an open addressed map.
|
SparseFieldVector<T extends FieldElement<T>> |
|
SparseGradient |
First derivative computation with large number of variables.
|
SparseRealMatrix |
Marker interface for RealMatrix implementations that require sparse backing storage
|
SparseRealVector |
Marker class for RealVectors that require sparse backing storage
|
SplineInterpolator |
Computes a natural (also known as "free", "unclamped") cubic spline interpolation for the data set.
|
Sqrt |
Square-root function.
|
StableRandomGenerator |
This class provides a stable normalized random generator.
|
StepFunction |
|
Subtract |
Subtract the second operand from the first.
|
SymmetricFieldGaussIntegrator<T extends CalculusFieldElement<T>> |
This class's implements integrate
method assuming that the integral is symmetric about 0.
|
SymmetricGaussIntegrator |
This class's implements integrate
method assuming that the integral is symmetric about 0.
|
SymmLQ |
|
SynchronizedRandomGenerator |
Any RandomGenerator implementation can be thread-safe if it
is used through an instance of this class.
|
Tan |
Tangent function.
|
Tanh |
Hyperbolic tangent function.
|
TaylorMap |
Container for a Taylor map.
|
TDistribution |
Implementation of Student's t-distribution.
|
Theta |
|
TrapezoidIntegrator |
Implements the
Trapezoid Rule for integration of real univariate functions.
|
TriangularDistribution |
Implementation of the triangular real distribution.
|
TricubicInterpolatingFunction |
|
TricubicInterpolator |
Generates a tricubic interpolating function.
|
TrivariateFunction |
An interface representing a trivariate real function.
|
TrivariateGridInterpolator |
Interface representing a trivariate real interpolating function where the
sample points must be specified on a regular grid.
|
Tuple |
This class allows to perform the same computation of all components of a Tuple at once.
|
Ulp |
ulp function.
|
UncorrelatedRandomVectorGenerator |
|
UniformIntegerDistribution |
Implementation of the uniform integer distribution.
|
UniformRandomGenerator |
This class implements a normalized uniform random generator.
|
UniformRealDistribution |
Implementation of the uniform real distribution.
|
UnitSphereRandomVectorGenerator |
Generate random vectors isotropically located on the surface of a sphere.
|
UnivariateDerivative<T extends UnivariateDerivative<T>> |
Abstract class representing both the value and the differentials of a function.
|
UnivariateDerivative1 |
Class representing both the value and the differentials of a function.
|
UnivariateDerivative1Field |
|
UnivariateDerivative2 |
Class representing both the value and the differentials of a function.
|
UnivariateDerivative2Field |
|
UnivariateDifferentiableFunction |
Interface for univariate functions derivatives.
|
UnivariateDifferentiableMatrixFunction |
|
UnivariateDifferentiableSolver |
Interface for (univariate real) rootfinding algorithms.
|
UnivariateDifferentiableVectorFunction |
|
UnivariateFunction |
An interface representing a univariate real function.
|
UnivariateFunctionDifferentiator |
Interface defining the function differentiation operation.
|
UnivariateIntegrator |
Interface for univariate real integration algorithms.
|
UnivariateInterpolator |
Interface representing a univariate real interpolating function.
|
UnivariateMatrixFunction |
An interface representing a univariate matrix function.
|
UnivariateMatrixFunctionDifferentiator |
Interface defining the function differentiation operation.
|
UnivariatePeriodicInterpolator |
|
UnivariateSolver |
Interface for (univariate real) root-finding algorithms.
|
UnivariateSolverUtils |
|
UnivariateVectorFunction |
An interface representing a univariate vectorial function.
|
UnivariateVectorFunctionDifferentiator |
Interface defining the function differentiation operation.
|
UnscentedTransformProvider |
Provider for unscented transform.
|
UTF8Control |
Control class loading properties in UTF-8 encoding.
|
WeibullDistribution |
Implementation of the Weibull distribution.
|
Well1024a |
This class implements the WELL1024a pseudo-random number generator
from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
|
Well19937a |
This class implements the WELL19937a pseudo-random number generator
from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
|
Well19937c |
This class implements the WELL19937c pseudo-random number generator
from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
|
Well44497a |
This class implements the WELL44497a pseudo-random number generator
from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
|
Well44497b |
This class implements the WELL44497b pseudo-random number generator
from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
|
Well512a |
This class implements the WELL512a pseudo-random number generator
from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
|
ZipfDistribution |
Implementation of the Zipf distribution.
|