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: -1111352570797662604L

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

serialVersionUID: -1316089546353786411L

Serialized Fields

dimension1

int dimension1
Deprecated. 
First dimension.


dimension2

int dimension2
Deprecated. 
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: 1384427981840836868L

Serialized Fields

argument

double[] argument
Argument causing function evaluation failure

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

serialVersionUID: 5261476508226103366L

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

serialVersionUID: 7428019509644517071L

Serialized Fields

pattern

Localizable pattern
Pattern used to build the message.


arguments

Object[] arguments
Arguments used to build the message.

Class org.apache.commons.math.MathRuntimeException extends RuntimeException implements Serializable

serialVersionUID: 9058794795027570002L

Serialized Fields

pattern

Localizable pattern
Pattern used to build the message.


arguments

Object[] arguments
Arguments used to build the message.

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

serialVersionUID: -5921271447220129118L

Serialized Fields

maxEvaluations

int maxEvaluations
Maximal number of evaluations allowed.

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

serialVersionUID: -7821226672760574694L

Serialized Fields

maxIterations

int maxIterations
Maximal number of iterations allowed.


Package org.apache.commons.math.analysis.interpolation

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

serialVersionUID: 107049519551235069L

Class org.apache.commons.math.analysis.interpolation.LoessInterpolator extends Object implements Serializable

serialVersionUID: 5204927143605193821L

Serialized Fields

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.


accuracy

double accuracy
If the median residual at a certain robustness iteration is less than this amount, no more iterations are done.

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

serialVersionUID: 3003707660147873733L


Package org.apache.commons.math.analysis.polynomials

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

Class org.apache.commons.math.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 override Complex.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.math.complex.ComplexField extends Object implements Serializable

serialVersionUID: -6130362688700788798L

Serialization Methods

readResolve

private Object readResolve()
Handle deserialization of the singleton.

Class org.apache.commons.math.complex.ComplexFormat extends CompositeFormat implements Serializable

serialVersionUID: -3343698360149467646L

Serialized Fields

imaginaryCharacter

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


imaginaryFormat

NumberFormat imaginaryFormat
The format used for the imaginary part.


realFormat

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

Serialized Fields

randomData

RandomDataImpl randomData
RandomData instance used to generate samples from the distribution

Since:
2.2

solverAbsoluteAccuracy

double solverAbsoluteAccuracy
Solver absolute accuracy for inverse cumulative computation

Since:
2.1

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

serialVersionUID: -38038050983108802L

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

serialVersionUID: -1146319659338487221L

Serialized Fields

randomData

RandomDataImpl randomData
RandomData instance used to generate samples from the distribution

Since:
2.2

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

serialVersionUID: -1221965979403477668L

Serialized Fields

alpha

double alpha
First shape parameter.


beta

double beta
Second shape parameter.


z

double z
Normalizing factor used in density computations. updated whenever alpha or beta are changed.


solverAbsoluteAccuracy

double solverAbsoluteAccuracy
Inverse cumulative probability accuracy

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.


solverAbsoluteAccuracy

double solverAbsoluteAccuracy
Inverse cumulative probability accuracy

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

serialVersionUID: -8352658048349159782L

Serialized Fields

gamma

GammaDistribution gamma
Internal Gamma distribution.


solverAbsoluteAccuracy

double solverAbsoluteAccuracy
Inverse cumulative probability accuracy

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

serialVersionUID: 2401296428283614780L

Serialized Fields

mean

double mean
The mean of this distribution.


solverAbsoluteAccuracy

double solverAbsoluteAccuracy
Inverse cumulative probability accuracy

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


solverAbsoluteAccuracy

double solverAbsoluteAccuracy
Inverse cumulative probability accuracy

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.


solverAbsoluteAccuracy

double solverAbsoluteAccuracy
Inverse cumulative probability accuracy

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.


solverAbsoluteAccuracy

double solverAbsoluteAccuracy
Inverse cumulative probability accuracy

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.


maxIterations

int maxIterations
Maximum number of iterations for cumulative probability. Cumulative probabilities are estimated using either Lanczos series approximation of Gamma#regularizedGammaP or continued fraction approximation of Gamma#regularizedGammaQ.


epsilon

double epsilon
Convergence criterion for cumulative probability.

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

serialVersionUID: -5852615386664158222L

