Serialized Form


Package org.apache.commons.math

Class org.apache.commons.math.ArgumentOutsideDomainException extends FunctionEvaluationException implements Serializable

serialVersionUID: -4965972841162580234L

Class org.apache.commons.math.ConvergenceException extends MathException implements Serializable

serialVersionUID: 4380655778005469702L

Class org.apache.commons.math.DimensionMismatchException extends MathException implements Serializable

serialVersionUID: -1316089546353786411L

Serialized Fields

dimension1

int dimension1
First dimension.


dimension2

int dimension2
Second dimension.

Class org.apache.commons.math.DuplicateSampleAbscissaException extends MathException implements Serializable

serialVersionUID: -2271007547170169872L

Class org.apache.commons.math.FunctionEvaluationException extends MathException implements Serializable

serialVersionUID: -7619974756160279127L

Serialized Fields

argument

double argument
Argument causing function evaluation failure

Class org.apache.commons.math.MathConfigurationException extends MathException implements Serializable

serialVersionUID: -4056541384141349722L

Class org.apache.commons.math.MathException extends java.lang.Exception implements Serializable

serialVersionUID: -8602234299177097102L

Serialized Fields

pattern

java.lang.String pattern
Pattern used to build the message.


arguments

java.lang.Object[] arguments
Arguments used to build the message.


rootCause

java.lang.Throwable rootCause
Root cause of the exception

Class org.apache.commons.math.MaxIterationsExceededException extends ConvergenceException implements Serializable

serialVersionUID: -2154780004193976271L

Serialized Fields

maxIterations

int maxIterations
Maximal number of iterations allowed.


Package org.apache.commons.math.analysis

Class org.apache.commons.math.analysis.BisectionSolver extends UnivariateRealSolverImpl implements Serializable

serialVersionUID: 4963578633786538912L

Class org.apache.commons.math.analysis.BrentSolver extends UnivariateRealSolverImpl implements Serializable

serialVersionUID: -2136672307739067002L

Class org.apache.commons.math.analysis.DividedDifferenceInterpolator extends java.lang.Object implements Serializable

serialVersionUID: 107049519551235069L

Class org.apache.commons.math.analysis.LaguerreSolver extends UnivariateRealSolverImpl implements Serializable

serialVersionUID: -3775334783473775723L

Serialized Fields

p

PolynomialFunction p
polynomial function to solve

Class org.apache.commons.math.analysis.MullerSolver extends UnivariateRealSolverImpl implements Serializable

serialVersionUID: 6552227503458976920L

Class org.apache.commons.math.analysis.NevilleInterpolator extends java.lang.Object implements Serializable

serialVersionUID: 3003707660147873733L

Class org.apache.commons.math.analysis.NewtonSolver extends UnivariateRealSolverImpl implements Serializable

serialVersionUID: 2067325783137941016L

Serialization Methods

readObject

private void readObject(java.io.ObjectInputStream in)
                 throws java.io.IOException,
                        java.lang.ClassNotFoundException
Custom deserialization to initialize transient deriviate field.

Throws:
java.io.IOException - if IO error occurs
java.lang.ClassNotFoundException - if instantiation error occurs

Class org.apache.commons.math.analysis.PolynomialFunction extends java.lang.Object implements Serializable

serialVersionUID: 3322454535052136809L

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.

Class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm extends java.lang.Object implements Serializable

serialVersionUID: -3965199246151093920L

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.


x

double[] x
Interpolating points (abscissas) and the function values at these points.


y

double[] y
Interpolating points (abscissas) and the function values at these points.


coefficientsComputed

boolean coefficientsComputed
Whether the polynomial coefficients are available.

Class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm extends java.lang.Object implements Serializable

serialVersionUID: -3353896576191389897L

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.


a

double[] a
Members of c[] are called centers of the Newton polynomial. When all c[i] = 0, a[] becomes normal polynomial coefficients, i.e. a[i] = coefficients[i].


c

double[] c
Members of c[] are called centers of the Newton polynomial. When all c[i] = 0, a[] becomes normal polynomial coefficients, i.e. a[i] = coefficients[i].


coefficientsComputed

boolean coefficientsComputed
Whether the polynomial coefficients are available.

Class org.apache.commons.math.analysis.PolynomialSplineFunction extends java.lang.Object implements Serializable

