Serialized Form
-
Package org.hipparchus.analysis.differentiation
-
Class org.hipparchus.analysis.differentiation.DerivativeStructure extends Object implements Serializable
- serialVersionUID:
- 20161220L
-
Serialized Fields
-
data
double[] data
Combined array holding all values. -
factory
DSFactory factory
Factory that built the instance.
-
-
Class org.hipparchus.analysis.differentiation.DSFactory extends Object implements Serializable
- serialVersionUID:
- 20161222L
-
Serialization Methods
-
writeReplace
private Object writeReplace()
Replace the instance with a data transfer object for serialization.
-
-
Class org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator extends Object implements Serializable
- serialVersionUID:
- 20120917L
-
Serialized Fields
-
halfSampleSpan
double halfSampleSpan
Half sample span. -
nbPoints
int nbPoints
Number of points to use. -
stepSize
double stepSize
Step size. -
tMax
double tMax
Upper bound for independent variable. -
tMin
double tMin
Lower bound for independent variable.
-
-
Class org.hipparchus.analysis.differentiation.SparseGradient extends Object implements Serializable
- serialVersionUID:
- 20131025L
-
-
Package org.hipparchus.analysis.interpolation
-
Class org.hipparchus.analysis.interpolation.BilinearInterpolatingFunction extends Object implements Serializable
- serialVersionUID:
- 20180926L
-
Class org.hipparchus.analysis.interpolation.DividedDifferenceInterpolator extends Object implements Serializable
- serialVersionUID:
- 107049519551235069L
-
Class org.hipparchus.analysis.interpolation.GridAxis extends Object implements Serializable
- serialVersionUID:
- 20180926L
-
Serialized Fields
-
cache
AtomicInteger cache
Cached value of last x index. -
grid
double[] grid
All the coordinates of the interpolation points, sorted in increasing order. -
n
int n
Number of points required for interpolation.
-
-
Class org.hipparchus.analysis.interpolation.LoessInterpolator extends Object implements Serializable
- serialVersionUID:
- 5204927143605193821L
-
Serialized Fields
-
accuracy
double accuracy
If the median residual at a certain robustness iteration is less than this amount, no more iterations are done. -
bandwidth
double bandwidth
The bandwidth parameter: when computing the loess fit at a particular point, this fraction of source points closest to the current point is taken into account for computing a least-squares regression.A sensible value is usually 0.25 to 0.5.
-
robustnessIters
int robustnessIters
The number of robustness iterations parameter: this many robustness iterations are done.A sensible value is usually 0 (just the initial fit without any robustness iterations) to 4.
-
-
Class org.hipparchus.analysis.interpolation.NevilleInterpolator extends Object implements Serializable
- serialVersionUID:
- 3003707660147873733L
-
-
Package org.hipparchus.analysis.polynomials
-
Class org.hipparchus.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.hipparchus.clustering
-
Class org.hipparchus.clustering.CentroidCluster extends Cluster<T extends Clusterable> implements Serializable
- serialVersionUID:
- -3075288519071812288L
-
Serialized Fields
-
center
Clusterable center
Center of the cluster.
-
-
Class org.hipparchus.clustering.Cluster extends Object implements Serializable
- serialVersionUID:
- -3442297081515880464L
-
Serialized Fields
-
points
List<T extends Clusterable> points
The points contained in this cluster.
-
-
Class org.hipparchus.clustering.DoublePoint extends Object implements Serializable
- serialVersionUID:
- 3946024775784901369L
-
Serialized Fields
-
point
double[] point
Point coordinates.
-
-
-
Package org.hipparchus.clustering.distance
-
Class org.hipparchus.clustering.distance.CanberraDistance extends Object implements Serializable
- serialVersionUID:
- -6972277381587032228L
-
Class org.hipparchus.clustering.distance.ChebyshevDistance extends Object implements Serializable
- serialVersionUID:
- -4694868171115238296L
-
Class org.hipparchus.clustering.distance.EarthMoversDistance extends Object implements Serializable
- serialVersionUID:
- -5406732779747414922L
-
Class org.hipparchus.clustering.distance.EuclideanDistance extends Object implements Serializable
- serialVersionUID:
- 1717556319784040040L
-
Class org.hipparchus.clustering.distance.ManhattanDistance extends Object implements Serializable
- serialVersionUID:
- -9108154600539125566L
-
-
Package org.hipparchus.complex
-
Class org.hipparchus.complex.Complex extends Object implements Serializable
- serialVersionUID:
- 20160305L
-
Serialization Methods
-
readResolve
protected final Object readResolve()
Resolve the transient fields in a deserialized Complex Object. Subclasses will need to overrideComplex.createComplex(double, double)
to deserialize properly.
-
-
Serialized Fields
-
imaginary
double imaginary
The imaginary part. -
real
double real
The real part.
-
-
Class org.hipparchus.complex.ComplexComparator extends Object implements Serializable
- serialVersionUID:
- 20171113L
-
Class org.hipparchus.complex.ComplexField extends Object implements Serializable
- serialVersionUID:
- 20160305L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.hipparchus.complex.Quaternion extends Object implements Serializable
- serialVersionUID:
- 20092012L
-
Serialized Fields
-
q0
double q0
First component (scalar part). -
q1
double q1
Second component (first vector part). -
q2
double q2
Third component (second vector part). -
q3
double q3
Fourth component (third vector part).
-
-
Class org.hipparchus.complex.RootsOfUnity extends Object implements Serializable
- serialVersionUID:
- 20120201L
-
Serialized Fields
-
isCounterClockWise
boolean isCounterClockWise
true
ifRootsOfUnity.computeRoots(int)
was called with a positive value of its argumentn
. In this case, counter-clockwise ordering of the roots of unity should be used. -
omegaCount
int omegaCount
Number of roots of unity. -
omegaImaginaryClockwise
double[] omegaImaginaryClockwise
Imaginary part of then
-th roots of unity, for negative values ofn
. In this array, the roots are stored in clockwise order. -
omegaImaginaryCounterClockwise
double[] omegaImaginaryCounterClockwise
Imaginary part of then
-th roots of unity, for positive values ofn
. In this array, the roots are stored in counter-clockwise order. -
omegaReal
double[] omegaReal
Real part of the roots.
-
-
-
Package org.hipparchus.distribution
-
Class org.hipparchus.distribution.EnumeratedDistribution extends Object implements Serializable
- serialVersionUID:
- 20123308L
-
Serialized Fields
-
probabilities
double[] probabilities
Probabilities of respective random variable values. For i = 0, ..., singletons.size() - 1, probability[i] is the probability that a random variable following this distribution takes the value singletons[i]. -
singletons
List<T> singletons
List of random variable values.
-
-
-
Package org.hipparchus.distribution.continuous
-
Class org.hipparchus.distribution.continuous.AbstractRealDistribution extends Object implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy.
-
-
Class org.hipparchus.distribution.continuous.BetaDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
alpha
double alpha
First shape parameter. -
beta
double beta
Second shape parameter. -
z
double z
Normalizing factor used in density computations.
-
-
Class org.hipparchus.distribution.continuous.CauchyDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
median
double median
The median of this distribution. -
scale
double scale
The scale of this distribution.
-
-
Class org.hipparchus.distribution.continuous.ChiSquaredDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
gamma
GammaDistribution gamma
Internal Gamma distribution.
-
-
Class org.hipparchus.distribution.continuous.ConstantRealDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
value
double value
Constant value of the distribution
-
-
Class org.hipparchus.distribution.continuous.EnumeratedRealDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20130308L
-
Serialized Fields
-
innerDistribution
EnumeratedDistribution<Double> innerDistribution
EnumeratedDistribution
(using theDouble
wrapper) used to generate the pmf.
-
-
Class org.hipparchus.distribution.continuous.ExponentialDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
logMean
double logMean
The logarithm of the mean, stored to reduce computing time. -
mean
double mean
The mean of this distribution.
-
-
Class org.hipparchus.distribution.continuous.FDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
denominatorDegreesOfFreedom
double denominatorDegreesOfFreedom
The numerator degrees of freedom. -
numeratorDegreesOfFreedom
double numeratorDegreesOfFreedom
The numerator degrees of freedom. -
numericalVariance
double numericalVariance
Cached numerical variance
-
-
Class org.hipparchus.distribution.continuous.GammaDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20120524L
-
Serialized Fields
-
densityPrefactor1
double densityPrefactor1
The constant value ofshape / scale * sqrt(e / (2 * pi * (shape + g + 0.5))) / L(shape)
, whereL(shape)
is the Lanczos approximation returned byGamma.lanczos(double)
. This prefactor is used inGammaDistribution.density(double)
, when no overflow occurs with the natural calculation. -
densityPrefactor2
double densityPrefactor2
The constant value ofshape * sqrt(e / (2 * pi * (shape + g + 0.5))) / L(shape)
, whereL(shape)
is the Lanczos approximation returned byGamma.lanczos(double)
. This prefactor is used inGammaDistribution.density(double)
, when overflow occurs with the natural calculation. -
logDensityPrefactor1
double logDensityPrefactor1
The constant value oflog(shape / scale * sqrt(e / (2 * pi * (shape + g + 0.5))) / L(shape))
, whereL(shape)
is the Lanczos approximation returned byGamma.lanczos(double)
. This prefactor is used inGammaDistribution.logDensity(double)
, when no overflow occurs with the natural calculation. -
logDensityPrefactor2
double logDensityPrefactor2
The constant value oflog(shape * sqrt(e / (2 * pi * (shape + g + 0.5))) / L(shape))
, whereL(shape)
is the Lanczos approximation returned byGamma.lanczos(double)
. This prefactor is used inGammaDistribution.logDensity(double)
, when overflow occurs with the natural calculation. -
maxLogY
double maxLogY
Upper bound onlog(y)
(y = x / scale
) for the selection of the computation method inGammaDistribution.density(double)
. Forlog(y) >= maxLogY
, the natural calculation overflows. -
minY
double minY
Lower bound ony = x / scale
for the selection of the computation method inGammaDistribution.density(double)
. Fory <= minY
, the natural calculation overflows. -
scale
double scale
The scale parameter. -
shape
double shape
The shape parameter. -
shiftedShape
double shiftedShape
-
-
Class org.hipparchus.distribution.continuous.GumbelDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20141003L
-
Serialized Fields
-
beta
double beta
The scale parameter. -
mu
double mu
The location parameter.
-
-
Class org.hipparchus.distribution.continuous.LaplaceDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20141003L
-
Serialized Fields
-
beta
double beta
The scale parameter. -
mu
double mu
The location parameter.
-
-
Class org.hipparchus.distribution.continuous.LevyDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20130314L
-
Serialized Fields
-
c
double c
Scale parameter. -
halfC
double halfC
Half of c (for calculations). -
mu
double mu
Location parameter.
-
-
Class org.hipparchus.distribution.continuous.LogisticDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20141003L
-
Serialized Fields
-
mu
double mu
The location parameter. -
s
double s
The scale parameter.
-
-
Class org.hipparchus.distribution.continuous.LogNormalDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20120112L
-
Serialized Fields
-
location
double location
The location parameter of this distribution (named m in MathWorld and ยต in Wikipedia). -
logShapePlusHalfLog2Pi
double logShapePlusHalfLog2Pi
The value oflog(shape) + 0.5 * log(2*PI)
stored for faster computation. -
shape
double shape
The shape parameter of this distribution.
-
-
Class org.hipparchus.distribution.continuous.NakagamiDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20141003L
-
Serialized Fields
-
mu
double mu
The shape parameter. -
omega
double omega
The scale parameter.
-
-
Class org.hipparchus.distribution.continuous.NormalDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
logStandardDeviationPlusHalfLog2Pi
double logStandardDeviationPlusHalfLog2Pi
The value oflog(sd) + 0.5*log(2*pi)
stored for faster computation. -
mean
double mean
Mean of this distribution. -
standardDeviation
double standardDeviation
Standard deviation of this distribution.
-
-
Class org.hipparchus.distribution.continuous.ParetoDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20130424L
-
Serialized Fields
-
scale
double scale
The scale parameter of this distribution. -
shape
double shape
The shape parameter of this distribution.
-
-
Class org.hipparchus.distribution.continuous.TDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
degreesOfFreedom
double degreesOfFreedom
The degrees of freedom. -
factor
double factor
Static computation factor based on degreesOfFreedom.
-
-
Class org.hipparchus.distribution.continuous.TriangularDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20120112L
-
Serialized Fields
-
a
double a
Lower limit of this distribution (inclusive). -
b
double b
Upper limit of this distribution (inclusive). -
c
double c
Mode of this distribution.
-
-
Class org.hipparchus.distribution.continuous.UniformRealDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20120109L
-
Serialized Fields
-
lower
double lower
Lower bound of this distribution (inclusive). -
upper
double upper
Upper bound of this distribution (exclusive).
-
-
Class org.hipparchus.distribution.continuous.WeibullDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
scale
double scale
The scale parameter. -
shape
double shape
The shape parameter.
-
-
-
Package org.hipparchus.distribution.discrete
-
Class org.hipparchus.distribution.discrete.AbstractIntegerDistribution extends Object implements Serializable
- serialVersionUID:
- 20160320L
-
Class org.hipparchus.distribution.discrete.BinomialDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
numberOfTrials
int numberOfTrials
The number of trials. -
probabilityOfSuccess
double probabilityOfSuccess
The probability of success.
-
-
Class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- 20130308L
-
Serialized Fields
-
innerDistribution
EnumeratedDistribution<Integer> innerDistribution
EnumeratedDistribution
instance (using theInteger
wrapper) used to generate the pmf.
-
-
Class org.hipparchus.distribution.discrete.GeometricDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- 20130507L
-
Serialized Fields
-
log1mProbabilityOfSuccess
double log1mProbabilityOfSuccess
log(1 - p)
where p is the probability of success. -
logProbabilityOfSuccess
double logProbabilityOfSuccess
log(p)
where p is the probability of success. -
probabilityOfSuccess
double probabilityOfSuccess
The probability of success.
-
-
Class org.hipparchus.distribution.discrete.HypergeometricDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
numberOfSuccesses
int numberOfSuccesses
The number of successes in the population. -
numericalVariance
double numericalVariance
Cached numerical variance -
populationSize
int populationSize
The population size. -
sampleSize
int sampleSize
The sample size.
-
-
Class org.hipparchus.distribution.discrete.PascalDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
log1mProbabilityOfSuccess
double log1mProbabilityOfSuccess
The value oflog(1-p)
, wherep
is the probability of success, stored for faster computation. -
logProbabilityOfSuccess
double logProbabilityOfSuccess
The value oflog(p)
, wherep
is the probability of success, stored for faster computation. -
numberOfSuccesses
int numberOfSuccesses
The number of successes. -
probabilityOfSuccess
double probabilityOfSuccess
The probability of success.
-
-
Class org.hipparchus.distribution.discrete.PoissonDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- 20160320L
-
Serialized Fields
-
epsilon
double epsilon
Convergence criterion for cumulative probability. -
maxIterations
int maxIterations
Maximum number of iterations for cumulative probability. Cumulative probabilities are estimated using either Lanczos series approximation ofGamma.regularizedGammaP(double, double, double, int)
or continued fraction approximation ofGamma.regularizedGammaQ(double, double, double, int)
. -
mean
double mean
Mean of the distribution. -
normal
NormalDistribution normal
Distribution used to compute normal approximation.
-
-
Class org.hipparchus.distribution.discrete.UniformIntegerDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- 20120109L
-
Serialized Fields
-
lower
int lower
Lower bound (inclusive) of this distribution. -
upper
int upper
Upper bound (inclusive) of this distribution.
-
-
Class org.hipparchus.distribution.discrete.ZipfDistribution extends AbstractIntegerDistribution implements Serializable
- serialVersionUID:
- 20150501L
-
Serialized Fields
-
exponent
double exponent
Exponent parameter of the distribution. -
nthHarmonic
double nthHarmonic
Cached values of the nth generalized harmonic. -
numberOfElements
int numberOfElements
Number of elements. -
numericalMean
double numericalMean
Cached numerical mean -
numericalMeanIsCalculated
boolean numericalMeanIsCalculated
Whether or not the numerical mean has been calculated -
numericalVariance
double numericalVariance
Cached numerical variance -
numericalVarianceIsCalculated
boolean numericalVarianceIsCalculated
Whether or not the numerical variance has been calculated
-
-
-
Package org.hipparchus.exception
-
Class org.hipparchus.exception.DummyLocalizable extends Object implements Serializable
- serialVersionUID:
- 8843275624471387299L
-
Serialized Fields
-
source
String source
Source string.
-
-
Class org.hipparchus.exception.MathIllegalArgumentException extends MathRuntimeException implements Serializable
- serialVersionUID:
- -6024911025449780478L
-
Class org.hipparchus.exception.MathIllegalStateException extends MathRuntimeException implements Serializable
- serialVersionUID:
- -6024911025449780478L
-
Class org.hipparchus.exception.MathRuntimeException extends RuntimeException implements Serializable
- serialVersionUID:
- 20160217L
-
Serialized Fields
-
parts
Object[] parts
Parts to insert in the format (no translation). -
specifier
Localizable specifier
Format specifier (to be translated).
-
-
Class org.hipparchus.exception.NullArgumentException extends NullPointerException implements Serializable
- serialVersionUID:
- 20160217L
-
Serialized Fields
-
parts
Object[] parts
Parts to insert in the format (no translation). -
specifier
Localizable specifier
Format specifier (to be translated).
-
-
-
Package org.hipparchus.fitting
-
Class org.hipparchus.fitting.WeightedObservedPoint extends Object implements Serializable
- serialVersionUID:
- 5306874947404636157L
-
Serialized Fields
-
weight
double weight
Weight of the measurement in the fitting process. -
x
double x
Abscissa of the point. -
y
double y
Observed value of the function at x.
-
-
Class org.hipparchus.fitting.WeightedObservedPoints extends Object implements Serializable
- serialVersionUID:
- 20130813L
-
Serialized Fields
-
observations
List<WeightedObservedPoint> observations
Observed points.
-
-
-
Package org.hipparchus.fraction
-
Class org.hipparchus.fraction.BigFraction extends Number implements Serializable
- serialVersionUID:
- -5630213147331578515L
-
Serialized Fields
-
denominator
BigInteger denominator
The denominator. -
numerator
BigInteger numerator
The numerator.
-
-
Class org.hipparchus.fraction.BigFractionField extends Object implements Serializable
- serialVersionUID:
- -1699294557189741703L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.hipparchus.fraction.BigFractionFormat extends org.hipparchus.fraction.AbstractFormat implements Serializable
- serialVersionUID:
- 20160323L
-
Class org.hipparchus.fraction.Fraction extends Number implements Serializable
- serialVersionUID:
- 3698073679419233275L
-
Serialized Fields
-
denominator
int denominator
The denominator. -
numerator
int numerator
The numerator.
-
-
Class org.hipparchus.fraction.FractionField extends Object implements Serializable
- serialVersionUID:
- -1257768487499119313L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.hipparchus.fraction.FractionFormat extends org.hipparchus.fraction.AbstractFormat implements Serializable
- serialVersionUID:
- 20160323L
-
Class org.hipparchus.fraction.ProperBigFractionFormat extends BigFractionFormat implements Serializable
- serialVersionUID:
- 20160323L
-
Serialized Fields
-
wholeFormat
NumberFormat wholeFormat
The format used for the whole number.
-
-
Class org.hipparchus.fraction.ProperFractionFormat extends FractionFormat implements Serializable
- serialVersionUID:
- 20160323L
-
Serialized Fields
-
wholeFormat
NumberFormat wholeFormat
The format used for the whole number.
-
-
-
Package org.hipparchus.geometry
-
Package org.hipparchus.geometry.enclosing
-
Class org.hipparchus.geometry.enclosing.EnclosingBall extends Object implements Serializable
- serialVersionUID:
- 20140126L
-
-
Package org.hipparchus.geometry.euclidean.oned
-
Class org.hipparchus.geometry.euclidean.oned.Euclidean1D extends Object implements Serializable
- serialVersionUID:
- -1178039568877797126L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.hipparchus.geometry.euclidean.oned.Euclidean1D.NoSubSpaceException extends MathRuntimeException implements Serializable
- serialVersionUID:
- 20140225L
-
Class org.hipparchus.geometry.euclidean.oned.Vector1D extends Object implements Serializable
- serialVersionUID:
- 7556674948671647925L
-
Serialized Fields
-
x
double x
Abscissa.
-
-
-
Package org.hipparchus.geometry.euclidean.threed
-
Class org.hipparchus.geometry.euclidean.threed.Euclidean3D extends Object implements Serializable
- serialVersionUID:
- 6249091865814886817L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.hipparchus.geometry.euclidean.threed.FieldRotation extends Object implements Serializable
- serialVersionUID:
- 20130224L
-
Serialized Fields
-
q0
T extends RealFieldElement<T> q0
Scalar coordinate of the quaternion. -
q1
T extends RealFieldElement<T> q1
First coordinate of the vectorial part of the quaternion. -
q2
T extends RealFieldElement<T> q2
Second coordinate of the vectorial part of the quaternion. -
q3
T extends RealFieldElement<T> q3
Third coordinate of the vectorial part of the quaternion.
-
-
Class org.hipparchus.geometry.euclidean.threed.FieldVector3D extends Object implements Serializable
- serialVersionUID:
- 20130224L
-
Serialized Fields
-
x
T extends RealFieldElement<T> x
Abscissa. -
y
T extends RealFieldElement<T> y
Ordinate. -
z
T extends RealFieldElement<T> z
Height.
-
-
Class org.hipparchus.geometry.euclidean.threed.Rotation extends Object implements Serializable
- serialVersionUID:
- -2153622329907944313L
-
Serialized Fields
-
q0
double q0
Scalar coordinate of the quaternion. -
q1
double q1
First coordinate of the vectorial part of the quaternion. -
q2
double q2
Second coordinate of the vectorial part of the quaternion. -
q3
double q3
Third coordinate of the vectorial part of the quaternion.
-
-
Class org.hipparchus.geometry.euclidean.threed.SphericalCoordinates extends Object implements Serializable
- serialVersionUID:
- 20130206L
-
Serialization Methods
-
writeReplace
private Object writeReplace()
Replace the instance with a data transfer object for serialization.
-
-
Serialized Fields
-
jacobian
double[][] jacobian
Jacobian of (r, θ Φ). -
phi
double phi
Polar angle (co-latitude) Φ. -
phiHessian
double[][] phiHessian
Hessian of polar (co-latitude) angle Φ. -
r
double r
Radius. -
rHessian
double[][] rHessian
Hessian of radius. -
theta
double theta
Azimuthal angle in the x-y plane θ. -
thetaHessian
double[][] thetaHessian
Hessian of azimuthal angle in the x-y plane θ. -
v
Vector3D v
Cartesian coordinates.
-
-
Class org.hipparchus.geometry.euclidean.threed.Vector3D extends Object implements Serializable
- serialVersionUID:
- 1313493323784566947L
-
Serialized Fields
-
x
double x
Abscissa. -
y
double y
Ordinate. -
z
double z
Height.
-
-
-
Package org.hipparchus.geometry.euclidean.twod
-
Class org.hipparchus.geometry.euclidean.twod.Euclidean2D extends Object implements Serializable
- serialVersionUID:
- 4793432849757649566L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.hipparchus.geometry.euclidean.twod.Vector2D extends Object implements Serializable
- serialVersionUID:
- 266938651998679754L
-
Serialized Fields
-
x
double x
Abscissa. -
y
double y
Ordinate.
-
-
-
Package org.hipparchus.geometry.euclidean.twod.hull
-
Class org.hipparchus.geometry.euclidean.twod.hull.ConvexHull2D extends Object implements Serializable
- serialVersionUID:
- 20140129L
-
Serialized Fields
-
tolerance
double tolerance
Tolerance threshold used during creation of the hull vertices. -
vertices
Vector2D[] vertices
Vertices of the hull.
-
-
-
Package org.hipparchus.geometry.hull
-
Package org.hipparchus.geometry.spherical.oned
-
Class org.hipparchus.geometry.spherical.oned.ArcsSet.InconsistentStateAt2PiWrapping extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 20140107L
-
Class org.hipparchus.geometry.spherical.oned.S1Point extends Object implements Serializable
- serialVersionUID:
- 20131218L
-
Serialized Fields
-
alpha
double alpha
Azimuthal angle \( \alpha \). -
vector
Vector2D vector
Corresponding 2D normalized vector.
-
-
Class org.hipparchus.geometry.spherical.oned.Sphere1D extends Object implements Serializable
- serialVersionUID:
- 20131218L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.hipparchus.geometry.spherical.oned.Sphere1D.NoSubSpaceException extends MathRuntimeException implements Serializable
- serialVersionUID:
- 20140225L
-
-
Package org.hipparchus.geometry.spherical.twod
-
Class org.hipparchus.geometry.spherical.twod.S2Point extends Object implements Serializable
- serialVersionUID:
- 20131218L
-
Serialized Fields
-
phi
double phi
Polar angle \( \varphi \). -
theta
double theta
Azimuthal angle \( \theta \) in the x-y plane. -
vector
Vector3D vector
Corresponding 3D normalized vector.
-
-
Class org.hipparchus.geometry.spherical.twod.Sphere2D extends Object implements Serializable
- serialVersionUID:
- 20131218L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
-
Package org.hipparchus.linear
-
Class org.hipparchus.linear.Array2DRowFieldMatrix extends AbstractFieldMatrix<T extends FieldElement<T>> implements Serializable
- serialVersionUID:
- 7260756672015356458L
-
Serialized Fields
-
data
T extends FieldElement<T>[][] data
Entries of the matrix
-
-
Class org.hipparchus.linear.Array2DRowRealMatrix extends AbstractRealMatrix implements Serializable
- serialVersionUID:
- -1067294169172445528L
-
Serialized Fields
-
data
double[][] data
Entries of the matrix.
-
-
Class org.hipparchus.linear.ArrayFieldVector extends Object implements Serializable
- serialVersionUID:
- 7648186910365927050L
-
Serialized Fields
-
data
T extends FieldElement<T>[] data
Entries of the vector. -
field
Field<T extends FieldElement<T>> field
Field to which the elements belong.
-
-
Class org.hipparchus.linear.ArrayRealVector extends RealVector implements Serializable
- serialVersionUID:
- -1097961340710804027L
-
Serialized Fields
-
data
double[] data
Entries of the vector.
-
-
Class org.hipparchus.linear.BlockFieldMatrix extends AbstractFieldMatrix<T extends FieldElement<T>> implements Serializable
- serialVersionUID:
- -4602336630143123183L
-
Serialized Fields
-
blockColumns
int blockColumns
Number of block columns of the matrix. -
blockRows
int blockRows
Number of block rows of the matrix. -
blocks
T extends FieldElement<T>[][] blocks
Blocks of matrix entries. -
columns
int columns
Number of columns of the matrix. -
rows
int rows
Number of rows of the matrix.
-
-
Class org.hipparchus.linear.BlockRealMatrix extends AbstractRealMatrix implements Serializable
- serialVersionUID:
- 4991895511313664478L
-
Serialized Fields
-
blockColumns
int blockColumns
Number of block columns of the matrix. -
blockRows
int blockRows
Number of block rows of the matrix. -
blocks
double[][] blocks
Blocks of matrix entries. -
columns
int columns
Number of columns of the matrix. -
rows
int rows
Number of rows of the matrix.
-
-
Class org.hipparchus.linear.DefaultIterativeLinearSolverEvent extends IterativeLinearSolverEvent implements Serializable
- serialVersionUID:
- 20120129L
-
Serialized Fields
-
b
RealVector b
The right-hand side vector. -
r
RealVector r
The current estimate of the residual. -
rnorm
double rnorm
The current estimate of the norm of the residual. -
x
RealVector x
The current estimate of the solution.
-
-
Class org.hipparchus.linear.DiagonalMatrix extends AbstractRealMatrix implements Serializable
- serialVersionUID:
- 20121229L
-
Serialized Fields
-
data
double[] data
Entries of the diagonal.
-
-
Class org.hipparchus.linear.IterativeLinearSolverEvent extends IterationEvent implements Serializable
- serialVersionUID:
- 20120129L
-
Class org.hipparchus.linear.OpenMapRealMatrix extends AbstractRealMatrix implements Serializable
- serialVersionUID:
- -5962461716457143437L
-
Serialized Fields
-
columns
int columns
Number of columns of the matrix. -
entries
OpenIntToDoubleHashMap entries
Storage for (sparse) matrix elements. -
rows
int rows
Number of rows of the matrix.
-
-
Class org.hipparchus.linear.OpenMapRealVector extends SparseRealVector implements Serializable
- serialVersionUID:
- 8772222695580707260L
-
Serialized Fields
-
entries
OpenIntToDoubleHashMap entries
Entries of the vector. -
epsilon
double epsilon
Tolerance for having a value considered zero. -
virtualSize
int virtualSize
Dimension of the vector.
-
-
Class org.hipparchus.linear.SparseFieldVector extends Object implements Serializable
- serialVersionUID:
- 7841233292190413362L
-
Serialized Fields
-
entries
OpenIntToFieldHashMap<T extends FieldElement<T>> entries
Entries of the vector. -
field
Field<T extends FieldElement<T>> field
Field to which the elements belong. -
virtualSize
int virtualSize
Dimension of the vector.
-
-
-
Package org.hipparchus.migration.exception
-
Class org.hipparchus.migration.exception.ConvergenceException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- 4330003017885151975L
-
Class org.hipparchus.migration.exception.DimensionMismatchException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- -8415396756375798143L
-
Serialized Fields
-
dimension
int dimension
Deprecated.Correct dimension.
-
-
Class org.hipparchus.migration.exception.InsufficientDataException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -2629324471511903359L
-
Class org.hipparchus.migration.exception.MathArithmeticException extends MathRuntimeException implements Serializable
- serialVersionUID:
- -6024911025449780478L
-
Class org.hipparchus.migration.exception.MathIllegalNumberException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -7447085893598031110L
-
Serialized Fields
-
argument
Number argument
Deprecated.Requested.
-
-
Class org.hipparchus.migration.exception.MathInternalError extends MathIllegalStateException implements Serializable
- serialVersionUID:
- -6276776513966934846L
-
Class org.hipparchus.migration.exception.MathParseException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- -6024911025449780478L
-
Class org.hipparchus.migration.exception.MathUnsupportedOperationException extends MathRuntimeException implements Serializable
- serialVersionUID:
- -6024911025449780478L
-
Class org.hipparchus.migration.exception.MaxCountExceededException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- 4330003017885151975L
-
Serialized Fields
-
max
Number max
Deprecated.Maximum number of evaluations.
-
-
Class org.hipparchus.migration.exception.MultiDimensionMismatchException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -8415396756375798143L
-
Class org.hipparchus.migration.exception.NoBracketingException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -3629324471511904459L
-
Serialized Fields
-
fHi
double fHi
Deprecated.Value at higher end of the interval. -
fLo
double fLo
Deprecated.Value at lower end of the interval. -
hi
double hi
Deprecated.Higher end of the interval. -
lo
double lo
Deprecated.Lower end of the interval.
-
-
Class org.hipparchus.migration.exception.NoDataException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -3629324471511904459L
-
Class org.hipparchus.migration.exception.NonMonotonicSequenceException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- 3596849179428944575L
-
Serialized Fields
-
direction
MathArrays.OrderDirection direction
Deprecated.Direction (positive for increasing, negative for decreasing). -
index
int index
Deprecated.Index of the wrong value. -
previous
Number previous
Deprecated.Previous value. -
strict
boolean strict
Deprecated.Whether the sequence must be strictly increasing or decreasing.
-
-
Class org.hipparchus.migration.exception.NotANumberException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- 20120906L
-
Class org.hipparchus.migration.exception.NotFiniteNumberException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- -6100997100383932834L
-
Class org.hipparchus.migration.exception.NotPositiveException extends NumberIsTooSmallException implements Serializable
- serialVersionUID:
- -2250556892093726375L
-
Class org.hipparchus.migration.exception.NotStrictlyPositiveException extends NumberIsTooSmallException implements Serializable
- serialVersionUID:
- -7824848630829852237L
-
Class org.hipparchus.migration.exception.NumberIsTooLargeException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- 4330003017885151975L
-
Serialized Fields
-
boundIsAllowed
boolean boundIsAllowed
Deprecated.Whether the maximum is included in the allowed range. -
max
Number max
Deprecated.Higher bound.
-
-
Class org.hipparchus.migration.exception.NumberIsTooSmallException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- -6100997100383932834L
-
Serialized Fields
-
boundIsAllowed
boolean boundIsAllowed
Deprecated.Whether the maximum is included in the allowed range. -
min
Number min
Deprecated.Higher bound.
-
-
Class org.hipparchus.migration.exception.OutOfRangeException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- 111601815794403609L
-
Class org.hipparchus.migration.exception.TooManyEvaluationsException extends MaxCountExceededException implements Serializable
- serialVersionUID:
- 4330003017885151975L
-
Class org.hipparchus.migration.exception.TooManyIterationsException extends MaxCountExceededException implements Serializable
- serialVersionUID:
- 20121211L
-
Class org.hipparchus.migration.exception.ZeroException extends MathIllegalNumberException implements Serializable
- serialVersionUID:
- -1960874856936000015L
-
-
Package org.hipparchus.migration.genetics
-
Class org.hipparchus.migration.genetics.InvalidRepresentationException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 1L
-
-
Package org.hipparchus.migration.geometry.euclidean
-
Class org.hipparchus.migration.geometry.euclidean.CardanEulerSingularityException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- -1360952845582206770L
-
-
Package org.hipparchus.migration.geometry.euclidean.threed
-
Class org.hipparchus.migration.geometry.euclidean.threed.NotARotationMatrixException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 5647178478658937642L
-
-
Package org.hipparchus.migration.linear
-
Class org.hipparchus.migration.linear.IllConditionedOperatorException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -7883263944530490135L
-
Class org.hipparchus.migration.linear.MatrixDimensionMismatchException extends MultiDimensionMismatchException implements Serializable
- serialVersionUID:
- -8415396756375798143L
-
Class org.hipparchus.migration.linear.NonPositiveDefiniteMatrixException extends NumberIsTooSmallException implements Serializable
- serialVersionUID:
- 1641613838113738061L
-
Serialized Fields
-
index
int index
Deprecated.Index (diagonal element). -
threshold
double threshold
Deprecated.Threshold.
-
-
Class org.hipparchus.migration.linear.NonPositiveDefiniteOperatorException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 917034489420549847L
-
Class org.hipparchus.migration.linear.NonSelfAdjointOperatorException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 1784999305030258247L
-
Class org.hipparchus.migration.linear.NonSquareMatrixException extends DimensionMismatchException implements Serializable
- serialVersionUID:
- -660069396594485772L
-
Class org.hipparchus.migration.linear.NonSquareOperatorException extends DimensionMismatchException implements Serializable
- serialVersionUID:
- -4145007524150846242L
-
Class org.hipparchus.migration.linear.NonSymmetricMatrixException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -7518495577824189882L
-
Serialized Fields
-
column
int column
Deprecated.Column. -
row
int row
Deprecated.Row. -
threshold
double threshold
Deprecated.Threshold.
-
-
Class org.hipparchus.migration.linear.SingularMatrixException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -4206514844735401070L
-
Class org.hipparchus.migration.linear.SingularOperatorException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- -476049978595245033L
-
-
Package org.hipparchus.migration.ode
-
Class org.hipparchus.migration.ode.ContinuousOutputModel extends DenseOutputModel implements Serializable
- serialVersionUID:
- 20160403L
-
Serialized Fields
-
interpolatedTime
double interpolatedTime
Deprecated.Interpolation time.
-
-
Class org.hipparchus.migration.ode.JacobianMatrices.MismatchedEquations extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 20120902L
-
Class org.hipparchus.migration.ode.UnknownParameterException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 20120902L
-
Serialized Fields
-
name
String name
Deprecated.Parameter name.
-
-
-
Package org.hipparchus.migration.ode.sampling
-
Package org.hipparchus.migration.optim.linear
-
Class org.hipparchus.migration.optim.linear.NoFeasibleSolutionException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- -3044253632189082760L
-
Class org.hipparchus.migration.optim.linear.UnboundedSolutionException extends MathIllegalStateException implements Serializable
- serialVersionUID:
- 940539497277290619L
-
-
Package org.hipparchus.migration.stat.regression
-
Class org.hipparchus.migration.stat.regression.ModelSpecificationException extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 4206514456095401070L
-
-
Package org.hipparchus.ode
-
Class org.hipparchus.ode.ComplexODEState extends Object implements Serializable
- serialVersionUID:
- 20180902L
-
Class org.hipparchus.ode.ComplexODEStateAndDerivative extends ComplexODEState implements Serializable
- serialVersionUID:
- 20180902L
-
Class org.hipparchus.ode.DenseOutputModel extends Object implements Serializable
- serialVersionUID:
- 20160328L
-
Serialized Fields
-
finalTime
double finalTime
Final integration time. -
forward
boolean forward
Integration direction indicator. -
index
int index
Current interpolator index. -
initialTime
double initialTime
Initial integration time. -
steps
List<ODEStateInterpolator> steps
Steps table.
-
-
Class org.hipparchus.ode.EquationsMapper extends Object implements Serializable
- serialVersionUID:
- 20160327L
-
Serialized Fields
-
start
int[] start
Start indices of the components.
-
-
Class org.hipparchus.ode.FieldEquationsMapper extends Object implements Serializable
- serialVersionUID:
- 20151114L
-
Serialized Fields
-
start
int[] start
Start indices of the components.
-
-
Class org.hipparchus.ode.ODEState extends Object implements Serializable
- serialVersionUID:
- 20160408L
-
Serialized Fields
-
completeDimension
int completeDimension
Complete dimension. -
primaryState
double[] primaryState
Primary state at time. -
secondaryState
double[][] secondaryState
Secondary state at time. -
time
double time
Time.
-
-
Class org.hipparchus.ode.ODEStateAndDerivative extends ODEState implements Serializable
- serialVersionUID:
- 20160408L
-
Serialized Fields
-
primaryDerivative
double[] primaryDerivative
Derivative of the primary state at time. -
secondaryDerivative
double[][] secondaryDerivative
Derivative of the secondary state at time.
-
-
Class org.hipparchus.ode.VariationalEquation.MismatchedEquations extends MathIllegalArgumentException implements Serializable
- serialVersionUID:
- 20120902L
-
-
Package org.hipparchus.ode.sampling
-
Class org.hipparchus.ode.sampling.AbstractODEStateInterpolator extends Object implements Serializable
- serialVersionUID:
- 20160328L
-
Serialized Fields
-
forward
boolean forward
integration direction. -
globalCurrentState
ODEStateAndDerivative globalCurrentState
Global current state. -
globalPreviousState
ODEStateAndDerivative globalPreviousState
Global previous state. -
mapper
EquationsMapper mapper
Mapper for ODE equations primary and secondary components. -
softCurrentState
ODEStateAndDerivative softCurrentState
Soft current state. -
softPreviousState
ODEStateAndDerivative softPreviousState
Soft previous state.
-
-
-
Package org.hipparchus.optim
-
Class org.hipparchus.optim.PointValuePair extends Pair<double[],Double> implements Serializable
- serialVersionUID:
- 20120513L
-
Serialization Methods
-
writeReplace
private Object writeReplace()
Replace the instance with a data transfer object for serialization.
-
-
Class org.hipparchus.optim.PointVectorValuePair extends Pair<double[],double[]> implements Serializable
- serialVersionUID:
- 20120513L
-
Serialization Methods
-
writeReplace
private Object writeReplace()
Replace the instance with a data transfer object for serialization.
-
-
-
Package org.hipparchus.optim.linear
-
Class org.hipparchus.optim.linear.LinearConstraint extends Object implements Serializable
- serialVersionUID:
- -764632794033034092L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream ois) throws ClassNotFoundException, IOException
Deserialize the instance.- Throws:
ClassNotFoundException
- if a class in the stream cannot be foundIOException
- if object cannot be read from the stream
-
writeObject
private void writeObject(ObjectOutputStream oos) throws IOException
Serialize the instance.- Throws:
IOException
- if object cannot be written to stream
-
-
Serialized Fields
-
relationship
Relationship relationship
Relationship between left and right hand sides (=, <=, >=). -
value
double value
Value of the constraint (right hand side).
-
-
Class org.hipparchus.optim.linear.LinearObjectiveFunction extends Object implements Serializable
- serialVersionUID:
- -4531815507568396090L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream ois) throws ClassNotFoundException, IOException
Deserialize the instance.- Throws:
ClassNotFoundException
- if a class in the stream cannot be foundIOException
- if object cannot be read from the stream
-
writeObject
private void writeObject(ObjectOutputStream oos) throws IOException
Serialize the instance.- Throws:
IOException
- if object cannot be written to stream
-
-
Serialized Fields
-
constantTerm
double constantTerm
Constant term of the linear equation.
-
-
-
Package org.hipparchus.optim.univariate
-
Class org.hipparchus.optim.univariate.UnivariatePointValuePair extends Object implements Serializable
- serialVersionUID:
- 1003888396256744753L
-
Serialized Fields
-
point
double point
Point. -
value
double value
Value of the objective function at the point.
-
-
-
Package org.hipparchus.random
-
Class org.hipparchus.random.AbstractWell extends org.hipparchus.random.IntRandomGenerator implements Serializable
- serialVersionUID:
- 20150223L
-
Serialized Fields
-
index
int index
Current index in the bytes pool. -
v
int[] v
Bytes pool.
-
-
Class org.hipparchus.random.ISAACRandom extends org.hipparchus.random.IntRandomGenerator implements Serializable
- serialVersionUID:
- 20160529L
-
Serialized Fields
-
arr
int[] arr
Service variable. -
count
int count
Count through the results in rsl[] -
isaacA
int isaacA
Accumulator -
isaacB
int isaacB
The last result -
isaacC
int isaacC
Counter, guarantees cycle is at least 2^40 -
isaacI
int isaacI
Service variable. -
isaacJ
int isaacJ
Service variable. -
isaacX
int isaacX
Service variable. -
mem
int[] mem
The internal state -
rsl
int[] rsl
The results given to the user
-
-
Class org.hipparchus.random.JDKRandomGenerator extends org.hipparchus.random.IntRandomGenerator implements Serializable
- serialVersionUID:
- 20151227L
-
Serialized Fields
-
delegate
Random delegate
JDK's RNG.
-
-
Class org.hipparchus.random.MersenneTwister extends org.hipparchus.random.IntRandomGenerator implements Serializable
- serialVersionUID:
- 20160529L
-
Serialized Fields
-
mt
int[] mt
Bytes pool. -
mti
int mti
Current index in the bytes pool.
-
-
Class org.hipparchus.random.RandomAdaptor extends Random implements Serializable
- serialVersionUID:
- 20160529L
-
Serialized Fields
-
randomGenerator
RandomGenerator randomGenerator
Wrapped randomGenerator instance
-
-
Class org.hipparchus.random.RandomDataGenerator extends org.hipparchus.random.ForwardingRandomGenerator implements Serializable
- serialVersionUID:
- 20160529L
-
Serialized Fields
-
randomGenerator
RandomGenerator randomGenerator
Source of random data
-
-
Class org.hipparchus.random.Well1024a extends AbstractWell implements Serializable
- serialVersionUID:
- 20150223L
-
Class org.hipparchus.random.Well19937a extends AbstractWell implements Serializable
- serialVersionUID:
- 20150223L
-
Class org.hipparchus.random.Well19937c extends AbstractWell implements Serializable
- serialVersionUID:
- 20150223L
-
Class org.hipparchus.random.Well44497a extends AbstractWell implements Serializable
- serialVersionUID:
- 20150223L
-
Class org.hipparchus.random.Well44497b extends AbstractWell implements Serializable
- serialVersionUID:
- 20150223L
-
Class org.hipparchus.random.Well512a extends AbstractWell implements Serializable
- serialVersionUID:
- 20150223L
-
-
Package org.hipparchus.samples
-
Class org.hipparchus.samples.ClusterAlgorithmComparison.ClusterPlot extends JComponent implements Serializable
-
Serialized Fields
-
clusters
List<? extends Cluster<DoublePoint>> clusters
-
duration
long duration
-
-
-
Class org.hipparchus.samples.ClusterAlgorithmComparison.Display extends ExampleUtils.ExampleFrame implements Serializable
-
Class org.hipparchus.samples.ExampleUtils.ExampleFrame extends JFrame implements Serializable
-
Class org.hipparchus.samples.IntegerDistributionComparison.Display extends ExampleUtils.ExampleFrame implements Serializable
-
Serialized Fields
-
container
JComponent container
-
-
-
Class org.hipparchus.samples.LowDiscrepancyGeneratorComparison.Display extends ExampleUtils.ExampleFrame implements Serializable
-
Class org.hipparchus.samples.LowDiscrepancyGeneratorComparison.Plot extends JComponent implements Serializable
-
Class org.hipparchus.samples.RealDistributionComparison.Display extends ExampleUtils.ExampleFrame implements Serializable
-
Serialized Fields
-
container
JComponent container
-
-
-
-
Package org.hipparchus.samples.clustering
-
Class org.hipparchus.samples.clustering.ImageClusteringExample.Display extends ExampleUtils.ExampleFrame implements Serializable
-
Serialized Fields
-
clusterImage
BufferedImage clusterImage
-
clusterSizeSpinner
JSpinner clusterSizeSpinner
-
painter
org.hipparchus.samples.clustering.ImageClusteringExample.Display.ImagePainter painter
-
referenceImage
BufferedImage referenceImage
-
referenceRaster
Raster referenceRaster
-
-
-
-
Package org.hipparchus.samples.geometry
-
Class org.hipparchus.samples.geometry.GeometryExample.Display extends ExampleUtils.ExampleFrame implements Serializable
-
Serialized Fields
-
canvas
org.piccolo2d.PCanvas canvas
-
container
JComponent container
-
controlPanel
JComponent controlPanel
-
points
List<Vector2D> points
-
-
-
-
Package org.hipparchus.stat
-
Class org.hipparchus.stat.Frequency extends Object implements Serializable
- serialVersionUID:
- 20160322L
-
Serialized Fields
-
freqTable
NavigableMap<T extends Comparable<T>,Long> freqTable
underlying collection
-
-
Class org.hipparchus.stat.LongFrequency extends Frequency<Long> implements Serializable
- serialVersionUID:
- 20160322L
-
-
Package org.hipparchus.stat.descriptive
-
Class org.hipparchus.stat.descriptive.DescriptiveStatistics extends Object implements Serializable
- serialVersionUID:
- 20160411L
-
Serialized Fields
-
eDA
ResizableDoubleArray eDA
Stored data values. -
geometricMeanImpl
UnivariateStatistic geometricMeanImpl
Geometric mean statistic implementation. -
kurtosisImpl
UnivariateStatistic kurtosisImpl
Kurtosis statistic implementation. -
maxImpl
UnivariateStatistic maxImpl
Maximum statistic implementation. -
meanImpl
UnivariateStatistic meanImpl
Mean statistic implementation. -
minImpl
UnivariateStatistic minImpl
Minimum statistic implementation. -
percentileImpl
Percentile percentileImpl
Percentile statistic implementation. -
skewnessImpl
UnivariateStatistic skewnessImpl
Skewness statistic implementation. -
sumImpl
UnivariateStatistic sumImpl
Sum statistic implementation. -
sumOfSquaresImpl
UnivariateStatistic sumOfSquaresImpl
Sum of squares statistic implementation. -
varianceImpl
UnivariateStatistic varianceImpl
Variance statistic implementation. -
windowSize
int windowSize
holds the window size.
-
-
Class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics extends Object implements Serializable
- serialVersionUID:
- 20160424L
-
Serialized Fields
-
covarianceImpl
VectorialCovariance covarianceImpl
Covariance statistic implementation -
geoMeanImpl
StorelessMultivariateStatistic geoMeanImpl
Geometric mean statistic implementation -
k
int k
Dimension of the data. -
maxImpl
StorelessMultivariateStatistic maxImpl
Maximum statistic implementation -
meanImpl
StorelessMultivariateStatistic meanImpl
Mean statistic implementation -
minImpl
StorelessMultivariateStatistic minImpl
Minimum statistic implementation -
n
long n
Count of values that have been added -
sumImpl
StorelessMultivariateStatistic sumImpl
Sum statistic implementation -
sumLogImpl
StorelessMultivariateStatistic sumLogImpl
Sum of log statistic implementation -
sumSqImpl
StorelessMultivariateStatistic sumSqImpl
Sum of squares statistic implementation
-
-
Class org.hipparchus.stat.descriptive.StatisticalSummaryValues extends Object implements Serializable
- serialVersionUID:
- 20160406L
-
Serialized Fields
-
max
double max
The maximum value -
mean
double mean
The sample mean -
min
double min
The minimum value -
n
long n
The number of observations in the sample -
sum
double sum
The sum of the sample values -
variance
double variance
The sample variance
-
-
Class org.hipparchus.stat.descriptive.StreamingStatistics extends Object implements Serializable
- serialVersionUID:
- 20160422L
-
Serialized Fields
-
computeExtrema
boolean computeExtrema
whether or not min and max are maintained -
computeMoments
boolean computeMoments
whether or not moment stats (sum, mean, variance) are maintained -
computePercentiles
boolean computePercentiles
whether or not percentiles are maintained -
computeSumOfLogs
boolean computeSumOfLogs
whether or not sum of logs and geometric mean are maintained -
computeSumOfSquares
boolean computeSumOfSquares
whether or not sum of squares and quadratic mean are maintained -
geoMeanImpl
GeometricMean geoMeanImpl
geoMean of values that have been added -
maxImpl
Max maxImpl
max of values that have been added -
meanImpl
Mean meanImpl
mean of values that have been added -
minImpl
Min minImpl
min of values that have been added -
n
long n
count of values that have been added -
populationVariance
Variance populationVariance
population variance of values that have been added -
randomPercentile
RandomPercentile randomPercentile
source of percentiles -
secondMoment
SecondMoment secondMoment
SecondMoment is used to compute the mean and variance -
sumImpl
Sum sumImpl
sum of values that have been added -
sumOfLogsImpl
SumOfLogs sumOfLogsImpl
sumLog of values that have been added -
sumOfSquaresImpl
SumOfSquares sumOfSquaresImpl
sum of the square of each value that has been added -
varianceImpl
Variance varianceImpl
variance of values that have been added
-
-
-
Package org.hipparchus.stat.descriptive.moment
-
Class org.hipparchus.stat.descriptive.moment.GeometricMean extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
incSumOfLogs
boolean incSumOfLogs
Determines whether or not this statistic can be incremented or cleared.Statistics based on (constructed from) external statistics cannot be incremented or cleared.
-
sumOfLogs
SumOfLogs sumOfLogs
Wrapped SumOfLogs instance
-
-
Class org.hipparchus.stat.descriptive.moment.Kurtosis extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
incMoment
boolean incMoment
Determines whether or not this statistic can be incremented or cleared.Statistics based on (constructed from) external moments cannot be incremented or cleared.
-
moment
org.hipparchus.stat.descriptive.moment.FourthMoment moment
Fourth Moment on which this statistic is based
-
-
Class org.hipparchus.stat.descriptive.moment.Mean extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
incMoment
boolean incMoment
Determines whether or not this statistic can be incremented or cleared.Statistics based on (constructed from) external moments cannot be incremented or cleared.
-
moment
org.hipparchus.stat.descriptive.moment.FirstMoment moment
First moment on which this statistic is based.
-
-
Class org.hipparchus.stat.descriptive.moment.SecondMoment extends org.hipparchus.stat.descriptive.moment.FirstMoment implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
m2
double m2
Second moment of values that have been added
-
-
Class org.hipparchus.stat.descriptive.moment.SemiVariance extends AbstractUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
biasCorrected
boolean biasCorrected
Determines whether or not bias correction is applied when computing the value of the statistic. True means that bias is corrected. -
varianceDirection
SemiVariance.Direction varianceDirection
Determines whether to calculate downside or upside SemiVariance.
-
-
Class org.hipparchus.stat.descriptive.moment.Skewness extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
incMoment
boolean incMoment
Determines whether or not this statistic can be incremented or cleared.Statistics based on (constructed from) external moments cannot be incremented or cleared.
-
moment
org.hipparchus.stat.descriptive.moment.ThirdMoment moment
Third moment on which this statistic is based
-
-
Class org.hipparchus.stat.descriptive.moment.StandardDeviation extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
variance
Variance variance
Wrapped Variance instance
-
-
Class org.hipparchus.stat.descriptive.moment.Variance extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
incMoment
boolean incMoment
Whether or notVariance.increment(double)
should increment the internal second moment. When a Variance is constructed with an external SecondMoment as a constructor parameter, this property is set to false and increments must be applied to the second moment directly. -
isBiasCorrected
boolean isBiasCorrected
Whether or not bias correction is applied when computing the value of the statistic. True means that bias is corrected. SeeVariance
for details on the formula. -
moment
SecondMoment moment
SecondMoment is used in incremental calculation of Variance
-
-
-
Package org.hipparchus.stat.descriptive.rank
-
Class org.hipparchus.stat.descriptive.rank.Max extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
n
long n
Number of values that have been added -
value
double value
Current value of the statistic
-
-
Class org.hipparchus.stat.descriptive.rank.Median extends AbstractUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
percentile
Percentile percentile
The percentile impl to calculate the median.
-
-
Class org.hipparchus.stat.descriptive.rank.Min extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
n
long n
Number of values that have been added -
value
double value
Current value of the statistic
-
-
Class org.hipparchus.stat.descriptive.rank.Percentile extends AbstractUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
cachedPivots
int[] cachedPivots
Cached pivots. -
estimationType
Percentile.EstimationType estimationType
Any of thePercentile.EstimationType
s such asCM
can be used. -
kthSelector
KthSelector kthSelector
Default KthSelector used with default pivoting strategy -
nanStrategy
NaNStrategy nanStrategy
NaN Handling of the input as defined byNaNStrategy
-
quantile
double quantile
Determines what percentile is computed when evaluate() is activated with no quantile argument.
-
-
Class org.hipparchus.stat.descriptive.rank.PSquarePercentile extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
countOfObservations
long countOfObservations
Counter to count the values/observations accepted into this data set -
initialFive
List<Double> initialFive
Initial list of 5 numbers corresponding to 5 markers. NOTE:watch out for the add methods that are overloaded -
markers
PSquarePercentile.PSquareMarkers markers
Markers is the marker collection object which comes to effect only after 5 values are inserted -
pValue
double pValue
Computed p value (i,e percentile value of data set hither to received) -
quantile
double quantile
The quantile needed should be in range of 0-1. The constructorPSquarePercentile(double)
ensures that passed in percentile is divided by 100.
-
-
Class org.hipparchus.stat.descriptive.rank.RandomPercentile extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 1L
-
Serialized Fields
-
bufferMap
org.hipparchus.stat.descriptive.rank.RandomPercentile.BufferMap bufferMap
Data structure used to manage buffers -
currentBuffer
org.hipparchus.stat.descriptive.rank.RandomPercentile.Buffer currentBuffer
Buffer currently being filled -
epsilon
double epsilon
Bound on the quantile estimation error -
h
int h
Maximum number of buffers minus 1 -
n
long n
Number of elements consumed from the input data stream -
randomGenerator
RandomGenerator randomGenerator
Source of random data -
s
int s
Storage size of each buffer
-
-
-
Package org.hipparchus.stat.descriptive.summary
-
Class org.hipparchus.stat.descriptive.summary.Product extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
n
long n
The number of values that have been added -
value
double value
The current Running Product
-
-
Class org.hipparchus.stat.descriptive.summary.Sum extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
n
long n
The number of values that have been added -
value
double value
The currently running sum
-
-
Class org.hipparchus.stat.descriptive.summary.SumOfLogs extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
n
int n
Number of values that have been added -
value
double value
The currently running value
-
-
Class org.hipparchus.stat.descriptive.summary.SumOfSquares extends AbstractStorelessUnivariateStatistic implements Serializable
- serialVersionUID:
- 20150412L
-
Serialized Fields
-
n
long n
Number of values that have been added -
value
double value
The currently running sumSq
-
-
-
Package org.hipparchus.stat.descriptive.vector
-
Class org.hipparchus.stat.descriptive.vector.VectorialCovariance extends Object implements Serializable
- serialVersionUID:
- 4118372414238930270L
-
Serialized Fields
-
isBiasCorrected
boolean isBiasCorrected
Indicator for bias correction. -
n
long n
Number of vectors in the sample. -
productsSums
double[] productsSums
Sums of products for each component. -
sums
double[] sums
Sums for each component.
-
-
Class org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic extends Object implements Serializable
- serialVersionUID:
- 20160413L
-
Serialized Fields
-
stats
StorelessUnivariateStatistic[] stats
Statistic for each component
-
-
-
Package org.hipparchus.stat.fitting
-
Class org.hipparchus.stat.fitting.EmpiricalDistribution extends AbstractRealDistribution implements Serializable
- serialVersionUID:
- 5729073523949762654L
-
Serialized Fields
-
binCount
int binCount
number of bins -
binStats
List<StreamingStatistics> binStats
List of SummaryStatistics objects characterizing the bins -
delta
double delta
Grid size -
loaded
boolean loaded
is the distribution loaded? -
max
double max
Max loaded value -
min
double min
Min loaded value -
randomData
RandomDataGenerator randomData
RandomDataGenerator instance to use in repeated calls to getNext() -
sampleStats
StreamingStatistics sampleStats
Sample statistics -
upperBounds
double[] upperBounds
upper bounds of subintervals in (0,1) "belonging" to the bins
-
-
-
Package org.hipparchus.stat.regression
-
Class org.hipparchus.stat.regression.RegressionResults extends Object implements Serializable
- serialVersionUID:
- 1L
-
Serialized Fields
-
containsConstant
boolean containsConstant
boolean flag indicator of whether a constant was included -
globalFitInfo
double[] globalFitInfo
array storing global results, SSE, MSE, RSQ, adjRSQ -
isSymmetricVCD
boolean isSymmetricVCD
boolean flag for variance covariance matrix in symm compressed storage -
nobs
long nobs
number of observations on which results are based -
parameters
double[] parameters
regression slope parameters -
rank
int rank
rank of the solution -
varCovData
double[][] varCovData
variance covariance matrix of parameters
-
-
Class org.hipparchus.stat.regression.SimpleRegression extends Object implements Serializable
- serialVersionUID:
- -3004689053607543335L
-
Serialized Fields
-
hasIntercept
boolean hasIntercept
include an intercept or not -
n
long n
number of observations -
sumX
double sumX
sum of x values -
sumXX
double sumXX
total variation in x (sum of squared deviations from xbar) -
sumXY
double sumXY
sum of products -
sumY
double sumY
sum of y values -
sumYY
double sumYY
total variation in y (sum of squared deviations from ybar) -
xbar
double xbar
mean of accumulated x values, used in updating formulas -
ybar
double ybar
mean of accumulated y values, used in updating formulas
-
-
-
Package org.hipparchus.transform
-
Class org.hipparchus.transform.FastCosineTransformer extends Object implements Serializable
- serialVersionUID:
- 20120212L
-
Serialized Fields
-
normalization
DctNormalization normalization
The type of DCT to be performed.
-
-
Class org.hipparchus.transform.FastFourierTransformer extends Object implements Serializable
- serialVersionUID:
- 20120210L
-
Serialized Fields
-
normalization
DftNormalization normalization
The type of DFT to be performed.
-
-
Class org.hipparchus.transform.FastHadamardTransformer extends Object implements Serializable
- serialVersionUID:
- 20120211L
-
Class org.hipparchus.transform.FastSineTransformer extends Object implements Serializable
- serialVersionUID:
- 20120211L
-
Serialized Fields
-
normalization
DstNormalization normalization
The type of DST to be performed.
-
-
-
Package org.hipparchus.util
-
Class org.hipparchus.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.hipparchus.util.BigRealField extends Object implements Serializable
- serialVersionUID:
- 20160327L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.hipparchus.util.Decimal64 extends Number implements Serializable
- serialVersionUID:
- 20120227L
-
Serialized Fields
-
value
double value
The primitivedouble
value of this object.
-
-
Class org.hipparchus.util.Decimal64Field extends Object implements Serializable
- serialVersionUID:
- 20161219L
-
Serialization Methods
-
readResolve
private Object readResolve()
Handle deserialization of the singleton.
-
-
Class org.hipparchus.util.IterationEvent extends EventObject implements Serializable
- serialVersionUID:
- 20120128L
-
Serialized Fields
-
iterations
int iterations
The number of iterations performed so far.
-
-
Class org.hipparchus.util.KthSelector extends Object implements Serializable
- serialVersionUID:
- 20140713L
-
Serialized Fields
-
pivotingStrategy
PivotingStrategy pivotingStrategy
APivotingStrategy
used for pivoting.
-
-
Class org.hipparchus.util.OpenIntToDoubleHashMap extends Object implements Serializable
- serialVersionUID:
- -3646337053166149105L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream stream) throws IOException, ClassNotFoundException
Read a serialized object.- Throws:
IOException
- if object cannot be readClassNotFoundException
- if the class corresponding to the serialized object cannot be found
-
-
Serialized Fields
-
keys
int[] keys
Keys table. -
mask
int mask
Bit mask for hash values. -
missingEntries
double missingEntries
Return value for missing entries. -
size
int size
Current size of the map. -
states
byte[] states
States table. -
values
double[] values
Values table.
-
-
Class org.hipparchus.util.OpenIntToFieldHashMap extends Object implements Serializable
- serialVersionUID:
- -9179080286849120720L
-
Serialization Methods
-
readObject
private void readObject(ObjectInputStream stream) throws IOException, ClassNotFoundException
Read a serialized object.- Throws:
IOException
- if object cannot be readClassNotFoundException
- if the class corresponding to the serialized object cannot be found
-
-
Serialized Fields
-
field
Field<T extends FieldElement<T>> field
Field to which the elements belong. -
keys
int[] keys
Keys table. -
mask
int mask
Bit mask for hash values. -
missingEntries
T extends FieldElement<T> missingEntries
Return value for missing entries. -
size
int size
Current size of the map. -
states
byte[] states
States table. -
values
T extends FieldElement<T>[] values
Values table.
-
-
Class org.hipparchus.util.ResizableDoubleArray extends Object implements Serializable
- serialVersionUID:
- 20160327L
-
Serialized Fields
-
contractionCriterion
double contractionCriterion
The contraction criteria determines when the internal array will be contracted to fit the number of elements contained in the element array + 1. -
expansionFactor
double expansionFactor
The expansion factor of the array. When the array needs to be expanded, the new array size will beinternalArray.length * expansionFactor
ifexpansionMode
is set to MULTIPLICATIVE, orinternalArray.length + expansionFactor
ifexpansionMode
is set to ADDITIVE. -
expansionMode
ResizableDoubleArray.ExpansionMode expansionMode
Determines whether array expansion byexpansionFactor
is additive or multiplicative. -
internalArray
double[] internalArray
The internal storage array. -
numElements
int numElements
The number of addressable elements in the array. Note that this has nothing to do with the length of the internal storage array. -
startIndex
int startIndex
The position of the first addressable element in the internal storage array. The addressable elements in the array areinternalArray[startIndex],...,internalArray[startIndex + numElements - 1]
.
-
-