Serialized Fields

degreesOfFreedom

double degreesOfFreedom
The degrees of freedom


solverAbsoluteAccuracy

double solverAbsoluteAccuracy
Inverse cumulative probability accuracy

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

serialVersionUID: 8589540077390120676L

Serialized Fields

shape

double shape
The shape parameter.


scale

double scale
The scale parameter.


solverAbsoluteAccuracy

double solverAbsoluteAccuracy
Inverse cumulative probability accuracy


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

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

serialVersionUID: -140627372283420404L

Serialized Fields

numberOfElements

int numberOfElements
Number of elements.


exponent

double exponent
Exponent parameter of the distribution.


Package org.apache.commons.math.estimation

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

serialVersionUID: -555440800213416949L

Serialized Fields

estimate

double estimate
Deprecated. 
Current value of the parameter


name

String name
Deprecated. 
Name of the parameter


bound

boolean bound
Deprecated. 
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
Deprecated. 
Threshold for cost steady state detection.


convergence

double convergence
Deprecated. 
Threshold for cost convergence.

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

serialVersionUID: -5705952631533171019L

Serialized Fields

solvedCols

int solvedCols
Deprecated. 
Number of solved variables.


diagR

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


jacNorm

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


beta

double[] beta
Deprecated. 
Coefficients of the Householder transforms vectors.


permutation

int[] permutation
Deprecated. 
Columns permutation array.


rank

int rank
Deprecated. 
Rank of the jacobian matrix.


lmPar

double lmPar
Deprecated. 
Levenberg-Marquardt parameter.


lmDir

double[] lmDir
Deprecated. 
Parameters evolution direction associated with lmPar.


initialStepBoundFactor

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


costRelativeTolerance

double costRelativeTolerance
Deprecated. 
Desired relative error in the sum of squares.


parRelativeTolerance

double parRelativeTolerance
Deprecated. 
Desired relative error in the approximate solution parameters.


orthoTolerance

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

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

serialVersionUID: 4360046376796901941L

Serialized Fields

weight

double weight
Deprecated. 
Measurement weight.


measuredValue

double measuredValue
Deprecated. 
Value of the measurements.


ignored

boolean ignored
Deprecated. 
Ignore measurement indicator.


Package org.apache.commons.math.exception

Class org.apache.commons.math.exception.ConvergenceException extends MathIllegalStateException implements Serializable

serialVersionUID: 4330003017885151975L

Class org.apache.commons.math.exception.DimensionMismatchException extends MathIllegalNumberException implements Serializable

serialVersionUID: -8415396756375798143L

Serialized Fields

dimension

int dimension
Correct dimension.

Class org.apache.commons.math.exception.MathIllegalArgumentException extends IllegalArgumentException implements Serializable

serialVersionUID: -6024911025449780478L

Serialized Fields

specific

Localizable specific
Pattern used to build the message (specific context).


general

Localizable general
Pattern used to build the message (general problem description).


arguments

Object[] arguments
Arguments used to build the message.

Class org.apache.commons.math.exception.MathIllegalNumberException extends MathIllegalArgumentException implements Serializable

serialVersionUID: -7447085893598031110L

Serialized Fields

argument

Number argument
Requested.

Class org.apache.commons.math.exception.MathIllegalStateException extends IllegalStateException implements Serializable

serialVersionUID: -6024911025449780478L

Serialized Fields

specific

Localizable specific
Pattern used to build the message (specific context).


general

Localizable general
Pattern used to build the message (general problem description).


arguments

Object[] arguments
Arguments used to build the message.

Class org.apache.commons.math.exception.MathInternalError extends MathIllegalStateException implements Serializable

serialVersionUID: -6276776513966934846L

Class org.apache.commons.math.exception.MathUnsupportedOperationException extends UnsupportedOperationException implements Serializable

serialVersionUID: -6024911025449780478L

Serialized Fields

specific

Localizable specific
Pattern used to build the message (specific context).


arguments

Object[] arguments
Arguments used to build the message.

Class org.apache.commons.math.exception.NoDataException extends MathIllegalStateException implements Serializable

serialVersionUID: -3629324471511904459L

Class org.apache.commons.math.exception.NonMonotonousSequenceException extends MathIllegalNumberException implements Serializable

serialVersionUID: 3596849179428944575L