serialVersionUID: 1619940313389547244L

Serialized Fields

knots

double[] knots
Spline segment interval delimiters (knots). Size is n+1 for n segments.


polynomials

PolynomialFunction[] polynomials
The polynomial functions that make up the spline. The first element determines the value of the spline over the first subinterval, the second over the second, etc. Spline function values are determined by evaluating these functions at (x - knot[i]) where i is the knot segment to which x belongs.


n

int n
Number of spline segments = number of polynomials = number of partition points - 1

Class org.apache.commons.math.analysis.RiddersSolver extends UnivariateRealSolverImpl implements Serializable

serialVersionUID: -4703139035737911735L

Class org.apache.commons.math.analysis.RombergIntegrator extends UnivariateRealIntegratorImpl implements Serializable

serialVersionUID: -1058849527738180243L

Class org.apache.commons.math.analysis.SecantSolver extends UnivariateRealSolverImpl implements Serializable

serialVersionUID: 1984971194738974867L

Class org.apache.commons.math.analysis.SimpsonIntegrator extends UnivariateRealIntegratorImpl implements Serializable

serialVersionUID: 3405465123320678216L

Class org.apache.commons.math.analysis.TrapezoidIntegrator extends UnivariateRealIntegratorImpl implements Serializable

serialVersionUID: 4978222553983172543L

Serialized Fields

s

double s
intermediate result

Class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl extends java.lang.Object implements Serializable

serialVersionUID: -3365294665201465048L

Serialized Fields

relativeAccuracy

double relativeAccuracy
maximum relative error


maximalIterationCount

int maximalIterationCount
maximum number of iterations


minimalIterationCount

int minimalIterationCount
minimum number of iterations


defaultRelativeAccuracy

double defaultRelativeAccuracy
default maximum relative error


defaultMaximalIterationCount

int defaultMaximalIterationCount
default maximum number of iterations


defaultMinimalIterationCount

int defaultMinimalIterationCount
default minimum number of iterations


resultComputed

boolean resultComputed
indicates whether an integral has been computed


result

double result
the last computed integral


iterationCount

int iterationCount
the last iteration count


f

UnivariateRealFunction f
the integrand function

Class org.apache.commons.math.analysis.UnivariateRealSolverImpl extends java.lang.Object implements Serializable

serialVersionUID: 1112491292565386596L

Serialized Fields

absoluteAccuracy

double absoluteAccuracy
Maximum absolute error.


relativeAccuracy

double relativeAccuracy
Maximum relative error.


functionValueAccuracy

double functionValueAccuracy
Maximum error of function.


maximalIterationCount

int maximalIterationCount
Maximum number of iterations.


defaultAbsoluteAccuracy

double defaultAbsoluteAccuracy
Default maximum absolute error.


defaultRelativeAccuracy

double defaultRelativeAccuracy
Default maximum relative error.


defaultFunctionValueAccuracy

double defaultFunctionValueAccuracy
Default maximum error of function.


defaultMaximalIterationCount

int defaultMaximalIterationCount
Default maximum number of iterations.


resultComputed

boolean resultComputed
Indicates where a root has been computed.


result

double result
The last computed root.


iterationCount

int iterationCount
The last iteration count.


f

UnivariateRealFunction f
The function to solve.


Package org.apache.commons.math.complex

Class org.apache.commons.math.complex.Complex extends java.lang.Object implements Serializable

serialVersionUID: -6530173849413811929L

Serialized Fields

imaginary

double imaginary
Deprecated. to be made final and private in 2.0
The imaginary part


real

double real
Deprecated. to be made final and private in 2.0
The real part

Class org.apache.commons.math.complex.ComplexFormat extends java.text.Format implements Serializable

serialVersionUID: -6337346779577272306L

Serialized Fields

imaginaryCharacter

java.lang.String imaginaryCharacter
The notation used to signify the imaginary part of the complex number.


imaginaryFormat

java.text.NumberFormat imaginaryFormat
The format used for the imaginary part.


realFormat

java.text.NumberFormat realFormat
The format used for the real part.


Package org.apache.commons.math.distribution

Class org.apache.commons.math.distribution.AbstractContinuousDistribution extends AbstractDistribution implements Serializable

serialVersionUID: -38038050983108802L

