Serialized Form
-
Package org.apache.commons.math3.analysis.differentiation
-
Class org.apache.commons.math3.analysis.differentiation.DerivativeStructure extends Object implements Serializable
- serialVersionUID:
- 20120730L
-
Serialization Methods
-
writeReplace
private Object writeReplace()
Replace the instance with a data transfer object for serialization.
-
-
Serialized Fields
-
data
double[] data
Combined array holding all values.
-
-
Class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator extends Object implements Serializable
- serialVersionUID:
- 20120917L
-
Serialized Fields
-
halfSampleSpan
double halfSampleSpan
Half sample span. -
nbPoints
int nbPoints
Number of points to use. -
stepSize
double stepSize
Step size. -
tMax
double tMax
Upper bound for independent variable. -
tMin
double tMin
Lower bound for independent variable.
-
-
Class org.apache.commons.math3.analysis.differentiation.SparseGradient extends Object implements Serializable
- serialVersionUID:
- 20131025L
-
-
Package org.apache.commons.math3.analysis.interpolation
-
Class org.apache.commons.math3.analysis.interpolation.DividedDifferenceInterpolator extends Object implements Serializable
- serialVersionUID:
- 107049519551235069L
-
Class org.apache.commons.math3.analysis.interpolation.LoessInterpolator extends Object implements Serializable
- serialVersionUID:
- 5204927143605193821L
-
Serialized Fields
-
accuracy
double accuracy
If the median residual at a certain robustness iteration is less than this amount, no more iterations are done. -
bandwidth
double bandwidth
The bandwidth parameter: when computing the loess fit at a particular point, this fraction of source points closest to the current point is taken into account for computing a least-squares regression.A sensible value is usually 0.25 to 0.5.
-
robustnessIters
int robustnessIters
The number of robustness iterations parameter: this many robustness iterations are done.A sensible value is usually 0 (just the initial fit without any robustness iterations) to 4.
-
-
Class org.apache.commons.math3.analysis.interpolation.NevilleInterpolator extends Object implements Serializable
- serialVersionUID:
- 3003707660147873733L
-
-
Package org.apache.commons.math3.analysis.polynomials
-
Class org.apache.commons.math3.analysis.polynomials.PolynomialFunction extends Object implements Serializable
- serialVersionUID:
- -7726511984200295583L
-
Serialized Fields
-
coefficients
double[] coefficients
The coefficients of the polynomial, ordered by degree -- i.e., coefficients[0] is the constant term and coefficients[n] is the coefficient of x^n where n is the degree of the polynomial.
-
-
-
Package org.apache.commons.math3.complex
-
Class org.apache.commons.math3.complex.Complex extends Object implements Serializable
- serialVersionUID:
- -6195664516687396620L
-
Serialization Methods
-
readResolve
protected final Object readResolve()
Resolve the transient fields in a deserialized Complex Object. Subclasses will need to overrideComplex.createComplex(double, double)
to deserialize properly.- Since:
- 2.0
-
-
Serialized Fields
-
imaginary
double imaginary
The imaginary part. -
real
double real
The real part.
-
-
Class org.apache.commons.math3.complex.ComplexField extends Object implements Serializable
- serialVersionUID:
- -6130362688700788798L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.apache.commons.math3.complex.Quaternion extends Object implements Serializable
- serialVersionUID:
- 20092012L
-
Serialized Fields
-
q0
double q0
First component (scalar part). -
q1
double q1
Second component (first vector part). -
q2
double q2
Third component (second vector part). -
q3
double q3
Fourth component (third vector part).
-
-
Class org.apache.commons.math3.complex.RootsOfUnity extends Object implements Serializable
- serialVersionUID:
- 20120201L
-
Serialized Fields
-
isCounterClockWise
boolean isCounterClockWise
true
ifRootsOfUnity.computeRoots(int)
was called with a positive value of its argumentn
. In this case, counter-clockwise ordering of the roots of unity should be used. -
omegaCount
int omegaCount
Number of roots of unity. -
omegaImaginaryClockwise
double[] omegaImaginaryClockwise
Imaginary part of then
-th roots of unity, for negative values ofn
. In this array, the roots are stored in clockwise order. -
omegaImaginaryCounterClockwise
double[] omegaImaginaryCounterClockwise
Imaginary part of then
-th roots of unity, for positive values ofn
. In this array, the roots are stored in counter-clockwise order. -
omegaReal
double[] omegaReal
Real part of the roots.
-
-
-
Package org.apache.commons.math3.distribution
-
Class org.apache.commons.math3.distribution.AbstractIntegerDistribution extends Object implements Serializable
- serialVersionUID:
- -1146319659338487221L
-
Serialized Fields
-
random
RandomGenerator random
RNG instance used to generate samples from the distribution.- Since:
- 3.1
-
randomData
RandomDataImpl randomData
Deprecated.As of 3.1, to be removed in 4.0. Please use theAbstractIntegerDistribution.random
instance variable instead.RandomData instance used to generate samples from the distribution.
-
-
Class org.apache.commons.math3.distribution.AbstractRealDistribution extends Object implements Serializable
- serialVersionUID:
- -38038050983108802L
-
Serialized Fields
-
random
RandomGenerator random
RNG instance used to generate samples from the distribution.- Since:
- 3.1
-
randomData
RandomDataImpl randomData
Deprecated.As of 3.1, to be removed in 4.0. Please use theAbstractRealDistribution.random
instance variable instead.RandomData instance used to generate samples from the distribution. -
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Solver absolute accuracy for inverse cumulative computation
-
-
Class org.apache.commons.math3.distribution.BetaDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- -1221965979403477668L
-
Serialized Fields
-
alpha
double alpha
First shape parameter. -
beta
double beta
Second shape parameter. -
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy. -
z
double z
Normalizing factor used in density computations. updated whenever alpha or beta are changed.
-
-
Class org.apache.commons.math3.distribution.BinomialDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- 6751309484392813623L
-
Serialized Fields
-
numberOfTrials
int numberOfTrials
The number of trials. -
probabilityOfSuccess
double probabilityOfSuccess
The probability of success.
-
-
Class org.apache.commons.math3.distribution.CauchyDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 8589540077390120676L
-
Serialized Fields
-
median
double median
The median of this distribution. -
scale
double scale
The scale of this distribution. -
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy
-
-
Class org.apache.commons.math3.distribution.ChiSquaredDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- -8352658048349159782L
-
Serialized Fields
-
gamma
GammaDistribution gamma
Internal Gamma distribution. -
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy
-
-
Class org.apache.commons.math3.distribution.ConstantRealDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- -4157745166772046273L
-
Serialized Fields
-
value
double value
Constant value of the distribution
-
-
Class org.apache.commons.math3.distribution.EnumeratedDistribution extends Object implements Serializable
- serialVersionUID:
- 20123308L
-
Serialized Fields
-
cumulativeProbabilities
double[] cumulativeProbabilities
Cumulative probabilities, cached to speed up sampling. -
probabilities
double[] probabilities
Probabilities of respective random variable values. For i = 0, ..., singletons.size() - 1, probability[i] is the probability that a random variable following this distribution takes the value singletons[i]. -
random
RandomGenerator random
RNG instance used to generate samples from the distribution. -
singletons
List<T> singletons
List of random variable values.
-
-
Class org.apache.commons.math3.distribution.EnumeratedIntegerDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- 20130308L
-
Serialized Fields
-
innerDistribution
EnumeratedDistribution<Integer> innerDistribution
EnumeratedDistribution
instance (using theInteger
wrapper) used to generate the pmf.
-
-
Class org.apache.commons.math3.distribution.EnumeratedRealDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20130308L
-
Serialized Fields
-
innerDistribution
EnumeratedDistribution<Double> innerDistribution
EnumeratedDistribution
(using theDouble
wrapper) used to generate the pmf.
-
-
Class org.apache.commons.math3.distribution.ExponentialDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 2401296428283614780L
-
Serialized Fields
-
logMean
double logMean
The logarithm of the mean, stored to reduce computing time. -
mean
double mean
The mean of this distribution. -
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy.
-
-
Class org.apache.commons.math3.distribution.FDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- -8516354193418641566L
-
Serialized Fields
-
denominatorDegreesOfFreedom
double denominatorDegreesOfFreedom
The numerator degrees of freedom. -
numeratorDegreesOfFreedom
double numeratorDegreesOfFreedom
The numerator degrees of freedom. -
numericalVariance
double numericalVariance
Cached numerical variance -
numericalVarianceIsCalculated
boolean numericalVarianceIsCalculated
Whether or not the numerical variance has been calculated -
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy.
-
-
Class org.apache.commons.math3.distribution.GammaDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20120524L
-
Serialized Fields
-
densityPrefactor1
double densityPrefactor1
The constant value ofshape / scale * sqrt(e / (2 * pi * (shape + g + 0.5))) / L(shape)
, whereL(shape)
is the Lanczos approximation returned byGamma.lanczos(double)
. This prefactor is used inGammaDistribution.density(double)
, when no overflow occurs with the natural calculation. -
densityPrefactor2
double densityPrefactor2
The constant value ofshape * sqrt(e / (2 * pi * (shape + g + 0.5))) / L(shape)
, whereL(shape)
is the Lanczos approximation returned byGamma.lanczos(double)
. This prefactor is used inGammaDistribution.density(double)
, when overflow occurs with the natural calculation. -
logDensityPrefactor1
double logDensityPrefactor1
The constant value oflog(shape / scale * sqrt(e / (2 * pi * (shape + g + 0.5))) / L(shape))
, whereL(shape)
is the Lanczos approximation returned byGamma.lanczos(double)
. This prefactor is used inGammaDistribution.logDensity(double)
, when no overflow occurs with the natural calculation. -
logDensityPrefactor2
double logDensityPrefactor2
The constant value oflog(shape * sqrt(e / (2 * pi * (shape + g + 0.5))) / L(shape))
, whereL(shape)
is the Lanczos approximation returned byGamma.lanczos(double)
. This prefactor is used inGammaDistribution.logDensity(double)
, when overflow occurs with the natural calculation. -
maxLogY
double maxLogY
Upper bound onlog(y)
(y = x / scale
) for the selection of the computation method inGammaDistribution.density(double)
. Forlog(y) >= maxLogY
, the natural calculation overflows. -
minY
double minY
Lower bound ony = x / scale
for the selection of the computation method inGammaDistribution.density(double)
. Fory <= minY
, the natural calculation overflows. -
scale
double scale
The scale parameter. -
shape
double shape
The shape parameter. -
shiftedShape
double shiftedShape
-
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy.
-
-
Class org.apache.commons.math3.distribution.GeometricDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- 20130507L
-
Serialized Fields
-
log1mProbabilityOfSuccess
double log1mProbabilityOfSuccess
log(1 - p)
where p is the probability of success. -
logProbabilityOfSuccess
double logProbabilityOfSuccess
log(p)
where p is the probability of success. -
probabilityOfSuccess
double probabilityOfSuccess
The probability of success.
-
-
Class org.apache.commons.math3.distribution.GumbelDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20141003L
-
Serialized Fields
-
beta
double beta
The scale parameter. -
mu
double mu
The location parameter.
-
-
Class org.apache.commons.math3.distribution.HypergeometricDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- -436928820673516179L
-
Serialized Fields
-
numberOfSuccesses
int numberOfSuccesses
The number of successes in the population. -
numericalVariance
double numericalVariance
Cached numerical variance -
numericalVarianceIsCalculated
boolean numericalVarianceIsCalculated
Whether or not the numerical variance has been calculated -
populationSize
int populationSize
The population size. -
sampleSize
int sampleSize
The sample size.
-
-
Class org.apache.commons.math3.distribution.KolmogorovSmirnovDistribution extends Object implements Serializable
- serialVersionUID:
- -4670676796862967187L
-
Serialized Fields
-
n
int n
Deprecated.Number of observations.
-
-
Class org.apache.commons.math3.distribution.LaplaceDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20141003L
-
Serialized Fields
-
beta
double beta
The scale parameter. -
mu
double mu
The location parameter.
-
-
Class org.apache.commons.math3.distribution.LevyDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20130314L
-
Serialized Fields
-
c
double c
Scale parameter. -
halfC
double halfC
Half of c (for calculations). -
mu
double mu
Location parameter.
-
-
Class org.apache.commons.math3.distribution.LogisticDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20141003L
-
Serialized Fields
-
mu
double mu
The location parameter. -
s
double s
The scale parameter.
-
-
Class org.apache.commons.math3.distribution.LogNormalDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20120112L
-
Serialized Fields
-
logShapePlusHalfLog2Pi
double logShapePlusHalfLog2Pi
The value oflog(shape) + 0.5 * log(2*PI)
stored for faster computation. -
scale
double scale
The scale parameter of this distribution. -
shape
double shape
The shape parameter of this distribution. -
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy.
-
-
Class org.apache.commons.math3.distribution.NakagamiDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20141003L
-
Serialized Fields
-
inverseAbsoluteAccuracy
double inverseAbsoluteAccuracy
Inverse cumulative probability accuracy. -
mu
double mu
The shape parameter. -
omega
double omega
The scale parameter.
-
-
Class org.apache.commons.math3.distribution.NormalDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 8589540077390120676L
-
Serialized Fields
-
logStandardDeviationPlusHalfLog2Pi
double logStandardDeviationPlusHalfLog2Pi
The value oflog(sd) + 0.5*log(2*pi)
stored for faster computation. -
mean
double mean
Mean of this distribution. -
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy. -
standardDeviation
double standardDeviation
Standard deviation of this distribution.
-
-
Class org.apache.commons.math3.distribution.ParetoDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20130424L
-
Serialized Fields
-
scale
double scale
The scale parameter of this distribution. -
shape
double shape
The shape parameter of this distribution. -
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy.
-
-
Class org.apache.commons.math3.distribution.PascalDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- 6751309484392813623L
-
Serialized Fields
-
log1mProbabilityOfSuccess
double log1mProbabilityOfSuccess
The value oflog(1-p)
, wherep
is the probability of success, stored for faster computation. -
logProbabilityOfSuccess
double logProbabilityOfSuccess
The value oflog(p)
, wherep
is the probability of success, stored for faster computation. -
numberOfSuccesses
int numberOfSuccesses
The number of successes. -
probabilityOfSuccess
double probabilityOfSuccess
The probability of success.
-
-
Class org.apache.commons.math3.distribution.PoissonDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- -3349935121172596109L
-
Serialized Fields
-
epsilon
double epsilon
Convergence criterion for cumulative probability. -
exponential
ExponentialDistribution exponential
Distribution needed for thePoissonDistribution.sample()
method. -
maxIterations
int maxIterations
Maximum number of iterations for cumulative probability. Cumulative probabilities are estimated using either Lanczos series approximation ofGamma.regularizedGammaP(double, double, double, int)
or continued fraction approximation ofGamma.regularizedGammaQ(double, double, double, int)
. -
mean
double mean
Mean of the distribution. -
normal
NormalDistribution normal
Distribution used to compute normal approximation.
-
-
Class org.apache.commons.math3.distribution.TDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- -5852615386664158222L
-
Serialized Fields
-
degreesOfFreedom
double degreesOfFreedom
The degrees of freedom. -
factor
double factor
Static computation factor based on degreesOfFreedom. -
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy.
-
-
Class org.apache.commons.math3.distribution.TriangularDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20120112L
-
Serialized Fields
-
a
double a
Lower limit of this distribution (inclusive). -
b
double b
Upper limit of this distribution (inclusive). -
c
double c
Mode of this distribution. -
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy.
-
-
Class org.apache.commons.math3.distribution.UniformIntegerDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- 20120109L
-
Serialized Fields
-
lower
int lower
Lower bound (inclusive) of this distribution. -
upper
int upper
Upper bound (inclusive) of this distribution.
-
-
Class org.apache.commons.math3.distribution.UniformRealDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20120109L
-
Serialized Fields
-
lower
double lower
Lower bound of this distribution (inclusive). -
upper
double upper
Upper bound of this distribution (exclusive).
-
-
Class org.apache.commons.math3.distribution.WeibullDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 8589540077390120676L
-
Serialized Fields
-
numericalMean
double numericalMean
Cached numerical mean -
numericalMeanIsCalculated
boolean numericalMeanIsCalculated
Whether or not the numerical mean has been calculated -
numericalVariance
double numericalVariance
Cached numerical variance -
numericalVarianceIsCalculated
boolean numericalVarianceIsCalculated
Whether or not the numerical variance has been calculated -
scale
double scale
The scale parameter. -
shape
double shape
The shape parameter. -
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy.
-
-
Class org.apache.commons.math3.distribution.ZipfDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- -140627372283420404L
-
Serialized Fields
-
exponent
double exponent
Exponent parameter of the distribution. -
numberOfElements
int numberOfElements
Number of elements. -
numericalMean
double numericalMean
Cached numerical mean -
numericalMeanIsCalculated
boolean numericalMeanIsCalculated
Whether or not the numerical mean has been calculated -
numericalVariance
double numericalVariance
Cached numerical variance -
numericalVarianceIsCalculated
boolean numericalVarianceIsCalculated
Whether or not the numerical variance has been calculated
-
-
-
Package org.apache.commons.math3.exception
-
Class org.apache.commons.math3.exception.ConvergenceException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- 4330003017885151975L
-
Class org.apache.commons.math3.exception.DimensionMismatchException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- -8415396756375798143L
-
Serialized Fields
-
dimension
int dimension
Correct dimension.
-
-
Class org.apache.commons.math3.exception.InsufficientDataException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -2629324471511903359L
-
Class org.apache.commons.math3.exception.MathArithmeticException extends ArithmeticException implements Serializable
- serialVersionUID:
- -6024911025449780478L
-
Serialized Fields
-
context
ExceptionContext context
Context.
-
-
Class org.apache.commons.math3.exception.MathIllegalArgumentException extends IllegalArgumentException implements Serializable
- serialVersionUID:
- -6024911025449780478L
-
Serialized Fields
-
context
ExceptionContext context
Context.
-
-
Class org.apache.commons.math3.exception.MathIllegalNumberException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -7447085893598031110L
-
Serialized Fields
-
argument
Number argument
Requested.
-
-
Class org.apache.commons.math3.exception.MathIllegalStateException extends IllegalStateException implements Serializable
- serialVersionUID:
- -6024911025449780478L
-
Serialized Fields
-
context
ExceptionContext context
Context.
-
-
Class org.apache.commons.math3.exception.MathInternalError extends MathIllegalStateException implements Serializable
- serialVersionUID:
- -6276776513966934846L
-
Class org.apache.commons.math3.exception.MathParseException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- -6024911025449780478L
-
Class org.apache.commons.math3.exception.MathRuntimeException extends RuntimeException implements Serializable
- serialVersionUID:
- 20120926L
-
Serialized Fields
-
context
ExceptionContext context
Context.
-
-
Class org.apache.commons.math3.exception.MathUnsupportedOperationException extends UnsupportedOperationException implements Serializable
- serialVersionUID:
- -6024911025449780478L
-
Serialized Fields
-
context
ExceptionContext context
Context.
-
-
Class org.apache.commons.math3.exception.MaxCountExceededException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- 4330003017885151975L
-
Serialized Fields
-
max
Number max
Maximum number of evaluations.
-
-
Class org.apache.commons.math3.exception.MultiDimensionMismatchException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -8415396756375798143L
-
Class org.apache.commons.math3.exception.NoBracketingException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -3629324471511904459L
-
Serialized Fields
-
fHi
double fHi
Value at higher end of the interval. -
fLo
double fLo
Value at lower end of the interval. -
hi
double hi
Higher end of the interval. -
lo
double lo
Lower end of the interval.
-
-
Class org.apache.commons.math3.exception.NoDataException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -3629324471511904459L
-
Class org.apache.commons.math3.exception.NonMonotonicSequenceException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- 3596849179428944575L
-
Serialized Fields
-
direction
MathArrays.OrderDirection direction
Direction (positive for increasing, negative for decreasing). -
index
int index
Index of the wrong value. -
previous
Number previous
Previous value. -
strict
boolean strict
Whether the sequence must be strictly increasing or decreasing.
-
-
Class org.apache.commons.math3.exception.NotANumberException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- 20120906L
-
Class org.apache.commons.math3.exception.NotFiniteNumberException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- -6100997100383932834L
-
Class org.apache.commons.math3.exception.NotPositiveException extends NumberIsTooSmallException implements Serializable
- serialVersionUID:
- -2250556892093726375L
-
Class org.apache.commons.math3.exception.NotStrictlyPositiveException extends NumberIsTooSmallException implements Serializable
- serialVersionUID:
- -7824848630829852237L
-
Class org.apache.commons.math3.exception.NullArgumentException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -6024911025449780478L
-
Class org.apache.commons.math3.exception.NumberIsTooLargeException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- 4330003017885151975L
-
Serialized Fields
-
boundIsAllowed
boolean boundIsAllowed
Whether the maximum is included in the allowed range. -
max
Number max
Higher bound.
-
-
Class org.apache.commons.math3.exception.NumberIsTooSmallException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- -6100997100383932834L
-
Serialized Fields
-
boundIsAllowed
boolean boundIsAllowed
Whether the maximum is included in the allowed range. -
min
Number min
Higher bound.
-
-
Class org.apache.commons.math3.exception.OutOfRangeException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- 111601815794403609L
-
Class org.apache.commons.math3.exception.TooManyEvaluationsException extends MaxCountExceededException implements Serializable
- serialVersionUID:
- 4330003017885151975L
-
Class org.apache.commons.math3.exception.TooManyIterationsException extends MaxCountExceededException implements Serializable
- serialVersionUID:
- 20121211L
-
Class org.apache.commons.math3.exception.ZeroException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- -1960874856936000015L
-
-
Package org.apache.commons.math3.exception.util
-
Class org.apache.commons.math3.exception.util.DummyLocalizable extends Object implements Serializable
- serialVersionUID:
- 8843275624471387299L
-
Serialized Fields
-
source
String source
Source string.
-
-
Class org.apache.commons.math3.exception.util.ExceptionContext extends Object implements Serializable
- serialVersionUID:
- -6024911025449780478L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream in) throws IOException, ClassNotFoundException
Deserialize this object from the given stream.- Throws:
IOException
- This should never happen.ClassNotFoundException
- This should never happen.
-
writeObject
private void writeObject(ObjectOutputStream out) throws IOException
Serialize this object to the given stream.- Throws:
IOException
- This should never happen.
-
-
Serialized Fields
-
context
Map<String,Object> context
Arbitrary context information. -
msgArguments
List<Object[]> msgArguments
Various informations that enrich the informative message. The arguments will replace the corresponding place-holders inExceptionContext.msgPatterns
. -
msgPatterns
List<Localizable> msgPatterns
Various informations that enrich the informative message. -
throwable
Throwable throwable
The throwable to which this context refers to.
-
-
-
Package org.apache.commons.math3.fitting
-
Class org.apache.commons.math3.fitting.WeightedObservedPoint extends Object implements Serializable
- serialVersionUID:
- 5306874947404636157L
-
Serialized Fields
-
weight
double weight
Weight of the measurement in the fitting process. -
x
double x
Abscissa of the point. -
y
double y
Observed value of the function at x.
-
-
Class org.apache.commons.math3.fitting.WeightedObservedPoints extends Object implements Serializable
- serialVersionUID:
- 20130813L
-
Serialized Fields
-
observations
List<WeightedObservedPoint> observations
Observed points.
-
-
-
Package org.apache.commons.math3.fraction
-
Class org.apache.commons.math3.fraction.AbstractFormat extends NumberFormat implements Serializable
- serialVersionUID:
- -6981118387974191891L
-
Serialized Fields
-
denominatorFormat
NumberFormat denominatorFormat
The format used for the denominator. -
numeratorFormat
NumberFormat numeratorFormat
The format used for the numerator.
-
-
Class org.apache.commons.math3.fraction.BigFraction extends Number implements Serializable
- serialVersionUID:
- -5630213147331578515L
-
Serialized Fields
-
denominator
BigInteger denominator
The denominator. -
numerator
BigInteger numerator
The numerator.
-
-
Class org.apache.commons.math3.fraction.BigFractionField extends Object implements Serializable
- serialVersionUID:
- -1699294557189741703L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.apache.commons.math3.fraction.BigFractionFormat extends AbstractFormat implements Serializable
- serialVersionUID:
- -2932167925527338976L
-
Class org.apache.commons.math3.fraction.Fraction extends Number implements Serializable
- serialVersionUID:
- 3698073679419233275L
-
Serialized Fields
-
denominator
int denominator
The denominator. -
numerator
int numerator
The numerator.
-
-
Class org.apache.commons.math3.fraction.FractionConversionException extends ConvergenceException implements Serializable
- serialVersionUID:
- -4661812640132576263L
-
Class org.apache.commons.math3.fraction.FractionField extends Object implements Serializable
- serialVersionUID:
- -1257768487499119313L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.apache.commons.math3.fraction.FractionFormat extends AbstractFormat implements Serializable
- serialVersionUID:
- 3008655719530972611L
-
Class org.apache.commons.math3.fraction.ProperBigFractionFormat extends BigFractionFormat implements Serializable
- serialVersionUID:
- -6337346779577272307L
-
Serialized Fields
-
wholeFormat
NumberFormat wholeFormat
The format used for the whole number.
-
-
Class org.apache.commons.math3.fraction.ProperFractionFormat extends FractionFormat implements Serializable
- serialVersionUID:
- 760934726031766749L
-
Serialized Fields
-
wholeFormat
NumberFormat wholeFormat
The format used for the whole number.
-
-
-
Package org.apache.commons.math3.genetics
-
Class org.apache.commons.math3.genetics.InvalidRepresentationException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 1L
-
-
Package org.apache.commons.math3.geometry
-
Package org.apache.commons.math3.geometry.enclosing
-
Class org.apache.commons.math3.geometry.enclosing.EnclosingBall extends Object implements Serializable
- serialVersionUID:
- 20140126L
-
-
Package org.apache.commons.math3.geometry.euclidean.oned
-
Class org.apache.commons.math3.geometry.euclidean.oned.Euclidean1D extends Object implements Serializable
- serialVersionUID:
- -1178039568877797126L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.apache.commons.math3.geometry.euclidean.oned.Euclidean1D.NoSubSpaceException extends MathUnsupportedOperationException implements Serializable
- serialVersionUID:
- 20140225L
-
Class org.apache.commons.math3.geometry.euclidean.oned.Vector1D extends Object implements Serializable
- serialVersionUID:
- 7556674948671647925L
-
Serialized Fields
-
x
double x
Abscissa.
-
-
-
Package org.apache.commons.math3.geometry.euclidean.threed
-
Class org.apache.commons.math3.geometry.euclidean.threed.CardanEulerSingularityException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- -1360952845582206770L
-
Class org.apache.commons.math3.geometry.euclidean.threed.Euclidean3D extends Object implements Serializable
- serialVersionUID:
- 6249091865814886817L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation extends Object implements Serializable
- serialVersionUID:
- 20130224L
-
Serialized Fields
-
q0
T extends RealFieldElement<T> q0
Scalar coordinate of the quaternion. -
q1
T extends RealFieldElement<T> q1
First coordinate of the vectorial part of the quaternion. -
q2
T extends RealFieldElement<T> q2
Second coordinate of the vectorial part of the quaternion. -
q3
T extends RealFieldElement<T> q3
Third coordinate of the vectorial part of the quaternion.
-
-
Class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D extends Object implements Serializable
- serialVersionUID:
- 20130224L
-
Serialized Fields
-
x
T extends RealFieldElement<T> x
Abscissa. -
y
T extends RealFieldElement<T> y
Ordinate. -
z
T extends RealFieldElement<T> z
Height.
-
-
Class org.apache.commons.math3.geometry.euclidean.threed.NotARotationMatrixException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 5647178478658937642L
-
Class org.apache.commons.math3.geometry.euclidean.threed.Rotation extends Object implements Serializable
- serialVersionUID:
- -2153622329907944313L
-
Serialized Fields
-
q0
double q0
Scalar coordinate of the quaternion. -
q1
double q1
First coordinate of the vectorial part of the quaternion. -
q2
double q2
Second coordinate of the vectorial part of the quaternion. -
q3
double q3
Third coordinate of the vectorial part of the quaternion.
-
-
Class org.apache.commons.math3.geometry.euclidean.threed.SphericalCoordinates extends Object implements Serializable
- serialVersionUID:
- 20130206L
-
Serialization Methods
-
writeReplace
private Object writeReplace()
Replace the instance with a data transfer object for serialization.
-
-
Serialized Fields
-
jacobian
double[][] jacobian
Jacobian of (r, θ &Phi). -
phi
double phi
Polar angle (co-latitude) Φ. -
phiHessian
double[][] phiHessian
Hessian of polar (co-latitude) angle Φ. -
r
double r
Radius. -
rHessian
double[][] rHessian
Hessian of radius. -
theta
double theta
Azimuthal angle in the x-y plane θ. -
thetaHessian
double[][] thetaHessian
Hessian of azimuthal angle in the x-y plane θ. -
v
Vector3D v
Cartesian coordinates.
-
-
Class org.apache.commons.math3.geometry.euclidean.threed.Vector3D extends Object implements Serializable
- serialVersionUID:
- 1313493323784566947L
-
Serialized Fields
-
x
double x
Abscissa. -
y
double y
Ordinate. -
z
double z
Height.
-
-
-
Package org.apache.commons.math3.geometry.euclidean.twod
-
Class org.apache.commons.math3.geometry.euclidean.twod.Euclidean2D extends Object implements Serializable
- serialVersionUID:
- 4793432849757649566L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.apache.commons.math3.geometry.euclidean.twod.Vector2D extends Object implements Serializable
- serialVersionUID:
- 266938651998679754L
-
Serialized Fields
-
x
double x
Abscissa. -
y
double y
Ordinate.
-
-
-
Package org.apache.commons.math3.geometry.euclidean.twod.hull
-
Class org.apache.commons.math3.geometry.euclidean.twod.hull.ConvexHull2D extends Object implements Serializable
- serialVersionUID:
- 20140129L
-
Serialized Fields
-
tolerance
double tolerance
Tolerance threshold used during creation of the hull vertices. -
vertices
Vector2D[] vertices
Vertices of the hull.
-
-
-
Package org.apache.commons.math3.geometry.hull
-
Package org.apache.commons.math3.geometry.spherical.oned
-
Class org.apache.commons.math3.geometry.spherical.oned.ArcsSet.InconsistentStateAt2PiWrapping extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 20140107L
-
Class org.apache.commons.math3.geometry.spherical.oned.S1Point extends Object implements Serializable
- serialVersionUID:
- 20131218L
-
Serialized Fields
-
alpha
double alpha
Azimuthal angle \( \alpha \). -
vector
Vector2D vector
Corresponding 2D normalized vector.
-
-
Class org.apache.commons.math3.geometry.spherical.oned.Sphere1D extends Object implements Serializable
- serialVersionUID:
- 20131218L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.apache.commons.math3.geometry.spherical.oned.Sphere1D.NoSubSpaceException extends MathUnsupportedOperationException implements Serializable
- serialVersionUID:
- 20140225L
-
-
Package org.apache.commons.math3.geometry.spherical.twod
-
Class org.apache.commons.math3.geometry.spherical.twod.S2Point extends Object implements Serializable
- serialVersionUID:
- 20131218L
-
Serialized Fields
-
phi
double phi
Polar angle \( \varphi \). -
theta
double theta
Azimuthal angle \( \theta \) in the x-y plane. -
vector
Vector3D vector
Corresponding 3D normalized vector.
-
-
Class org.apache.commons.math3.geometry.spherical.twod.Sphere2D extends Object implements Serializable
- serialVersionUID:
- 20131218L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
-
Package org.apache.commons.math3.linear
-
Class org.apache.commons.math3.linear.Array2DRowFieldMatrix extends AbstractFieldMatrix<T extends FieldElement<T>> implements Serializable
- serialVersionUID:
- 7260756672015356458L
-
Serialized Fields
-
data
T extends FieldElement<T>[][] data
Entries of the matrix
-
-
Class org.apache.commons.math3.linear.Array2DRowRealMatrix extends AbstractRealMatrix implements Serializable
- serialVersionUID:
- -1067294169172445528L
-
Serialized Fields
-
data
double[][] data
Entries of the matrix.
-
-
Class org.apache.commons.math3.linear.ArrayFieldVector extends Object implements Serializable
- serialVersionUID:
- 7648186910365927050L
-
Serialized Fields
-
data
T extends FieldElement<T>[] data
Entries of the vector. -
field
Field<T extends FieldElement<T>> field
Field to which the elements belong.
-
-
Class org.apache.commons.math3.linear.ArrayRealVector extends RealVector implements Serializable
- serialVersionUID:
- -1097961340710804027L
-
Serialized Fields
-
data
double[] data
Entries of the vector.
-
-
Class org.apache.commons.math3.linear.BlockFieldMatrix extends AbstractFieldMatrix<T extends FieldElement<T>> implements Serializable
- serialVersionUID:
- -4602336630143123183L
-
Serialized Fields
-
blockColumns
int blockColumns
Number of block columns of the matrix. -
blockRows
int blockRows
Number of block rows of the matrix. -
blocks
T extends FieldElement<T>[][] blocks
Blocks of matrix entries. -
columns
int columns
Number of columns of the matrix. -
rows
int rows
Number of rows of the matrix.
-
-
Class org.apache.commons.math3.linear.BlockRealMatrix extends AbstractRealMatrix implements Serializable
- serialVersionUID:
- 4991895511313664478L
-
Serialized Fields
-
blockColumns
int blockColumns
Number of block columns of the matrix. -
blockRows
int blockRows
Number of block rows of the matrix. -
blocks
double[][] blocks
Blocks of matrix entries. -
columns
int columns
Number of columns of the matrix. -
rows
int rows
Number of rows of the matrix.
-
-
Class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent extends IterativeLinearSolverEvent implements Serializable
- serialVersionUID:
- 20120129L
-
Serialized Fields
-
b
RealVector b
The right-hand side vector. -
r
RealVector r
The current estimate of the residual. -
rnorm
double rnorm
The current estimate of the norm of the residual. -
x
RealVector x
The current estimate of the solution.
-
-
Class org.apache.commons.math3.linear.DiagonalMatrix extends AbstractRealMatrix implements Serializable
- serialVersionUID:
- 20121229L
-
Serialized Fields
-
data
double[] data
Entries of the diagonal.
-
-
Class org.apache.commons.math3.linear.IllConditionedOperatorException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -7883263944530490135L
-
Class org.apache.commons.math3.linear.IterativeLinearSolverEvent extends IterationEvent implements Serializable
- serialVersionUID:
- 20120129L
-
Class org.apache.commons.math3.linear.MatrixDimensionMismatchException extends MultiDimensionMismatchException implements Serializable
- serialVersionUID:
- -8415396756375798143L
-
Class org.apache.commons.math3.linear.NonPositiveDefiniteMatrixException extends NumberIsTooSmallException implements Serializable
- serialVersionUID:
- 1641613838113738061L
-
Serialized Fields
-
index
int index
Index (diagonal element). -
threshold
double threshold
Threshold.
-
-
Class org.apache.commons.math3.linear.NonPositiveDefiniteOperatorException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 917034489420549847L
-
Class org.apache.commons.math3.linear.NonSelfAdjointOperatorException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 1784999305030258247L
-
Class org.apache.commons.math3.linear.NonSquareMatrixException extends DimensionMismatchException implements Serializable
- serialVersionUID:
- -660069396594485772L
-
Class org.apache.commons.math3.linear.NonSquareOperatorException extends DimensionMismatchException implements Serializable
- serialVersionUID:
- -4145007524150846242L
-
Class org.apache.commons.math3.linear.NonSymmetricMatrixException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -7518495577824189882L
-
Serialized Fields
-
column
int column
Column. -
row
int row
Row. -
threshold
double threshold
Threshold.
-
-
Class org.apache.commons.math3.linear.OpenMapRealMatrix extends AbstractRealMatrix implements Serializable
- serialVersionUID:
- -5962461716457143437L
-
Serialized Fields
-
columns
int columns
Number of columns of the matrix. -
entries
OpenIntToDoubleHashMap entries
Storage for (sparse) matrix elements. -
rows
int rows
Number of rows of the matrix.
-
-
Class org.apache.commons.math3.linear.OpenMapRealVector extends SparseRealVector implements Serializable
- serialVersionUID:
- 8772222695580707260L
-
Serialized Fields
-
entries
OpenIntToDoubleHashMap entries
Entries of the vector. -
epsilon
double epsilon
Tolerance for having a value considered zero. -
virtualSize
int virtualSize
Dimension of the vector.
-
-
Class org.apache.commons.math3.linear.SingularMatrixException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -4206514844735401070L
-
Class org.apache.commons.math3.linear.SingularOperatorException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -476049978595245033L
-
Class org.apache.commons.math3.linear.SparseFieldVector extends Object implements Serializable
- serialVersionUID:
- 7841233292190413362L
-
Serialized Fields
-
entries
OpenIntToFieldHashMap<T extends FieldElement<T>> entries
Entries of the vector. -
field
Field<T extends FieldElement<T>> field
Field to which the elements belong. -
virtualSize
int virtualSize
Dimension of the vector.
-
-
-
Package org.apache.commons.math3.ml.clustering
-
Class org.apache.commons.math3.ml.clustering.CentroidCluster extends Cluster<T extends Clusterable> implements Serializable
- serialVersionUID:
- -3075288519071812288L
-
Serialized Fields
-
center
Clusterable center
Center of the cluster.
-
-
Class org.apache.commons.math3.ml.clustering.Cluster extends Object implements Serializable
- serialVersionUID:
- -3442297081515880464L
-
Serialized Fields
-
points
List<T extends Clusterable> points
The points contained in this cluster.
-
-
Class org.apache.commons.math3.ml.clustering.DoublePoint extends Object implements Serializable
- serialVersionUID:
- 3946024775784901369L
-
Serialized Fields
-
point
double[] point
Point coordinates.
-
-
-
Package org.apache.commons.math3.ml.distance
-
Class org.apache.commons.math3.ml.distance.CanberraDistance extends Object implements Serializable
- serialVersionUID:
- -6972277381587032228L
-
Class org.apache.commons.math3.ml.distance.ChebyshevDistance extends Object implements Serializable
- serialVersionUID:
- -4694868171115238296L
-
Class org.apache.commons.math3.ml.distance.EarthMoversDistance extends Object implements Serializable
- serialVersionUID:
- -5406732779747414922L
-
Class org.apache.commons.math3.ml.distance.EuclideanDistance extends Object implements Serializable
- serialVersionUID:
- 1717556319784040040L
-
Class org.apache.commons.math3.ml.distance.ManhattanDistance extends Object implements Serializable
- serialVersionUID:
- -9108154600539125566L
-
-
Package org.apache.commons.math3.ml.neuralnet
-
Class org.apache.commons.math3.ml.neuralnet.Network extends Object implements Serializable
- serialVersionUID:
- 20130207L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream in)
Prevents proxy bypass. -
writeReplace
private Object writeReplace()
Custom serialization.
-
-
Serialized Fields
-
featureSize
int featureSize
Neuron's features set size. -
linkMap
ConcurrentHashMap<Long,Set<Long>> linkMap
Links. -
neuronMap
ConcurrentHashMap<Long,Neuron> neuronMap
Neurons. -
nextId
AtomicLong nextId
Next available neuron identifier.
-
-
Class org.apache.commons.math3.ml.neuralnet.Network.NeuronIdentifierComparator extends Object implements Serializable
- serialVersionUID:
- 20130207L
-
Class org.apache.commons.math3.ml.neuralnet.Neuron extends Object implements Serializable
- serialVersionUID:
- 20130207L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream in)
Prevents proxy bypass. -
writeReplace
private Object writeReplace()
Custom serialization.
-
-
Serialized Fields
-
features
AtomicReference<double[]> features
Neuron data. -
identifier
long identifier
Identifier. -
numberOfAttemptedUpdates
AtomicLong numberOfAttemptedUpdates
Number of attempts to update a neuron. -
numberOfSuccessfulUpdates
AtomicLong numberOfSuccessfulUpdates
Number of successful updates of a neuron. -
size
int size
Length of the feature set.
-
-
-
Package org.apache.commons.math3.ml.neuralnet.oned
-
Class org.apache.commons.math3.ml.neuralnet.oned.NeuronString extends Object implements Serializable
- serialVersionUID:
- 1L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream in)
Prevents proxy bypass. -
writeReplace
private Object writeReplace()
Custom serialization.
-
-
Serialized Fields
-
identifiers
long[] identifiers
Mapping of the 1D coordinate to the neuron identifiers (attributed by theNeuronString.network
instance). -
network
Network network
Underlying network. -
size
int size
Number of neurons. -
wrap
boolean wrap
Wrap.
-
-
-
Package org.apache.commons.math3.ml.neuralnet.twod
-
Class org.apache.commons.math3.ml.neuralnet.twod.NeuronSquareMesh2D extends Object implements Serializable
- serialVersionUID:
- 1L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream in)
Prevents proxy bypass. -
writeReplace
private Object writeReplace()
Custom serialization.
-
-
Serialized Fields
-
identifiers
long[][] identifiers
Mapping of the 2D coordinates (in the rectangular mesh) to the neuron identifiers (attributed by theNeuronSquareMesh2D.network
instance). -
neighbourhood
SquareNeighbourhood neighbourhood
Neighbourhood type. -
network
Network network
Underlying network. -
numberOfColumns
int numberOfColumns
Number of columns. -
numberOfRows
int numberOfRows
Number of rows. -
wrapColumns
boolean wrapColumns
Wrap. -
wrapRows
boolean wrapRows
Wrap.
-
-
-
Package org.apache.commons.math3.ode
-
Class org.apache.commons.math3.ode.ContinuousOutputModel extends Object implements Serializable
- serialVersionUID:
- -1417964919405031606L
-
Serialized Fields
-
finalTime
double finalTime
Final integration time. -
forward
boolean forward
Integration direction indicator. -
index
int index
Current interpolator index. -
initialTime
double initialTime
Initial integration time. -
steps
List<StepInterpolator> steps
Steps table.
-
-
Class org.apache.commons.math3.ode.EquationsMapper extends Object implements Serializable
- serialVersionUID:
- 20110925L
-
Serialized Fields
-
dimension
int dimension
Dimension of the secondary state parameters. -
firstIndex
int firstIndex
Index of the first equation element in complete state arrays.
-
-
Class org.apache.commons.math3.ode.FieldEquationsMapper extends Object implements Serializable
- serialVersionUID:
- 20151114L
-
Serialized Fields
-
start
int[] start
Start indices of the components.
-
-
Class org.apache.commons.math3.ode.JacobianMatrices.MismatchedEquations extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 20120902L
-
Class org.apache.commons.math3.ode.UnknownParameterException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 20120902L
-
Serialized Fields
-
name
String name
Parameter name.
-
-
-
Package org.apache.commons.math3.ode.sampling
-
Class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator extends Object implements Serializable
-
Serialization Methods
-
readExternal
public abstract void readExternal(ObjectInput in) throws IOException, ClassNotFoundException
- Throws:
IOException
ClassNotFoundException
-
writeExternal
public abstract void writeExternal(ObjectOutput out) throws IOException
- Throws:
IOException
-
-
-
Class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator extends AbstractStepInterpolator implements Serializable
- serialVersionUID:
- -7179861704951334960L
-
Serialization Methods
-
readExternal
public void readExternal(ObjectInput in) throws IOException, ClassNotFoundException
- Throws:
IOException
ClassNotFoundException
-
writeExternal
public void writeExternal(ObjectOutput out) throws IOException
- Throws:
IOException
-
-
-
Package org.apache.commons.math3.optim
-
Class org.apache.commons.math3.optim.PointValuePair extends Pair<double[],Double> implements Serializable
- serialVersionUID:
- 20120513L
-
Serialization Methods
-
writeReplace
private Object writeReplace()
Replace the instance with a data transfer object for serialization.
-
-
Class org.apache.commons.math3.optim.PointVectorValuePair extends Pair<double[],double[]> implements Serializable
- serialVersionUID:
- 20120513L
-
Serialization Methods
-
writeReplace
private Object writeReplace()
Replace the instance with a data transfer object for serialization.
-
-
-
Package org.apache.commons.math3.optim.linear
-
Class org.apache.commons.math3.optim.linear.LinearConstraint extends Object implements Serializable
- serialVersionUID:
- -764632794033034092L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream ois) throws ClassNotFoundException, IOException
Deserialize the instance.- Throws:
ClassNotFoundException
- if a class in the stream cannot be foundIOException
- if object cannot be read from the stream
-
writeObject
private void writeObject(ObjectOutputStream oos) throws IOException
Serialize the instance.- Throws:
IOException
- if object cannot be written to stream
-
-
Serialized Fields
-
relationship
Relationship relationship
Relationship between left and right hand sides (=, <=, >=). -
value
double value
Value of the constraint (right hand side).
-
-
Class org.apache.commons.math3.optim.linear.LinearObjectiveFunction extends Object implements Serializable
- serialVersionUID:
- -4531815507568396090L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream ois) throws ClassNotFoundException, IOException
Deserialize the instance.- Throws:
ClassNotFoundException
- if a class in the stream cannot be foundIOException
- if object cannot be read from the stream
-
writeObject
private void writeObject(ObjectOutputStream oos) throws IOException
Serialize the instance.- Throws:
IOException
- if object cannot be written to stream
-
-
Serialized Fields
-
constantTerm
double constantTerm
Constant term of the linear equation.
-
-
Class org.apache.commons.math3.optim.linear.NoFeasibleSolutionException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- -3044253632189082760L
-
Class org.apache.commons.math3.optim.linear.UnboundedSolutionException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- 940539497277290619L
-
-
Package org.apache.commons.math3.optim.univariate
-
Class org.apache.commons.math3.optim.univariate.UnivariatePointValuePair extends Object implements Serializable
- serialVersionUID:
- 1003888396256744753L
-
Serialized Fields
-
point
double point
Point. -
value
double value
Value of the objective function at the point.
-
-
-
Package org.apache.commons.math3.optimization
-
Class org.apache.commons.math3.optimization.PointValuePair extends Pair<double[],Double> implements Serializable
- serialVersionUID:
- 20120513L
-
Serialization Methods
-
writeReplace
private Object writeReplace()
Deprecated.Replace the instance with a data transfer object for serialization.
-
-
Class org.apache.commons.math3.optimization.PointVectorValuePair extends Pair<double[],double[]> implements Serializable
- serialVersionUID:
- 20120513L
-
Serialization Methods
-
writeReplace
private Object writeReplace()
Deprecated.Replace the instance with a data transfer object for serialization.
-
-
-
Package org.apache.commons.math3.optimization.fitting
-
Class org.apache.commons.math3.optimization.fitting.WeightedObservedPoint extends Object implements Serializable
- serialVersionUID:
- 5306874947404636157L
-
Serialized Fields
-
weight
double weight
Deprecated.Weight of the measurement in the fitting process. -
x
double x
Deprecated.Abscissa of the point. -
y
double y
Deprecated.Observed value of the function at x.
-
-
-
Package org.apache.commons.math3.optimization.linear
-
Class org.apache.commons.math3.optimization.linear.LinearConstraint extends Object implements Serializable
- serialVersionUID:
- -764632794033034092L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream ois) throws ClassNotFoundException, IOException
Deprecated.Deserialize the instance.- Throws:
ClassNotFoundException
- if a class in the stream cannot be foundIOException
- if object cannot be read from the stream
-
writeObject
private void writeObject(ObjectOutputStream oos) throws IOException
Deprecated.Serialize the instance.- Throws:
IOException
- if object cannot be written to stream
-
-
Serialized Fields
-
relationship
Relationship relationship
Deprecated.Relationship between left and right hand sides (=, <=, >=). -
value
double value
Deprecated.Value of the constraint (right hand side).
-
-
Class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction extends Object implements Serializable
- serialVersionUID:
- -4531815507568396090L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream ois) throws ClassNotFoundException, IOException
Deprecated.Deserialize the instance.- Throws:
ClassNotFoundException
- if a class in the stream cannot be foundIOException
- if object cannot be read from the stream
-
writeObject
private void writeObject(ObjectOutputStream oos) throws IOException
Deprecated.Serialize the instance.- Throws:
IOException
- if object cannot be written to stream
-
-
Serialized Fields
-
constantTerm
double constantTerm
Deprecated.Constant term of the linear equation.
-
-
Class org.apache.commons.math3.optimization.linear.NoFeasibleSolutionException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- -3044253632189082760L
-
Class org.apache.commons.math3.optimization.linear.UnboundedSolutionException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- 940539497277290619L
-
-
Package org.apache.commons.math3.optimization.univariate
-
Class org.apache.commons.math3.optimization.univariate.UnivariatePointValuePair extends Object implements Serializable
- serialVersionUID:
- 1003888396256744753L
-
Serialized Fields
-
point
double point
Deprecated.Point. -
value
double value
Deprecated.Value of the objective function at the point.
-
-
-
Package org.apache.commons.math3.random
-
Class org.apache.commons.math3.random.AbstractWell extends BitsStreamGenerator implements Serializable
- serialVersionUID:
- -817701723016583596L
-
Serialized Fields
-
i1
int[] i1
Index indirection table giving for each index the value index + m1 taking table size into account. -
i2
int[] i2
Index indirection table giving for each index the value index + m2 taking table size into account. -
i3
int[] i3
Index indirection table giving for each index the value index + m3 taking table size into account. -
index
int index
Current index in the bytes pool. -
iRm1
int[] iRm1
Index indirection table giving for each index its predecessor taking table size into account. -
iRm2
int[] iRm2
Index indirection table giving for each index its second predecessor taking table size into account. -
v
int[] v
Bytes pool.
-
-
Class org.apache.commons.math3.random.BitsStreamGenerator extends Object implements Serializable
- serialVersionUID:
- 20130104L
-
Serialized Fields
-
nextGaussian
double nextGaussian
Next gaussian.
-
-
Class org.apache.commons.math3.random.EmpiricalDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 5729073523949762654L
-
Serialized Fields
-
binCount
int binCount
number of bins -
binStats
List<SummaryStatistics> binStats
List of SummaryStatistics objects characterizing the bins -
delta
double delta
Grid size -
loaded
boolean loaded
is the distribution loaded? -
max
double max
Max loaded value -
min
double min
Min loaded value -
randomData
RandomDataGenerator randomData
RandomDataGenerator instance to use in repeated calls to getNext() -
sampleStats
SummaryStatistics sampleStats
Sample statistics -
upperBounds
double[] upperBounds
upper bounds of subintervals in (0,1) "belonging" to the bins
-
-
Class org.apache.commons.math3.random.ISAACRandom extends BitsStreamGenerator implements Serializable
- serialVersionUID:
- 7288197941165002400L
-
Serialized Fields
-
arr
int[] arr
Service variable. -
count
int count
Count through the results in rsl[] -
isaacA
int isaacA
Accumulator -
isaacB
int isaacB
The last result -
isaacC
int isaacC
Counter, guarantees cycle is at least 2^40 -
isaacI
int isaacI
Service variable. -
isaacJ
int isaacJ
Service variable. -
isaacX
int isaacX
Service variable. -
mem
int[] mem
The internal state -
rsl
int[] rsl
The results given to the user
-
-
Class org.apache.commons.math3.random.JDKRandomGenerator extends Random implements Serializable
- serialVersionUID:
- -7745277476784028798L
-
Class org.apache.commons.math3.random.MersenneTwister extends BitsStreamGenerator implements Serializable
- serialVersionUID:
- 8661194735290153518L
-
Serialized Fields
-
mt
int[] mt
Bytes pool. -
mti
int mti
Current index in the bytes pool.
-
-
Class org.apache.commons.math3.random.RandomAdaptor extends Random implements Serializable
- serialVersionUID:
- 2306581345647615033L
-
Serialized Fields
-
randomGenerator
RandomGenerator randomGenerator
Wrapped randomGenerator instance
-
-
Class org.apache.commons.math3.random.RandomDataGenerator extends Object implements Serializable
- serialVersionUID:
- -626730818244969716L
-
Serialized Fields
-
rand
RandomGenerator rand
underlying random number generator -
secRand
RandomGenerator secRand
underlying secure random number generator
-
-
Class org.apache.commons.math3.random.RandomDataImpl extends Object implements Serializable
- serialVersionUID:
- -626730818244969716L
-
Serialized Fields
-
delegate
RandomDataGenerator delegate
Deprecated.RandomDataGenerator delegate
-
-
Class org.apache.commons.math3.random.Well1024a extends AbstractWell implements Serializable
- serialVersionUID:
- 5680173464174485492L
-
Class org.apache.commons.math3.random.Well19937a extends AbstractWell implements Serializable
- serialVersionUID:
- -7462102162223815419L
-
Class org.apache.commons.math3.random.Well19937c extends AbstractWell implements Serializable
- serialVersionUID:
- -7203498180754925124L
-
Class org.apache.commons.math3.random.Well44497a extends AbstractWell implements Serializable
- serialVersionUID:
- -3859207588353972099L
-
Class org.apache.commons.math3.random.Well44497b extends AbstractWell implements Serializable
- serialVersionUID:
- 4032007538246675492L
-
Class org.apache.commons.math3.random.Well512a extends AbstractWell implements Serializable
- serialVersionUID:
- -6104179812103820574L
-
-
Package org.apache.commons.math3.stat
-
Class org.apache.commons.math3.stat.Frequency extends Object implements Serializable
- serialVersionUID:
- -3845586908418844111L
-
Serialized Fields
-
freqTable
SortedMap<Comparable<?>,Long> freqTable
underlying collection
-
-
-
Package org.apache.commons.math3.stat.clustering
-
Class org.apache.commons.math3.stat.clustering.Cluster extends Object implements Serializable
- serialVersionUID:
- -3442297081515880464L
-
Serialized Fields
-
center
T extends Clusterable<T> center
Deprecated.Center of the cluster. -
points
List<T extends Clusterable<T>> points
Deprecated.The points contained in this cluster.
-
-
Class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint extends Object implements Serializable
- serialVersionUID:
- 8026472786091227632L
-
Serialized Fields
-
point
double[] point
Deprecated.Point coordinates.
-
-
Class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint extends Object implements Serializable
- serialVersionUID:
- 3946024775784901369L
-
Serialized Fields
-
point
int[] point
Deprecated.Point coordinates.
-
-
-
Package org.apache.commons.math3.stat.descriptive
-
Class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics extends Object implements Serializable
- serialVersionUID:
- -8207112444016386906L
-
Serialized Fields
-
statistics
SummaryStatistics statistics
The SummaryStatistics in which aggregate statistics are accumulated. -
statisticsPrototype
SummaryStatistics statisticsPrototype
A SummaryStatistics serving as a prototype for creating SummaryStatistics contributing to this aggregate
-
-
Class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics extends Object implements Serializable
- serialVersionUID:
- 4133067267405273064L
-
Serialized Fields
-
eDA
ResizableDoubleArray eDA
Stored data values -
geometricMeanImpl
UnivariateStatistic geometricMeanImpl
Geometric mean statistic implementation - can be reset by setter. -
kurtosisImpl
UnivariateStatistic kurtosisImpl
Kurtosis statistic implementation - can be reset by setter. -
maxImpl
UnivariateStatistic maxImpl
Maximum statistic implementation - can be reset by setter. -
meanImpl
UnivariateStatistic meanImpl
Mean statistic implementation - can be reset by setter. -
minImpl
UnivariateStatistic minImpl
Minimum statistic implementation - can be reset by setter. -
percentileImpl
UnivariateStatistic percentileImpl
Percentile statistic implementation - can be reset by setter. -
skewnessImpl
UnivariateStatistic skewnessImpl
Skewness statistic implementation - can be reset by setter. -
sumImpl
UnivariateStatistic sumImpl
Sum statistic implementation - can be reset by setter. -
sumsqImpl
UnivariateStatistic sumsqImpl
Sum of squares statistic implementation - can be reset by setter. -
varianceImpl
UnivariateStatistic varianceImpl
Variance statistic implementation - can be reset by setter. -
windowSize
int windowSize
hold the window size
-
-
Class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics extends Object implements Serializable
- serialVersionUID:
- 2271900808994826718L
-
Serialized Fields
-
covarianceImpl
VectorialCovariance covarianceImpl
Covariance statistic implementation - cannot be reset. -
geoMeanImpl
StorelessUnivariateStatistic[] geoMeanImpl
Geometric mean statistic implementation - can be reset by setter. -
k
int k
Dimension of the data. -
maxImpl
StorelessUnivariateStatistic[] maxImpl
Maximum statistic implementation - can be reset by setter. -
meanImpl
StorelessUnivariateStatistic[] meanImpl
Mean statistic implementation - can be reset by setter. -
minImpl
StorelessUnivariateStatistic[] minImpl
Minimum statistic implementation - can be reset by setter. -
n
long n
Count of values that have been added -
sumImpl
StorelessUnivariateStatistic[] sumImpl
Sum statistic implementation - can be reset by setter. -
sumLogImpl
StorelessUnivariateStatistic[] sumLogImpl
Sum of log statistic implementation - can be reset by setter. -
sumSqImpl
StorelessUnivariateStatistic[] sumSqImpl
Sum of squares statistic implementation - can be reset by setter.
-
-
Class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues extends Object implements Serializable
- serialVersionUID:
- -5108854841843722536L
-
Serialized Fields
-
max
double max
The maximum value -
mean
double mean
The sample mean -
min
double min
The minimum value -
n
long n
The number of observations in the sample -
sum
double sum
The sum of the sample values -
variance
double variance
The sample variance
-
-
Class org.apache.commons.math3.stat.descriptive.SummaryStatistics extends Object implements Serializable
- serialVersionUID:
- -2021321786743555871L
-
Serialized Fields
-
geoMean
GeometricMean geoMean
geoMean of values that have been added -
geoMeanImpl
StorelessUnivariateStatistic geoMeanImpl
Geometric mean statistic implementation - can be reset by setter. -
max
Max max
max of values that have been added -
maxImpl
StorelessUnivariateStatistic maxImpl
Maximum statistic implementation - can be reset by setter. -
mean
Mean mean
mean of values that have been added -
meanImpl
StorelessUnivariateStatistic meanImpl
Mean statistic implementation - can be reset by setter. -
min
Min min
min of values that have been added -
minImpl
StorelessUnivariateStatistic minImpl
Minimum statistic implementation - can be reset by setter. -
n
long n
count of values that have been added -
secondMoment
SecondMoment secondMoment
SecondMoment is used to compute the mean and variance -
sum
Sum sum
sum of values that have been added -
sumImpl
StorelessUnivariateStatistic sumImpl
Sum statistic implementation - can be reset by setter. -
sumLog
SumOfLogs sumLog
sumLog of values that have been added -
sumLogImpl
StorelessUnivariateStatistic sumLogImpl
Sum of log statistic implementation - can be reset by setter. -
sumsq
SumOfSquares sumsq
sum of the square of each value that has been added -
sumsqImpl
StorelessUnivariateStatistic sumsqImpl
Sum of squares statistic implementation - can be reset by setter. -
variance
Variance variance
variance of values that have been added -
varianceImpl
StorelessUnivariateStatistic varianceImpl
Variance statistic implementation - can be reset by setter.
-
-
Class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics extends DescriptiveStatistics implements Serializable
- serialVersionUID:
- 1L
-
Class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics extends MultivariateSummaryStatistics implements Serializable
- serialVersionUID:
- 7099834153347155363L
-
Class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics extends SummaryStatistics implements Serializable
- serialVersionUID:
- 1909861009042253704L
-
-
Package org.apache.commons.math3.stat.descriptive.moment
-
Class org.apache.commons.math3.stat.descriptive.moment.GeometricMean extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- -8178734905303459453L
-
Serialized Fields
-
sumOfLogs
StorelessUnivariateStatistic sumOfLogs
Wrapped SumOfLogs instance
-
-
Class org.apache.commons.math3.stat.descriptive.moment.Kurtosis extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 2784465764798260919L
-
Serialized Fields
-
incMoment
boolean incMoment
Determines whether or not this statistic can be incremented or cleared.Statistics based on (constructed from) external moments cannot be incremented or cleared.
-
moment
org.apache.commons.math3.stat.descriptive.moment.FourthMoment moment
Fourth Moment on which this statistic is based
-
-
Class org.apache.commons.math3.stat.descriptive.moment.Mean extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- -1296043746617791564L
-
Serialized Fields
-
incMoment
boolean incMoment
Determines whether or not this statistic can be incremented or cleared.Statistics based on (constructed from) external moments cannot be incremented or cleared.
-
moment
org.apache.commons.math3.stat.descriptive.moment.FirstMoment moment
First moment on which this statistic is based.
-
-
Class org.apache.commons.math3.stat.descriptive.moment.SecondMoment extends org.apache.commons.math3.stat.descriptive.moment.FirstMoment implements Serializable
- serialVersionUID:
- 3942403127395076445L
-
Serialized Fields
-
m2
double m2
second moment of values that have been added
-
-
Class org.apache.commons.math3.stat.descriptive.moment.SemiVariance extends AbstractUnivariateStatistic implements Serializable
- serialVersionUID:
- -2653430366886024994L
-
Serialized Fields
-
biasCorrected
boolean biasCorrected
Determines whether or not bias correction is applied when computing the value of the statisic. True means that bias is corrected. -
varianceDirection
SemiVariance.Direction varianceDirection
Determines whether to calculate downside or upside SemiVariance.
-
-
Class org.apache.commons.math3.stat.descriptive.moment.Skewness extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 7101857578996691352L
-
Serialized Fields
-
incMoment
boolean incMoment
Determines whether or not this statistic can be incremented or cleared.Statistics based on (constructed from) external moments cannot be incremented or cleared.
-
moment
org.apache.commons.math3.stat.descriptive.moment.ThirdMoment moment
Third moment on which this statistic is based
-
-
Class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 5728716329662425188L
-
Serialized Fields
-
variance
Variance variance
Wrapped Variance instance
-
-
Class org.apache.commons.math3.stat.descriptive.moment.Variance extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- -9111962718267217978L
-
Serialized Fields
-
incMoment
boolean incMoment
Whether or notVariance.increment(double)
should increment the internal second moment. When a Variance is constructed with an external SecondMoment as a constructor parameter, this property is set to false and increments must be applied to the second moment directly. -
isBiasCorrected
boolean isBiasCorrected
Whether or not bias correction is applied when computing the value of the statistic. True means that bias is corrected. SeeVariance
for details on the formula. -
moment
SecondMoment moment
SecondMoment is used in incremental calculation of Variance
-
-
Class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance extends Object implements Serializable
- serialVersionUID:
- 4118372414238930270L
-
Serialized Fields
-
isBiasCorrected
boolean isBiasCorrected
Indicator for bias correction. -
n
long n
Number of vectors in the sample. -
productsSums
double[] productsSums
Sums of products for each component. -
sums
double[] sums
Sums for each component.
-
-
Class org.apache.commons.math3.stat.descriptive.moment.VectorialMean extends Object implements Serializable
- serialVersionUID:
- 8223009086481006892L
-
Serialized Fields
-
means
Mean[] means
Means for each component.
-
-
-
Package org.apache.commons.math3.stat.descriptive.rank
-
Class org.apache.commons.math3.stat.descriptive.rank.Max extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- -5593383832225844641L
-
Serialized Fields
-
n
long n
Number of values that have been added -
value
double value
Current value of the statistic
-
-
Class org.apache.commons.math3.stat.descriptive.rank.Median extends Percentile implements Serializable
- serialVersionUID:
- -3961477041290915687L
-
Class org.apache.commons.math3.stat.descriptive.rank.Min extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- -2941995784909003131L
-
Serialized Fields
-
n
long n
Number of values that have been added -
value
double value
Current value of the statistic
-
-
Class org.apache.commons.math3.stat.descriptive.rank.Percentile extends AbstractUnivariateStatistic implements Serializable
- serialVersionUID:
- -8091216485095130416L
-
Serialized Fields
-
cachedPivots
int[] cachedPivots
Cached pivots. -
estimationType
Percentile.EstimationType estimationType
Any of thePercentile.EstimationType
s such asCM
can be used. -
kthSelector
KthSelector kthSelector
Default KthSelector used with default pivoting strategy -
nanStrategy
NaNStrategy nanStrategy
NaN Handling of the input as defined byNaNStrategy
-
quantile
double quantile
Determines what percentile is computed when evaluate() is activated with no quantile argument
-
-
Class org.apache.commons.math3.stat.descriptive.rank.PSquarePercentile extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 2283912083175715479L
-
Serialized Fields
-
countOfObservations
long countOfObservations
Counter to count the values/observations accepted into this data set -
initialFive
List<Double> initialFive
Initial list of 5 numbers corresponding to 5 markers. NOTE:watch out for the add methods that are overloaded -
markers
PSquarePercentile.PSquareMarkers markers
Markers is the marker collection object which comes to effect only after 5 values are inserted -
pValue
double pValue
Computed p value (i,e percentile value of data set hither to received) -
quantile
double quantile
The quantile needed should be in range of 0-1. The constructorPSquarePercentile(double)
ensures that passed in percentile is divided by 100.
-
-
-
Package org.apache.commons.math3.stat.descriptive.summary
-
Class org.apache.commons.math3.stat.descriptive.summary.Product extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 2824226005990582538L
-
Serialized Fields
-
n
long n
The number of values that have been added -
value
double value
The current Running Product.
-
-
Class org.apache.commons.math3.stat.descriptive.summary.Sum extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- -8231831954703408316L
-
Serialized Fields
-
n
long n
-
value
double value
The currently running sum.
-
-
Class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- -370076995648386763L
-
Serialized Fields
-
n
int n
Number of values that have been added -
value
double value
The currently running value
-
-
Class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 1460986908574398008L
-
Serialized Fields
-
n
long n
-
value
double value
The currently running sumSq
-
-
-
Package org.apache.commons.math3.stat.regression
-
Class org.apache.commons.math3.stat.regression.ModelSpecificationException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 4206514456095401070L
-
Class org.apache.commons.math3.stat.regression.RegressionResults extends Object implements Serializable
- serialVersionUID:
- 1L
-
Serialized Fields
-
containsConstant
boolean containsConstant
boolean flag indicator of whether a constant was included -
globalFitInfo
double[] globalFitInfo
array storing global results, SSE, MSE, RSQ, adjRSQ -
isSymmetricVCD
boolean isSymmetricVCD
boolean flag for variance covariance matrix in symm compressed storage -
nobs
long nobs
number of observations on which results are based -
parameters
double[] parameters
regression slope parameters -
rank
int rank
rank of the solution -
varCovData
double[][] varCovData
variance covariance matrix of parameters
-
-
Class org.apache.commons.math3.stat.regression.SimpleRegression extends Object implements Serializable
- serialVersionUID:
- -3004689053607543335L
-
Serialized Fields
-
hasIntercept
boolean hasIntercept
include an intercept or not -
n
long n
number of observations -
sumX
double sumX
sum of x values -
sumXX
double sumXX
total variation in x (sum of squared deviations from xbar) -
sumXY
double sumXY
sum of products -
sumY
double sumY
sum of y values -
sumYY
double sumYY
total variation in y (sum of squared deviations from ybar) -
xbar
double xbar
mean of accumulated x values, used in updating formulas -
ybar
double ybar
mean of accumulated y values, used in updating formulas
-
-
-
Package org.apache.commons.math3.transform
-
Class org.apache.commons.math3.transform.FastCosineTransformer extends Object implements Serializable
- serialVersionUID:
- 20120212L
-
Serialized Fields
-
normalization
DctNormalization normalization
The type of DCT to be performed.
-
-
Class org.apache.commons.math3.transform.FastFourierTransformer extends Object implements Serializable
- serialVersionUID:
- 20120210L
-
Serialized Fields
-
normalization
DftNormalization normalization
The type of DFT to be performed.
-
-
Class org.apache.commons.math3.transform.FastHadamardTransformer extends Object implements Serializable
- serialVersionUID:
- 20120211L
-
Class org.apache.commons.math3.transform.FastSineTransformer extends Object implements Serializable
- serialVersionUID:
- 20120211L
-
Serialized Fields
-
normalization
DstNormalization normalization
The type of DST to be performed.
-
-
-
Package org.apache.commons.math3.util
-
Class org.apache.commons.math3.util.BigReal extends Object implements Serializable
- serialVersionUID:
- 4984534880991310382L
-
Serialized Fields
-
d
BigDecimal d
Underlying BigDecimal. -
roundingMode
RoundingMode roundingMode
Rounding mode for divisions. -
scale
int scale
BigDecimal scale
-
-
Class org.apache.commons.math3.util.BigRealField extends Object implements Serializable
- serialVersionUID:
- 4756431066541037559L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.apache.commons.math3.util.CentralPivotingStrategy extends Object implements Serializable
- serialVersionUID:
- 20140713L
-
Class org.apache.commons.math3.util.Decimal64 extends Number implements Serializable
- serialVersionUID:
- 20120227L
-
Serialized Fields
-
value
double value
The primitivedouble
value of this object.
-
-
Class org.apache.commons.math3.util.DefaultTransformer extends Object implements Serializable
- serialVersionUID:
- 4019938025047800455L
-
Class org.apache.commons.math3.util.IterationEvent extends EventObject implements Serializable
- serialVersionUID:
- 20120128L
-
Serialized Fields
-
iterations
int iterations
The number of iterations performed so far.
-
-
Class org.apache.commons.math3.util.KthSelector extends Object implements Serializable
- serialVersionUID:
- 20140713L
-
Serialized Fields
-
pivotingStrategy
PivotingStrategyInterface pivotingStrategy
APivotingStrategyInterface
used for pivoting
-
-
Class org.apache.commons.math3.util.MedianOf3PivotingStrategy extends Object implements Serializable
- serialVersionUID:
- 20140713L
-
Class org.apache.commons.math3.util.OpenIntToDoubleHashMap extends Object implements Serializable
- serialVersionUID:
- -3646337053166149105L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream stream) throws IOException, ClassNotFoundException
Read a serialized object.- Throws:
IOException
- if object cannot be readClassNotFoundException
- if the class corresponding to the serialized object cannot be found
-
-
Serialized Fields
-
keys
int[] keys
Keys table. -
mask
int mask
Bit mask for hash values. -
missingEntries
double missingEntries
Return value for missing entries. -
size
int size
Current size of the map. -
states
byte[] states
States table. -
values
double[] values
Values table.
-
-
Class org.apache.commons.math3.util.OpenIntToFieldHashMap extends Object implements Serializable
- serialVersionUID:
- -9179080286849120720L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream stream) throws IOException, ClassNotFoundException
Read a serialized object.- Throws:
IOException
- if object cannot be readClassNotFoundException
- if the class corresponding to the serialized object cannot be found
-
-
Serialized Fields
-
field
Field<T extends FieldElement<T>> field
Field to which the elements belong. -
keys
int[] keys
Keys table. -
mask
int mask
Bit mask for hash values. -
missingEntries
T extends FieldElement<T> missingEntries
Return value for missing entries. -
size
int size
Current size of the map. -
states
byte[] states
States table. -
values
T extends FieldElement<T>[] values
Values table.
-
-
Class org.apache.commons.math3.util.RandomPivotingStrategy extends Object implements Serializable
- serialVersionUID:
- 20140713L
-
Serialized Fields
-
random
RandomGenerator random
Random generator to use for selecting pivot.
-
-
Class org.apache.commons.math3.util.ResizableDoubleArray extends Object implements Serializable
- serialVersionUID:
- -3485529955529426875L
-
Serialized Fields
-
contractionCriterion
double contractionCriterion
The contraction criteria determines when the internal array will be contracted to fit the number of elements contained in the element array + 1. -
expansionFactor
double expansionFactor
The expansion factor of the array. When the array needs to be expanded, the new array size will beinternalArray.length * expansionFactor
ifexpansionMode
is set to MULTIPLICATIVE_MODE, orinternalArray.length + expansionFactor
ifexpansionMode
is set to ADDITIVE_MODE. -
expansionMode
ResizableDoubleArray.ExpansionMode expansionMode
Determines whether array expansion byexpansionFactor
is additive or multiplicative. -
internalArray
double[] internalArray
The internal storage array. -
numElements
int numElements
The number of addressable elements in the array. Note that this has nothing to do with the length of the internal storage array. -
startIndex
int startIndex
The position of the first addressable element in the internal storage array. The addressable elements in the array areinternalArray[startIndex],...,internalArray[startIndex + numElements - 1]
.
-
-
Class org.apache.commons.math3.util.TransformerMap extends Object implements Serializable
- serialVersionUID:
- 4605318041528645258L
-
Serialized Fields
-
defaultTransformer
NumberTransformer defaultTransformer
A default Number Transformer for Numbers and numeric Strings. -
map
Map<Class<?>,NumberTransformer> map
The internal Map.
-
-