Serialized Fields

direction

MathUtils.OrderDirection direction
Direction (positive for increasing, negative for decreasing).


strict

boolean strict
Whether the sequence must be strictly increasing or decreasing.


index

int index
Index of the wrong value.


previous

Number previous
Previous value.

Class org.apache.commons.math.exception.NotPositiveException extends NumberIsTooSmallException implements Serializable

serialVersionUID: -2250556892093726375L

Class org.apache.commons.math.exception.NotStrictlyPositiveException extends NumberIsTooSmallException implements Serializable

serialVersionUID: -7824848630829852237L

Class org.apache.commons.math.exception.NullArgumentException extends MathIllegalArgumentException implements Serializable

serialVersionUID: -6024911025449780478L

Class org.apache.commons.math.exception.NumberIsTooLargeException extends MathIllegalNumberException implements Serializable

serialVersionUID: 4330003017885151975L

Serialized Fields

max

Number max
Higher bound.


boundIsAllowed

boolean boundIsAllowed
Whether the maximum is included in the allowed range.

Class org.apache.commons.math.exception.NumberIsTooSmallException extends MathIllegalNumberException implements Serializable

serialVersionUID: -6100997100383932834L

Serialized Fields

min

Number min
Higher bound.


boundIsAllowed

boolean boundIsAllowed
Whether the maximum is included in the allowed range.

Class org.apache.commons.math.exception.OutOfRangeException extends MathIllegalNumberException implements Serializable

serialVersionUID: 111601815794403609L

Serialized Fields

lo

Number lo
Lower bound.


hi

Number hi
Higher bound.

Class org.apache.commons.math.exception.ZeroException extends MathIllegalNumberException implements Serializable

serialVersionUID: -1960874856936000015L


Package org.apache.commons.math.exception.util

Class org.apache.commons.math.exception.util.DummyLocalizable extends Object implements Serializable

serialVersionUID: 8843275624471387299L

Serialized Fields

source

String source
Source string.


Package org.apache.commons.math.fraction

Class org.apache.commons.math.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.math.fraction.BigFraction extends Number implements Serializable

serialVersionUID: -5630213147331578515L

Serialized Fields

numerator

BigInteger numerator
The numerator.


denominator

BigInteger denominator
The denominator.

Class org.apache.commons.math.fraction.BigFractionField extends Object implements Serializable

serialVersionUID: -1699294557189741703L

Serialization Methods

readResolve

private Object readResolve()
Handle deserialization of the singleton.

Class org.apache.commons.math.fraction.BigFractionFormat extends AbstractFormat implements Serializable

serialVersionUID: -2932167925527338976L

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

serialVersionUID: 3698073679419233275L

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.FractionField extends Object implements Serializable

serialVersionUID: -1257768487499119313L

Serialization Methods

readResolve

private Object readResolve()
Handle deserialization of the singleton.

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

serialVersionUID: 3008655719530972611L

Class org.apache.commons.math.fraction.ProperBigFractionFormat extends BigFractionFormat implements Serializable

serialVersionUID: -6337346779577272307L

Serialized Fields

wholeFormat

NumberFormat wholeFormat
The format used for the whole number.

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

serialVersionUID: 760934726031766749L

Serialized Fields

wholeFormat

NumberFormat wholeFormat
The format used for the whole number.


Package org.apache.commons.math.genetics

Class org.apache.commons.math.genetics.InvalidRepresentationException extends Exception implements Serializable

serialVersionUID: 1L


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

serialVersionUID: 5133268763396045979L

Serialized Fields

x

double x
Abscissa.


y

double y
Ordinate.


z

double z
Height.

Class org.apache.commons.math.geometry.Vector3DFormat extends CompositeFormat implements Serializable

serialVersionUID: -5447606608652576301L

Serialized Fields

prefix

String prefix
Prefix.


suffix

String suffix
Suffix.


separator

String separator
Separator.


trimmedPrefix

String trimmedPrefix
Trimmed prefix.


trimmedSuffix

String trimmedSuffix
Trimmed suffix.


trimmedSeparator

String trimmedSeparator
Trimmed separator.


format

NumberFormat format
The format used for components.


Package org.apache.commons.math.linear

Class org.apache.commons.math.linear.Array2DRowFieldMatrix extends AbstractFieldMatrix<T extends FieldElement<T>> implements Serializable