Class org.apache.commons.math.distribution.AbstractDistribution extends java.lang.Object implements Serializable

serialVersionUID: -38038050983108802L

Class org.apache.commons.math.distribution.AbstractIntegerDistribution extends AbstractDistribution implements Serializable

serialVersionUID: -1146319659338487221L

Class org.apache.commons.math.distribution.BinomialDistributionImpl 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.math.distribution.CauchyDistributionImpl extends AbstractContinuousDistribution implements Serializable

serialVersionUID: 8589540077390120676L

Serialized Fields

median

double median
The median of this distribution.


scale

double scale
The scale of this distribution.

Class org.apache.commons.math.distribution.ChiSquaredDistributionImpl extends AbstractContinuousDistribution implements Serializable

serialVersionUID: -8352658048349159782L

Serialized Fields

gamma

GammaDistribution gamma
Internal Gamma distribution.

Class org.apache.commons.math.distribution.ExponentialDistributionImpl extends AbstractContinuousDistribution implements Serializable

serialVersionUID: 2401296428283614780L

Serialized Fields

mean

double mean
The mean of this distribution.

Class org.apache.commons.math.distribution.FDistributionImpl extends AbstractContinuousDistribution implements Serializable

serialVersionUID: -8516354193418641566L

Serialized Fields

numeratorDegreesOfFreedom

double numeratorDegreesOfFreedom
The numerator degrees of freedom


denominatorDegreesOfFreedom

double denominatorDegreesOfFreedom
The numerator degrees of freedom

Class org.apache.commons.math.distribution.GammaDistributionImpl extends AbstractContinuousDistribution implements Serializable

serialVersionUID: -3239549463135430361L

Serialized Fields

alpha

double alpha
The shape parameter.


beta

double beta
The scale parameter.

Class org.apache.commons.math.distribution.HypergeometricDistributionImpl extends AbstractIntegerDistribution implements Serializable

serialVersionUID: -436928820673516179L

Serialized Fields

numberOfSuccesses

int numberOfSuccesses
The number of successes in the population.


populationSize

int populationSize
The population size.


sampleSize

int sampleSize
The sample size.

Class org.apache.commons.math.distribution.NormalDistributionImpl extends AbstractContinuousDistribution implements Serializable

serialVersionUID: 8589540077390120676L

Serialized Fields

mean

double mean
The mean of this distribution.


standardDeviation

double standardDeviation
The standard deviation of this distribution.

Class org.apache.commons.math.distribution.PascalDistributionImpl extends AbstractIntegerDistribution implements Serializable

serialVersionUID: 6751309484392813623L

Serialized Fields

numberOfSuccesses

int numberOfSuccesses
The number of successes


probabilityOfSuccess

double probabilityOfSuccess
The probability of success

Class org.apache.commons.math.distribution.PoissonDistributionImpl extends AbstractIntegerDistribution implements Serializable

serialVersionUID: -3349935121172596109L

Serialized Fields

normal

NormalDistribution normal
Distribution used to compute normal approximation.


mean

double mean
Holds the Poisson mean for the distribution.

Class org.apache.commons.math.distribution.TDistributionImpl extends AbstractContinuousDistribution implements Serializable

serialVersionUID: -5852615386664158222L

Serialized Fields

degreesOfFreedom

double degreesOfFreedom
The degrees of freedom

Class org.apache.commons.math.distribution.WeibullDistributionImpl extends AbstractContinuousDistribution implements Serializable

serialVersionUID: 8589540077390120676L

Serialized Fields

alpha

double alpha
The shape parameter.


beta

double beta
The scale parameter.


Package org.apache.commons.math.estimation

Class org.apache.commons.math.estimation.EstimatedParameter extends java.lang.Object implements Serializable

serialVersionUID: -555440800213416949L

Serialized Fields

name

java.lang.String name
Name of the parameter


estimate

double estimate
Current value of the parameter


bound

boolean bound
Indicator for bound parameters (ie parameters that should not be estimated)

Class org.apache.commons.math.estimation.EstimationException extends MathException implements Serializable

serialVersionUID: -573038581493881337L

Class org.apache.commons.math.estimation.GaussNewtonEstimator extends AbstractEstimator implements Serializable

serialVersionUID: 5485001826076289109L

Serialized Fields

