序列化表格
-
程序包 org.hipparchus.analysis.differentiation
-
类 org.hipparchus.analysis.differentiation.DerivativeStructure
class DerivativeStructure extends Object implements Serializable- serialVersionUID:
- 20161220L
-
序列化字段
-
data
double[] data
Combined array holding all values. -
factory
DSFactory factory
Factory that built the instance.
-
-
类 org.hipparchus.analysis.differentiation.DSFactory
class DSFactory extends Object implements Serializable- serialVersionUID:
- 20161222L
-
序列化方法
-
writeReplace
Replace the instance with a data transfer object for serialization.
-
-
类 org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
class FiniteDifferencesDifferentiator extends Object implements Serializable- serialVersionUID:
- 20120917L
-
序列化字段
-
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.
-
-
类 org.hipparchus.analysis.differentiation.Gradient
class Gradient extends Object implements Serializable- serialVersionUID:
- 20200520L
-
序列化字段
-
grad
double[] grad
Gradient of the function. -
value
double value
Value of the function.
-
-
类 org.hipparchus.analysis.differentiation.SparseGradient
class SparseGradient extends Object implements Serializable- serialVersionUID:
- 20131025L
-
类 org.hipparchus.analysis.differentiation.UnivariateDerivative
class UnivariateDerivative extends Object implements Serializable- serialVersionUID:
- 20200519L
-
类 org.hipparchus.analysis.differentiation.UnivariateDerivative1
class UnivariateDerivative1 extends UnivariateDerivative<UnivariateDerivative1> implements Serializable- serialVersionUID:
- 20200519L
-
序列化字段
-
f0
double f0
Value of the function. -
f1
double f1
First derivative of the function.
-
-
类 org.hipparchus.analysis.differentiation.UnivariateDerivative1Field
class UnivariateDerivative1Field extends Object implements Serializable- serialVersionUID:
- 20200519L
-
序列化方法
-
readResolve
Handle deserialization of the singleton.
-
-
序列化字段
-
factory
DSFactory factory
Associated factory for conversions toDerivativeStructure
. -
one
UnivariateDerivative1 one
One constant. -
zero
UnivariateDerivative1 zero
Zero constant.
-
-
类 org.hipparchus.analysis.differentiation.UnivariateDerivative2
class UnivariateDerivative2 extends UnivariateDerivative<UnivariateDerivative2> implements Serializable- serialVersionUID:
- 20200520L
-
序列化字段
-
f0
double f0
Value of the function. -
f1
double f1
First derivative of the function. -
f2
double f2
Second derivative of the function.
-
-
类 org.hipparchus.analysis.differentiation.UnivariateDerivative2Field
class UnivariateDerivative2Field extends Object implements Serializable- serialVersionUID:
- 20200520L
-
序列化方法
-
readResolve
Handle deserialization of the singleton.
-
-
序列化字段
-
factory
DSFactory factory
Associated factory for conversions toDerivativeStructure
. -
one
UnivariateDerivative2 one
One constant. -
zero
UnivariateDerivative2 zero
Zero constant.
-
-
-
程序包 org.hipparchus.analysis.interpolation
-
类 org.hipparchus.analysis.interpolation.BilinearInterpolatingFunction
class BilinearInterpolatingFunction extends Object implements Serializable- serialVersionUID:
- 20180926L
-
类 org.hipparchus.analysis.interpolation.DividedDifferenceInterpolator
class DividedDifferenceInterpolator extends Object implements Serializable- serialVersionUID:
- 107049519551235069L
-
类 org.hipparchus.analysis.interpolation.GridAxis
class GridAxis extends Object implements Serializable- serialVersionUID:
- 20180926L
-
序列化字段
-
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.
-
-
类 org.hipparchus.analysis.interpolation.LoessInterpolator
class LoessInterpolator extends Object implements Serializable- serialVersionUID:
- 5204927143605193821L
-
序列化字段
-
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.
-
-
类 org.hipparchus.analysis.interpolation.NevilleInterpolator
class NevilleInterpolator extends Object implements Serializable- serialVersionUID:
- 3003707660147873733L
-
-
程序包 org.hipparchus.analysis.polynomials
-
类 org.hipparchus.analysis.polynomials.PolynomialFunction
class PolynomialFunction extends Object implements Serializable- serialVersionUID:
- -7726511984200295583L
-
序列化字段
-
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.
-
-
类 org.hipparchus.analysis.polynomials.SmoothStepFactory.QuadraticSmoothStepFunction
class QuadraticSmoothStepFunction extends SmoothStepFactory.SmoothStepFunction implements Serializable- serialVersionUID:
- 20230422L
-
类 org.hipparchus.analysis.polynomials.SmoothStepFactory.SmoothStepFunction
class SmoothStepFunction extends PolynomialFunction implements Serializable- serialVersionUID:
- 20230113L
-
-
程序包 org.hipparchus.clustering
-
类 org.hipparchus.clustering.CentroidCluster
- serialVersionUID:
- -3075288519071812288L
-
序列化字段
-
center
Clusterable center
Center of the cluster.
-
-
类 org.hipparchus.clustering.Cluster
class Cluster extends Object implements Serializable- serialVersionUID:
- -3442297081515880464L
-
序列化字段
-
points
List<T extends Clusterable> points
The points contained in this cluster.
-
-
类 org.hipparchus.clustering.DoublePoint
class DoublePoint extends Object implements Serializable- serialVersionUID:
- 3946024775784901369L
-
序列化字段
-
point
double[] point
Point coordinates.
-
-
-
程序包 org.hipparchus.clustering.distance
-
类 org.hipparchus.clustering.distance.CanberraDistance
class CanberraDistance extends Object implements Serializable- serialVersionUID:
- -6972277381587032228L
-
类 org.hipparchus.clustering.distance.ChebyshevDistance
class ChebyshevDistance extends Object implements Serializable- serialVersionUID:
- -4694868171115238296L
-
类 org.hipparchus.clustering.distance.EarthMoversDistance
class EarthMoversDistance extends Object implements Serializable- serialVersionUID:
- -5406732779747414922L
-
类 org.hipparchus.clustering.distance.EuclideanDistance
class EuclideanDistance extends Object implements Serializable- serialVersionUID:
- 1717556319784040040L
-
类 org.hipparchus.clustering.distance.ManhattanDistance
class ManhattanDistance extends Object implements Serializable- serialVersionUID:
- -9108154600539125566L
-
-
程序包 org.hipparchus.complex
-
类 org.hipparchus.complex.Complex
class Complex extends Object implements Serializable- serialVersionUID:
- 20160305L
-
序列化方法
-
readResolve
Resolve the transient fields in a deserialized Complex Object. Subclasses will need to overrideComplex.createComplex(double, double)
to deserialize properly.
-
-
序列化字段
-
imaginary
double imaginary
The imaginary part. -
real
double real
The real part.
-
-
类 org.hipparchus.complex.ComplexComparator
class ComplexComparator extends Object implements Serializable- serialVersionUID:
- 20171113L
-
类 org.hipparchus.complex.ComplexField
class ComplexField extends Object implements Serializable- serialVersionUID:
- 20160305L
-
序列化方法
-
readResolve
Handle deserialization of the singleton.
-
-
类 org.hipparchus.complex.ComplexTest.TestComplex
class TestComplex extends Complex implements Serializable- serialVersionUID:
- 3268726724160389237L
-
类 org.hipparchus.complex.Quaternion
class Quaternion extends Object implements Serializable- serialVersionUID:
- 20092012L
-
序列化字段
-
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).
-
-
类 org.hipparchus.complex.RootsOfUnity
class RootsOfUnity extends Object implements Serializable- serialVersionUID:
- 20120201L
-
序列化字段
-
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.
-
-
-
程序包 org.hipparchus.distribution
-
类 org.hipparchus.distribution.EnumeratedDistribution
class EnumeratedDistribution extends Object implements Serializable- serialVersionUID:
- 20123308L
-
序列化字段
-
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.
-
-
-
程序包 org.hipparchus.distribution.continuous
-
类 org.hipparchus.distribution.continuous.AbstractRealDistribution
class AbstractRealDistribution extends Object implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
solverAbsoluteAccuracy
double solverAbsoluteAccuracy
Inverse cumulative probability accuracy.
-
-
类 org.hipparchus.distribution.continuous.BetaDistribution
class BetaDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
alpha
double alpha
First shape parameter. -
beta
double beta
Second shape parameter. -
z
double z
Normalizing factor used in density computations.
-
-
类 org.hipparchus.distribution.continuous.CauchyDistribution
class CauchyDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
median
double median
The median of this distribution. -
scale
double scale
The scale of this distribution.
-
-
类 org.hipparchus.distribution.continuous.ChiSquaredDistribution
class ChiSquaredDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
gamma
GammaDistribution gamma
Internal Gamma distribution.
-
-
类 org.hipparchus.distribution.continuous.ConstantRealDistribution
class ConstantRealDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
value
double value
Constant value of the distribution
-
-
类 org.hipparchus.distribution.continuous.EnumeratedRealDistribution
class EnumeratedRealDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20130308L
-
序列化字段
-
innerDistribution
EnumeratedDistribution<Double> innerDistribution
EnumeratedDistribution
(using theDouble
wrapper) used to generate the pmf.
-
-
类 org.hipparchus.distribution.continuous.ExponentialDistribution
class ExponentialDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
logMean
double logMean
The logarithm of the mean, stored to reduce computing time. -
mean
double mean
The mean of this distribution.
-
-
类 org.hipparchus.distribution.continuous.FDistribution
class FDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
denominatorDegreesOfFreedom
double denominatorDegreesOfFreedom
The numerator degrees of freedom. -
numeratorDegreesOfFreedom
double numeratorDegreesOfFreedom
The numerator degrees of freedom. -
numericalVariance
double numericalVariance
Cached numerical variance
-
-
类 org.hipparchus.distribution.continuous.GammaDistribution
class GammaDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20120524L
-
序列化字段
-
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
-
-
类 org.hipparchus.distribution.continuous.GumbelDistribution
class GumbelDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20141003L
-
序列化字段
-
beta
double beta
The scale parameter. -
mu
double mu
The location parameter.
-
-
类 org.hipparchus.distribution.continuous.LaplaceDistribution
class LaplaceDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20141003L
-
序列化字段
-
beta
double beta
The scale parameter. -
mu
double mu
The location parameter.
-
-
类 org.hipparchus.distribution.continuous.LevyDistribution
class LevyDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20130314L
-
序列化字段
-
c
double c
Scale parameter. -
halfC
double halfC
Half of c (for calculations). -
mu
double mu
Location parameter.
-
-
类 org.hipparchus.distribution.continuous.LogisticDistribution
class LogisticDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20141003L
-
序列化字段
-
mu
double mu
The location parameter. -
s
double s
The scale parameter.
-
-
类 org.hipparchus.distribution.continuous.LogNormalDistribution
class LogNormalDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20120112L
-
序列化字段
-
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.
-
-
类 org.hipparchus.distribution.continuous.NakagamiDistribution
class NakagamiDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20141003L
-
序列化字段
-
mu
double mu
The shape parameter. -
omega
double omega
The scale parameter.
-
-
类 org.hipparchus.distribution.continuous.NormalDistribution
class NormalDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
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.
-
-
类 org.hipparchus.distribution.continuous.ParetoDistribution
class ParetoDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20130424L
-
序列化字段
-
scale
double scale
The scale parameter of this distribution. -
shape
double shape
The shape parameter of this distribution.
-
-
类 org.hipparchus.distribution.continuous.TDistribution
class TDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
degreesOfFreedom
double degreesOfFreedom
The degrees of freedom. -
factor
double factor
Static computation factor based on degreesOfFreedom.
-
-
类 org.hipparchus.distribution.continuous.TriangularDistribution
class TriangularDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20120112L
-
序列化字段
-
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.
-
-
类 org.hipparchus.distribution.continuous.UniformRealDistribution
class UniformRealDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20120109L
-
序列化字段
-
lower
double lower
Lower bound of this distribution (inclusive). -
upper
double upper
Upper bound of this distribution (exclusive).
-
-
类 org.hipparchus.distribution.continuous.WeibullDistribution
class WeibullDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
scale
double scale
The scale parameter. -
shape
double shape
The shape parameter.
-
-
-
程序包 org.hipparchus.distribution.discrete
-
类 org.hipparchus.distribution.discrete.AbstractIntegerDistribution
class AbstractIntegerDistribution extends Object implements Serializable- serialVersionUID:
- 20160320L
-
类 org.hipparchus.distribution.discrete.BinomialDistribution
class BinomialDistribution extends AbstractIntegerDistribution implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
numberOfTrials
int numberOfTrials
The number of trials. -
probabilityOfSuccess
double probabilityOfSuccess
The probability of success.
-
-
类 org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
class EnumeratedIntegerDistribution extends AbstractIntegerDistribution implements Serializable- serialVersionUID:
- 20130308L
-
序列化字段
-
innerDistribution
EnumeratedDistribution<Integer> innerDistribution
EnumeratedDistribution
instance (using theInteger
wrapper) used to generate the pmf.
-
-
类 org.hipparchus.distribution.discrete.GeometricDistribution
class GeometricDistribution extends AbstractIntegerDistribution implements Serializable- serialVersionUID:
- 20130507L
-
序列化字段
-
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.
-
-
类 org.hipparchus.distribution.discrete.HypergeometricDistribution
class HypergeometricDistribution extends AbstractIntegerDistribution implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
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.
-
-
类 org.hipparchus.distribution.discrete.PascalDistribution
class PascalDistribution extends AbstractIntegerDistribution implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
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.
-
-
类 org.hipparchus.distribution.discrete.PoissonDistribution
class PoissonDistribution extends AbstractIntegerDistribution implements Serializable- serialVersionUID:
- 20160320L
-
序列化字段
-
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.
-
-
类 org.hipparchus.distribution.discrete.UniformIntegerDistribution
class UniformIntegerDistribution extends AbstractIntegerDistribution implements Serializable- serialVersionUID:
- 20120109L
-
序列化字段
-
lower
int lower
Lower bound (inclusive) of this distribution. -
upper
int upper
Upper bound (inclusive) of this distribution.
-
-
类 org.hipparchus.distribution.discrete.ZipfDistribution
class ZipfDistribution extends AbstractIntegerDistribution implements Serializable- serialVersionUID:
- 20150501L
-
序列化字段
-
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
-
-
-
程序包 org.hipparchus.exception
-
类 org.hipparchus.exception.DummyLocalizable
class DummyLocalizable extends Object implements Serializable- serialVersionUID:
- 8843275624471387299L
-
序列化字段
-
source
String source
Source string.
-
-
异常错误类 org.hipparchus.exception.MathIllegalArgumentException
class MathIllegalArgumentException extends MathRuntimeException implements Serializable- serialVersionUID:
- -6024911025449780478L
-
异常错误类 org.hipparchus.exception.MathIllegalStateException
class MathIllegalStateException extends MathRuntimeException implements Serializable- serialVersionUID:
- -6024911025449780478L
-
异常错误类 org.hipparchus.exception.MathRuntimeException
class MathRuntimeException extends RuntimeException implements Serializable- serialVersionUID:
- 20160217L
-
序列化字段
-
parts
Object[] parts
Parts to insert in the format (no translation). -
specifier
Localizable specifier
Format specifier (to be translated).
-
-
异常错误类 org.hipparchus.exception.NullArgumentException
class NullArgumentException extends NullPointerException implements Serializable- serialVersionUID:
- 20160217L
-
序列化字段
-
parts
Object[] parts
Parts to insert in the format (no translation). -
specifier
Localizable specifier
Format specifier (to be translated).
-
-
-
程序包 org.hipparchus.fitting
-
类 org.hipparchus.fitting.WeightedObservedPoint
class WeightedObservedPoint extends Object implements Serializable- serialVersionUID:
- 5306874947404636157L
-
序列化字段
-
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.
-
-
类 org.hipparchus.fitting.WeightedObservedPoints
class WeightedObservedPoints extends Object implements Serializable- serialVersionUID:
- 20130813L
-
序列化字段
-
observations
List<WeightedObservedPoint> observations
Observed points.
-
-
-
程序包 org.hipparchus.fraction
-
类 org.hipparchus.fraction.BigFraction
class BigFraction extends Number implements Serializable- serialVersionUID:
- -5630213147331578515L
-
序列化字段
-
denominator
BigInteger denominator
The denominator. -
numerator
BigInteger numerator
The numerator.
-
-
类 org.hipparchus.fraction.BigFractionField
class BigFractionField extends Object implements Serializable- serialVersionUID:
- -1699294557189741703L
-
序列化方法
-
readResolve
Handle deserialization of the singleton.
-
-
类 org.hipparchus.fraction.BigFractionFormat
class BigFractionFormat extends org.hipparchus.fraction.AbstractFormat implements Serializable- serialVersionUID:
- 20160323L
-
类 org.hipparchus.fraction.Fraction
class Fraction extends Number implements Serializable- serialVersionUID:
- 3698073679419233275L
-
序列化字段
-
denominator
int denominator
The denominator. -
numerator
int numerator
The numerator.
-
-
类 org.hipparchus.fraction.FractionField
class FractionField extends Object implements Serializable- serialVersionUID:
- -1257768487499119313L
-
序列化方法
-
readResolve
Handle deserialization of the singleton.
-
-
类 org.hipparchus.fraction.FractionFormat
class FractionFormat extends org.hipparchus.fraction.AbstractFormat implements Serializable- serialVersionUID:
- 20160323L
-
类 org.hipparchus.fraction.ProperBigFractionFormat
class ProperBigFractionFormat extends BigFractionFormat implements Serializable- serialVersionUID:
- 20160323L
-
序列化字段
-
wholeFormat
NumberFormat wholeFormat
The format used for the whole number.
-
-
类 org.hipparchus.fraction.ProperFractionFormat
class ProperFractionFormat extends FractionFormat implements Serializable- serialVersionUID:
- 20160323L
-
序列化字段
-
wholeFormat
NumberFormat wholeFormat
The format used for the whole number.
-
-
-
程序包 org.hipparchus.geometry
-
程序包 org.hipparchus.geometry.enclosing
-
类 org.hipparchus.geometry.enclosing.EnclosingBall
class EnclosingBall extends Object implements Serializable- serialVersionUID:
- 20140126L
-
-
程序包 org.hipparchus.geometry.euclidean.oned
-
类 org.hipparchus.geometry.euclidean.oned.Euclidean1D
class Euclidean1D extends Object implements Serializable- serialVersionUID:
- -1178039568877797126L
-
序列化方法
-
readResolve
Handle deserialization of the singleton.
-
-
异常错误类 org.hipparchus.geometry.euclidean.oned.Euclidean1D.NoSubSpaceException
class NoSubSpaceException extends MathRuntimeException implements Serializable- serialVersionUID:
- 20140225L
-
类 org.hipparchus.geometry.euclidean.oned.Vector1D
class Vector1D extends Object implements Serializable- serialVersionUID:
- 7556674948671647925L
-
序列化字段
-
x
double x
Abscissa.
-
-
-
程序包 org.hipparchus.geometry.euclidean.threed
-
类 org.hipparchus.geometry.euclidean.threed.Euclidean3D
class Euclidean3D extends Object implements Serializable- serialVersionUID:
- 6249091865814886817L
-
序列化方法
-
readResolve
Handle deserialization of the singleton.
-
-
类 org.hipparchus.geometry.euclidean.threed.FieldRotation
class FieldRotation extends Object implements Serializable- serialVersionUID:
- 20130224L
-
序列化字段
-
q0
T extends CalculusFieldElement<T> q0
Scalar coordinate of the quaternion. -
q1
T extends CalculusFieldElement<T> q1
First coordinate of the vectorial part of the quaternion. -
q2
T extends CalculusFieldElement<T> q2
Second coordinate of the vectorial part of the quaternion. -
q3
T extends CalculusFieldElement<T> q3
Third coordinate of the vectorial part of the quaternion.
-
-
类 org.hipparchus.geometry.euclidean.threed.FieldVector3D
class FieldVector3D extends Object implements Serializable- serialVersionUID:
- 20130224L
-
序列化字段
-
x
T extends CalculusFieldElement<T> x
Abscissa. -
y
T extends CalculusFieldElement<T> y
Ordinate. -
z
T extends CalculusFieldElement<T> z
Height.
-
-
类 org.hipparchus.geometry.euclidean.threed.Rotation
class Rotation extends Object implements Serializable- serialVersionUID:
- -2153622329907944313L
-
序列化字段
-
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.
-
-
类 org.hipparchus.geometry.euclidean.threed.SphericalCoordinates
class SphericalCoordinates extends Object implements Serializable- serialVersionUID:
- 20130206L
-
序列化方法
-
writeReplace
Replace the instance with a data transfer object for serialization.
-
-
序列化字段
-
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.
-
-
类 org.hipparchus.geometry.euclidean.threed.Vector3D
class Vector3D extends Object implements Serializable- serialVersionUID:
- 1313493323784566947L
-
序列化字段
-
x
double x
Abscissa. -
y
double y
Ordinate. -
z
double z
Height.
-
-
-
程序包 org.hipparchus.geometry.euclidean.twod
-
类 org.hipparchus.geometry.euclidean.twod.Euclidean2D
class Euclidean2D extends Object implements Serializable- serialVersionUID:
- 4793432849757649566L
-
序列化方法
-
readResolve
Handle deserialization of the singleton.
-
-
类 org.hipparchus.geometry.euclidean.twod.Vector2D
class Vector2D extends Object implements Serializable- serialVersionUID:
- 266938651998679754L
-
序列化字段
-
x
double x
Abscissa. -
y
double y
Ordinate.
-
-
-
程序包 org.hipparchus.geometry.euclidean.twod.hull
-
类 org.hipparchus.geometry.euclidean.twod.hull.ConvexHull2D
class ConvexHull2D extends Object implements Serializable- serialVersionUID:
- 20140129L
-
序列化字段
-
tolerance
double tolerance
Tolerance threshold used during creation of the hull vertices. -
vertices
Vector2D[] vertices
Vertices of the hull.
-
-
-
程序包 org.hipparchus.geometry.hull
-
程序包 org.hipparchus.geometry.spherical.oned
-
异常错误类 org.hipparchus.geometry.spherical.oned.ArcsSet.InconsistentStateAt2PiWrapping
class InconsistentStateAt2PiWrapping extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- 20140107L
-
类 org.hipparchus.geometry.spherical.oned.S1Point
class S1Point extends Object implements Serializable- serialVersionUID:
- 20131218L
-
序列化字段
-
alpha
double alpha
Azimuthal angle \( \alpha \). -
vector
Vector2D vector
Corresponding 2D normalized vector.
-
-
类 org.hipparchus.geometry.spherical.oned.Sphere1D
class Sphere1D extends Object implements Serializable- serialVersionUID:
- 20131218L
-
序列化方法
-
readResolve
Handle deserialization of the singleton.
-
-
异常错误类 org.hipparchus.geometry.spherical.oned.Sphere1D.NoSubSpaceException
class NoSubSpaceException extends MathRuntimeException implements Serializable- serialVersionUID:
- 20140225L
-
-
程序包 org.hipparchus.geometry.spherical.twod
-
类 org.hipparchus.geometry.spherical.twod.S2Point
class S2Point extends Object implements Serializable- serialVersionUID:
- 20131218L
-
序列化字段
-
phi
double phi
Polar angle \( \varphi \). -
theta
double theta
Azimuthal angle \( \theta \) in the x-y plane. -
vector
Vector3D vector
Corresponding 3D normalized vector.
-
-
类 org.hipparchus.geometry.spherical.twod.Sphere2D
class Sphere2D extends Object implements Serializable- serialVersionUID:
- 20131218L
-
序列化方法
-
readResolve
Handle deserialization of the singleton.
-
-
-
程序包 org.hipparchus.linear
-
类 org.hipparchus.linear.Array2DRowFieldMatrix
class Array2DRowFieldMatrix extends AbstractFieldMatrix<T extends FieldElement<T>> implements Serializable- serialVersionUID:
- 7260756672015356458L
-
序列化字段
-
data
T extends FieldElement<T>[][] data
Entries of the matrix
-
-
类 org.hipparchus.linear.Array2DRowRealMatrix
class Array2DRowRealMatrix extends AbstractRealMatrix implements Serializable- serialVersionUID:
- -1067294169172445528L
-
序列化字段
-
data
double[][] data
Entries of the matrix.
-
-
类 org.hipparchus.linear.ArrayFieldVector
class ArrayFieldVector extends Object implements Serializable- serialVersionUID:
- 7648186910365927050L
-
序列化字段
-
data
T extends FieldElement<T>[] data
Entries of the vector. -
field
Field<T extends FieldElement<T>> field
Field to which the elements belong.
-
-
类 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
class FieldVectorTestImpl extends Object implements Serializable- serialVersionUID:
- 3970959016014158539L
-
序列化字段
-
data
T extends FieldElement<T>[] data
Entries of the vector. -
field
Field<T extends FieldElement<T>> field
-
-
类 org.hipparchus.linear.ArrayRealVector
class ArrayRealVector extends RealVector implements Serializable- serialVersionUID:
- -1097961340710804027L
-
序列化字段
-
data
double[] data
Entries of the vector.
-
-
类 org.hipparchus.linear.BlockFieldMatrix
class BlockFieldMatrix extends AbstractFieldMatrix<T extends FieldElement<T>> implements Serializable- serialVersionUID:
- -4602336630143123183L
-
序列化字段
-
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.
-
-
类 org.hipparchus.linear.BlockRealMatrix
class BlockRealMatrix extends AbstractRealMatrix implements Serializable- serialVersionUID:
- 4991895511313664478L
-
序列化字段
-
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.
-
-
类 org.hipparchus.linear.DefaultIterativeLinearSolverEvent
class DefaultIterativeLinearSolverEvent extends IterativeLinearSolverEvent implements Serializable- serialVersionUID:
- 20120129L
-
序列化字段
-
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.
-
-
类 org.hipparchus.linear.DiagonalMatrix
class DiagonalMatrix extends AbstractRealMatrix implements Serializable- serialVersionUID:
- 20121229L
-
序列化字段
-
data
double[] data
Entries of the diagonal.
-
-
类 org.hipparchus.linear.IterativeLinearSolverEvent
class IterativeLinearSolverEvent extends IterationEvent implements Serializable- serialVersionUID:
- 20120129L
-
类 org.hipparchus.linear.OpenMapRealMatrix
class OpenMapRealMatrix extends AbstractRealMatrix implements Serializable- serialVersionUID:
- -5962461716457143437L
-
序列化字段
-
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.
-
-
类 org.hipparchus.linear.OpenMapRealVector
class OpenMapRealVector extends SparseRealVector implements Serializable- serialVersionUID:
- 8772222695580707260L
-
序列化字段
-
entries
OpenIntToDoubleHashMap entries
Entries of the vector. -
epsilon
double epsilon
Tolerance for having a value considered zero. -
virtualSize
int virtualSize
Dimension of the vector.
-
-
类 org.hipparchus.linear.RealVectorAbstractTest.RealVectorTestImpl
class RealVectorTestImpl extends RealVector implements Serializable- serialVersionUID:
- 20120706L
-
序列化字段
-
data
double[] data
Entries of the vector.
-
-
类 org.hipparchus.linear.SparseFieldVector
class SparseFieldVector extends Object implements Serializable- serialVersionUID:
- 7841233292190413362L
-
序列化字段
-
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.
-
-
-
程序包 org.hipparchus.migration.exception
-
异常错误类 org.hipparchus.migration.exception.ConvergenceException
class ConvergenceException extends MathIllegalStateException implements Serializable- serialVersionUID:
- 4330003017885151975L
-
异常错误类 org.hipparchus.migration.exception.DimensionMismatchException
class DimensionMismatchException extends MathIllegalNumberException implements Serializable- serialVersionUID:
- -8415396756375798143L
-
序列化字段
-
dimension
int dimension
已过时。Correct dimension.
-
-
异常错误类 org.hipparchus.migration.exception.InsufficientDataException
class InsufficientDataException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- -2629324471511903359L
-
异常错误类 org.hipparchus.migration.exception.MathArithmeticException
class MathArithmeticException extends MathRuntimeException implements Serializable- serialVersionUID:
- -6024911025449780478L
-
异常错误类 org.hipparchus.migration.exception.MathIllegalNumberException
class MathIllegalNumberException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- -7447085893598031110L
-
序列化字段
-
argument
Number argument
已过时。Requested.
-
-
异常错误类 org.hipparchus.migration.exception.MathInternalError
class MathInternalError extends MathIllegalStateException implements Serializable- serialVersionUID:
- -6276776513966934846L
-
异常错误类 org.hipparchus.migration.exception.MathParseException
class MathParseException extends MathIllegalStateException implements Serializable- serialVersionUID:
- -6024911025449780478L
-
异常错误类 org.hipparchus.migration.exception.MathUnsupportedOperationException
class MathUnsupportedOperationException extends MathRuntimeException implements Serializable- serialVersionUID:
- -6024911025449780478L
-
异常错误类 org.hipparchus.migration.exception.MaxCountExceededException
class MaxCountExceededException extends MathIllegalStateException implements Serializable- serialVersionUID:
- 4330003017885151975L
-
序列化字段
-
max
Number max
已过时。Maximum number of evaluations.
-
-
异常错误类 org.hipparchus.migration.exception.MultiDimensionMismatchException
class MultiDimensionMismatchException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- -8415396756375798143L
-
异常错误类 org.hipparchus.migration.exception.NoBracketingException
class NoBracketingException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- -3629324471511904459L
-
序列化字段
-
fHi
double fHi
已过时。Value at higher end of the interval. -
fLo
double fLo
已过时。Value at lower end of the interval. -
hi
double hi
已过时。Higher end of the interval. -
lo
double lo
已过时。Lower end of the interval.
-
-
异常错误类 org.hipparchus.migration.exception.NoDataException
class NoDataException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- -3629324471511904459L
-
异常错误类 org.hipparchus.migration.exception.NonMonotonicSequenceException
class NonMonotonicSequenceException extends MathIllegalNumberException implements Serializable- serialVersionUID:
- 3596849179428944575L
-
序列化字段
-
direction
MathArrays.OrderDirection direction
已过时。Direction (positive for increasing, negative for decreasing). -
index
int index
已过时。Index of the wrong value. -
previous
Number previous
已过时。Previous value. -
strict
boolean strict
已过时。Whether the sequence must be strictly increasing or decreasing.
-
-
异常错误类 org.hipparchus.migration.exception.NotANumberException
class NotANumberException extends MathIllegalNumberException implements Serializable- serialVersionUID:
- 20120906L
-
异常错误类 org.hipparchus.migration.exception.NotFiniteNumberException
class NotFiniteNumberException extends MathIllegalNumberException implements Serializable- serialVersionUID:
- -6100997100383932834L
-
异常错误类 org.hipparchus.migration.exception.NotPositiveException
class NotPositiveException extends NumberIsTooSmallException implements Serializable- serialVersionUID:
- -2250556892093726375L
-
异常错误类 org.hipparchus.migration.exception.NotStrictlyPositiveException
class NotStrictlyPositiveException extends NumberIsTooSmallException implements Serializable- serialVersionUID:
- -7824848630829852237L
-
异常错误类 org.hipparchus.migration.exception.NumberIsTooLargeException
class NumberIsTooLargeException extends MathIllegalNumberException implements Serializable- serialVersionUID:
- 4330003017885151975L
-
序列化字段
-
boundIsAllowed
boolean boundIsAllowed
已过时。Whether the maximum is included in the allowed range. -
max
Number max
已过时。Higher bound.
-
-
异常错误类 org.hipparchus.migration.exception.NumberIsTooSmallException
class NumberIsTooSmallException extends MathIllegalNumberException implements Serializable- serialVersionUID:
- -6100997100383932834L
-
序列化字段
-
boundIsAllowed
boolean boundIsAllowed
已过时。Whether the maximum is included in the allowed range. -
min
Number min
已过时。Higher bound.
-
-
异常错误类 org.hipparchus.migration.exception.OutOfRangeException
class OutOfRangeException extends MathIllegalNumberException implements Serializable- serialVersionUID:
- 111601815794403609L
-
异常错误类 org.hipparchus.migration.exception.TooManyEvaluationsException
class TooManyEvaluationsException extends MaxCountExceededException implements Serializable- serialVersionUID:
- 4330003017885151975L
-
异常错误类 org.hipparchus.migration.exception.TooManyIterationsException
class TooManyIterationsException extends MaxCountExceededException implements Serializable- serialVersionUID:
- 20121211L
-
异常错误类 org.hipparchus.migration.exception.ZeroException
class ZeroException extends MathIllegalNumberException implements Serializable- serialVersionUID:
- -1960874856936000015L
-
-
程序包 org.hipparchus.migration.genetics
-
异常错误类 org.hipparchus.migration.genetics.InvalidRepresentationException
class InvalidRepresentationException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- 1L
-
-
程序包 org.hipparchus.migration.geometry.euclidean
-
异常错误类 org.hipparchus.migration.geometry.euclidean.CardanEulerSingularityException
class CardanEulerSingularityException extends MathIllegalStateException implements Serializable- serialVersionUID:
- -1360952845582206770L
-
-
程序包 org.hipparchus.migration.geometry.euclidean.threed
-
异常错误类 org.hipparchus.migration.geometry.euclidean.threed.NotARotationMatrixException
class NotARotationMatrixException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- 5647178478658937642L
-
-
程序包 org.hipparchus.migration.linear
-
异常错误类 org.hipparchus.migration.linear.IllConditionedOperatorException
class IllConditionedOperatorException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- -7883263944530490135L
-
异常错误类 org.hipparchus.migration.linear.MatrixDimensionMismatchException
class MatrixDimensionMismatchException extends MultiDimensionMismatchException implements Serializable- serialVersionUID:
- -8415396756375798143L
-
异常错误类 org.hipparchus.migration.linear.NonPositiveDefiniteMatrixException
class NonPositiveDefiniteMatrixException extends NumberIsTooSmallException implements Serializable- serialVersionUID:
- 1641613838113738061L
-
序列化字段
-
index
int index
已过时。Index (diagonal element). -
threshold
double threshold
已过时。Threshold.
-
-
异常错误类 org.hipparchus.migration.linear.NonPositiveDefiniteOperatorException
class NonPositiveDefiniteOperatorException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- 917034489420549847L
-
异常错误类 org.hipparchus.migration.linear.NonSelfAdjointOperatorException
class NonSelfAdjointOperatorException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- 1784999305030258247L
-
异常错误类 org.hipparchus.migration.linear.NonSquareMatrixException
class NonSquareMatrixException extends DimensionMismatchException implements Serializable- serialVersionUID:
- -660069396594485772L
-
异常错误类 org.hipparchus.migration.linear.NonSquareOperatorException
class NonSquareOperatorException extends DimensionMismatchException implements Serializable- serialVersionUID:
- -4145007524150846242L
-
异常错误类 org.hipparchus.migration.linear.NonSymmetricMatrixException
class NonSymmetricMatrixException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- -7518495577824189882L
-
序列化字段
-
column
int column
已过时。Column. -
row
int row
已过时。Row. -
threshold
double threshold
已过时。Threshold.
-
-
异常错误类 org.hipparchus.migration.linear.SingularMatrixException
class SingularMatrixException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- -4206514844735401070L
-
异常错误类 org.hipparchus.migration.linear.SingularOperatorException
class SingularOperatorException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- -476049978595245033L
-
-
程序包 org.hipparchus.migration.ode
-
类 org.hipparchus.migration.ode.ContinuousOutputModel
class ContinuousOutputModel extends DenseOutputModel implements Serializable- serialVersionUID:
- 20160403L
-
序列化字段
-
interpolatedTime
double interpolatedTime
已过时。Interpolation time.
-
-
异常错误类 org.hipparchus.migration.ode.JacobianMatrices.MismatchedEquations
class MismatchedEquations extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- 20120902L
-
异常错误类 org.hipparchus.migration.ode.UnknownParameterException
class UnknownParameterException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- 20120902L
-
序列化字段
-
name
String name
已过时。Parameter name.
-
-
-
程序包 org.hipparchus.migration.ode.sampling
-
程序包 org.hipparchus.migration.optim.linear
-
异常错误类 org.hipparchus.migration.optim.linear.NoFeasibleSolutionException
class NoFeasibleSolutionException extends MathIllegalStateException implements Serializable- serialVersionUID:
- -3044253632189082760L
-
异常错误类 org.hipparchus.migration.optim.linear.UnboundedSolutionException
class UnboundedSolutionException extends MathIllegalStateException implements Serializable- serialVersionUID:
- 940539497277290619L
-
-
程序包 org.hipparchus.migration.stat.regression
-
异常错误类 org.hipparchus.migration.stat.regression.ModelSpecificationException
class ModelSpecificationException extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- 4206514456095401070L
-
-
程序包 org.hipparchus.ode
-
类 org.hipparchus.ode.ComplexODEState
class ComplexODEState extends Object implements Serializable- serialVersionUID:
- 20180902L
-
类 org.hipparchus.ode.ComplexODEStateAndDerivative
class ComplexODEStateAndDerivative extends ComplexODEState implements Serializable- serialVersionUID:
- 20180902L
-
类 org.hipparchus.ode.DenseOutputModel
class DenseOutputModel extends Object implements Serializable- serialVersionUID:
- 20160328L
-
序列化字段
-
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.
-
-
类 org.hipparchus.ode.EquationsMapper
class EquationsMapper extends Object implements Serializable- serialVersionUID:
- 20160327L
-
序列化字段
-
start
int[] start
Start indices of the components.
-
-
类 org.hipparchus.ode.FieldEquationsMapper
class FieldEquationsMapper extends Object implements Serializable- serialVersionUID:
- 20151114L
-
序列化字段
-
start
int[] start
Start indices of the components.
-
-
类 org.hipparchus.ode.ODEState
class ODEState extends Object implements Serializable- serialVersionUID:
- 20160408L
-
序列化字段
-
completeDimension
int completeDimension
Complete dimension. -
primaryState
double[] primaryState
Primary state at time. -
secondaryState
double[][] secondaryState
Secondary state at time. -
time
double time
Time.
-
-
类 org.hipparchus.ode.ODEStateAndDerivative
class ODEStateAndDerivative extends ODEState implements Serializable- serialVersionUID:
- 20160408L
-
序列化字段
-
primaryDerivative
double[] primaryDerivative
Derivative of the primary state at time. -
secondaryDerivative
double[][] secondaryDerivative
Derivative of the secondary state at time.
-
-
异常错误类 org.hipparchus.ode.VariationalEquation.MismatchedEquations
class MismatchedEquations extends MathIllegalArgumentException implements Serializable- serialVersionUID:
- 20120902L
-
-
程序包 org.hipparchus.ode.nonstiff
-
异常错误类 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest.LocalException
class LocalException extends RuntimeException implements Serializable- serialVersionUID:
- 20151208L
-
异常错误类 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest.LocalException
class LocalException extends RuntimeException implements Serializable- serialVersionUID:
- 20151208L
-
-
程序包 org.hipparchus.ode.sampling
-
类 org.hipparchus.ode.sampling.AbstractODEStateInterpolator
class AbstractODEStateInterpolator extends Object implements Serializable- serialVersionUID:
- 20160328L
-
序列化字段
-
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.
-
-
类 org.hipparchus.ode.sampling.DummyStepInterpolator
class DummyStepInterpolator extends AbstractODEStateInterpolator implements Serializable- serialVersionUID:
- 20160402L
-
-
程序包 org.hipparchus.optim
-
类 org.hipparchus.optim.PointValuePair
class PointValuePair extends Pair<double[],Double> implements Serializable - serialVersionUID:
- 20120513L
-
序列化方法
-
writeReplace
Replace the instance with a data transfer object for serialization.
-
-
类 org.hipparchus.optim.PointVectorValuePair
class PointVectorValuePair extends Pair<double[],double[]> implements Serializable - serialVersionUID:
- 20120513L
-
序列化方法
-
writeReplace
Replace the instance with a data transfer object for serialization.
-
-
-
程序包 org.hipparchus.optim.linear
-
类 org.hipparchus.optim.linear.LinearConstraint
class LinearConstraint extends Object implements Serializable- serialVersionUID:
- -764632794033034092L
-
序列化方法
-
readObject
Deserialize the instance.- 参数:
ois
- stream from which the object should be read- 抛出:
ClassNotFoundException
- if a class in the stream cannot be foundIOException
- if object cannot be read from the stream
-
writeObject
Serialize the instance.- 参数:
oos
- stream where object should be written- 抛出:
IOException
- if object cannot be written to stream
-
-
序列化字段
-
relationship
Relationship relationship
Relationship between left and right hand sides (=, <=, >=). -
value
double value
Value of the constraint (right hand side).
-
-
类 org.hipparchus.optim.linear.LinearObjectiveFunction
class LinearObjectiveFunction extends Object implements Serializable- serialVersionUID:
- -4531815507568396090L
-
序列化方法
-
readObject
Deserialize the instance.- 参数:
ois
- stream from which the object should be read- 抛出:
ClassNotFoundException
- if a class in the stream cannot be foundIOException
- if object cannot be read from the stream
-
writeObject
Serialize the instance.- 参数:
oos
- stream where object should be written- 抛出:
IOException
- if object cannot be written to stream
-
-
序列化字段
-
constantTerm
double constantTerm
Constant term of the linear equation.
-
-
-
程序包 org.hipparchus.optim.univariate
-
类 org.hipparchus.optim.univariate.UnivariatePointValuePair
class UnivariatePointValuePair extends Object implements Serializable- serialVersionUID:
- 1003888396256744753L
-
序列化字段
-
point
double point
Point. -
value
double value
Value of the objective function at the point.
-
-
-
程序包 org.hipparchus.random
-
类 org.hipparchus.random.AbstractWell
class AbstractWell extends org.hipparchus.random.IntRandomGenerator implements Serializable- serialVersionUID:
- 20150223L
-
序列化字段
-
index
int index
Current index in the bytes pool. -
v
int[] v
Bytes pool.
-
-
类 org.hipparchus.random.ISAACRandom
class ISAACRandom extends org.hipparchus.random.IntRandomGenerator implements Serializable- serialVersionUID:
- 20160529L
-
序列化字段
-
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
-
-
类 org.hipparchus.random.JDKRandomGenerator
class JDKRandomGenerator extends org.hipparchus.random.IntRandomGenerator implements Serializable- serialVersionUID:
- 20151227L
-
序列化字段
-
delegate
Random delegate
JDK's RNG.
-
-
类 org.hipparchus.random.MersenneTwister
class MersenneTwister extends org.hipparchus.random.IntRandomGenerator implements Serializable- serialVersionUID:
- 20160529L
-
序列化字段
-
mt
int[] mt
Bytes pool. -
mti
int mti
Current index in the bytes pool.
-
-
类 org.hipparchus.random.RandomAdaptor
class RandomAdaptor extends Random implements Serializable- serialVersionUID:
- 20160529L
-
序列化字段
-
randomGenerator
RandomGenerator randomGenerator
Wrapped randomGenerator instance
-
-
类 org.hipparchus.random.RandomDataGenerator
class RandomDataGenerator extends org.hipparchus.random.ForwardingRandomGenerator implements Serializable- serialVersionUID:
- 20160529L
-
序列化字段
-
randomGenerator
RandomGenerator randomGenerator
Source of random data
-
-
类 org.hipparchus.random.Well1024a
class Well1024a extends AbstractWell implements Serializable- serialVersionUID:
- 20150223L
-
类 org.hipparchus.random.Well19937a
class Well19937a extends AbstractWell implements Serializable- serialVersionUID:
- 20150223L
-
类 org.hipparchus.random.Well19937c
class Well19937c extends AbstractWell implements Serializable- serialVersionUID:
- 20150223L
-
类 org.hipparchus.random.Well44497a
class Well44497a extends AbstractWell implements Serializable- serialVersionUID:
- 20150223L
-
类 org.hipparchus.random.Well44497b
class Well44497b extends AbstractWell implements Serializable- serialVersionUID:
- 20150223L
-
类 org.hipparchus.random.Well512a
class Well512a extends AbstractWell implements Serializable- serialVersionUID:
- 20150223L
-
-
程序包 org.hipparchus.samples
-
类 org.hipparchus.samples.ClusterAlgorithmComparison.ClusterPlot
class ClusterPlot extends JComponent implements Serializable-
序列化字段
-
clusters
List<? extends Cluster<DoublePoint>> clusters
Clusters. -
duration
long duration
Duration of the computation.
-
-
-
类 org.hipparchus.samples.ClusterAlgorithmComparison.Display
class Display extends ExampleUtils.ExampleFrame implements Serializable -
类 org.hipparchus.samples.ExampleUtils.ExampleFrame
class ExampleFrame extends JFrame implements Serializable -
类 org.hipparchus.samples.IntegerDistributionComparison.Display
class Display extends ExampleUtils.ExampleFrame implements Serializable-
序列化字段
-
container
JComponent container
Container.
-
-
-
类 org.hipparchus.samples.LowDiscrepancyGeneratorComparison.Display
class Display extends ExampleUtils.ExampleFrame implements Serializable -
类 org.hipparchus.samples.LowDiscrepancyGeneratorComparison.Plot
class Plot extends JComponent implements Serializable -
类 org.hipparchus.samples.RealDistributionComparison.Display
class Display extends ExampleUtils.ExampleFrame implements Serializable-
序列化字段
-
container
JComponent container
Container.
-
-
-
-
程序包 org.hipparchus.samples.clustering
-
类 org.hipparchus.samples.clustering.ImageClusteringExample.Display
class Display extends ExampleUtils.ExampleFrame implements Serializable-
序列化字段
-
clusterImage
BufferedImage clusterImage
Cluster image. -
clusterSizeSpinner
JSpinner clusterSizeSpinner
Spinner. -
painter
org.hipparchus.samples.clustering.ImageClusteringExample.Display.ImagePainter painter
Painter for the clusters. -
referenceImage
BufferedImage referenceImage
Reference image. -
referenceRaster
Raster referenceRaster
Reference raster.
-
-
-
-
程序包 org.hipparchus.samples.geometry
-
类 org.hipparchus.samples.geometry.GeometryExample.Display
class Display extends ExampleUtils.ExampleFrame implements Serializable-
序列化字段
-
canvas
org.piccolo2d.PCanvas canvas
Canvas for plotting. -
container
JComponent container
Container. -
controlPanel
JComponent controlPanel
Control panel. -
points
List<Vector2D> points
Points to plot.
-
-
-
-
程序包 org.hipparchus.stat
-
类 org.hipparchus.stat.Frequency
class Frequency extends Object implements Serializable- serialVersionUID:
- 20160322L
-
序列化字段
-
freqTable
NavigableMap<T extends Comparable<T>,
Long> freqTable underlying collection
-
-
类 org.hipparchus.stat.LongFrequency
- serialVersionUID:
- 20160322L
-
-
程序包 org.hipparchus.stat.descriptive
-
类 org.hipparchus.stat.descriptive.DescriptiveStatistics
class DescriptiveStatistics extends Object implements Serializable- serialVersionUID:
- 20160411L
-
序列化字段
-
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.
-
-
类 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
class MultivariateSummaryStatistics extends Object implements Serializable- serialVersionUID:
- 20160424L
-
序列化字段
-
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
-
-
类 org.hipparchus.stat.descriptive.StatisticalSummaryValues
class StatisticalSummaryValues extends Object implements Serializable- serialVersionUID:
- 20160406L
-
序列化字段
-
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
-
-
类 org.hipparchus.stat.descriptive.StreamingStatistics
class StreamingStatistics extends Object implements Serializable- serialVersionUID:
- 20160422L
-
序列化字段
-
computeExtrema
boolean computeExtrema
whether or not min and max are maintained -
computeMoments
boolean computeMoments
whether or not moment stats (sum, mean, variance) 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
-
-
-
程序包 org.hipparchus.stat.descriptive.moment
-
类 org.hipparchus.stat.descriptive.moment.GeometricMean
class GeometricMean extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
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
-
-
类 org.hipparchus.stat.descriptive.moment.Kurtosis
class Kurtosis extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
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
-
-
类 org.hipparchus.stat.descriptive.moment.Mean
class Mean extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
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.
-
-
类 org.hipparchus.stat.descriptive.moment.SecondMoment
class SecondMoment extends org.hipparchus.stat.descriptive.moment.FirstMoment implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
m2
double m2
Second moment of values that have been added
-
-
类 org.hipparchus.stat.descriptive.moment.SemiVariance
class SemiVariance extends AbstractUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
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.
-
-
类 org.hipparchus.stat.descriptive.moment.Skewness
class Skewness extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
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
-
-
类 org.hipparchus.stat.descriptive.moment.StandardDeviation
class StandardDeviation extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
variance
Variance variance
Wrapped Variance instance
-
-
类 org.hipparchus.stat.descriptive.moment.Variance
class Variance extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
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
-
-
-
程序包 org.hipparchus.stat.descriptive.rank
-
类 org.hipparchus.stat.descriptive.rank.Max
class Max extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
n
long n
Number of values that have been added -
value
double value
Current value of the statistic
-
-
类 org.hipparchus.stat.descriptive.rank.Median
class Median extends AbstractUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
percentile
Percentile percentile
The percentile impl to calculate the median.
-
-
类 org.hipparchus.stat.descriptive.rank.Min
class Min extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
n
long n
Number of values that have been added -
value
double value
Current value of the statistic
-
-
类 org.hipparchus.stat.descriptive.rank.Percentile
class Percentile extends AbstractUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
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.
-
-
类 org.hipparchus.stat.descriptive.rank.PSquarePercentile
class PSquarePercentile extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
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.
-
-
类 org.hipparchus.stat.descriptive.rank.RandomPercentile
class RandomPercentile extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 1L
-
序列化字段
-
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
-
-
-
程序包 org.hipparchus.stat.descriptive.summary
-
类 org.hipparchus.stat.descriptive.summary.Product
class Product extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
n
long n
The number of values that have been added -
value
double value
The current Running Product
-
-
类 org.hipparchus.stat.descriptive.summary.Sum
class Sum extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
n
long n
The number of values that have been added -
value
double value
The currently running sum
-
-
类 org.hipparchus.stat.descriptive.summary.SumOfLogs
class SumOfLogs extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
n
int n
Number of values that have been added -
value
double value
The currently running value
-
-
类 org.hipparchus.stat.descriptive.summary.SumOfSquares
class SumOfSquares extends AbstractStorelessUnivariateStatistic implements Serializable- serialVersionUID:
- 20150412L
-
序列化字段
-
n
long n
Number of values that have been added -
value
double value
The currently running sumSq
-
-
-
程序包 org.hipparchus.stat.descriptive.vector
-
类 org.hipparchus.stat.descriptive.vector.VectorialCovariance
class VectorialCovariance extends Object implements Serializable- serialVersionUID:
- 4118372414238930270L
-
序列化字段
-
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.
-
-
类 org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic
class VectorialStorelessStatistic extends Object implements Serializable- serialVersionUID:
- 20160413L
-
序列化字段
-
stats
StorelessUnivariateStatistic[] stats
Statistic for each component
-
-
-
程序包 org.hipparchus.stat.fitting
-
类 org.hipparchus.stat.fitting.EmpiricalDistribution
class EmpiricalDistribution extends AbstractRealDistribution implements Serializable- serialVersionUID:
- 5729073523949762654L
-
序列化字段
-
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
-
-
-
程序包 org.hipparchus.stat.regression
-
类 org.hipparchus.stat.regression.RegressionResults
class RegressionResults extends Object implements Serializable- serialVersionUID:
- 1L
-
序列化字段
-
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
-
-
类 org.hipparchus.stat.regression.SimpleRegression
class SimpleRegression extends Object implements Serializable- serialVersionUID:
- -3004689053607543335L
-
序列化字段
-
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
-
-
-
程序包 org.hipparchus.transform
-
类 org.hipparchus.transform.FastCosineTransformer
class FastCosineTransformer extends Object implements Serializable- serialVersionUID:
- 20120212L
-
序列化字段
-
normalization
DctNormalization normalization
The type of DCT to be performed.
-
-
类 org.hipparchus.transform.FastFourierTransformer
class FastFourierTransformer extends Object implements Serializable- serialVersionUID:
- 20120210L
-
序列化字段
-
normalization
DftNormalization normalization
The type of DFT to be performed.
-
-
类 org.hipparchus.transform.FastHadamardTransformer
class FastHadamardTransformer extends Object implements Serializable- serialVersionUID:
- 20120211L
-
类 org.hipparchus.transform.FastSineTransformer
class FastSineTransformer extends Object implements Serializable- serialVersionUID:
- 20120211L
-
序列化字段
-
normalization
DstNormalization normalization
The type of DST to be performed.
-
-
-
程序包 org.hipparchus.util
-
类 org.hipparchus.util.BigReal
class BigReal extends Object implements Serializable- serialVersionUID:
- 4984534880991310382L
-
序列化字段
-
d
BigDecimal d
Underlying BigDecimal. -
roundingMode
RoundingMode roundingMode
Rounding mode for divisions. -
scale
int scale
BigDecimal scale
-
-
类 org.hipparchus.util.BigRealField
class BigRealField extends Object implements Serializable- serialVersionUID:
- 20160327L
-
序列化方法
-
readResolve
Handle deserialization of the singleton.
-
-
类 org.hipparchus.util.Binary64
class Binary64 extends Number implements Serializable- serialVersionUID:
- 20120227L
-
序列化字段
-
value
double value
The primitivedouble
value of this object.
-
-
类 org.hipparchus.util.Binary64Field
class Binary64Field extends Object implements Serializable- serialVersionUID:
- 20161219L
-
序列化方法
-
readResolve
Handle deserialization of the singleton.
-
-
类 org.hipparchus.util.IterationEvent
class IterationEvent extends EventObject implements Serializable- serialVersionUID:
- 20120128L
-
序列化字段
-
iterations
int iterations
The number of iterations performed so far.
-
-
类 org.hipparchus.util.KthSelector
class KthSelector extends Object implements Serializable- serialVersionUID:
- 20140713L
-
序列化字段
-
pivotingStrategy
PivotingStrategy pivotingStrategy
APivotingStrategy
used for pivoting.
-
-
类 org.hipparchus.util.OpenIntToDoubleHashMap
class OpenIntToDoubleHashMap extends Object implements Serializable- serialVersionUID:
- -3646337053166149105L
-
序列化方法
-
readObject
Read a serialized object.- 参数:
stream
- input stream- 抛出:
IOException
- if object cannot be readClassNotFoundException
- if the class corresponding to the serialized object cannot be found
-
-
序列化字段
-
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.
-
-
类 org.hipparchus.util.OpenIntToFieldHashMap
class OpenIntToFieldHashMap extends Object implements Serializable- serialVersionUID:
- -9179080286849120720L
-
序列化方法
-
readObject
Read a serialized object.- 参数:
stream
- input stream- 抛出:
IOException
- if object cannot be readClassNotFoundException
- if the class corresponding to the serialized object cannot be found
-
-
序列化字段
-
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.
-
-
类 org.hipparchus.util.ResizableDoubleArray
class ResizableDoubleArray extends Object implements Serializable- serialVersionUID:
- 20160327L
-
序列化字段
-
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]
.
-
-