serialVersionUID: 7260756672015356458L

Serialized Fields

data

FieldElement<T>[][] data
Entries of the matrix

Class org.apache.commons.math.linear.Array2DRowRealMatrix extends AbstractRealMatrix implements Serializable

serialVersionUID: -1067294169172445528L

Serialized Fields

data

double[][] data
Entries of the matrix

Class org.apache.commons.math.linear.ArrayFieldVector extends Object implements Serializable

serialVersionUID: 7648186910365927050L

Serialized Fields

data

FieldElement<T>[] data
Entries of the vector.


field

Field<T> field
Field to which the elements belong.

Class org.apache.commons.math.linear.ArrayRealVector extends AbstractRealVector implements Serializable

serialVersionUID: -1097961340710804027L

Serialized Fields

data

double[] data
Entries of the vector.

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

serialVersionUID: -1011428905656140431L

Serialized Fields

data

BigDecimal[][] data
Deprecated. 
Entries of the matrix


lu

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


permutation

int[] permutation
Deprecated. 
Permutation associated with LU decomposition


parity

int parity
Deprecated. 
Parity of the permutation associated with the LU decomposition


roundingMode

int roundingMode
Deprecated. 
Rounding mode for divisions


scale

int scale
Deprecated. 
BigDecimal scale

Class org.apache.commons.math.linear.BlockFieldMatrix extends AbstractFieldMatrix<T extends FieldElement<T>> implements Serializable

serialVersionUID: -4602336630143123183L

Serialized Fields

blocks

FieldElement<T>[][] blocks
Blocks of matrix entries.


rows

int rows
Number of rows of the matrix.


columns

int columns
Number of columns of the matrix.


blockRows

int blockRows
Number of block rows of the matrix.


blockColumns

int blockColumns
Number of block columns of the matrix.

Class org.apache.commons.math.linear.BlockRealMatrix extends AbstractRealMatrix implements Serializable

serialVersionUID: 4991895511313664478L

Serialized Fields

blocks

double[][] blocks
Blocks of matrix entries.


rows

int rows
Number of rows of the matrix.


columns

int columns
Number of columns of the matrix.


blockRows

int blockRows
Number of block rows of the matrix.


blockColumns

int blockColumns
Number of block columns of the matrix.

Class org.apache.commons.math.linear.InvalidMatrixException extends MathRuntimeException implements Serializable

serialVersionUID: -2068020346562029801L

Class org.apache.commons.math.linear.MatrixIndexException extends MathRuntimeException implements Serializable

serialVersionUID: 8120540015829487660L

Class org.apache.commons.math.linear.MatrixVisitorException extends MathRuntimeException implements Serializable

serialVersionUID: 3814333035048617048L

Class org.apache.commons.math.linear.NonSquareMatrixException extends InvalidMatrixException implements Serializable

serialVersionUID: 8996207526636673730L

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

serialVersionUID: 4122929125438624648L

Class org.apache.commons.math.linear.NotSymmetricMatrixException extends MathException implements Serializable

serialVersionUID: -7012803946709786097L

Class org.apache.commons.math.linear.OpenMapRealMatrix extends AbstractRealMatrix implements Serializable

serialVersionUID: -5962461716457143437L

Serialized Fields

rows

int rows
Number of rows of the matrix.


columns

int columns
Number of columns of the matrix.


entries

OpenIntToDoubleHashMap entries
Storage for (sparse) matrix elements.

Class org.apache.commons.math.linear.OpenMapRealVector extends AbstractRealVector implements Serializable

serialVersionUID: 8772222695580707260L

Serialized Fields

entries

OpenIntToDoubleHashMap entries
Entries of the vector.


virtualSize

int virtualSize
Dimension of the vector.


epsilon

double epsilon
Tolerance for having a value considered zero.

Class org.apache.commons.math.linear.RealMatrixImpl extends AbstractRealMatrix implements Serializable

serialVersionUID: -1067294169172445528L

Serialized Fields

data

double[][] data
Deprecated. 
Entries of the matrix

Class org.apache.commons.math.linear.RealVectorFormat extends CompositeFormat implements Serializable

serialVersionUID: -708767813036157690L

Serialized Fields

prefix

String prefix
Prefix.