steadyStateThreshold

double steadyStateThreshold
Threshold for cost steady state detection.


convergence

double convergence
Threshold for cost convergence.

Class org.apache.commons.math.estimation.LevenbergMarquardtEstimator extends AbstractEstimator implements Serializable

serialVersionUID: -5705952631533171019L

Serialized Fields

solvedCols

int solvedCols
Number of solved variables.


diagR

double[] diagR
Diagonal elements of the R matrix in the Q.R. decomposition.


jacNorm

double[] jacNorm
Norms of the columns of the jacobian matrix.


beta

double[] beta
Coefficients of the Householder transforms vectors.


permutation

int[] permutation
Columns permutation array.


rank

int rank
Rank of the jacobian matrix.


lmPar

double lmPar
Levenberg-Marquardt parameter.


lmDir

double[] lmDir
Parameters evolution direction associated with lmPar.


initialStepBoundFactor

double initialStepBoundFactor
Positive input variable used in determining the initial step bound.


costRelativeTolerance

double costRelativeTolerance
Desired relative error in the sum of squares.


parRelativeTolerance

double parRelativeTolerance
Desired relative error in the approximate solution parameters.


orthoTolerance

double orthoTolerance
Desired max cosine on the orthogonality between the function vector and the columns of the jacobian.

Class org.apache.commons.math.estimation.WeightedMeasurement extends java.lang.Object implements Serializable

Serialized Fields

weight

double weight
Measurement weight.


measuredValue

double measuredValue
Value of the measurements.


ignored

boolean ignored
Ignore measurement indicator.


Package org.apache.commons.math.fraction

Class org.apache.commons.math.fraction.Fraction extends java.lang.Number implements Serializable

serialVersionUID: -8958519416450949235L

Serialized Fields

denominator

int denominator
The denominator.


numerator

int numerator
The numerator.

Class org.apache.commons.math.fraction.FractionConversionException extends ConvergenceException implements Serializable

serialVersionUID: -4661812640132576263L

Class org.apache.commons.math.fraction.FractionFormat extends java.text.Format implements Serializable

serialVersionUID: -6337346779577272306L

Serialized Fields

denominatorFormat

java.text.NumberFormat denominatorFormat
The format used for the denominator.


numeratorFormat

java.text.NumberFormat numeratorFormat
The format used for the numerator.

Class org.apache.commons.math.fraction.ProperFractionFormat extends FractionFormat implements Serializable

serialVersionUID: -6337346779577272307L

Serialized Fields

wholeFormat

java.text.NumberFormat wholeFormat
The format used for the whole number.


Package org.apache.commons.math.geometry

Class org.apache.commons.math.geometry.CardanEulerSingularityException extends MathException implements Serializable

serialVersionUID: -1360952845582206770L

Class org.apache.commons.math.geometry.NotARotationMatrixException extends MathException implements Serializable

serialVersionUID: 5647178478658937642L

Class org.apache.commons.math.geometry.Rotation extends java.lang.Object implements Serializable

serialVersionUID: 8225864499430109352L

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.math.geometry.Vector3D extends java.lang.Object implements Serializable

serialVersionUID: -5721105387745193385L

Serialized Fields

x

double x
Abscissa.


y

double y
Ordinate.


z

double z
Height.


Package org.apache.commons.math.linear

Class org.apache.commons.math.linear.BigMatrixImpl extends java.lang.Object implements Serializable

serialVersionUID: -1011428905656140431L

Serialized Fields

data

java.math.BigDecimal[][] data
Entries of the matrix


lu

java.math.BigDecimal[][] lu
Entries of cached LU decomposition. All updates to data (other than luDecompose()) *must* set this to null


permutation

int[] permutation
Permutation associated with LU decomposition


parity

int parity
Parity of the permutation associated with the LU decomposition


roundingMode

int roundingMode
Rounding mode for divisions


scale

int scale
BigDecimal scale

Class org.apache.commons.math.linear.InvalidMatrixException extends java.lang.RuntimeException implements Serializable

serialVersionUID: 5318837237354354107L

Class org.apache.commons.math.linear.MatrixIndexException extends java.lang.RuntimeException implements Serializable

serialVersionUID: -1341109412864309526L

Class org.apache.commons.math.linear.RealMatrixImpl extends java.lang.Object implements Serializable

