索引
常量字段值|所有程序包|所有类和接口|序列化表格
E
- E - 类中的静态变量 org.hipparchus.util.FastMath
-
Napier's constant e, base of the natural logarithm.
- E(Complex) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralComplexTest
- E(Complex, Complex) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralComplexTest
- E(FieldComplex<Binary64>) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralFieldComplexTest
- E(FieldComplex<Binary64>, FieldComplex<Binary64>) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralFieldComplexTest
- E(T) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralAbstractComplexTest
- E(T, T) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralAbstractComplexTest
- EarthMoversDistance - org.hipparchus.clustering.distance中的类
-
Calculates the Earh Mover's distance (also known as Wasserstein metric) between two distributions.
- EarthMoversDistance() - 类的构造器 org.hipparchus.clustering.distance.EarthMoversDistance
-
Empty constructor.
- EarthMoversDistanceTest - org.hipparchus.clustering.distance中的类
-
Tests for
EarthMoversDistance
class. - EarthMoversDistanceTest() - 类的构造器 org.hipparchus.clustering.distance.EarthMoversDistanceTest
- ebeAdd(double[], double[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Creates an array whose contents will be the element-by-element addition of the arguments.
- ebeDivide(double[], double[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Creates an array whose contents will be the element-by-element division of the first argument by the second.
- ebeDivide(ArrayFieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Element-by-element division.
- ebeDivide(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Element-by-element division.
- ebeDivide(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- ebeDivide(FieldVector<T>) - 接口中的方法 org.hipparchus.linear.FieldVector
-
Element-by-element division.
- ebeDivide(FieldVector<T>) - 类中的方法 org.hipparchus.linear.SparseFieldVector
-
Element-by-element division.
- ebeDivide(RealVector) - 类中的方法 org.hipparchus.linear.ArrayRealVector
-
Element-by-element division.
- ebeDivide(RealVector) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
-
Element-by-element division.
- ebeDivide(RealVector) - 类中的方法 org.hipparchus.linear.RealVector
-
Element-by-element division.
- ebeDivide(RealVector) - 类中的方法 org.hipparchus.linear.RealVectorAbstractTest.RealVectorTestImpl
- ebeDivide(T[]) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- ebeMultiply(double[], double[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Creates an array whose contents will be the element-by-element multiplication of the arguments.
- ebeMultiply(ArrayFieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Element-by-element multiplication.
- ebeMultiply(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Element-by-element multiplication.
- ebeMultiply(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- ebeMultiply(FieldVector<T>) - 接口中的方法 org.hipparchus.linear.FieldVector
-
Element-by-element multiplication.
- ebeMultiply(FieldVector<T>) - 类中的方法 org.hipparchus.linear.SparseFieldVector
-
Element-by-element multiplication.
- ebeMultiply(RealVector) - 类中的方法 org.hipparchus.linear.ArrayRealVector
-
Element-by-element multiplication.
- ebeMultiply(RealVector) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
-
Element-by-element multiplication.
- ebeMultiply(RealVector) - 类中的方法 org.hipparchus.linear.RealVector
-
Element-by-element multiplication.
- ebeMultiply(RealVector) - 类中的方法 org.hipparchus.linear.RealVectorAbstractTest.RealVectorTestImpl
- ebeMultiply(T[]) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- ebeSubtract(double[], double[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Creates an array whose contents will be the element-by-element subtraction of the second argument from the first.
- Edge - org.hipparchus.geometry.spherical.twod中的类
-
Spherical polygons boundary edge.
- EDGE_CONNECTED_TO_ONE_FACET - 枚举类 中的枚举常量 org.hipparchus.geometry.LocalizedGeometryFormats
-
EDGE_CONNECTED_TO_ONE_FACET.
- EDGE_CONNECTED_TO_ONE_FACET - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。EDGE_CONNECTED_TO_ONE_FACET.
- EigenDecompositionNonSymmetric - org.hipparchus.linear中的类
-
Calculates the eigen decomposition of a non-symmetric real matrix.
- EigenDecompositionNonSymmetric(RealMatrix) - 类的构造器 org.hipparchus.linear.EigenDecompositionNonSymmetric
-
Calculates the eigen decomposition of the given real matrix.
- EigenDecompositionNonSymmetric(RealMatrix, double) - 类的构造器 org.hipparchus.linear.EigenDecompositionNonSymmetric
-
Calculates the eigen decomposition of the given real matrix.
- EigenDecompositionNonSymmetricTest - org.hipparchus.linear中的类
- EigenDecompositionNonSymmetricTest() - 类的构造器 org.hipparchus.linear.EigenDecompositionNonSymmetricTest
- EigenDecompositionSymmetric - org.hipparchus.linear中的类
-
Calculates the eigen decomposition of a symmetric real matrix.
- EigenDecompositionSymmetric(double[], double[]) - 类的构造器 org.hipparchus.linear.EigenDecompositionSymmetric
-
Calculates the eigen decomposition of the symmetric tridiagonal matrix.
- EigenDecompositionSymmetric(double[], double[], double, boolean) - 类的构造器 org.hipparchus.linear.EigenDecompositionSymmetric
-
Calculates the eigen decomposition of the symmetric tridiagonal matrix.
- EigenDecompositionSymmetric(RealMatrix) - 类的构造器 org.hipparchus.linear.EigenDecompositionSymmetric
-
Calculates the eigen decomposition of the given symmetric real matrix.
- EigenDecompositionSymmetric(RealMatrix, double, boolean) - 类的构造器 org.hipparchus.linear.EigenDecompositionSymmetric
-
Calculates the eigen decomposition of the given real matrix.
- EigenDecompositionSymmetricTest - org.hipparchus.linear中的类
- EigenDecompositionSymmetricTest() - 类的构造器 org.hipparchus.linear.EigenDecompositionSymmetricTest
- EigenSolverTest - org.hipparchus.linear中的类
- EigenSolverTest() - 类的构造器 org.hipparchus.linear.EigenSolverTest
- eliminateZeroMassPoints(int[], double[]) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Eliminates points with zero mass from densityPoints and densityValues parallel arrays.
- Ellipse<T> - org.hipparchus.ode.nonstiff中的类
- EmbeddedRungeKuttaFieldIntegrator<T> - org.hipparchus.ode.nonstiff中的类
-
This class implements the common part of all embedded Runge-Kutta integrators for Ordinary Differential Equations.
- EmbeddedRungeKuttaFieldIntegrator(Field<T>, String, int, double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Build a Runge-Kutta integrator with the given Butcher array.
- EmbeddedRungeKuttaFieldIntegrator(Field<T>, String, int, double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Build a Runge-Kutta integrator with the given Butcher array.
- EmbeddedRungeKuttaFieldIntegratorAbstractTest - org.hipparchus.ode.nonstiff中的类
- EmbeddedRungeKuttaFieldIntegratorAbstractTest() - 类的构造器 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- EmbeddedRungeKuttaFieldIntegratorAbstractTest.LocalException - org.hipparchus.ode.nonstiff中的异常错误类
- EmbeddedRungeKuttaIntegrator - org.hipparchus.ode.nonstiff中的类
-
This class implements the common part of all embedded Runge-Kutta integrators for Ordinary Differential Equations.
- EmbeddedRungeKuttaIntegrator(String, int, double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Build a Runge-Kutta integrator with the given Butcher array.
- EmbeddedRungeKuttaIntegrator(String, int, double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Build a Runge-Kutta integrator with the given Butcher array.
- EmbeddedRungeKuttaIntegratorAbstractTest - org.hipparchus.ode.nonstiff中的类
- EmbeddedRungeKuttaIntegratorAbstractTest() - 类的构造器 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- EmbeddedRungeKuttaIntegratorAbstractTest.LocalException - org.hipparchus.ode.nonstiff中的异常错误类
- Embedding<S,
T> - org.hipparchus.geometry.partitioning中的接口 -
This interface defines mappers between a space and one of its sub-spaces.
- empiricalDistribution - 类中的变量 org.hipparchus.stat.fitting.EmpiricalDistributionTest
- EmpiricalDistribution - org.hipparchus.stat.fitting中的类
-
Represents an empirical probability distribution -- a probability distribution derived from observed data without making any assumptions about the functional form of the population distribution that the data come from.
- EmpiricalDistribution() - 类的构造器 org.hipparchus.stat.fitting.EmpiricalDistribution
-
Creates a new EmpiricalDistribution with the default bin count.
- EmpiricalDistribution(int) - 类的构造器 org.hipparchus.stat.fitting.EmpiricalDistribution
-
Creates a new EmpiricalDistribution with the specified bin count.
- EmpiricalDistribution(int, RandomGenerator) - 类的构造器 org.hipparchus.stat.fitting.EmpiricalDistribution
-
Creates a new EmpiricalDistribution with the specified bin count using the provided
RandomGenerator
as the source of random data. - EmpiricalDistribution(RandomGenerator) - 类的构造器 org.hipparchus.stat.fitting.EmpiricalDistribution
-
Creates a new EmpiricalDistribution with default bin count using the provided
RandomGenerator
as the source of random data. - empiricalDistribution2 - 类中的变量 org.hipparchus.stat.fitting.EmpiricalDistributionTest
- EmpiricalDistributionTest - org.hipparchus.stat.fitting中的类
-
Test cases for the EmpiricalDistribution class
- EmpiricalDistributionTest() - 类的构造器 org.hipparchus.stat.fitting.EmpiricalDistributionTest
- EMPTY_CLUSTER_IN_K_MEANS - 枚举类 中的枚举常量 org.hipparchus.clustering.LocalizedClusteringFormats
-
EMPTY_CLUSTER_IN_K_MEANS.
- EMPTY_CLUSTER_IN_K_MEANS - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。EMPTY_CLUSTER_IN_K_MEANS.
- EMPTY_INTERPOLATION_SAMPLE - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
EMPTY_INTERPOLATION_SAMPLE.
- EMPTY_INTERPOLATION_SAMPLE - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。EMPTY_INTERPOLATION_SAMPLE.
- EMPTY_POLYNOMIALS_COEFFICIENTS_ARRAY - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
EMPTY_POLYNOMIALS_COEFFICIENTS_ARRAY.
- EMPTY_POLYNOMIALS_COEFFICIENTS_ARRAY - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。EMPTY_POLYNOMIALS_COEFFICIENTS_ARRAY.
- EMPTY_SELECTED_COLUMN_INDEX_ARRAY - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
EMPTY_SELECTED_COLUMN_INDEX_ARRAY.
- EMPTY_SELECTED_COLUMN_INDEX_ARRAY - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。EMPTY_SELECTED_COLUMN_INDEX_ARRAY.
- EMPTY_SELECTED_ROW_INDEX_ARRAY - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
EMPTY_SELECTED_ROW_INDEX_ARRAY.
- EMPTY_SELECTED_ROW_INDEX_ARRAY - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。EMPTY_SELECTED_ROW_INDEX_ARRAY.
- EMPTY_STRING_FOR_IMAGINARY_CHARACTER - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。EMPTY_STRING_FOR_IMAGINARY_CHARACTER.
- EMPTY_STRING_FOR_IMAGINARY_CHARACTER - 枚举类 中的枚举常量 org.hipparchus.migration.LocalizedMigrationFormats
-
已过时。EMPTY_STRING_FOR_IMAGINARY_CHARACTER.
- emptyHyperplane() - 类中的方法 org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Build a sub-hyperplane covering nothing.
- emptyHyperplane() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Plane
-
Build a sub-hyperplane covering nothing.
- emptyHyperplane() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Line
-
Build a sub-hyperplane covering nothing.
- emptyHyperplane() - 接口中的方法 org.hipparchus.geometry.partitioning.Hyperplane
-
Build a sub-hyperplane covering nothing.
- emptyHyperplane() - 类中的方法 org.hipparchus.geometry.spherical.oned.LimitAngle
-
Build a sub-hyperplane covering nothing.
- emptyHyperplane() - 类中的方法 org.hipparchus.geometry.spherical.twod.Circle
-
Build a sub-hyperplane covering nothing.
- enclose(Iterable<P>) - 接口中的方法 org.hipparchus.geometry.enclosing.Encloser
-
Find a ball enclosing a list of points.
- enclose(Iterable<P>) - 类中的方法 org.hipparchus.geometry.enclosing.WelzlEncloser
-
Find a ball enclosing a list of points.
- Encloser<S,
P> - org.hipparchus.geometry.enclosing中的接口 -
Interface for algorithms computing enclosing balls.
- EnclosingBall<S,
P> - org.hipparchus.geometry.enclosing中的类 -
This class represents a ball enclosing some points.
- EnclosingBall(P, double, P...) - 类的构造器 org.hipparchus.geometry.enclosing.EnclosingBall
-
Simple constructor.
- end() - 类中的方法 org.hipparchus.linear.DefaultFieldMatrixChangingVisitor
-
End visiting a matrix.
- end() - 类中的方法 org.hipparchus.linear.DefaultFieldMatrixPreservingVisitor
-
End visiting a matrix.
- end() - 类中的方法 org.hipparchus.linear.DefaultRealMatrixChangingVisitor
-
End visiting a matrix.
- end() - 类中的方法 org.hipparchus.linear.DefaultRealMatrixPreservingVisitor
-
End visiting a matrix.
- end() - 接口中的方法 org.hipparchus.linear.FieldMatrixChangingVisitor
-
End visiting a matrix.
- end() - 接口中的方法 org.hipparchus.linear.FieldMatrixPreservingVisitor
-
End visiting a matrix.
- end() - 接口中的方法 org.hipparchus.linear.FieldVectorChangingVisitor
-
End visiting a vector.
- end() - 接口中的方法 org.hipparchus.linear.FieldVectorPreservingVisitor
-
End visiting a vector.
- end() - 接口中的方法 org.hipparchus.linear.RealMatrixChangingVisitor
-
End visiting a matrix.
- end() - 接口中的方法 org.hipparchus.linear.RealMatrixPreservingVisitor
-
End visiting a matrix.
- end() - 接口中的方法 org.hipparchus.linear.RealVectorChangingVisitor
-
End visiting a vector.
- end() - 接口中的方法 org.hipparchus.linear.RealVectorPreservingVisitor
-
End visiting a vector.
- ENDPOINTS_NOT_AN_INTERVAL - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
ENDPOINTS_NOT_AN_INTERVAL.
- ENDPOINTS_NOT_AN_INTERVAL - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。ENDPOINTS_NOT_AN_INTERVAL.
- enforceSymmetry(double[]) - 类中的方法 org.hipparchus.analysis.integration.gauss.AbstractRuleFactory
-
Enforce symmetry of roots.
- enforceSymmetry(T[]) - 类中的方法 org.hipparchus.analysis.integration.gauss.FieldAbstractRuleFactory
-
Enforce symmetry of roots.
- Entry() - 类的构造器 org.hipparchus.linear.RealVector.Entry
-
Simple constructor.
- entrySetIterator() - 类中的方法 org.hipparchus.stat.Frequency
-
Return an Iterator over the set of keys and values that have been added.
- entryTolerance - 类中的变量 org.hipparchus.linear.Array2DRowFieldMatrixTest
- entryTolerance - 类中的变量 org.hipparchus.linear.Array2DRowRealMatrixTest
- entryTolerance - 类中的变量 org.hipparchus.linear.BlockFieldMatrixTest
- entryTolerance - 类中的变量 org.hipparchus.linear.BlockRealMatrixTest
- entryTolerance - 类中的变量 org.hipparchus.linear.SparseFieldMatrixTest
- entryTolerance - 类中的变量 org.hipparchus.linear.SparseFieldVectorTest
- entryTolerance - 类中的变量 org.hipparchus.linear.SparseRealMatrixTest
- EnumeratedDistribution<T> - org.hipparchus.distribution中的类
-
A generic implementation of a discrete probability distribution (Wikipedia) over a finite sample space, based on an enumerated list of <value, probability> pairs.
- EnumeratedDistribution(List<Pair<T, Double>>) - 类的构造器 org.hipparchus.distribution.EnumeratedDistribution
-
Create an enumerated distribution using the given probability mass function enumeration.
- EnumeratedDistributionTest - org.hipparchus.distribution中的类
- EnumeratedDistributionTest() - 类的构造器 org.hipparchus.distribution.EnumeratedDistributionTest
- EnumeratedIntegerDistribution - org.hipparchus.distribution.discrete中的类
-
Implementation of an integer-valued
EnumeratedDistribution
. - EnumeratedIntegerDistribution(int[]) - 类的构造器 org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
Create a discrete integer-valued distribution from the input data.
- EnumeratedIntegerDistribution(int[], double[]) - 类的构造器 org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
Create a discrete distribution using the given probability mass function definition.
- EnumeratedIntegerDistributionTest - org.hipparchus.distribution.discrete中的类
-
Test class for
EnumeratedIntegerDistribution
. - EnumeratedIntegerDistributionTest() - 类的构造器 org.hipparchus.distribution.discrete.EnumeratedIntegerDistributionTest
-
Creates the default distribution object used for testing.
- EnumeratedRealDistribution - org.hipparchus.distribution.continuous中的类
-
Implementation of a real-valued
EnumeratedDistribution
. - EnumeratedRealDistribution(double[]) - 类的构造器 org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
Create a discrete real-valued distribution from the input data.
- EnumeratedRealDistribution(double[], double[]) - 类的构造器 org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
Create a discrete real-valued distribution using the given probability mass function enumeration.
- EnumeratedRealDistributionTest - org.hipparchus.distribution.continuous中的类
-
Test class for
EnumeratedRealDistribution
. - EnumeratedRealDistributionTest() - 类的构造器 org.hipparchus.distribution.continuous.EnumeratedRealDistributionTest
-
Creates the default distribution object used for testing.
- EPS - 类中的静态变量 org.hipparchus.linear.UnmodifiableRealVectorAbstractTest
-
Absolute tolerance.
- EPSILON - 类中的静态变量 org.hipparchus.util.Precision
-
Largest double-precision floating-point number such that
1 + EPSILON
is numerically equal to 1. - EQ - 枚举类 中的枚举常量 org.hipparchus.optim.linear.Relationship
-
Equality relationship.
- EQUAL_VERTICES_IN_SIMPLEX - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。EQUAL_VERTICES_IN_SIMPLEX.
- EQUAL_VERTICES_IN_SIMPLEX - 枚举类 中的枚举常量 org.hipparchus.optim.LocalizedOptimFormats
-
EQUAL_VERTICES_IN_SIMPLEX.
- equals(byte[], byte[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Returns
true
if both arguments arenull
or have same dimensions and all their elements are equals. - equals(double[], double[]) - 类中的静态方法 org.hipparchus.linear.UnmodifiableRealVectorAbstractTest
-
Returns
true
if the specifieddouble
arrays are equal (within a given tolerance). - equals(double[], double[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Returns
true
iff both arguments arenull
or have same dimensions and all their elements are equal as defined byPrecision.equals(double,double)
. - equals(double, double) - 类中的静态方法 org.hipparchus.linear.UnmodifiableRealVectorAbstractTest
-
Returns
true
if the specifieddouble
are equal (within a given tolerance). - equals(double, double) - 类中的静态方法 org.hipparchus.util.MathUtils
-
Returns
true
if the values are equal according to semantics ofDouble.equals(Object)
. - equals(double, double) - 类中的静态方法 org.hipparchus.util.Precision
-
Returns true iff they are equal as defined by
equals(x, y, 1)
. - equals(double, double, double) - 类中的静态方法 org.hipparchus.util.Precision
-
Returns
true
if there is no double value strictly between the arguments or the difference between them is within the range of allowed error (inclusive). - equals(double, double, int) - 类中的静态方法 org.hipparchus.util.Precision
-
Returns true if the arguments are equal or within the range of allowed error (inclusive).
- equals(float[], float[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by
Precision.equals(float,float)
. - equals(float, float) - 类中的静态方法 org.hipparchus.util.Precision
-
Returns true iff they are equal as defined by
equals(x, y, 1)
. - equals(float, float, float) - 类中的静态方法 org.hipparchus.util.Precision
-
Returns true if the arguments are equal or within the range of allowed error (inclusive).
- equals(float, float, int) - 类中的静态方法 org.hipparchus.util.Precision
-
Returns true if the arguments are equal or within the range of allowed error (inclusive).
- equals(int[], int[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Returns
true
if both arguments arenull
or have same dimensions and all their elements are equals. - equals(long[], long[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Returns
true
if both arguments arenull
or have same dimensions and all their elements are equals. - equals(short[], short[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Returns
true
if both arguments arenull
or have same dimensions and all their elements are equals. - equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Test for the equality of two derivative structures.
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.DSFactory.DSField
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.FDSFactory.DerivativeField
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
Test for the equality of two univariate derivatives.
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradientField
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Test for the equality of two univariate derivatives.
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1Field
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Test for the equality of two univariate derivatives.
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2Field
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
Test for the equality of two univariate derivatives.
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.GradientField
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Test for the equality of two sparse gradients.
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Test for the equality of two univariate derivatives.
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1Field
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Test for the equality of two univariate derivatives.
- equals(Object) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2Field
- equals(Object) - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunction
- equals(Object) - 类中的方法 org.hipparchus.clustering.DoublePoint
- equals(Object) - 类中的方法 org.hipparchus.complex.Complex
-
Test for equality with another object.
- equals(Object) - 类中的方法 org.hipparchus.complex.ComplexField
- equals(Object) - 类中的方法 org.hipparchus.complex.FieldComplex
-
Test for equality with another object.
- equals(Object) - 类中的方法 org.hipparchus.complex.FieldComplexField
- equals(Object) - 类中的方法 org.hipparchus.complex.Quaternion
- equals(Object) - 类中的方法 org.hipparchus.dfp.Dfp
-
Check if instance is equal to x.
- equals(Object) - 类中的方法 org.hipparchus.dfp.DfpField
- equals(Object) - 类中的方法 org.hipparchus.fraction.BigFraction
-
Test for the equality of two fractions.
- equals(Object) - 类中的方法 org.hipparchus.fraction.BigFractionField
- equals(Object) - 类中的方法 org.hipparchus.fraction.Fraction
-
Test for the equality of two fractions.
- equals(Object) - 类中的方法 org.hipparchus.fraction.FractionField
- equals(Object) - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
-
Test for the equality of two 1D vectors.
- equals(Object) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Test for the equality of two 3D vectors.
- equals(Object) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Test for the equality of two 3D vectors.
- equals(Object) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Test for the equality of two 2D vectors.
- equals(Object) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Test for the equality of two 2D vectors.
- equals(Object) - 类中的方法 org.hipparchus.geometry.spherical.oned.S1Point
-
Test for the equality of two points on the 1-sphere.
- equals(Object) - 类中的方法 org.hipparchus.geometry.spherical.twod.S2Point
-
Test for the equality of two points on the 2-sphere.
- equals(Object) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
-
Returns true iff
object
is aFieldMatrix
instance with the same dimensions as this and all corresponding matrix entries are equal. - equals(Object) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
-
Returns true iff
object
is aRealMatrix
instance with the same dimensions as this and all corresponding matrix entries are equal. - equals(Object) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Test for the equality of two vectors.
- equals(Object) - 类中的方法 org.hipparchus.linear.ArrayRealVector
-
Test for the equality of two real vectors.
- equals(Object) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
-
Test for the equality of two real vectors.
- equals(Object) - 类中的方法 org.hipparchus.linear.RealVector
-
Test for the equality of two real vectors.
- equals(Object) - 类中的方法 org.hipparchus.linear.SparseFieldVector
- equals(Object) - 类中的方法 org.hipparchus.optim.linear.LinearConstraint
- equals(Object) - 类中的方法 org.hipparchus.optim.linear.LinearObjectiveFunction
- equals(Object) - 类中的方法 org.hipparchus.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Returns true iff
object
is the same type ofStorelessUnivariateStatistic
(the object's class equals this instance) returning the same values as this forgetResult()
andgetN()
. - equals(Object) - 类中的方法 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns true iff
object
is aMultivariateSummaryStatistics
instance and all statistics have the same values as this. - equals(Object) - 类中的方法 org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
Returns true iff
o
is aPSquarePercentile
returning the same values as this forgetResult()
andgetN()
and also having equal markers - equals(Object) - 类中的方法 org.hipparchus.stat.descriptive.StatisticalSummaryValues
-
Returns true iff
object
is aStatisticalSummary
instance and all statistics have the same values as this. - equals(Object) - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns true iff
object
is aStreamingStatistics
instance and all statistics have the same values as this. - equals(Object) - 类中的方法 org.hipparchus.stat.descriptive.vector.VectorialCovariance
- equals(Object) - 类中的方法 org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic
- equals(Object) - 类中的方法 org.hipparchus.stat.Frequency
- equals(Object) - 类中的方法 org.hipparchus.util.BigReal
- equals(Object) - 类中的方法 org.hipparchus.util.BigRealField
- equals(Object) - 类中的方法 org.hipparchus.util.Binary64
- equals(Object) - 类中的方法 org.hipparchus.util.Binary64Field
- equals(Object) - 类中的方法 org.hipparchus.util.FieldTuple
- equals(Object) - 类中的方法 org.hipparchus.util.Pair
-
Compare the specified object with this entry for equality.
- equals(Object) - 类中的方法 org.hipparchus.util.ResizableDoubleArray
-
Returns true iff object is a ResizableDoubleArray with the same properties as this and an identical internal storage array.
- equals(Object) - 类中的方法 org.hipparchus.util.Tuple
- equals(Object, Object) - 类中的静态方法 org.hipparchus.linear.UnmodifiableRealVectorAbstractTest
-
Returns
true
if the specifiedObject
are equal. - equals(Complex, Complex) - 类中的静态方法 org.hipparchus.complex.Complex
-
Returns
true
iff the values are equal as defined byequals(x, y, 1)
. - equals(Complex, Complex, double) - 类中的静态方法 org.hipparchus.complex.Complex
-
Returns
true
if, both for the real part and for the imaginary part, there is no double value strictly between the arguments or the difference between them is within the range of allowed error (inclusive). - equals(Complex, Complex, int) - 类中的静态方法 org.hipparchus.complex.Complex
-
Test for the floating-point equality between Complex objects.
- equals(FieldComplex<T>, FieldComplex<T>) - 类中的静态方法 org.hipparchus.complex.FieldComplex
-
Returns
true
iff the values are equal as defined byequals(x, y, 1)
. - equals(FieldComplex<T>, FieldComplex<T>, double) - 类中的静态方法 org.hipparchus.complex.FieldComplex
-
Returns
true
if, both for the real part and for the imaginary part, there is no T value strictly between the arguments or the difference between them is within the range of allowed error (inclusive). - equals(FieldComplex<T>, FieldComplex<T>, int) - 类中的静态方法 org.hipparchus.complex.FieldComplex
-
Test for the floating-point equality between Complex objects.
- equals(Quaternion, double) - 类中的方法 org.hipparchus.complex.Quaternion
-
Checks whether this instance is equal to another quaternion within a given tolerance.
- equals(RealMatrix, RealMatrix) - 类中的静态方法 org.hipparchus.linear.UnmodifiableRealVectorAbstractTest
-
Returns
true
if the specifiedRealMatrix
are equal (within a given tolerance). - equals(RealVector, double[]) - 类中的静态方法 org.hipparchus.linear.UnmodifiableRealVectorAbstractTest
-
Returns
true
if the specifiedRealVector
is equal to the specifieddouble
array (within a given tolerance). - equals(RealVector, RealVector) - 类中的静态方法 org.hipparchus.linear.UnmodifiableRealVectorAbstractTest
-
Returns
true
if the specifiedRealVector
are equal (within a given tolerance). - equalsIeee754(Object) - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
-
Test for the equality of two 1D vectors.
- equalsIeee754(Object) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Test for the equality of two 3D vectors.
- equalsIeee754(Object) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Test for the equality of two 2D vectors.
- equalsIeee754(Object) - 类中的方法 org.hipparchus.geometry.spherical.oned.S1Point
-
Test for the equality of two points on the 1-sphere.
- equalsIeee754(Object) - 类中的方法 org.hipparchus.geometry.spherical.twod.S2Point
-
Test for the equality of two points on the 2-sphere.
- equalsIncludingNaN(double[], double[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Returns
true
iff both arguments arenull
or have same dimensions and all their elements are equal as defined bythis method
. - equalsIncludingNaN(double, double) - 类中的静态方法 org.hipparchus.util.Precision
-
Returns true if the arguments are both NaN or they are equal as defined by
equals(x, y, 1)
. - equalsIncludingNaN(double, double, double) - 类中的静态方法 org.hipparchus.util.Precision
-
Returns true if the arguments are both NaN, are equal or are within the range of allowed error (inclusive).
- equalsIncludingNaN(double, double, int) - 类中的静态方法 org.hipparchus.util.Precision
-
Returns true if both arguments are NaN or if they are equal as defined by
equals(x, y, maxUlps)
. - equalsIncludingNaN(float[], float[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by
this method
. - equalsIncludingNaN(float, float) - 类中的静态方法 org.hipparchus.util.Precision
-
Returns true if both arguments are NaN or they are equal as defined by
equals(x, y, 1)
. - equalsIncludingNaN(float, float, float) - 类中的静态方法 org.hipparchus.util.Precision
-
Returns true if the arguments are both NaN, are equal, or are within the range of allowed error (inclusive).
- equalsIncludingNaN(float, float, int) - 类中的静态方法 org.hipparchus.util.Precision
-
Returns true if the arguments are both NaN or if they are equal as defined by
equals(x, y, maxUlps)
. - equalsWithRelativeTolerance(double, double, double) - 类中的静态方法 org.hipparchus.util.Precision
-
Returns
true
if there is no double value strictly between the arguments or the relative difference between them is less than or equal to the given tolerance. - equalsWithRelativeTolerance(Complex, Complex, double) - 类中的静态方法 org.hipparchus.complex.Complex
-
Returns
true
if, both for the real part and for the imaginary part, there is no double value strictly between the arguments or the relative difference between them is smaller or equal to the given tolerance. - equalsWithRelativeTolerance(FieldComplex<T>, FieldComplex<T>, double) - 类中的静态方法 org.hipparchus.complex.FieldComplex
-
Returns
true
if, both for the real part and for the imaginary part, there is no T value strictly between the arguments or the relative difference between them is smaller or equal to the given tolerance. - Equation() - 类的构造器 org.hipparchus.ode.events.CloseEventsTest.Equation
- Equation() - 类的构造器 org.hipparchus.ode.events.FieldCloseEventsTest.Equation
- EquationODE() - 类的构造器 org.hipparchus.ode.events.FieldCloseEventsTest.EquationODE
- EquationsMapper - org.hipparchus.ode中的类
-
Class mapping the part of a complete state or derivative that pertains to a specific differential equation.
- erf(double) - 类中的静态方法 org.hipparchus.special.Erf
-
Returns the error function. \[ \mathrm{erf}(x) = \frac{2}{\sqrt{\pi}} \int_{t=0}^x e^{-t^2}dt \]
- erf(double, double) - 类中的静态方法 org.hipparchus.special.Erf
-
Returns the difference between erf(x1) and erf(x2).
- erf(T) - 类中的静态方法 org.hipparchus.special.Erf
-
Returns the error function. \[ \mathrm{erf}(x) = \frac{2}{\sqrt{\pi}} \int_{t=0}^x e^{-t^2}dt \]
- erf(T, T) - 类中的静态方法 org.hipparchus.special.Erf
-
Returns the difference between erf(x1) and erf(x2).
- Erf - org.hipparchus.special中的类
-
This is a utility class that provides computation methods related to the error functions.
- erfc(double) - 类中的静态方法 org.hipparchus.special.Erf
-
Returns the complementary error function. \[ \mathrm{erfc}(x) = \frac{2}{\sqrt{\pi}} \int_{t=x}^\infty e^{-t^2}dt = 1 - \mathrm{erf}
- erfc(T) - 类中的静态方法 org.hipparchus.special.Erf
-
Returns the complementary error function. \[ erfc(x) = \frac{2}{\sqrt{\pi}} \int_x^\infty e^{-t^2}dt = 1 - erf(x) \]
- erfcInv(double) - 类中的静态方法 org.hipparchus.special.Erf
-
Returns the inverse erfc.
- erfcInv(T) - 类中的静态方法 org.hipparchus.special.Erf
-
Returns the inverse erfc.
- erfInv(double) - 类中的静态方法 org.hipparchus.special.Erf
-
Returns the inverse erf.
- erfInv(T) - 类中的静态方法 org.hipparchus.special.Erf
-
Returns the inverse erf.
- ErfTest - org.hipparchus.special中的类
- ErfTest() - 类的构造器 org.hipparchus.special.ErfTest
- ERR_SCALE - 类中的静态变量 org.hipparchus.dfp.Dfp
-
The amount under/overflows are scaled by before going to trap handler
- ERROR - 枚举类 中的枚举常量 org.hipparchus.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
-
Generate an error.
- errorEstimation(double[], double, double[], double[], RealMatrix) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsBashforthIntegrator
-
Estimate error.
- errorEstimation(double[], double, double[], double[], RealMatrix) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Estimate error.
- errorEstimation(double[], double, double[], double[], RealMatrix) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsMoultonIntegrator
-
Estimate error.
- errorEstimation(T[], T, T[], T[], FieldMatrix<T>) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegrator
-
Estimate error.
- errorEstimation(T[], T, T[], T[], FieldMatrix<T>) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Estimate error.
- errorEstimation(T[], T, T[], T[], FieldMatrix<T>) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegrator
-
Estimate error.
- estimate(double[][], int) - 类中的静态方法 org.hipparchus.stat.fitting.MultivariateNormalMixtureExpectationMaximization
-
Helper method to create a multivariate normal mixture model which can be used to initialize
MultivariateNormalMixtureExpectationMaximization.fit(MixtureMultivariateNormalDistribution)
. - estimate(double[], int[], double, int, KthSelector) - 枚举类中的方法 org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
Estimation based on Kth selection.
- estimate(int) - 接口中的方法 org.hipparchus.stat.descriptive.rank.PSquarePercentile.PSquareMarkers
-
An Estimate of the percentile value of a given Marker
- estimateError(double[][], double[], double[], double) - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
Compute the error ratio.
- estimateError(double[][], double[], double[], double) - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
Compute the error ratio.
- estimateError(double[][], double[], double[], double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Compute the error ratio.
- estimateError(double[][], double[], double[], double) - 类中的方法 org.hipparchus.ode.nonstiff.HighamHall54Integrator
-
Compute the error ratio.
- estimateError(T[][], T[], T[], T) - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
-
Compute the error ratio.
- estimateError(T[][], T[], T[], T) - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
-
Compute the error ratio.
- estimateError(T[][], T[], T[], T) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Compute the error ratio.
- estimateError(T[][], T[], T[], T) - 类中的方法 org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
-
Compute the error ratio.
- estimateErrorVariance() - 类中的方法 org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Estimates the variance of the error.
- estimateRegressandVariance() - 类中的方法 org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Returns the variance of the regressand, ie Var(y).
- estimateRegressandVariance() - 接口中的方法 org.hipparchus.stat.regression.MultipleLinearRegression
-
Returns the variance of the regressand, ie Var(y).
- estimateRegressionParameters() - 类中的方法 org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Estimates the regression parameters b.
- estimateRegressionParameters() - 接口中的方法 org.hipparchus.stat.regression.MultipleLinearRegression
-
Estimates the regression parameters b.
- estimateRegressionParametersStandardErrors() - 类中的方法 org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Returns the standard errors of the regression parameters.
- estimateRegressionParametersStandardErrors() - 接口中的方法 org.hipparchus.stat.regression.MultipleLinearRegression
-
Returns the standard errors of the regression parameters.
- estimateRegressionParametersVariance() - 类中的方法 org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Estimates the variance of the regression parameters, ie Var(b).
- estimateRegressionParametersVariance() - 接口中的方法 org.hipparchus.stat.regression.MultipleLinearRegression
-
Estimates the variance of the regression parameters, ie Var(b).
- estimateRegressionStandardError() - 类中的方法 org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Estimates the standard error of the regression.
- estimateResiduals() - 类中的方法 org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Estimates the residuals, ie u = y - X*b.
- estimateResiduals() - 接口中的方法 org.hipparchus.stat.regression.MultipleLinearRegression
-
Estimates the residuals, ie u = y - X*b.
- estimationStep(T) - 类中的方法 org.hipparchus.filtering.kalman.extended.ExtendedKalmanFilter
-
Perform one estimation step.
- estimationStep(T) - 接口中的方法 org.hipparchus.filtering.kalman.KalmanFilter
-
Perform one estimation step.
- estimationStep(T) - 类中的方法 org.hipparchus.filtering.kalman.linear.LinearKalmanFilter
-
Perform one estimation step.
- estimationStep(T) - 类中的方法 org.hipparchus.filtering.kalman.unscented.UnscentedKalmanFilter
-
Perform one estimation step.
- Euclidean1D - org.hipparchus.geometry.euclidean.oned中的类
-
This class implements a one-dimensional space.
- Euclidean1D.NoSubSpaceException - org.hipparchus.geometry.euclidean.oned中的异常错误类
-
Specialized exception for inexistent sub-space.
- Euclidean1DTest - org.hipparchus.geometry.euclidean.oned中的类
- Euclidean1DTest() - 类的构造器 org.hipparchus.geometry.euclidean.oned.Euclidean1DTest
- Euclidean2D - org.hipparchus.geometry.euclidean.twod中的类
-
This class implements a two-dimensional space.
- Euclidean2DTest - org.hipparchus.geometry.euclidean.twod中的类
- Euclidean2DTest() - 类的构造器 org.hipparchus.geometry.euclidean.twod.Euclidean2DTest
- Euclidean3D - org.hipparchus.geometry.euclidean.threed中的类
-
This class implements a three-dimensional space.
- Euclidean3DTest - org.hipparchus.geometry.euclidean.threed中的类
- Euclidean3DTest() - 类的构造器 org.hipparchus.geometry.euclidean.threed.Euclidean3DTest
- EuclideanDistance - org.hipparchus.clustering.distance中的类
-
Calculates the L2 (Euclidean) distance between two points.
- EuclideanDistance() - 类的构造器 org.hipparchus.clustering.distance.EuclideanDistance
-
Empty constructor.
- EuclideanDistanceTest - org.hipparchus.clustering.distance中的类
-
Tests for
EuclideanDistance
class. - EuclideanDistanceTest() - 类的构造器 org.hipparchus.clustering.distance.EuclideanDistanceTest
- EULER_ANGLES_SINGULARITY - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。EULER_ANGLES_SINGULARITY.
- EULER_ANGLES_SINGULARITY - 枚举类 中的枚举常量 org.hipparchus.migration.LocalizedMigrationFormats
-
已过时。EULER_ANGLES_SINGULARITY.
- EulerFieldIntegrator<T> - org.hipparchus.ode.nonstiff中的类
-
This class implements a simple Euler integrator for Ordinary Differential Equations.
- EulerFieldIntegrator(Field<T>, T) - 类的构造器 org.hipparchus.ode.nonstiff.EulerFieldIntegrator
-
Simple constructor.
- EulerFieldIntegratorTest - org.hipparchus.ode.nonstiff中的类
- EulerFieldIntegratorTest() - 类的构造器 org.hipparchus.ode.nonstiff.EulerFieldIntegratorTest
- EulerFieldStateInterpolatorTest - org.hipparchus.ode.nonstiff中的类
- EulerFieldStateInterpolatorTest() - 类的构造器 org.hipparchus.ode.nonstiff.EulerFieldStateInterpolatorTest
- EulerIntegrator - org.hipparchus.ode.nonstiff中的类
-
This class implements a simple Euler integrator for Ordinary Differential Equations.
- EulerIntegrator(double) - 类的构造器 org.hipparchus.ode.nonstiff.EulerIntegrator
-
Simple constructor.
- EulerIntegratorTest - org.hipparchus.ode.nonstiff中的类
- EulerIntegratorTest() - 类的构造器 org.hipparchus.ode.nonstiff.EulerIntegratorTest
- EulerStateInterpolatorTest - org.hipparchus.ode.nonstiff中的类
- EulerStateInterpolatorTest() - 类的构造器 org.hipparchus.ode.nonstiff.EulerStateInterpolatorTest
- evaluate() - 类中的方法 org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Returns the result of evaluating the statistic over the stored data.
- evaluate(double) - 类中的方法 org.hipparchus.stat.descriptive.rank.Percentile
-
Returns the result of evaluating the statistic over the stored data.
- evaluate(double) - 类中的方法 org.hipparchus.util.ContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(double[]) - 接口中的方法 org.hipparchus.stat.descriptive.UnivariateStatistic
-
Returns the result of evaluating the statistic over the input array.
- evaluate(double[]) - 接口中的方法 org.hipparchus.util.MathArrays.Function
-
Operates on an entire array.
- evaluate(double[], double) - 类中的静态方法 org.hipparchus.analysis.polynomials.PolynomialFunction
-
Uses Horner's Method to evaluate the polynomial with the given coefficients at the argument.
- evaluate(double[], double) - 类中的方法 org.hipparchus.stat.descriptive.moment.SemiVariance
-
Returns the
SemiVariance
of the designated values against the cutoff, using instance properties variancDirection and biasCorrection. - evaluate(double[], double) - 类中的方法 org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Returns the Standard Deviation of the entries in the input array, using the precomputed mean value.
- evaluate(double[], double) - 类中的方法 org.hipparchus.stat.descriptive.moment.Variance
-
Returns the variance of the entries in the input array, using the precomputed mean value.
- evaluate(double[], double) - 类中的方法 org.hipparchus.stat.descriptive.rank.Percentile
-
Returns an estimate of the
p
th percentile of the values in thevalues
array. - evaluate(double[], double[]) - 接口中的方法 org.hipparchus.stat.descriptive.WeightedEvaluation
-
Returns the result of evaluating the statistic over the input array, using the supplied weights.
- evaluate(double[], double[], double) - 类中的静态方法 org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Evaluate the Lagrange polynomial using Neville's Algorithm.
- evaluate(double[], double[], double) - 类中的静态方法 org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Evaluate the Newton polynomial using nested multiplication.
- evaluate(double[], double[], double) - 类中的方法 org.hipparchus.stat.descriptive.moment.Variance
-
Returns the weighted variance of the values in the input array, using the precomputed weighted mean value.
- evaluate(double[], double[], double, int, int) - 类中的方法 org.hipparchus.stat.descriptive.moment.Variance
-
Returns the weighted variance of the entries in the specified portion of the input array, using the precomputed weighted mean value.
- evaluate(double[], double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.moment.Mean
-
Returns the weighted arithmetic mean of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.moment.Variance
-
Returns the weighted variance of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.summary.Product
-
Returns the weighted product of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.summary.Sum
-
The weighted sum of the entries in the specified portion of the input array, or 0 if the designated subarray is empty.
- evaluate(double[], double[], int, int) - 接口中的方法 org.hipparchus.stat.descriptive.WeightedEvaluation
-
Returns the result of evaluating the statistic over the specified entries in the input array, using corresponding entries in the supplied weights array.
- evaluate(double[], double, int, int) - 类中的方法 org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Returns the Standard Deviation of the entries in the specified portion of the input array, using the precomputed mean value.
- evaluate(double[], double, int, int) - 类中的方法 org.hipparchus.stat.descriptive.moment.Variance
-
Returns the variance of the entries in the specified portion of the input array, using the precomputed mean value.
- evaluate(double[], double, SemiVariance.Direction) - 类中的方法 org.hipparchus.stat.descriptive.moment.SemiVariance
-
Returns the
SemiVariance
of the designated values against the cutoff in the given direction, using the current value of the biasCorrection instance property. - evaluate(double[], double, SemiVariance.Direction, boolean, int, int) - 类中的方法 org.hipparchus.stat.descriptive.moment.SemiVariance
-
Returns the
SemiVariance
of the designated values against the cutoff in the given direction with the provided bias correction. - evaluate(double[], double, KthSelector) - 枚举类中的方法 org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
Evaluate method to compute the percentile for a given bounded array.
- evaluate(double[], int[], double, KthSelector) - 枚举类中的方法 org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
- evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Returns the result of evaluating the statistic over the specified entries in the input array.
- evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.moment.GeometricMean
-
Returns the geometric mean of the entries in the specified portion of the input array.
- evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.moment.Kurtosis
-
Returns the kurtosis of the entries in the specified portion of the input array.
- evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.moment.Mean
-
Returns the arithmetic mean of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.moment.SemiVariance
-
Returns the
SemiVariance
of the designated values against the mean, using instance properties varianceDirection and biasCorrection. - evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.moment.Skewness
-
Returns the Skewness of the entries in the specified portion of the input array.
- evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Returns the Standard Deviation of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.moment.Variance
-
Returns the variance of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.rank.Max
-
Returns the maximum of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.rank.Median
-
Returns the result of evaluating the statistic over the specified entries in the input array.
- evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.rank.Min
-
Returns the minimum of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.rank.Percentile
-
Returns an estimate of the
quantile
th percentile of the designated values in thevalues
array. - evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Returns an estimate of the median, computed using the designated array segment as input data.
- evaluate(double[], int, int) - 接口中的方法 org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
-
Returns the result of evaluating the statistic over the specified entries in the input array.
- evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.summary.Product
-
Returns the product of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.summary.Sum
-
The sum of the entries in the specified portion of the input array, or 0 if the designated subarray is empty.
- evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.summary.SumOfLogs
-
Returns the sum of the natural logs of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.summary.SumOfSquares
-
Returns the sum of the squares of the entries in the specified portion of the input array, or
Double.NaN
if the designated subarray is empty. - evaluate(double[], int, int) - 接口中的方法 org.hipparchus.stat.descriptive.UnivariateStatistic
-
Returns the result of evaluating the statistic over the specified entries in the input array.
- evaluate(double[], int, int) - 接口中的方法 org.hipparchus.util.MathArrays.Function
-
Operates on a sub-array.
- evaluate(double[], int, int, double) - 类中的方法 org.hipparchus.stat.descriptive.rank.Percentile
-
Returns an estimate of the
p
th percentile of the values in thevalues
array, starting with the element in (0-based) positionbegin
in the array and includinglength
values. - evaluate(double[], SemiVariance.Direction) - 类中的方法 org.hipparchus.stat.descriptive.moment.SemiVariance
-
This method calculates
SemiVariance
for the entire array against the mean, using the current value of the biasCorrection instance property. - evaluate(double, double) - 类中的方法 org.hipparchus.util.ContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(double, double[]) - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Returns an estimate of percentile over the given array.
- evaluate(double, double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Returns an estimate of the given percentile, computed using the designated array segment as input data.
- evaluate(double, double, int) - 类中的方法 org.hipparchus.util.ContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(double, int) - 类中的方法 org.hipparchus.util.ContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(MultivariateFunction, Comparator<PointValuePair>) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Evaluate all the non-evaluated points of the simplex.
- evaluate(RealVector) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
-
Evaluate the model at the specified point.
- evaluate(RealVector) - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem
-
Evaluate the model at the specified point.
- evaluate(T) - 类中的方法 org.hipparchus.util.FieldContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(T[], T) - 类中的静态方法 org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Uses Horner's Method to evaluate the polynomial with the given coefficients at the argument.
- evaluate(T, double) - 类中的方法 org.hipparchus.util.FieldContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(T, double, int) - 类中的方法 org.hipparchus.util.FieldContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluate(T, int) - 类中的方法 org.hipparchus.util.FieldContinuedFraction
-
Evaluates the continued fraction at the value x.
- evaluateStep(FieldODEStateInterpolator<T>) - 类中的方法 org.hipparchus.ode.events.FieldDetectorBasedEventState
-
Evaluate the impact of the proposed step on the event handler.
- evaluateStep(FieldODEStateInterpolator<T>) - 接口中的方法 org.hipparchus.ode.events.FieldEventState
-
Evaluate the impact of the proposed step on the event handler.
- evaluateStep(FieldODEStateInterpolator<T>) - 类中的方法 org.hipparchus.ode.events.FieldStepEndEventState
-
Evaluate the impact of the proposed step on the event handler.
- evaluateStep(ODEStateInterpolator) - 类中的方法 org.hipparchus.ode.events.DetectorBasedEventState
-
Evaluate the impact of the proposed step on the handler.
- evaluateStep(ODEStateInterpolator) - 接口中的方法 org.hipparchus.ode.events.EventState
-
Evaluate the impact of the proposed step on the handler.
- evaluateStep(ODEStateInterpolator) - 类中的方法 org.hipparchus.ode.events.StepEndEventState
-
Evaluate the impact of the proposed step on the handler.
- EVALUATION - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
EVALUATION.
- EVALUATION - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。EVALUATION.
- evaluationChecker(ConvergenceChecker<PointVectorValuePair>) - 类中的静态方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
View a convergence checker specified for a
PointVectorValuePair
as one specified for anLeastSquaresProblem.Evaluation
. - EvaluationRmsChecker - org.hipparchus.optim.nonlinear.vector.leastsquares中的类
-
Check if an optimization has converged based on the change in computed RMS.
- EvaluationRmsChecker(double) - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.EvaluationRmsChecker
-
Create a convergence checker for the RMS with the same relative and absolute tolerance.
- EvaluationRmsChecker(double, double) - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.EvaluationRmsChecker
-
Create a convergence checker for the RMS with a relative and absolute tolerance.
- EvaluationRmsCheckerTest - org.hipparchus.optim.nonlinear.vector.leastsquares中的类
-
Unit tests for
EvaluationRmsChecker
. - EvaluationRmsCheckerTest() - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.EvaluationRmsCheckerTest
- evaluations - 类中的变量 org.hipparchus.optim.BaseOptimizer
-
Evaluations counter.
- EVALUATIONS - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
EVALUATIONS.
- EVALUATIONS - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。EVALUATIONS.
- EvaluationTest - org.hipparchus.optim.nonlinear.vector.leastsquares中的类
-
The only features tested here are utility methods defined in
LeastSquaresProblem.Evaluation
that compute the chi-square and parameters standard-deviations. - EvaluationTest() - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.EvaluationTest
- EvaluationTestValidation - org.hipparchus.optim.nonlinear.vector.leastsquares中的类
-
This class demonstrates the main functionality of the
LeastSquaresProblem.Evaluation
, common to the optimizer implementations in packageorg.hipparchus.optim.nonlinear.vector.leastsquares
. - EvaluationTestValidation() - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.EvaluationTestValidation
- Event(double, double, int) - 类的构造器 org.hipparchus.ode.events.ReappearingEventTest.Event
-
Constructor for the
ReappearingEventTest.Event
class. - Event(double, double, int, boolean, boolean) - 类的构造器 org.hipparchus.ode.events.EventSlopeFilterTest.Event
- EventHandler - org.hipparchus.migration.ode.events中的接口
-
已过时。
- EventHandler.Action - org.hipparchus.migration.ode.events中的枚举类
-
已过时。as of 1.0, replaced with
Action
- eventOccurred(double, double[], boolean) - 接口中的方法 org.hipparchus.migration.ode.events.EventHandler
-
已过时。Handle an event and choose what to do next.
- eventOccurred(FieldODEStateAndDerivative<T>, FieldODEEventDetector<T>, boolean) - 接口中的方法 org.hipparchus.ode.events.FieldODEEventHandler
-
Handle an event and choose what to do next.
- eventOccurred(ODEStateAndDerivative, ODEEventDetector, boolean) - 接口中的方法 org.hipparchus.ode.events.ODEEventHandler
-
Handle an event and choose what to do next.
- EventOccurrence - org.hipparchus.ode.events中的类
-
Class to hold the data related to an event occurrence that is needed to decide how to modify integration.
- EventOccurrence(Action, ODEState, double) - 类的构造器 org.hipparchus.ode.events.EventOccurrence
-
Create a new occurrence of an event.
- Events - 程序包 org.hipparchus.ode.events中的搜索标记
- 节
- EventSlopeFilter<T> - org.hipparchus.ode.events中的类
-
Wrapper used to detect only increasing or decreasing events.
- EventSlopeFilter(T, FilterType) - 类的构造器 org.hipparchus.ode.events.EventSlopeFilter
-
Wrap an
event detector
. - EventSlopeFilterTest - org.hipparchus.ode.events中的类
- EventSlopeFilterTest() - 类的构造器 org.hipparchus.ode.events.EventSlopeFilterTest
- EventSlopeFilterTest.Event - org.hipparchus.ode.events中的类
-
State events for this unit test.
- EventSlopeFilterTest.FieldEvent<T> - org.hipparchus.ode.events中的类
-
State events for this unit test.
- EventsScheduling - org.hipparchus.ode.events中的类
-
Check events handlers and step handlers are called at consistent times.
- EventsScheduling() - 类的构造器 org.hipparchus.ode.events.EventsScheduling
- EventState - org.hipparchus.ode.events中的接口
-
This interface handles the state for either one
event handler
or onestep end handler
during integration steps. - exactLog2(int) - 类中的静态方法 org.hipparchus.transform.TransformUtils
-
Returns the base-2 logarithm of the specified
int
. - exactP(double, int, int, boolean) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
-
Computes \(P(D_{n,m} > d)\) if
strict
istrue
; otherwise \(P(D_{n,m} \ge d)\), where \(D_{n,m}\) is the 2-sample Kolmogorov-Smirnov statistic. - exactP(double, int, int, boolean) - 类中的方法 org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Computes \(P(D_{n,m} > d)\) if
strict
istrue
; otherwise \(P(D_{n,m} \ge d)\), where \(D_{n,m}\) is the 2-sample Kolmogorov-Smirnov statistic. - exactP341(double, int, int, boolean) - 类中的方法 org.hipparchus.stat.inference.KolmogorovSmirnovTestTest
-
This is copied directly from version 3.4.1 of commons math.
- ExampleFrame() - 类的构造器 org.hipparchus.samples.ExampleUtils.ExampleFrame
-
Empty constructor.
- ExampleUtils - org.hipparchus.samples中的类
-
Graphics utilities for examples.
- ExampleUtils() - 类的构造器 org.hipparchus.samples.ExampleUtils
-
Empty constructor.
- ExampleUtils.ExampleFrame - org.hipparchus.samples中的类
-
Display frame.
- exceedMaxEvaluations() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegratorTest
- exceedMaxEvaluations() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsBashforthIntegratorTest
- exceedMaxEvaluations() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsFieldIntegratorAbstractTest
- exceedMaxEvaluations() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsIntegratorAbstractTest
- exceedMaxEvaluations() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegratorTest
- exceedMaxEvaluations() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsMoultonIntegratorTest
- EXCLUDE - 类中的静态变量 org.hipparchus.linear.UnmodifiableRealVectorAbstractTest
-
The list of methods which are excluded from the general test
UnmodifiableRealVectorAbstractTest.testAllButExcluded()
. - exp - 类中的变量 org.hipparchus.dfp.Dfp
-
Exponent.
- exp() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Exponential.
- exp() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Exponential.
- exp() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
Exponential.
- exp() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Exponential.
- exp() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Exponential.
- exp() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
Exponential.
- exp() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Exponential.
- exp() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Exponential.
- exp() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Exponential.
- exp() - 接口中的方法 org.hipparchus.CalculusFieldElement
-
Exponential.
- exp() - 类中的方法 org.hipparchus.complex.Complex
-
Compute the exponential function of this complex number.
- exp() - 类中的方法 org.hipparchus.complex.FieldComplex
-
Compute the exponential function of this complex number.
- exp() - 类中的方法 org.hipparchus.dfp.Dfp
-
Exponential.
- exp() - 类中的方法 org.hipparchus.util.Binary64
-
Exponential.
- exp() - 类中的方法 org.hipparchus.util.FieldTuple
-
Exponential.
- exp() - 类中的方法 org.hipparchus.util.Tuple
-
Exponential.
- exp(double) - 类中的静态方法 org.hipparchus.util.FastMath
-
Exponential function.
- exp(double[], int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute exponential of a derivative structure.
- exp(Dfp) - 类中的静态方法 org.hipparchus.dfp.DfpMath
-
Computes e to the given power.
- exp(T) - 类中的静态方法 org.hipparchus.util.FastMath
-
Exponential function.
- exp(T[], int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute exponential of a derivative structure.
- Exp - org.hipparchus.analysis.function中的类
-
Exponential function.
- Exp() - 类的构造器 org.hipparchus.analysis.function.Exp
-
Empty constructor.
- expand() - 类中的方法 org.hipparchus.util.ResizableDoubleArray
-
Expands the internal storage array using the expansion factor.
- ExpandableODE - org.hipparchus.ode中的类
-
This class represents a combined set of first order differential equations, with at least a primary set of equations expandable by some sets of secondary equations.
- ExpandableODE(OrdinaryDifferentialEquation) - 类的构造器 org.hipparchus.ode.ExpandableODE
-
Build an expandable set from its primary ODE set.
- ExpandableODETest - org.hipparchus.ode中的类
- ExpandableODETest() - 类的构造器 org.hipparchus.ode.ExpandableODETest
- EXPANSION_FACTOR_SMALLER_THAN_ONE - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
EXPANSION_FACTOR_SMALLER_THAN_ONE.
- EXPANSION_FACTOR_SMALLER_THAN_ONE - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。EXPANSION_FACTOR_SMALLER_THAN_ONE.
- expected - 类中的变量 org.hipparchus.random.RandomDataGeneratorTest
- EXPECTED_COR_NO_BIAS - 类中的静态变量 org.hipparchus.stat.projection.PCATest
-
This is the expected value give or take sign when centering and scaling (correlation) is applied with no bias adjustment.
- EXPECTED_MEAN - 类中的静态变量 org.hipparchus.stat.projection.PCATest
- EXPECTED_VARIANCE - 类中的静态变量 org.hipparchus.stat.projection.PCATest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.moment.FirstMomentTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.moment.FourthMomentTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.moment.GeometricMeanTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.moment.KurtosisTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.moment.MeanTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.moment.SecondMomentTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.moment.SemiVarianceTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.moment.SkewnessTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.moment.StandardDeviationTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.moment.ThirdMomentTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.moment.VarianceTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.rank.MaxTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.rank.MedianTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.rank.MinTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.rank.PercentileTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.rank.PSquarePercentileTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentileTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.StorelessUnivariateStatisticAbstractTest
-
Expected value for the testArray defined in UnivariateStatisticAbstractTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.summary.ProductTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.summary.SumLogTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.summary.SumSqTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.summary.SumTest
- expectedValue() - 类中的方法 org.hipparchus.stat.descriptive.UnivariateStatisticAbstractTest
- expectedWeightedValue() - 类中的方法 org.hipparchus.stat.descriptive.moment.MeanTest
-
Expected value for the testArray defined in UnivariateStatisticAbstractTest
- expectedWeightedValue() - 类中的方法 org.hipparchus.stat.descriptive.moment.VarianceTest
-
Expected value for the testArray defined in UnivariateStatisticAbstractTest
- expectedWeightedValue() - 类中的方法 org.hipparchus.stat.descriptive.summary.ProductTest
-
Expected value for the testArray defined in UnivariateStatisticAbstractTest
- expectedWeightedValue() - 类中的方法 org.hipparchus.stat.descriptive.summary.SumTest
-
Expected value for the testArray defined in UnivariateStatisticAbstractTest
- expInternal(Dfp) - 类中的静态方法 org.hipparchus.dfp.DfpMath
-
Computes e to the given power.
- expm1() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Exponential minus 1.
- expm1() - 接口中的方法 org.hipparchus.CalculusFieldElement
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.complex.Complex
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.complex.FieldComplex
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.dfp.Dfp
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.util.Binary64
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.util.FieldTuple
-
Exponential minus 1.
- expm1() - 类中的方法 org.hipparchus.util.Tuple
-
Exponential minus 1.
- expm1(double) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute exp(x) - 1
- expm1(double[], int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute exp(x) - 1 of a derivative structure.
- expm1(T) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute exp(x) - 1
- expm1(T[], int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute exp(x) - 1 of a derivative structure.
- Expm1 - org.hipparchus.analysis.function中的类
-
ex-1
function. - Expm1() - 类的构造器 org.hipparchus.analysis.function.Expm1
-
Empty constructor.
- EXPONENT - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
EXPONENT.
- EXPONENT - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。EXPONENT.
- ExponentialDistribution - org.hipparchus.distribution.continuous中的类
-
Implementation of the exponential distribution.
- ExponentialDistribution(double) - 类的构造器 org.hipparchus.distribution.continuous.ExponentialDistribution
-
Create an exponential distribution with the given mean.
- ExponentialDistributionTest - org.hipparchus.distribution.continuous中的类
-
Test cases for ExponentialDistribution.
- ExponentialDistributionTest() - 类的构造器 org.hipparchus.distribution.continuous.ExponentialDistributionTest
- ExtendedKalmanFilter<T> - org.hipparchus.filtering.kalman.extended中的类
-
Kalman filter for
non-linear process
. - ExtendedKalmanFilter(MatrixDecomposer, NonLinearProcess<T>, ProcessEstimate) - 类的构造器 org.hipparchus.filtering.kalman.extended.ExtendedKalmanFilter
-
Simple constructor.
- ExtendedKalmanFilterTest - org.hipparchus.filtering.kalman.extended中的类
- ExtendedKalmanFilterTest() - 类的构造器 org.hipparchus.filtering.kalman.extended.ExtendedKalmanFilterTest
- extractEquationData(int, double[]) - 类中的方法 org.hipparchus.ode.EquationsMapper
-
Extract equation data from a complete state or derivative array.
- extractEquationData(int, T[]) - 类中的方法 org.hipparchus.ode.FieldEquationsMapper
-
Extract equation data from a complete state or derivative array.
- extractField(T[]) - 类中的静态方法 org.hipparchus.linear.AbstractFieldMatrix
-
Get the elements type from an array.
- extractField(T[][]) - 类中的静态方法 org.hipparchus.linear.AbstractFieldMatrix
-
Get the elements type from an array.
- extractMainSetJacobian(ODEState) - 类中的方法 org.hipparchus.migration.ode.JacobianMatrices
-
已过时。Extract the Jacobian matrix with respect to state.
- extractMainSetJacobian(ODEState) - 类中的方法 org.hipparchus.ode.VariationalEquation
-
Extract the Jacobian matrix with respect to state.
- extractParameterJacobian(ODEState, String) - 类中的方法 org.hipparchus.migration.ode.JacobianMatrices
-
已过时。Extract the Jacobian matrix with respect to one parameter.
- extractParameterJacobian(ODEState, String) - 类中的方法 org.hipparchus.ode.VariationalEquation
-
Extract the Jacobian matrix with respect to one parameter.
- extrema(boolean) - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics.StreamingStatisticsBuilder
-
Sets the computeExtrema setting of the factory.
常量字段值|所有程序包|所有类和接口|序列化表格
ODEEventDetector