suffix

String suffix
Suffix.


separator

String separator
Separator.


trimmedPrefix

String trimmedPrefix
Trimmed prefix.


trimmedSuffix

String trimmedSuffix
Trimmed suffix.


trimmedSeparator

String trimmedSeparator
Trimmed separator.


format

NumberFormat format
The format used for components.

Class org.apache.commons.math.linear.SingularMatrixException extends InvalidMatrixException implements Serializable

serialVersionUID: -7379143356784298432L

Class org.apache.commons.math.linear.SparseFieldVector extends Object implements Serializable

serialVersionUID: 7841233292190413362L

Serialized Fields

field

Field<T> field
Field to which the elements belong.


entries

OpenIntToFieldHashMap<T extends FieldElement<T>> entries
Entries of the vector.


virtualSize

int virtualSize
Dimension of the vector.


Package org.apache.commons.math.ode

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

serialVersionUID: -1417964919405031606L

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

List<E> steps
Steps table.

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

serialVersionUID: 5666710788967425123L

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

serialVersionUID: -1607588949778036796L


Package org.apache.commons.math.ode.events

Class org.apache.commons.math.ode.events.EventException extends MathException implements Serializable

serialVersionUID: -898215297400035290L


Package org.apache.commons.math.ode.jacobians

Package org.apache.commons.math.ode.sampling

Class org.apache.commons.math.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.math.ode.sampling.DummyStepInterpolator extends AbstractStepInterpolator implements Serializable

serialVersionUID: 1708010296707839488L

Serialization Methods

readExternal

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

Throws:
IOException - if the instance cannot be read

writeExternal

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

Throws:
IOException - if the instance cannot be written

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

Class org.apache.commons.math.optimization.OptimizationException extends ConvergenceException implements Serializable

serialVersionUID: -4605887730798282127L

Class org.apache.commons.math.optimization.RealPointValuePair extends Object implements Serializable

serialVersionUID: 1003888396256744753L

Serialized Fields

point

double[] point
Point coordinates.


value

double value
Value of the objective function at the point.

Class org.apache.commons.math.optimization.VectorialPointValuePair extends Object implements Serializable

serialVersionUID: 1003888396256744753L

Serialized Fields

point

double[] point
Point coordinates.


value

double[] value
Vectorial value of the objective function at the point.


Package org.apache.commons.math.optimization.fitting

Class org.apache.commons.math.optimization.fitting.GaussianDerivativeFunction extends Object implements Serializable

serialVersionUID: -6500229089670174766L

Serialized Fields

b

double b
Parameter b of this function.


c

double c
Parameter c of this function.


d2

double d2
Square of the parameter d of this function.

Class org.apache.commons.math.optimization.fitting.GaussianFunction extends Object implements Serializable

serialVersionUID: -3195385616125629512L

Serialized Fields

a

double a
Parameter a of this function.


b

double b
Parameter b of this function.


c

double c
Parameter c of this function.


d

double d
Parameter d of this function.

Class org.apache.commons.math.optimization.fitting.ParametricGaussianFunction extends Object implements Serializable

serialVersionUID: -3875578602503903233L

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


Package org.apache.commons.math.optimization.linear

Class org.apache.commons.math.optimization.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 found
IOException - 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.math.optimization.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 found
IOException - 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.math.optimization.linear.NoFeasibleSolutionException extends OptimizationException implements Serializable

serialVersionUID: -3044253632189082760L

Class org.apache.commons.math.optimization.linear.UnboundedSolutionException extends OptimizationException implements Serializable

serialVersionUID: 940539497277290619L


Package org.apache.commons.math.random

Class org.apache.commons.math.random.AbstractWell extends BitsStreamGenerator implements Serializable

serialVersionUID: -817701723016583596L

Serialized Fields

index

int index
Current index in the bytes pool.


v

int[] v
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.


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.

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

serialVersionUID: 5729073523949762654L

Serialized Fields

binStats

List<E> binStats
List of SummaryStatistics objects characterizing the bins


sampleStats

SummaryStatistics sampleStats
Sample statistics


max

double max
Max loaded value


min

double min
Min loaded value


delta

double delta
Grid size


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 Random implements Serializable

serialVersionUID: -7745277476784028798L

Class org.apache.commons.math.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.math.random.RandomAdaptor extends Random implements Serializable