serialVersionUID: 4237564493130426188L

Serialized Fields

data

double[][] data
Entries of the matrix


lu

double[][] lu
Entries of cached LU decomposition. All updates to data (other than luDecompose()) *must* set this to null


permutation

int[] permutation
Permutation associated with LU decomposition


parity

int parity
Parity of the permutation associated with the LU decomposition


Package org.apache.commons.math.ode

Class org.apache.commons.math.ode.AbstractStepInterpolator extends java.lang.Object implements Serializable

Serialization Methods

readExternal

public abstract void readExternal(java.io.ObjectInput in)
                           throws java.io.IOException
Read the instance from an input channel.

Throws:
java.io.IOException - if the instance cannot be read

writeExternal

public abstract void writeExternal(java.io.ObjectOutput out)
                            throws java.io.IOException
Write the instance to an output channel.

Throws:
java.io.IOException - if the instance cannot be written

Class org.apache.commons.math.ode.ContinuousOutputModel extends java.lang.Object implements Serializable

serialVersionUID: 2259286184268533249L

Serialized Fields

initialTime

double initialTime
Initial integration time.


finalTime

double finalTime
Final integration time.


forward

boolean forward
Integration direction indicator.


index

int index
Current interpolator index.


steps

java.util.ArrayList<E> steps
Steps table.

Class org.apache.commons.math.ode.DerivativeException extends MathException implements Serializable

serialVersionUID: -4100440615830558122L

Class org.apache.commons.math.ode.DummyStepHandler extends java.lang.Object implements Serializable

serialVersionUID: 2731635121223090252L

Class org.apache.commons.math.ode.DummyStepInterpolator extends AbstractStepInterpolator implements Serializable

serialVersionUID: 1708010296707839488L

Serialization Methods

readExternal

public void readExternal(java.io.ObjectInput in)
                  throws java.io.IOException
Read the instance from an input channel.

Throws:
java.io.IOException - if the instance cannot be read

writeExternal

public void writeExternal(java.io.ObjectOutput out)
                   throws java.io.IOException
Write the instance to an output channel.

Throws:
java.io.IOException - if the instance cannot be written

Class org.apache.commons.math.ode.IntegratorException extends MathException implements Serializable

serialVersionUID: -1215318282266670558L


Package org.apache.commons.math.optimization

Class org.apache.commons.math.optimization.CostException extends MathException implements Serializable

serialVersionUID: 467695563268795689L


Package org.apache.commons.math.random

Class org.apache.commons.math.random.AbstractRandomGenerator extends java.lang.Object implements Serializable

Serialized Fields

cachedNormalDeviate

double cachedNormalDeviate
Cached random normal value. The default implementation for AbstractRandomGenerator.nextGaussian() generates pairs of values and this field caches the second value so that the full algorithm is not executed for every activation. The value Double.NaN signals that there is no cached value. Use AbstractRandomGenerator.clear() to clear the cached value.

Class org.apache.commons.math.random.EmpiricalDistributionImpl extends java.lang.Object implements Serializable

serialVersionUID: -6773236347582113490L

Serialized Fields

binStats

java.util.ArrayList<E> binStats
List of SummaryStatistics objects characterizing the bins


sampleStats

SummaryStatistics sampleStats
Sample statistics


binCount

int binCount
number of bins


loaded

boolean loaded
is the distribution loaded?


upperBounds

double[] upperBounds
upper bounds of subintervals in (0,1) "belonging" to the bins


randomData

RandomData randomData
RandomData instance to use in repeated calls to getNext()

Class org.apache.commons.math.random.JDKRandomGenerator extends java.util.Random implements Serializable

serialVersionUID: -3561898582944940550L

Class org.apache.commons.math.random.NotPositiveDefiniteMatrixException extends MathException implements Serializable

serialVersionUID: 4122929125438624648L

Class org.apache.commons.math.random.RandomAdaptor extends java.util.Random implements Serializable

serialVersionUID: 2570805822599485047L

Serialized Fields

randomGenerator

RandomGenerator randomGenerator
Wrapped randomGenerator instance

Class org.apache.commons.math.random.RandomDataImpl extends java.lang.Object implements Serializable

serialVersionUID: -626730818244969716L

Serialized Fields

rand

RandomGenerator rand
underlying random number generator


secRand

java.security.SecureRandom secRand
underlying secure random number generator


Package org.apache.commons.math.special

Class org.apache.commons.math.special.Beta extends java.lang.Object implements Serializable

serialVersionUID: -3833485397404128220L

Class org.apache.commons.math.special.Erf extends java.lang.Object implements Serializable

serialVersionUID: 490960015010326571L

Class org.apache.commons.math.special.Gamma extends java.lang.Object implements Serializable

serialVersionUID: -6587513359895466954L


Package org.apache.commons.math.stat

Class org.apache.commons.math.stat.Frequency extends java.lang.Object implements Serializable

serialVersionUID: -3845586908418844111L

Serialized Fields

freqTable

java.util.TreeMap<K,V> freqTable
underlying collection


Package org.apache.commons.math.stat.descriptive

Class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic extends AbstractUnivariateStatistic implements Serializable

serialVersionUID: -44915725420072521L

Class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic extends java.lang.Object implements Serializable

serialVersionUID: -8007759382851708045L

Class org.apache.commons.math.stat.descriptive.DescriptiveStatistics extends java.lang.Object implements Serializable

serialVersionUID: -2734185686570407433L

Serialized Fields

windowSize

int windowSize
hold the window size


eDA

ResizableDoubleArray eDA
Stored data values


meanImpl

UnivariateStatistic meanImpl
Mean statistic implementation - can be reset by setter.


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.


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.


varianceImpl

UnivariateStatistic varianceImpl
Variance statistic implementation - can be reset by setter.


sumsqImpl

UnivariateStatistic sumsqImpl
Sum of squares statistic implementation - can be reset by setter.


sumImpl

UnivariateStatistic sumImpl
Sum statistic implementation - can be reset by setter.

Class org.apache.commons.math.stat.descriptive.DescriptiveStatisticsImpl extends DescriptiveStatistics implements Serializable

serialVersionUID: -6467796944112488424L

Class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics extends java.lang.Object implements Serializable

serialVersionUID: 2271900808994826718L

Serialized Fields

k

int k
Dimension of the data.


n

long n
Count of values that have been added


sumImpl

StorelessUnivariateStatistic[] sumImpl
Sum statistic implementation - can be reset by setter.


sumSqImpl

StorelessUnivariateStatistic[] sumSqImpl
Sum of squares statistic implementation - can be reset by setter.


minImpl

StorelessUnivariateStatistic[] minImpl
Minimum statistic implementation - can be reset by setter.


maxImpl

StorelessUnivariateStatistic[] maxImpl
Maximum statistic implementation - can be reset by setter.


sumLogImpl

StorelessUnivariateStatistic[] sumLogImpl
Sum of log statistic implementation - can be reset by setter.


geoMeanImpl

StorelessUnivariateStatistic[] geoMeanImpl
Geometric mean statistic implementation - can be reset by setter.


meanImpl

StorelessUnivariateStatistic[] meanImpl
Mean statistic implementation - can be reset by setter.


covarianceImpl

VectorialCovariance covarianceImpl
Covariance statistic implementation - cannot be reset.

Class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues extends java.lang.Object implements Serializable

serialVersionUID: -5108854841843722536L

Serialized Fields

mean

double mean
The sample mean


variance

double variance
The sample variance


n

long n
The number of observations in the sample


max

double max
The maximum value


min

double min
The minimum value


sum

double sum
The sum of the sample values

Class org.apache.commons.math.stat.descriptive.SummaryStatistics extends java.lang.Object implements Serializable

serialVersionUID: -3346512372447011854L

Serialized Fields

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


sumsq

SumOfSquares sumsq
sum of the square of each value that has been added


min

Min min
min of values that have been added


max

Max max
max of values that have been added


sumLog

SumOfLogs sumLog
sumLog of values that have been added


geoMean

GeometricMean geoMean
geoMean of values that have been added


mean

Mean mean
mean of values that have been added


variance

Variance variance
variance of values that have been added


sumImpl

StorelessUnivariateStatistic sumImpl
Sum statistic implementation - can be reset by setter.


sumsqImpl

StorelessUnivariateStatistic sumsqImpl
Sum of squares statistic implementation - can be reset by setter.


minImpl