serialVersionUID: 2306581345647615033L

Serialized Fields

randomGenerator

RandomGenerator randomGenerator
Wrapped randomGenerator instance

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

serialVersionUID: -626730818244969716L

Serialized Fields

rand

RandomGenerator rand
underlying random number generator


secRand

SecureRandom secRand
underlying secure random number generator

Class org.apache.commons.math.random.Well1024a extends AbstractWell implements Serializable

serialVersionUID: 5680173464174485492L

Class org.apache.commons.math.random.Well19937a extends AbstractWell implements Serializable

serialVersionUID: -7462102162223815419L

Class org.apache.commons.math.random.Well19937c extends AbstractWell implements Serializable

serialVersionUID: -7203498180754925124L

Class org.apache.commons.math.random.Well44497a extends AbstractWell implements Serializable

serialVersionUID: -3859207588353972099L

Class org.apache.commons.math.random.Well44497b extends AbstractWell implements Serializable

serialVersionUID: 4032007538246675492L

Class org.apache.commons.math.random.Well512a extends AbstractWell implements Serializable

serialVersionUID: -6104179812103820574L


Package org.apache.commons.math.stat

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

serialVersionUID: -3845586908418844111L

Serialized Fields

freqTable

TreeMap<K,V> freqTable
underlying collection


Package org.apache.commons.math.stat.clustering

Class org.apache.commons.math.stat.clustering.Cluster extends Object implements Serializable

serialVersionUID: -3442297081515880464L

Serialized Fields

points

List<E> points
The points contained in this cluster.


center

Clusterable<T> center
Center of the cluster.

Class org.apache.commons.math.stat.clustering.EuclideanIntegerPoint extends Object implements Serializable

serialVersionUID: 3946024775784901369L

Serialized Fields

point

int[] point
Point coordinates.


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

Class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics extends Object implements Serializable

serialVersionUID: -8207112444016386906L

Serialized Fields

statisticsPrototype

SummaryStatistics statisticsPrototype
A SummaryStatistics serving as a prototype for creating SummaryStatistics contributing to this aggregate


statistics

SummaryStatistics statistics
The SummaryStatistics in which aggregate statistics are accumulated.

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

serialVersionUID: 4133067267405273064L

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.MultivariateSummaryStatistics extends 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 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 Object implements Serializable

serialVersionUID: -2021321786743555871L

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.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: 6112755307178490473L

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


cachedPivots

int[] cachedPivots
Cached pivots.


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 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.FastFourierTransformer extends Object implements Serializable

serialVersionUID: 5138259215438106000L

Serialized Fields

roots

org.apache.commons.math.transform.FastFourierTransformer.RootsOfUnity roots
roots of unity


Package org.apache.commons.math.util

Class org.apache.commons.math.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.math.util.BigRealField extends Object implements Serializable

serialVersionUID: 4756431066541037559L

Serialization Methods

readResolve

private Object readResolve()
Handle deserialization of the singleton.

Class org.apache.commons.math.util.CompositeFormat extends Format implements Serializable

serialVersionUID: 5358685519349262494L

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

serialVersionUID: 4019938025047800455L

Class org.apache.commons.math.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 read
ClassNotFoundException - if the class corresponding to the serialized object cannot be found
Serialized Fields

keys

int[] keys
Keys table.


values

double[] values
Values table.


states

byte[] states
States table.


missingEntries

double missingEntries
Return value for missing entries.


size

int size
Current size of the map.


mask

int mask
Bit mask for hash values.

Class org.apache.commons.math.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 read
ClassNotFoundException - if the class corresponding to the serialized object cannot be found
Serialized Fields

field

Field<T> field
Field to which the elements belong.


keys

int[] keys
Keys table.


values

FieldElement<T>[] values
Values table.


states

byte[] states
States table.


missingEntries

FieldElement<T> missingEntries
Return value for missing entries.


size

int size
Current size of the map.


mask

int mask
Bit mask for hash values.

Class org.apache.commons.math.util.ResizableDoubleArray extends 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 Object implements Serializable

serialVersionUID: 4605318041528645258L

Serialized Fields

defaultTransformer

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


map

Map<K,V> map
The internal Map.



Copyright © 2003-2011 The Apache Software Foundation. All Rights Reserved.