StorelessUnivariateStatistic minImpl
Minimum statistic implementation - can be reset by setter.


maxImpl

StorelessUnivariateStatistic maxImpl
Maximum statistic implementation - can be reset by setter.


sumLogImpl

StorelessUnivariateStatistic sumLogImpl
Sum of log statistic implementation - can be reset by setter.


geoMeanImpl

StorelessUnivariateStatistic geoMeanImpl
Geometric mean statistic implementation - can be reset by setter.


meanImpl

StorelessUnivariateStatistic meanImpl
Mean statistic implementation - can be reset by setter.


varianceImpl

StorelessUnivariateStatistic varianceImpl
Variance statistic implementation - can be reset by setter.

Class org.apache.commons.math.stat.descriptive.SummaryStatisticsImpl extends SummaryStatistics implements Serializable

serialVersionUID: 8528794411480425963L

Class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics extends DescriptiveStatistics implements Serializable

serialVersionUID: 1L

Class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics extends MultivariateSummaryStatistics implements Serializable

serialVersionUID: 7099834153347155363L

Class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics extends SummaryStatistics implements Serializable

serialVersionUID: 1909861009042253704L


Package org.apache.commons.math.stat.descriptive.moment

Class org.apache.commons.math.stat.descriptive.moment.FirstMoment extends AbstractStorelessUnivariateStatistic implements Serializable

serialVersionUID: -803343206421984070L

Serialized Fields

n

long n
Count of values that have been added


m1

double m1
First moment of values that have been added


dev

double dev
Deviation of most recently added value from previous first moment. Retained to prevent repeated computation in higher order moments.


nDev

double nDev
Deviation of most recently added value from previous first moment, normalized by previous sample size. Retained to prevent repeated computation in higher order moments

Class org.apache.commons.math.stat.descriptive.moment.FourthMoment extends ThirdMoment implements Serializable

serialVersionUID: 4763990447117157611L

Serialized Fields

m4

double m4
fourth moment of values that have been added

Class org.apache.commons.math.stat.descriptive.moment.GeometricMean extends AbstractStorelessUnivariateStatistic implements Serializable

serialVersionUID: -8178734905303459453L

Serialized Fields

sumOfLogs

StorelessUnivariateStatistic sumOfLogs
Wrapped SumOfLogs instance

Class org.apache.commons.math.stat.descriptive.moment.Kurtosis extends AbstractStorelessUnivariateStatistic implements Serializable

serialVersionUID: 2784465764798260919L

Serialized Fields

moment

FourthMoment moment
Fourth Moment on which this statistic is based


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.

Class org.apache.commons.math.stat.descriptive.moment.Mean extends AbstractStorelessUnivariateStatistic implements Serializable

serialVersionUID: -1296043746617791564L

Serialized Fields

moment

FirstMoment moment
First moment on which this statistic is based.


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.

Class org.apache.commons.math.stat.descriptive.moment.SecondMoment extends FirstMoment implements Serializable

serialVersionUID: 3942403127395076445L

Serialized Fields

m2

double m2
second moment of values that have been added

Class org.apache.commons.math.stat.descriptive.moment.Skewness extends AbstractStorelessUnivariateStatistic implements Serializable

serialVersionUID: 7101857578996691352L

Serialized Fields

moment

ThirdMoment moment
Third moment on which this statistic is based


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.

Class org.apache.commons.math.stat.descriptive.moment.StandardDeviation extends AbstractStorelessUnivariateStatistic implements Serializable

serialVersionUID: 5728716329662425188L

Serialized Fields

variance

Variance variance
Wrapped Variance instance

Class org.apache.commons.math.stat.descriptive.moment.ThirdMoment extends SecondMoment implements Serializable

serialVersionUID: -7818711964045118679L

Serialized Fields

m3

double m3
third moment of values that have been added


nDevSq

double nDevSq
Square of deviation of most recently added value from previous first moment, normalized by previous sample size. Retained to prevent repeated computation in higher order moments. nDevSq = nDev * nDev.

Class org.apache.commons.math.stat.descriptive.moment.Variance extends AbstractStorelessUnivariateStatistic implements Serializable

serialVersionUID: -9111962718267217978L

Serialized Fields

moment

SecondMoment moment
SecondMoment is used in incremental calculation of Variance


incMoment

boolean incMoment
Boolean test to determine if this Variance should also increment the second moment, this evaluates to false when this Variance is constructed with an external SecondMoment as a parameter.


isBiasCorrected

boolean isBiasCorrected
Determines whether or not bias correction is applied when computing the value of the statisic. True means that bias is corrected. See Variance for details on the formula.

Class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance extends java.lang.Object implements Serializable

serialVersionUID: 4118372414238930270L

Serialized Fields

sums

double[] sums
Sums for each component.


productsSums

double[] productsSums
Sums of products for each component.


isBiasCorrected

boolean isBiasCorrected
Indicator for bias correction.


n

long n
Number of vectors in the sample.

Class org.apache.commons.math.stat.descriptive.moment.VectorialMean extends java.lang.Object implements Serializable

serialVersionUID: 8223009086481006892L

Serialized Fields

means

Mean[] means
Means for each component.


Package org.apache.commons.math.stat.descriptive.rank

Class org.apache.commons.math.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.math.stat.descriptive.rank.Median extends Percentile implements Serializable

serialVersionUID: -3961477041290915687L

Class org.apache.commons.math.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.math.stat.descriptive.rank.Percentile extends AbstractUnivariateStatistic implements Serializable

serialVersionUID: -8091216485095130416L

Serialized Fields

quantile

double quantile
Determines what percentile is computed when evaluate() is activated with no quantile argument


Package org.apache.commons.math.stat.descriptive.summary

Class org.apache.commons.math.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.math.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.math.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.math.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.math.stat.regression

Class org.apache.commons.math.stat.regression.SimpleRegression extends java.lang.Object implements Serializable

serialVersionUID: -3004689053607543335L

Serialized Fields

distribution

TDistribution distribution
the distribution used to compute inference statistics.


sumX

double sumX
sum of x values


sumXX

double sumXX
total variation in x (sum of squared deviations from xbar)


sumY

double sumY
sum of y values


sumYY

double sumYY
total variation in y (sum of squared deviations from ybar)


sumXY

double sumXY
sum of products


n

long n
number of observations


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.math.transform

Class org.apache.commons.math.transform.FastCosineTransformer extends java.lang.Object implements Serializable

serialVersionUID: -7673941545134707766L

Class org.apache.commons.math.transform.FastFourierTransformer extends java.lang.Object implements Serializable

serialVersionUID: 5138259215438106000L

Serialized Fields

omega

Complex[] omega
array of the roots of unity


omegaCount

int omegaCount
|omegaCount| is the length of lasted computed omega[]. omegaCount is positive for forward transform and negative for inverse transform.

Class org.apache.commons.math.transform.FastSineTransformer extends java.lang.Object implements Serializable

serialVersionUID: -478002039949390854L


Package org.apache.commons.math.util

Class org.apache.commons.math.util.ContinuedFraction extends java.lang.Object implements Serializable

serialVersionUID: 1768555336266158242L

Class org.apache.commons.math.util.DefaultTransformer extends java.lang.Object implements Serializable

serialVersionUID: 4019938025047800455L

Class org.apache.commons.math.util.ResizableDoubleArray extends java.lang.Object implements Serializable

serialVersionUID: -3485529955529426875L

Serialized Fields

contractionCriteria

float contractionCriteria
The contraction criteria determines when the internal array will be contracted to fit the number of elements contained in the element array + 1.


expansionFactor

float expansionFactor
The expansion factor of the array. When the array needs to be expanded, the new array size will be internalArray.length * expansionFactor if expansionMode is set to MULTIPLICATIVE_MODE, or internalArray.length + expansionFactor if expansionMode is set to ADDITIVE_MODE.


expansionMode

int expansionMode
Determines whether array expansion by expansionFactor is additive or multiplicative.


initialCapacity

int initialCapacity
The initial capacity of the array. Initial capacity is not exposed as a property as it is only meaningful when passed to a constructor.


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 are internalArray[startIndex],...,internalArray[startIndex + numElements -1]

Class org.apache.commons.math.util.TransformerMap extends java.lang.Object implements Serializable

serialVersionUID: -942772950698439883L

Serialized Fields

defaultTransformer

NumberTransformer defaultTransformer
A default Number Transformer for Numbers and numeric Strings.


map

java.util.Map<K,V> map
The internal Map.