索引
常量字段值|所有程序包|所有类和接口|序列化表格
D
- D(Complex) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralComplexTest
- D(Complex, Complex) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralComplexTest
- D(FieldComplex<Binary64>) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralFieldComplexTest
- D(FieldComplex<Binary64>, FieldComplex<Binary64>) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralFieldComplexTest
- D(T) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralAbstractComplexTest
- D(T, T) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralAbstractComplexTest
- da - 类中的变量 org.hipparchus.util.ResizableDoubleArrayTest
- DANTZIG - 枚举类 中的枚举常量 org.hipparchus.optim.linear.PivotSelectionRule
-
The classical rule, the variable with the most negative coefficient in the objective function row will be chosen as entering variable.
- data - 类中的变量 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
-
Entries of the vector.
- data - 类中的变量 org.hipparchus.linear.RealVectorAbstractTest.RealVectorTestImpl
-
Entries of the vector.
- data() - 类中的静态方法 org.hipparchus.transform.FastCosineTransformerTest
-
Returns an array containing
true, false
in order to check both standard and orthogonal DCTs. - data() - 类中的静态方法 org.hipparchus.transform.FastSineTransformerTest
-
Returns an array containing
true, false
in order to check both standard and orthogonal DSTs. - data() - 类中的静态方法 org.hipparchus.util.FastMathStrictComparisonTest
- dataArray - 类中的变量 org.hipparchus.stat.fitting.EmpiricalDistributionTest
- DATASET1 - 类中的静态变量 org.hipparchus.fitting.GaussianCurveFitterTest
-
Good data.
- DATASET2 - 类中的静态变量 org.hipparchus.fitting.GaussianCurveFitterTest
-
Poor data: right of peak not symmetric with left of peak.
- DATASET3 - 类中的静态变量 org.hipparchus.fitting.GaussianCurveFitterTest
-
Poor data: long tails.
- DATASET4 - 类中的静态变量 org.hipparchus.fitting.GaussianCurveFitterTest
-
Poor data: right of peak is missing.
- DATASET5 - 类中的静态变量 org.hipparchus.fitting.GaussianCurveFitterTest
-
Good data, but few points.
- DBSCANClusterer<T> - org.hipparchus.clustering中的类
-
DBSCAN (density-based spatial clustering of applications with noise) algorithm.
- DBSCANClusterer(double, int) - 类的构造器 org.hipparchus.clustering.DBSCANClusterer
-
Creates a new instance of a DBSCANClusterer.
- DBSCANClusterer(double, int, DistanceMeasure) - 类的构造器 org.hipparchus.clustering.DBSCANClusterer
-
Creates a new instance of a DBSCANClusterer.
- DBSCANClustererTest - org.hipparchus.clustering中的类
- DBSCANClustererTest() - 类的构造器 org.hipparchus.clustering.DBSCANClustererTest
- dc() - 类中的方法 org.hipparchus.special.elliptic.jacobi.CopolarC
-
Get the value of the dc function.
- dc() - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldCopolarC
-
Get the value of the dc function.
- DctNormalization - org.hipparchus.transform中的枚举类
-
This enumeration defines the various types of normalizations that can be applied to discrete cosine transforms (DCT).
- Decimal10 - org.hipparchus.dfp中的类
- Decimal10(Dfp) - 类的构造器 org.hipparchus.dfp.Decimal10
- Decimal10(DfpField, byte, byte) - 类的构造器 org.hipparchus.dfp.Decimal10
- Decimal10(DfpField, String) - 类的构造器 org.hipparchus.dfp.Decimal10
- decompose(double[][]) - 类中的方法 org.hipparchus.linear.QRDecomposition
-
Decompose matrix.
- decompose(double[][]) - 类中的方法 org.hipparchus.linear.RRQRDecomposition
-
Decompose matrix.
- decompose(FieldMatrix<T>) - 类中的方法 org.hipparchus.linear.FieldLUDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(FieldMatrix<T>) - 接口中的方法 org.hipparchus.linear.FieldMatrixDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(FieldMatrix<T>) - 类中的方法 org.hipparchus.linear.FieldQRDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(RealMatrix) - 类中的方法 org.hipparchus.linear.CholeskyDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(RealMatrix) - 类中的方法 org.hipparchus.linear.LUDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(RealMatrix) - 接口中的方法 org.hipparchus.linear.MatrixDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(RealMatrix) - 类中的方法 org.hipparchus.linear.QRDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(RealMatrix) - 类中的方法 org.hipparchus.linear.SingularValueDecomposer
-
Get a solver for finding the A × X = B solution in least square sense.
- decompose(T[][]) - 类中的方法 org.hipparchus.linear.FieldQRDecomposition
-
Decompose matrix.
- DecompositionSolver - org.hipparchus.linear中的接口
-
Interface handling decomposition algorithms that can solve A × X = B.
- DECREASING - 枚举类 中的枚举常量 org.hipparchus.util.MathArrays.OrderDirection
-
Constant for decreasing direction.
- decrementExact(int) - 类中的静态方法 org.hipparchus.util.FastMath
-
Decrement a number, detecting overflows.
- decrementExact(long) - 类中的静态方法 org.hipparchus.util.FastMath
-
Decrement a number, detecting overflows.
- DEFAULT_ABSOLUTE_ACCURACY - 类中的静态变量 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Default absolute accuracy.
- DEFAULT_ABSOLUTE_ACCURACY - 类中的静态变量 org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Default absolute accuracy.
- DEFAULT_ABSOLUTE_ACCURACY - 类中的静态变量 org.hipparchus.analysis.solvers.BaseSecantSolver
-
Default absolute accuracy.
- DEFAULT_ABSOLUTE_ACCURACY - 类中的静态变量 org.hipparchus.analysis.solvers.SecantSolver
-
Default absolute accuracy.
- DEFAULT_ABSOLUTE_POSITIVITY_THRESHOLD - 类中的静态变量 org.hipparchus.linear.CholeskyDecomposition
-
Default threshold below which diagonal elements are considered null and matrix not positive definite.
- DEFAULT_ACCURACY - 类中的静态变量 org.hipparchus.analysis.interpolation.LoessInterpolator
-
Default value for accuracy.
- DEFAULT_ALPHA - 类中的静态变量 org.hipparchus.util.MerweUnscentedTransform
-
Default value for alpha (0.5, see reference).
- DEFAULT_BANDWIDTH - 类中的静态变量 org.hipparchus.analysis.interpolation.LoessInterpolator
-
Default value of the bandwidth parameter.
- DEFAULT_BETA - 类中的静态变量 org.hipparchus.util.MerweUnscentedTransform
-
Default value for beta (2.0, see reference).
- DEFAULT_BIN_COUNT - 类中的静态变量 org.hipparchus.stat.fitting.EmpiricalDistribution
-
Default bin count
- DEFAULT_DECIMAL_DIGITS - 类中的静态变量 org.hipparchus.analysis.integration.gauss.GaussIntegratorFactory
-
Number of digits for Legendre high precision.
- DEFAULT_EIGENVECTORS_EQUALITY - 类中的静态变量 org.hipparchus.linear.ComplexEigenDecomposition
-
Default threshold below which eigenvectors are considered equal.
- DEFAULT_EPSILON - 类中的静态变量 org.hipparchus.distribution.discrete.PoissonDistribution
-
Default convergence criterion.
- DEFAULT_EPSILON - 类中的静态变量 org.hipparchus.linear.ComplexEigenDecomposition
-
Default value to use for internal epsilon.
- DEFAULT_EPSILON - 类中的静态变量 org.hipparchus.linear.EigenDecompositionNonSymmetric
-
Default epsilon value to use for internal epsilon
- DEFAULT_EPSILON - 类中的静态变量 org.hipparchus.linear.EigenDecompositionSymmetric
-
Default epsilon value to use for internal epsilon
- DEFAULT_EPSILON - 类中的静态变量 org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Default quantile estimation error setting
- DEFAULT_EPSILON_AV_VD_CHECK - 类中的静态变量 org.hipparchus.linear.ComplexEigenDecomposition
-
Internally used epsilon criteria for final AV=VD check.
- DEFAULT_EXTEND - 类中的静态变量 org.hipparchus.analysis.interpolation.UnivariatePeriodicInterpolator
-
Default number of extension points of the samples array.
- DEFAULT_FORMAT - 类中的静态变量 org.hipparchus.linear.MatrixUtils
-
The default format for
RealMatrix
objects. - DEFAULT_HIGH_EXP - 类中的静态变量 org.hipparchus.util.RyuDouble
-
Default high switch level to scientific notation.
- DEFAULT_INITIAL_RADIUS - 类中的静态变量 org.hipparchus.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
-
Default value for
BOBYQAOptimizer.initialTrustRegionRadius
: 10.0 . - DEFAULT_KAPPA - 类中的静态变量 org.hipparchus.util.JulierUnscentedTransform
-
Default value for kappa, (0.0, see reference).
- DEFAULT_KAPPA - 类中的静态变量 org.hipparchus.util.MerweUnscentedTransform
-
Default value for kappa, (0.0, see reference).
- DEFAULT_LOW_EXP - 类中的静态变量 org.hipparchus.util.RyuDouble
-
Default low switch level to scientific notation.
- DEFAULT_MAX_ITER - 类中的静态变量 org.hipparchus.ode.events.AbstractFieldODEDetector
-
Default maximum number of iterations in the event time search.
- DEFAULT_MAX_ITER - 类中的静态变量 org.hipparchus.ode.events.AbstractODEDetector
-
Default maximum number of iterations in the event time search.
- DEFAULT_MAX_ITERATIONS - 类中的静态变量 org.hipparchus.distribution.discrete.PoissonDistribution
-
Default maximum number of iterations for cumulative probability calculations.
- DEFAULT_MAX_ITERATIONS_COUNT - 类中的静态变量 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Default maximal iteration count.
- DEFAULT_MAX_ITERATIONS_COUNT - 类中的静态变量 org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Default maximal iteration count.
- DEFAULT_MAXCHECK - 类中的静态变量 org.hipparchus.ode.events.AbstractFieldODEDetector
-
Default maximum checking interval (s).
- DEFAULT_MAXCHECK - 类中的静态变量 org.hipparchus.ode.events.AbstractODEDetector
-
Default maximum checking interval (s).
- DEFAULT_MIN_ITERATIONS_COUNT - 类中的静态变量 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Default minimal iteration count.
- DEFAULT_MIN_ITERATIONS_COUNT - 类中的静态变量 org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Default minimal iteration count.
- DEFAULT_NAN_STRATEGY - 类中的静态变量 org.hipparchus.stat.ranking.NaturalRanking
-
default NaN strategy
- DEFAULT_PERCENTILE - 类中的变量 org.hipparchus.stat.descriptive.rank.PercentileTest
-
A default percentile to be used for
PercentileTest.getUnivariateStatistic()
- DEFAULT_PREFIX - 类中的静态变量 org.hipparchus.geometry.VectorFormat
-
The default prefix: "{".
- DEFAULT_RELATIVE_ACCURACY - 类中的静态变量 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Default relative accuracy.
- DEFAULT_RELATIVE_ACCURACY - 类中的静态变量 org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Default relative accuracy.
- DEFAULT_RELATIVE_SYMMETRY_THRESHOLD - 类中的静态变量 org.hipparchus.linear.CholeskyDecomposition
-
Default threshold above which off-diagonal elements are considered too different and matrix not symmetric.
- DEFAULT_ROBUSTNESS_ITERS - 类中的静态变量 org.hipparchus.analysis.interpolation.LoessInterpolator
-
Default value of the number of robustness iterations.
- DEFAULT_SEPARATOR - 类中的静态变量 org.hipparchus.geometry.VectorFormat
-
The default separator: ", ".
- DEFAULT_SOLVER_ABSOLUTE_ACCURACY - 类中的静态变量 org.hipparchus.distribution.continuous.AbstractRealDistribution
-
Default absolute accuracy for inverse cumulative computation.
- DEFAULT_STOPPING_RADIUS - 类中的静态变量 org.hipparchus.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
-
Default value for
BOBYQAOptimizer.stoppingTrustRegionRadius
: 1.0E-8 . - DEFAULT_SUFFIX - 类中的静态变量 org.hipparchus.geometry.VectorFormat
-
The default suffix: "}".
- DEFAULT_THRESHOLD - 类中的静态变量 org.hipparchus.ode.events.AbstractFieldODEDetector
-
Default convergence threshold (s).
- DEFAULT_THRESHOLD - 类中的静态变量 org.hipparchus.ode.events.AbstractODEDetector
-
Default convergence threshold (s).
- DEFAULT_TIES_STRATEGY - 类中的静态变量 org.hipparchus.stat.ranking.NaturalRanking
-
default ties strategy
- DEFAULT_ZERO_TOLERANCE - 类中的静态变量 org.hipparchus.linear.OpenMapRealVector
-
Default Tolerance for having a value considered zero.
- DefaultFieldMatrixChangingVisitor<T> - org.hipparchus.linear中的类
-
Default implementation of the
FieldMatrixChangingVisitor
interface. - DefaultFieldMatrixChangingVisitor(T) - 类的构造器 org.hipparchus.linear.DefaultFieldMatrixChangingVisitor
-
Build a new instance.
- DefaultFieldMatrixPreservingVisitor<T> - org.hipparchus.linear中的类
-
Default implementation of the
FieldMatrixPreservingVisitor
interface. - DefaultFieldMatrixPreservingVisitor(T) - 类的构造器 org.hipparchus.linear.DefaultFieldMatrixPreservingVisitor
-
Build a new instance.
- DefaultIterativeLinearSolverEvent - org.hipparchus.linear中的类
-
A default concrete implementation of the abstract class
IterativeLinearSolverEvent
. - DefaultIterativeLinearSolverEvent(Object, int, RealVector, RealVector, double) - 类的构造器 org.hipparchus.linear.DefaultIterativeLinearSolverEvent
-
Creates a new instance of this class.
- DefaultIterativeLinearSolverEvent(Object, int, RealVector, RealVector, RealVector, double) - 类的构造器 org.hipparchus.linear.DefaultIterativeLinearSolverEvent
-
Creates a new instance of this class.
- DefaultRealMatrixChangingVisitor - org.hipparchus.linear中的类
-
Default implementation of the
RealMatrixChangingVisitor
interface. - DefaultRealMatrixChangingVisitor() - 类的构造器 org.hipparchus.linear.DefaultRealMatrixChangingVisitor
-
Empty constructor.
- DefaultRealMatrixPreservingVisitor - org.hipparchus.linear中的类
-
Default implementation of the
RealMatrixPreservingVisitor
interface. - DefaultRealMatrixPreservingVisitor() - 类的构造器 org.hipparchus.linear.DefaultRealMatrixPreservingVisitor
-
Empty constructor.
- defaultSettings() - 类中的方法 org.hipparchus.stat.projection.PCATest
- defaultTolerance - 类中的变量 org.hipparchus.distribution.continuous.CauchyDistributionTest
- defaultTolerance - 类中的变量 org.hipparchus.distribution.continuous.NormalDistributionTest
- defaultTolerance - 类中的变量 org.hipparchus.distribution.discrete.PascalDistributionTest
- defineOptimizer(LeastSquaresProblem.Evaluation) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractSequentialLeastSquaresOptimizerAbstractTest
-
Set an instance of the optimizer under test.
- defineOptimizer(LeastSquaresProblem.Evaluation) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizerWithCholeskyTest
- defineOptimizer(LeastSquaresProblem.Evaluation) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizerWithLUTest
- defineOptimizer(LeastSquaresProblem.Evaluation) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizerWithQRNormalTest
- defineOptimizer(LeastSquaresProblem.Evaluation) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizerWithQRTest
- defineOptimizer(LeastSquaresProblem.Evaluation) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizerWithSVDTest
- degenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsStateInterpolatorTest
- degenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.ClassicalRungeKuttaStateInterpolatorTest
- degenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince54StateInterpolatorTest
- degenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince853StateInterpolatorTest
- degenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.EulerStateInterpolatorTest
- degenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.FieldODEStateInterpolatorAbstractTest
- degenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.GillStateInterpolatorTest
- degenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.GraggBulirschStoerStateInterpolatorTest
- degenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.HighamHall54StateInterpolatorTest
- degenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.LutherStateInterpolatorTest
- degenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.MidpointStateInterpolatorTest
- degenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.ODEStateInterpolatorAbstractTest
- degenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.ThreeEighthesStateInterpolatorTest
- degree() - 类中的方法 org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Returns the degree of the polynomial.
- degree() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunction
-
Returns the degree of the polynomial.
- degree() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Returns the degree of the polynomial.
- degree() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Returns the degree of the polynomial.
- DEGREES_OF_FREEDOM - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
DEGREES_OF_FREEDOM.
- DEGREES_OF_FREEDOM - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。DEGREES_OF_FREEDOM.
- delegate() - 类中的方法 org.hipparchus.random.RandomDataGenerator
-
Returns the backing delegate instance that methods are forwarded to.
- DELTA - 类中的静态变量 org.hipparchus.stat.projection.PCATest
- DENOMINATOR - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
DENOMINATOR.
- DENOMINATOR - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。DENOMINATOR.
- DENOMINATOR_FORMAT - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
DENOMINATOR_FORMAT.
- DENOMINATOR_FORMAT - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。DENOMINATOR_FORMAT.
- DenseOutputModel - org.hipparchus.ode中的类
-
This class stores all information provided by an ODE integrator during the integration process and build a continuous model of the solution from this.
- DenseOutputModel() - 类的构造器 org.hipparchus.ode.DenseOutputModel
-
Simple constructor.
- DenseOutputModelTest - org.hipparchus.ode中的类
- DenseOutputModelTest() - 类的构造器 org.hipparchus.ode.DenseOutputModelTest
- density(double) - 类中的方法 org.hipparchus.distribution.continuous.BetaDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.CauchyDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.ConstantRealDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
For a random variable
X
whose values are distributed according to this distribution, this method returnsP(X = x)
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.ExponentialDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.FDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.GammaDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.GumbelDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.LaplaceDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.LevyDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.LogisticDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.LogNormalDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.NakagamiDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.NormalDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.ParetoDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.TDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.TriangularDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.UniformRealDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.distribution.continuous.WeibullDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 接口中的方法 org.hipparchus.distribution.RealDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double) - 类中的方法 org.hipparchus.stat.fitting.EmpiricalDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double[]) - 类中的方法 org.hipparchus.distribution.multivariate.MixtureMultivariateRealDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double[]) - 类中的方法 org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double[]) - 接口中的方法 org.hipparchus.distribution.MultivariateRealDistribution
-
Returns the probability density function (PDF) of this distribution evaluated at the specified point
x
. - density(double, double, double) - 类中的静态方法 org.hipparchus.distribution.continuous.GammaDistributionTest
- DependentVectorsHandler - org.hipparchus.linear中的枚举类
-
Enumerate to specify how dependent vectors should be handled in
MatrixUtils.orthonormalize(List, double, DependentVectorsHandler)
andMatrixUtils.orthonormalize(Field, List, CalculusFieldElement, DependentVectorsHandler)
. - DERIVATION_ORDER_NOT_ALLOWED - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
DERIVATION_ORDER_NOT_ALLOWED.
- derivative(MultivariateDifferentiableFunction, int[]) - 类中的静态方法 org.hipparchus.analysis.FunctionUtils
-
Convert an
MultivariateDifferentiableFunction
to anMultivariateFunction
computing nth order derivative. - derivative(UnivariateDifferentiableFunction, int) - 类中的静态方法 org.hipparchus.analysis.FunctionUtils
-
Convert an
UnivariateDifferentiableFunction
to anUnivariateFunction
computing nth order derivative. - Derivative<T> - org.hipparchus.analysis.differentiation中的接口
-
Interface representing both the value and the differentials of a function.
- derivatives(double, int) - 类中的方法 org.hipparchus.analysis.interpolation.HermiteInterpolator
-
Interpolate value and first derivatives at a specified abscissa.
- derivatives(T, int) - 类中的方法 org.hipparchus.analysis.interpolation.FieldHermiteInterpolator
-
Interpolate value and first derivatives at a specified abscissa.
- derivativesConsistency() - 类中的方法 org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegratorTest
- DerivativeStructure - org.hipparchus.analysis.differentiation中的类
-
Class representing both the value and the differentials of a function.
- DerivativeStructureTest - org.hipparchus.analysis.differentiation中的类
-
Test for class
DerivativeStructure
. - DerivativeStructureTest() - 类的构造器 org.hipparchus.analysis.differentiation.DerivativeStructureTest
- DescriptiveStatistics - org.hipparchus.stat.descriptive中的类
-
Maintains a dataset of values of a single variable and computes descriptive statistics based on stored data.
- DescriptiveStatistics() - 类的构造器 org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Construct a DescriptiveStatistics instance with an infinite window.
- DescriptiveStatistics(double[]) - 类的构造器 org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Construct a DescriptiveStatistics instance with an infinite window and the initial data values in double[] initialDoubleArray.
- DescriptiveStatistics(int) - 类的构造器 org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Construct a DescriptiveStatistics instance with the specified window.
- DescriptiveStatistics(DescriptiveStatistics) - 类的构造器 org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Copy constructor.
- DescriptiveStatisticsTest - org.hipparchus.stat.descriptive中的类
-
Test cases for the
DescriptiveStatistics
class. - DescriptiveStatisticsTest() - 类的构造器 org.hipparchus.stat.descriptive.DescriptiveStatisticsTest
- detData - 类中的变量 org.hipparchus.linear.Array2DRowFieldMatrixTest
- detData - 类中的变量 org.hipparchus.linear.Array2DRowRealMatrixTest
- detData - 类中的变量 org.hipparchus.linear.BlockFieldMatrixTest
- detData - 类中的变量 org.hipparchus.linear.BlockRealMatrixTest
- detData - 类中的变量 org.hipparchus.linear.SparseFieldMatrixTest
- detData - 类中的变量 org.hipparchus.linear.SparseRealMatrixTest
- detData2 - 类中的变量 org.hipparchus.linear.Array2DRowFieldMatrixTest
- detData2 - 类中的变量 org.hipparchus.linear.Array2DRowRealMatrixTest
- detData2 - 类中的变量 org.hipparchus.linear.BlockFieldMatrixTest
- detData2 - 类中的变量 org.hipparchus.linear.BlockRealMatrixTest
- detData2 - 类中的变量 org.hipparchus.linear.SparseFieldMatrixTest
- detData2 - 类中的变量 org.hipparchus.linear.SparseRealMatrixTest
- DetectorBasedEventState - org.hipparchus.ode.events中的类
-
This class handles the state for one
event handler
during integration steps. - DetectorBasedEventState(ODEEventDetector) - 类的构造器 org.hipparchus.ode.events.DetectorBasedEventState
-
Simple constructor.
- DetectorBasedEventStateTest - org.hipparchus.ode.events中的类
- DetectorBasedEventStateTest() - 类的构造器 org.hipparchus.ode.events.DetectorBasedEventStateTest
- dev - 类中的变量 org.hipparchus.stat.descriptive.moment.SecondMoment
-
Deviation of most recently added value from previous first moment.
- df(double, double, double, double) - 类中的方法 org.hipparchus.stat.inference.TTest
-
Computes approximate degrees of freedom for 2-sample t-test.
- Dfp - org.hipparchus.dfp中的类
-
Decimal floating point library for Java
- Dfp(Dfp) - 类的构造器 org.hipparchus.dfp.Dfp
-
Copy constructor.
- Dfp(DfpField) - 类的构造器 org.hipparchus.dfp.Dfp
-
Makes an instance with a value of zero.
- Dfp(DfpField, byte) - 类的构造器 org.hipparchus.dfp.Dfp
-
Create an instance from a byte value.
- Dfp(DfpField, byte, byte) - 类的构造器 org.hipparchus.dfp.Dfp
-
Creates an instance with a non-finite value.
- Dfp(DfpField, double) - 类的构造器 org.hipparchus.dfp.Dfp
-
Create an instance from a double value.
- Dfp(DfpField, int) - 类的构造器 org.hipparchus.dfp.Dfp
-
Create an instance from an int value.
- Dfp(DfpField, long) - 类的构造器 org.hipparchus.dfp.Dfp
-
Create an instance from a long value.
- Dfp(DfpField, String) - 类的构造器 org.hipparchus.dfp.Dfp
-
Create an instance from a String representation.
- dfp2sci() - 类中的方法 org.hipparchus.dfp.Dfp
-
Convert an instance to a string using scientific notation.
- dfp2string() - 类中的方法 org.hipparchus.dfp.Dfp
-
Convert an instance to a string using normal notation.
- DfpDec - org.hipparchus.dfp中的类
-
Subclass of
Dfp
which hides the radix-10000 artifacts of the superclass. - DfpDec(Dfp) - 类的构造器 org.hipparchus.dfp.DfpDec
-
Copy constructor.
- DfpDec(DfpField) - 类的构造器 org.hipparchus.dfp.DfpDec
-
Makes an instance with a value of zero.
- DfpDec(DfpField, byte) - 类的构造器 org.hipparchus.dfp.DfpDec
-
Create an instance from a byte value.
- DfpDec(DfpField, byte, byte) - 类的构造器 org.hipparchus.dfp.DfpDec
-
Creates an instance with a non-finite value.
- DfpDec(DfpField, double) - 类的构造器 org.hipparchus.dfp.DfpDec
-
Create an instance from a double value.
- DfpDec(DfpField, int) - 类的构造器 org.hipparchus.dfp.DfpDec
-
Create an instance from an int value.
- DfpDec(DfpField, long) - 类的构造器 org.hipparchus.dfp.DfpDec
-
Create an instance from a long value.
- DfpDec(DfpField, String) - 类的构造器 org.hipparchus.dfp.DfpDec
-
Create an instance from a String representation.
- DfpDecTest - org.hipparchus.dfp中的类
- DfpDecTest() - 类的构造器 org.hipparchus.dfp.DfpDecTest
- DfpField - org.hipparchus.dfp中的类
-
Field for Decimal floating point instances.
- DfpField(int) - 类的构造器 org.hipparchus.dfp.DfpField
-
Create a factory for the specified number of radix digits.
- DfpField.RoundingMode - org.hipparchus.dfp中的枚举类
-
Enumerate for rounding modes.
- DfpMath - org.hipparchus.dfp中的类
-
Mathematical routines for use with
Dfp
. - DfpMathTest - org.hipparchus.dfp中的类
- DfpMathTest() - 类的构造器 org.hipparchus.dfp.DfpMathTest
- DfpTest - org.hipparchus.dfp中的类
- DfpTest() - 类的构造器 org.hipparchus.dfp.DfpTest
- DftNormalization - org.hipparchus.transform中的枚举类
-
This enumeration defines the various types of normalizations that can be applied to discrete Fourier transforms (DFT).
- DiagonalMatrix - org.hipparchus.linear中的类
-
Implementation of a diagonal matrix.
- DiagonalMatrix(double[]) - 类的构造器 org.hipparchus.linear.DiagonalMatrix
-
Creates a matrix using the input array as the underlying data.
- DiagonalMatrix(double[], boolean) - 类的构造器 org.hipparchus.linear.DiagonalMatrix
-
Creates a matrix using the input array as the underlying data.
- DiagonalMatrix(int) - 类的构造器 org.hipparchus.linear.DiagonalMatrix
-
Creates a matrix with the supplied dimension.
- DiagonalMatrixTest - org.hipparchus.linear中的类
-
Test cases for the
DiagonalMatrix
class. - DiagonalMatrixTest() - 类的构造器 org.hipparchus.linear.DiagonalMatrixTest
- difference(Region<S>, Region<S>) - 类中的方法 org.hipparchus.geometry.partitioning.RegionFactory
-
Compute the difference of two regions.
- difference(FieldSinCos<S>, FieldSinCos<S>) - 类中的静态方法 org.hipparchus.util.FieldSinCos
-
Compute sine and cosine of angles difference.
- difference(FieldSinhCosh<S>, FieldSinhCosh<S>) - 类中的静态方法 org.hipparchus.util.FieldSinhCosh
-
Compute hyperbolic sine and hyperbolic cosine of angles difference.
- difference(SinCos, SinCos) - 类中的静态方法 org.hipparchus.util.SinCos
-
Compute sine and cosine of angles difference.
- difference(SinhCosh, SinhCosh) - 类中的静态方法 org.hipparchus.util.SinhCosh
-
Compute hyperbolic sine and hyperbolic cosine of angles difference.
- DIFFERENT_ROWS_LENGTHS - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
DIFFERENT_ROWS_LENGTHS.
- DIFFERENT_ROWS_LENGTHS - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。DIFFERENT_ROWS_LENGTHS.
- differentiate(double[]) - 类中的静态方法 org.hipparchus.analysis.polynomials.PolynomialFunction
-
Returns the coefficients of the derivative of the polynomial with the given coefficients.
- differentiate(int, int) - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Differentiate w.r.t. one independent variable.
- differentiate(int, int) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Differentiate w.r.t. one independent variable.
- differentiate(UnivariateFunction) - 类中的方法 org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
Create an implementation of a
differential
from a regularfunction
. - differentiate(UnivariateFunction) - 接口中的方法 org.hipparchus.analysis.differentiation.UnivariateFunctionDifferentiator
-
Create an implementation of a
differential
from a regularfunction
. - differentiate(UnivariateMatrixFunction) - 类中的方法 org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
Create an implementation of a
differential
from a regularmatrix function
. - differentiate(UnivariateMatrixFunction) - 接口中的方法 org.hipparchus.analysis.differentiation.UnivariateMatrixFunctionDifferentiator
-
Create an implementation of a
differential
from a regularmatrix function
. - differentiate(UnivariateVectorFunction) - 类中的方法 org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
Create an implementation of a
differential
from a regularvector function
. - differentiate(UnivariateVectorFunction) - 接口中的方法 org.hipparchus.analysis.differentiation.UnivariateVectorFunctionDifferentiator
-
Create an implementation of a
differential
from a regularvector function
. - differentiate(T[]) - 类中的静态方法 org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Returns the coefficients of the derivative of the polynomial with the given coefficients.
- digamma(double) - 类中的静态方法 org.hipparchus.special.Gamma
-
Computes the digamma function of x.
- digamma(T) - 类中的静态方法 org.hipparchus.special.Gamma
-
Computes the digamma function of x.
- DIGEST_NOT_INITIALIZED - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
DIGEST_NOT_INITIALIZED.
- DIGEST_NOT_INITIALIZED - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。DIGEST_NOT_INITIALIZED.
- DIM - 类中的静态变量 org.hipparchus.linear.UnmodifiableRealVectorAbstractTest
-
The dimension of the randomly generated vectors.
- DIMENSION - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
DIMENSION.
- DIMENSION - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。DIMENSION.
- dimension2() - 类中的方法 org.hipparchus.clustering.MultiKMeansPlusPlusClustererTest
- DimensionMismatchException - org.hipparchus.migration.exception中的异常错误类
-
已过时。
- DimensionMismatchException(int, int) - 异常错误类的构造器 org.hipparchus.migration.exception.DimensionMismatchException
-
已过时。Construct an exception from the mismatched dimensions.
- DimensionMismatchException(Localizable, int, int) - 异常错误类的构造器 org.hipparchus.migration.exception.DimensionMismatchException
-
已过时。Construct an exception from the mismatched dimensions.
- DIMENSIONS_MISMATCH - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
DIMENSIONS_MISMATCH.
- DIMENSIONS_MISMATCH - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。DIMENSIONS_MISMATCH.
- DIMENSIONS_MISMATCH_2x2 - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
DIMENSIONS_MISMATCH_2x2.
- DIMENSIONS_MISMATCH_2x2 - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。DIMENSIONS_MISMATCH_2x2.
- DIMENSIONS_MISMATCH_SIMPLE - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。DIMENSIONS_MISMATCH_SIMPLE.
- DIMENSIONS_MISMATCH_SIMPLE - 枚举类 中的枚举常量 org.hipparchus.migration.LocalizedMigrationFormats
-
已过时。DIMENSIONS_MISMATCH_SIMPLE.
- discardFrontElements(int) - 类中的方法 org.hipparchus.util.ResizableDoubleArray
-
Discards the
i
initial elements of the array. - discardMostRecentElements(int) - 类中的方法 org.hipparchus.util.ResizableDoubleArray
-
Discards the
i
last elements of the array. - DISCRETE_CUMULATIVE_PROBABILITY_RETURNED_NAN - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
DISCRETE_CUMULATIVE_PROBABILITY_RETURNED_NAN.
- DISCRETE_CUMULATIVE_PROBABILITY_RETURNED_NAN - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。DISCRETE_CUMULATIVE_PROBABILITY_RETURNED_NAN.
- DiskGenerator - org.hipparchus.geometry.euclidean.twod中的类
-
Class generating an enclosing ball from its support points.
- DiskGenerator() - 类的构造器 org.hipparchus.geometry.euclidean.twod.DiskGenerator
-
Empty constructor.
- DiskGeneratorTest - org.hipparchus.geometry.euclidean.twod中的类
- DiskGeneratorTest() - 类的构造器 org.hipparchus.geometry.euclidean.twod.DiskGeneratorTest
- Display() - 类的构造器 org.hipparchus.samples.ClusterAlgorithmComparison.Display
-
Simple consructor.
- Display() - 类的构造器 org.hipparchus.samples.clustering.ImageClusteringExample.Display
-
Simple constructor.
- Display() - 类的构造器 org.hipparchus.samples.geometry.GeometryExample.Display
-
Simple constructor.
- Display() - 类的构造器 org.hipparchus.samples.IntegerDistributionComparison.Display
-
Simple constructor.
- Display() - 类的构造器 org.hipparchus.samples.LowDiscrepancyGeneratorComparison.Display
-
Simple constructor.
- Display() - 类的构造器 org.hipparchus.samples.RealDistributionComparison.Display
-
Simple constructor.
- distance(double[], double[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Calculates the L2 (Euclidean) distance between two points.
- distance(int[], int[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Calculates the L2 (Euclidean) distance between two points.
- distance(Clusterable, Clusterable) - 类中的方法 org.hipparchus.clustering.Clusterer
-
Calculates the distance between two
Clusterable
instances with the configuredDistanceMeasure
. - distance(Clusterable, Clusterable) - 类中的方法 org.hipparchus.clustering.evaluation.ClusterEvaluator
-
Calculates the distance between two
Clusterable
instances with the configuredDistanceMeasure
. - distance(Vector1D, Vector1D) - 类中的静态方法 org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the distance between two vectors according to the L2 norm.
- distance(FieldLine<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldLine
-
Compute the shortest distance between the instance and another line.
- distance(FieldRotation<T>, FieldRotation<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Compute the distance between two rotations.
- distance(FieldVector3D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldLine
-
Compute the distance between the instance and a point.
- distance(FieldVector3D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between the instance and another vector according to the L2 norm.
- distance(FieldVector3D<T>, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L2 norm.
- distance(FieldVector3D<T>, Vector3D) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L2 norm.
- distance(Line) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Line
-
Compute the shortest distance between the instance and another line.
- distance(Rotation, Rotation) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.Rotation
-
Compute the distance between two rotations.
- distance(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldLine
-
Compute the distance between the instance and a point.
- distance(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between the instance and another vector according to the L2 norm.
- distance(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Line
-
Compute the distance between the instance and a point.
- distance(Vector3D, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L2 norm.
- distance(Vector3D, Vector3D) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between two vectors according to the L2 norm.
- distance(FieldVector2D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between the instance and another vector according to the L2 norm.
- distance(FieldVector2D<T>, FieldVector2D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance(FieldVector2D<T>, Vector2D) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance(Vector2D) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between the instance and another vector according to the L2 norm.
- distance(Vector2D) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Line
-
Compute the distance between the instance and a point.
- distance(Vector2D) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Segment
-
Calculates the shortest distance from a point to this line segment.
- distance(Vector2D, FieldVector2D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance(Vector2D, Vector2D) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance(Point<Euclidean1D>) - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the distance between the instance and another point.
- distance(Point<Euclidean3D>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between the instance and another point.
- distance(Point<Euclidean2D>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between the instance and another point.
- distance(Point<Sphere1D>) - 类中的方法 org.hipparchus.geometry.spherical.oned.S1Point
-
Compute the distance between the instance and another point.
- distance(Point<Sphere2D>) - 类中的方法 org.hipparchus.geometry.spherical.twod.S2Point
-
Compute the distance between the instance and another point.
- distance(Point<S>) - 接口中的方法 org.hipparchus.geometry.Point
-
Compute the distance between the instance and another point.
- distance(S1Point, S1Point) - 类中的静态方法 org.hipparchus.geometry.spherical.oned.S1Point
-
Compute the distance (angular separation) between two points.
- distance(S2Point, S2Point) - 类中的静态方法 org.hipparchus.geometry.spherical.twod.S2Point
-
Compute the distance (angular separation) between two points.
- distance1(double[], double[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Calculates the L1 (sum of abs) distance between two points.
- distance1(int[], int[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Calculates the L1 (sum of abs) distance between two points.
- distance1(FieldVector3D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(FieldVector3D<T>, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L1 norm.
- distance1(FieldVector3D<T>, Vector3D) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L1 norm.
- distance1(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(Vector3D, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L1 norm.
- distance1(Vector3D, Vector3D) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between two vectors according to the L1 norm.
- distance1(FieldVector2D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(FieldVector2D<T>, FieldVector2D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance1(FieldVector2D<T>, Vector2D) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance1(Vector2D) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(Vector2D, FieldVector2D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L2 norm.
- distance1(Vector2D, Vector2D) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between two vectors according to the L1 norm.
- distance1(Vector<Euclidean1D, Vector1D>) - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(Vector<Euclidean3D, Vector3D>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(Vector<Euclidean2D, Vector2D>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between the instance and another vector according to the L1 norm.
- distance1(Vector<S, V>) - 接口中的方法 org.hipparchus.geometry.Vector
-
Compute the distance between the instance and another vector according to the L1 norm.
- distanceInf(double[], double[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Calculates the L∞ (max of abs) distance between two points.
- distanceInf(int[], int[]) - 类中的静态方法 org.hipparchus.util.MathArrays
-
Calculates the L∞ (max of abs) distance between two points.
- distanceInf(Vector1D, Vector1D) - 类中的静态方法 org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(FieldVector3D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(FieldVector3D<T>, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(FieldVector3D<T>, Vector3D) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(Vector3D, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector3D, Vector3D) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(FieldVector2D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(FieldVector2D<T>, FieldVector2D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(FieldVector2D<T>, Vector2D) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector2D) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(Vector2D, FieldVector2D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector2D, Vector2D) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between two vectors according to the L∞ norm.
- distanceInf(Vector<Euclidean1D, Vector1D>) - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(Vector<Euclidean3D, Vector3D>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(Vector<Euclidean2D, Vector2D>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the distance between the instance and another vector according to the L∞ norm.
- distanceInf(Vector<S, V>) - 接口中的方法 org.hipparchus.geometry.Vector
-
Compute the distance between the instance and another vector according to the L∞ norm.
- DistanceMeasure - org.hipparchus.clustering.distance中的接口
-
Interface for distance measures of n-dimensional vectors.
- distanceSq(Vector1D, Vector1D) - 类中的静态方法 org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the square of the distance between two vectors.
- distanceSq(FieldVector3D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(FieldVector3D<T>, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the square of the distance between two vectors.
- distanceSq(FieldVector3D<T>, Vector3D) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector3D, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector3D, Vector3D) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the square of the distance between two vectors.
- distanceSq(FieldVector2D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(FieldVector2D<T>, FieldVector2D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the square of the distance between two vectors.
- distanceSq(FieldVector2D<T>, Vector2D) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector2D) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector2D, FieldVector2D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector2D, Vector2D) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the square of the distance between two vectors.
- distanceSq(Vector<Euclidean1D, Vector1D>) - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector<Euclidean3D, Vector3D>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector<Euclidean2D, Vector2D>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the square of the distance between the instance and another vector.
- distanceSq(Vector<S, V>) - 接口中的方法 org.hipparchus.geometry.Vector
-
Compute the square of the distance between the instance and another vector.
- DISTRIBUTION_NOT_LOADED - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
DISTRIBUTION_NOT_LOADED.
- DISTRIBUTION_NOT_LOADED - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。DISTRIBUTION_NOT_LOADED.
- DIV - 枚举类 中的枚举常量 org.hipparchus.linear.RealVectorAbstractTest.BinaryOperation
- divide(double) - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
'÷' operator.
- divide(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'÷' operator.
- divide(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
'÷' operator.
- divide(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'÷' operator.
- divide(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'÷' operator.
- divide(double) - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
'÷' operator.
- divide(double) - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
'÷' operator.
- divide(double) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
'÷' operator.
- divide(double) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
'÷' operator.
- divide(double) - 接口中的方法 org.hipparchus.CalculusFieldElement
-
'÷' operator.
- divide(double) - 类中的方法 org.hipparchus.complex.Complex
-
Returns a
Complex
whose value is(this / divisor)
, withdivisor
interpreted as a real number. - divide(double) - 类中的方法 org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value is(this / divisor)
, withdivisor
interpreted as a real number. - divide(double) - 类中的方法 org.hipparchus.dfp.Dfp
-
'÷' operator.
- divide(double) - 类中的方法 org.hipparchus.util.Binary64
-
'÷' operator.
- divide(double) - 类中的方法 org.hipparchus.util.FieldTuple
-
'÷' operator.
- divide(double) - 类中的方法 org.hipparchus.util.Tuple
-
'÷' operator.
- divide(double[], int, double[], int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Perform division of two derivative structures.
- divide(int) - 类中的方法 org.hipparchus.dfp.Dfp
-
Divide by a single digit less than radix.
- divide(int) - 类中的方法 org.hipparchus.fraction.BigFraction
-
Divide the value of this fraction by the passed
int
, iethis * 1 / i
, returning the result in reduced form. - divide(int) - 类中的方法 org.hipparchus.fraction.Fraction
-
Divide the fraction by an integer.
- divide(long) - 类中的方法 org.hipparchus.fraction.BigFraction
-
Divide the value of this fraction by the passed
long
, iethis * 1 / l
, returning the result in reduced form. - divide(BigInteger) - 类中的方法 org.hipparchus.fraction.BigFraction
-
Divide the value of this fraction by the passed
BigInteger
, iethis * 1 / bg
, returning the result in reduced form. - divide(DerivativeStructure) - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute this ÷ a.
- divide(FieldDerivativeStructure<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute this ÷ a.
- divide(FieldGradient<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
Compute this ÷ a.
- divide(FieldUnivariateDerivative1<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute this ÷ a.
- divide(FieldUnivariateDerivative2<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute this ÷ a.
- divide(Gradient) - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
Compute this ÷ a.
- divide(SparseGradient) - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Compute this ÷ a.
- divide(UnivariateDerivative1) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute this ÷ a.
- divide(UnivariateDerivative2) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute this ÷ a.
- divide(Complex) - 类中的方法 org.hipparchus.complex.Complex
-
Returns a
Complex
whose value is(this / divisor)
. - divide(FieldComplex<T>) - 类中的方法 org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value is(this / divisor)
. - divide(Dfp) - 类中的方法 org.hipparchus.dfp.Dfp
-
Divide this by divisor.
- divide(BigFraction) - 类中的方法 org.hipparchus.fraction.BigFraction
-
Divide the value of this fraction by another, returning the result in reduced form.
- divide(Fraction) - 类中的方法 org.hipparchus.fraction.Fraction
-
Divide the value of this fraction by another.
- divide(BigReal) - 类中的方法 org.hipparchus.util.BigReal
-
Compute this ÷ a.
- divide(Binary64) - 类中的方法 org.hipparchus.util.Binary64
-
Compute this ÷ a.
- divide(FieldTuple<T>) - 类中的方法 org.hipparchus.util.FieldTuple
-
Compute this ÷ a.
- divide(Tuple) - 类中的方法 org.hipparchus.util.Tuple
-
Compute this ÷ a.
- divide(T) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'÷' operator.
- divide(T) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
'÷' operator.
- divide(T) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'÷' operator.
- divide(T) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'÷' operator.
- divide(T) - 类中的方法 org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value is(this / divisor)
, withdivisor
interpreted as a real number. - divide(T) - 接口中的方法 org.hipparchus.FieldElement
-
Compute this ÷ a.
- divide(T[], int, T[], int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Perform division of two derivative structures.
- Divide - org.hipparchus.analysis.function中的类
-
Divide the first operand by the second.
- Divide() - 类的构造器 org.hipparchus.analysis.function.Divide
-
Empty constructor.
- DividedDifferenceInterpolator - org.hipparchus.analysis.interpolation中的类
-
Implements the Divided Difference Algorithm for interpolation of real univariate functions.
- DividedDifferenceInterpolator() - 类的构造器 org.hipparchus.analysis.interpolation.DividedDifferenceInterpolator
-
Empty constructor.
- DividedDifferenceInterpolatorTest - org.hipparchus.analysis.interpolation中的类
-
Test case for Divided Difference interpolator.
- DividedDifferenceInterpolatorTest() - 类的构造器 org.hipparchus.analysis.interpolation.DividedDifferenceInterpolatorTest
- divideExact(int, int) - 类中的静态方法 org.hipparchus.util.FastMath
-
Divide two integers, checking for overflow.
- divideExact(long, long) - 类中的静态方法 org.hipparchus.util.FastMath
-
Divide two long integers, checking for overflow.
- divideUnsigned(int, int) - 类中的静态方法 org.hipparchus.util.ArithmeticUtils
-
Returns the unsigned quotient of dividing the first argument by the second where each argument and the result is interpreted as an unsigned value.
- divideUnsigned(long, long) - 类中的静态方法 org.hipparchus.util.ArithmeticUtils
-
Returns the unsigned quotient of dividing the first argument by the second where each argument and the result is interpreted as an unsigned value.
- dn() - 类中的方法 org.hipparchus.special.elliptic.jacobi.CopolarN
-
Get the value of the dn function.
- dn() - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldCopolarN
-
Get the value of the dn function.
- doBackward(double, double, double, String) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsIntegratorAbstractTest
- doBackward(Field<T>, double, double, double, String) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsFieldIntegratorAbstractTest
- doComputeDerivatives(double, double[]) - 类中的方法 org.hipparchus.ode.TestProblem1
- doComputeDerivatives(double, double[]) - 类中的方法 org.hipparchus.ode.TestProblem2
- doComputeDerivatives(double, double[]) - 类中的方法 org.hipparchus.ode.TestProblem3
- doComputeDerivatives(double, double[]) - 类中的方法 org.hipparchus.ode.TestProblem4
- doComputeDerivatives(double, double[]) - 类中的方法 org.hipparchus.ode.TestProblem5
- doComputeDerivatives(double, double[]) - 类中的方法 org.hipparchus.ode.TestProblem6
- doComputeDerivatives(double, double[]) - 类中的方法 org.hipparchus.ode.TestProblem7
- doComputeDerivatives(double, double[]) - 类中的方法 org.hipparchus.ode.TestProblem8
- doComputeDerivatives(double, double[]) - 类中的方法 org.hipparchus.ode.TestProblemAbstract
- doComputeDerivatives(T, T[]) - 类中的方法 org.hipparchus.ode.TestFieldProblem1
- doComputeDerivatives(T, T[]) - 类中的方法 org.hipparchus.ode.TestFieldProblem2
- doComputeDerivatives(T, T[]) - 类中的方法 org.hipparchus.ode.TestFieldProblem3
- doComputeDerivatives(T, T[]) - 类中的方法 org.hipparchus.ode.TestFieldProblem4
- doComputeDerivatives(T, T[]) - 类中的方法 org.hipparchus.ode.TestFieldProblem5
- doComputeDerivatives(T, T[]) - 类中的方法 org.hipparchus.ode.TestFieldProblem6
- doComputeDerivatives(T, T[]) - 类中的方法 org.hipparchus.ode.TestFieldProblem7
- doComputeDerivatives(T, T[]) - 类中的方法 org.hipparchus.ode.TestFieldProblem8
- doComputeDerivatives(T, T[]) - 类中的方法 org.hipparchus.ode.TestFieldProblemAbstract
- doDegenerateInterpolation() - 类中的方法 org.hipparchus.ode.nonstiff.ODEStateInterpolatorAbstractTest
- doDegenerateInterpolation(Field<T>) - 类中的方法 org.hipparchus.ode.nonstiff.FieldODEStateInterpolatorAbstractTest
- doDimensionCheck() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsIntegratorAbstractTest
- doDimensionCheck(Field<T>) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsFieldIntegratorAbstractTest
- doEvent(FieldODEStateAndDerivative<T>) - 类中的方法 org.hipparchus.ode.events.FieldDetectorBasedEventState
-
Notify the user's listener of the event.
- doEvent(FieldODEStateAndDerivative<T>) - 接口中的方法 org.hipparchus.ode.events.FieldEventState
-
Notify the user's listener of the event.
- doEvent(FieldODEStateAndDerivative<T>) - 类中的方法 org.hipparchus.ode.events.FieldStepEndEventState
-
Notify the user's listener of the event.
- doEvent(ODEStateAndDerivative) - 类中的方法 org.hipparchus.ode.events.DetectorBasedEventState
-
Notify the user's listener of the event.
- doEvent(ODEStateAndDerivative) - 接口中的方法 org.hipparchus.ode.events.EventState
-
Notify the user's listener of the event.
- doEvent(ODEStateAndDerivative) - 类中的方法 org.hipparchus.ode.events.StepEndEventState
-
Notify the user's listener of the event.
- doExceedMaxEvaluations(int) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsIntegratorAbstractTest
- doExceedMaxEvaluations(Field<T>, int) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsFieldIntegratorAbstractTest
- doIntegrate() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - 类中的方法 org.hipparchus.analysis.integration.FieldMidPointIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - 类中的方法 org.hipparchus.analysis.integration.FieldRombergIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - 类中的方法 org.hipparchus.analysis.integration.FieldSimpsonIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - 类中的方法 org.hipparchus.analysis.integration.FieldTrapezoidIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - 类中的方法 org.hipparchus.analysis.integration.IterativeLegendreFieldGaussIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - 类中的方法 org.hipparchus.analysis.integration.IterativeLegendreGaussIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - 类中的方法 org.hipparchus.analysis.integration.MidPointIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - 类中的方法 org.hipparchus.analysis.integration.RombergIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - 类中的方法 org.hipparchus.analysis.integration.SimpsonIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doIntegrate() - 类中的方法 org.hipparchus.analysis.integration.TrapezoidIntegrator
-
Method for implementing actual integration algorithms in derived classes.
- doInterpolationAtBounds(double) - 类中的方法 org.hipparchus.ode.nonstiff.ODEStateInterpolatorAbstractTest
- doInterpolationAtBounds(Field<T>, double) - 类中的方法 org.hipparchus.ode.nonstiff.FieldODEStateInterpolatorAbstractTest
- doInterpolationInside(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.ODEStateInterpolatorAbstractTest
- doInterpolationInside(Field<T>, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.FieldODEStateInterpolatorAbstractTest
- doIteration(SimplexTableau) - 类中的方法 org.hipparchus.optim.linear.SimplexSolver
-
Runs one iteration of the Simplex method on the given model.
- DomainColoring - org.hipparchus.samples.complex中的类
-
Base class for domain coloring.
- DomainColoring(double) - 类的构造器 org.hipparchus.samples.complex.DomainColoring
-
Simple constructor.
- doNbPointsTest() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsFieldIntegratorAbstractTest
- doNbPointsTest() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsIntegratorAbstractTest
- doNonFieldInterpolatorConsistency(Field<T>, double, double, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.FieldODEStateInterpolatorAbstractTest
- doOptimize() - 类中的方法 org.hipparchus.optim.BaseMultiStartMultivariateOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - 类中的方法 org.hipparchus.optim.BaseOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - 类中的方法 org.hipparchus.optim.linear.SimplexSolver
-
Performs the bulk of the optimization algorithm.
- doOptimize() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.PowellOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.SimplexOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - 类中的方法 org.hipparchus.optim.univariate.BrentOptimizer
-
Performs the bulk of the optimization algorithm.
- doOptimize() - 类中的方法 org.hipparchus.optim.univariate.MultiStartUnivariateOptimizer
-
Performs the bulk of the optimization algorithm.
- doPolynomial(int, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsIntegratorAbstractTest
- doPolynomial(Field<T>, int, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsFieldIntegratorAbstractTest
- doRestrictBothEnds(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.ODEStateInterpolatorAbstractTest
- doRestrictBothEnds(Field<T>, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.FieldODEStateInterpolatorAbstractTest
- doRestrictCurrent(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.ODEStateInterpolatorAbstractTest
- doRestrictCurrent(Field<T>, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.FieldODEStateInterpolatorAbstractTest
- doRestrictPrevious(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.ODEStateInterpolatorAbstractTest
- doRestrictPrevious(Field<T>, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.FieldODEStateInterpolatorAbstractTest
- DormandPrince54FieldIntegrator<T> - org.hipparchus.ode.nonstiff中的类
-
This class implements the 5(4) Dormand-Prince integrator for Ordinary Differential Equations.
- DormandPrince54FieldIntegrator(Field<T>, double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
-
Simple constructor.
- DormandPrince54FieldIntegrator(Field<T>, double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
-
Simple constructor.
- DormandPrince54FieldIntegratorTest - org.hipparchus.ode.nonstiff中的类
- DormandPrince54FieldIntegratorTest() - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegratorTest
- DormandPrince54FieldStateInterpolatorTest - org.hipparchus.ode.nonstiff中的类
- DormandPrince54FieldStateInterpolatorTest() - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince54FieldStateInterpolatorTest
- DormandPrince54Integrator - org.hipparchus.ode.nonstiff中的类
-
This class implements the 5(4) Dormand-Prince integrator for Ordinary Differential Equations.
- DormandPrince54Integrator(double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
Simple constructor.
- DormandPrince54Integrator(double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
Simple constructor.
- DormandPrince54IntegratorTest - org.hipparchus.ode.nonstiff中的类
- DormandPrince54IntegratorTest() - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince54IntegratorTest
- DormandPrince54StateInterpolatorTest - org.hipparchus.ode.nonstiff中的类
- DormandPrince54StateInterpolatorTest() - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince54StateInterpolatorTest
- DormandPrince853FieldIntegrator<T> - org.hipparchus.ode.nonstiff中的类
-
This class implements the 8(5,3) Dormand-Prince integrator for Ordinary Differential Equations.
- DormandPrince853FieldIntegrator(Field<T>, double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
-
Simple constructor.
- DormandPrince853FieldIntegrator(Field<T>, double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
-
Simple constructor.
- DormandPrince853FieldIntegratorTest - org.hipparchus.ode.nonstiff中的类
- DormandPrince853FieldIntegratorTest() - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegratorTest
- DormandPrince853FieldStateInterpolatorTest - org.hipparchus.ode.nonstiff中的类
- DormandPrince853FieldStateInterpolatorTest() - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince853FieldStateInterpolatorTest
- DormandPrince853Integrator - org.hipparchus.ode.nonstiff中的类
-
This class implements the 8(5,3) Dormand-Prince integrator for Ordinary Differential Equations.
- DormandPrince853Integrator(double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
Simple constructor.
- DormandPrince853Integrator(double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
Simple constructor.
- DormandPrince853IntegratorTest - org.hipparchus.ode.nonstiff中的类
- DormandPrince853IntegratorTest() - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince853IntegratorTest
- DormandPrince853StateInterpolatorTest - org.hipparchus.ode.nonstiff中的类
- DormandPrince853StateInterpolatorTest() - 类的构造器 org.hipparchus.ode.nonstiff.DormandPrince853StateInterpolatorTest
- doSolve() - 类中的方法 org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - 类中的方法 org.hipparchus.analysis.solvers.BaseSecantSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - 类中的方法 org.hipparchus.analysis.solvers.BisectionSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - 类中的方法 org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - 类中的方法 org.hipparchus.analysis.solvers.BrentSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - 类中的方法 org.hipparchus.analysis.solvers.LaguerreSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - 类中的方法 org.hipparchus.analysis.solvers.MullerSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - 类中的方法 org.hipparchus.analysis.solvers.MullerSolver2
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - 类中的方法 org.hipparchus.analysis.solvers.NewtonRaphsonSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - 类中的方法 org.hipparchus.analysis.solvers.RiddersSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolve() - 类中的方法 org.hipparchus.analysis.solvers.SecantSolver
-
Method for implementing actual optimization algorithms in derived classes.
- doSolveInterval() - 类中的方法 org.hipparchus.analysis.solvers.BaseSecantSolver
-
Find a root and return the containing interval.
- doSolveInterval() - 类中的方法 org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolver
-
Find a root and return the containing interval.
- doTestBackward(double, double, double, String) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestBackward(double, double, double, String) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestBackward(Field<T>, double, double, double, String) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestBackward(Field<T>, double, double, double, String) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestBigStep(double, double, double, String) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestBigStep(Field<T>, double, double, double, String) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestComposeField(double[]) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructureAbstractTest
- doTestComposePrimitive(double[]) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructureAbstractTest
- doTestDecreasingSteps(double, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestDecreasingSteps(Field<T>, double, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestDerivativesConsistency(double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestDerivativesConsistency(Field<T>, double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestEbeBinaryOperation(RealVectorAbstractTest.BinaryOperation, boolean, boolean) - 类中的方法 org.hipparchus.linear.RealVectorAbstractTest
- doTestEvents(double, String) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestEvents(Field<T>, double, String) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestEventsErrors(Field<T>) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestEventsNoConvergence(Field<T>) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestForwardBackwardExceptions() - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestForwardBackwardExceptions(Field<T>) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestHypotNoOverflow(int) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructureAbstractTest
- doTestIncreasingTolerance(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsIntegratorAbstractTest
- doTestIncreasingTolerance(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestIncreasingTolerance(Field<T>, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsFieldIntegratorAbstractTest
- doTestIncreasingTolerance(Field<T>, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestKepler(double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestKepler(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestKepler(Field<T>, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestKepler(Field<T>, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestLinearCombination1DoubleDS(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructureAbstractTest
- doTestLinearCombination1DSDS(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructureAbstractTest
- doTestLinearCombination1FieldDS(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructureAbstractTest
- doTestLinearCombinationReference(DoubleFunction<T>, double, double) - 类中的方法 org.hipparchus.CalculusFieldElementAbstractTest
- doTestMinStep(Field<T>) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestMissedEndEvent(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestMissedEndEvent(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestMissedEndEvent(Field<T>, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestNonFieldIntegratorConsistency(Field<T>) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestNonFieldIntegratorConsistency(Field<T>) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestPartialDerivatives(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestPartialDerivatives(double, double[]) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestPartialDerivatives(double, double[]) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestResetAfterStep(int, int) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestResetAfterStep(Field<T>, int, int) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestRootNSingularity(boolean) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructureAbstractTest
- doTestSanityChecks() - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestSanityChecks(Field<T>) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestSanityChecks(Field<T>) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestSecondaryEquations(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsIntegratorAbstractTest
- doTestSecondaryEquations(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestSecondaryEquations(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestSecondaryEquations(Field<T>, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsFieldIntegratorAbstractTest
- doTestSecondaryEquations(Field<T>, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestSecondaryEquations(Field<T>, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestSerialization(int, double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestSingleStep(double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestSingleStep(Field<T>, double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestSmallStep(double, double, double, String) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestSmallStep(Field<T>, double, double, double, String) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestStartFailure() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsIntegratorAbstractTest
- doTestStartFailure(Field<T>) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsFieldIntegratorAbstractTest
- doTestStepEnd(int, String) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestStepEnd(Field<T>, int, String) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestStepSize(double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestStepSize(Field<T>, double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestStopAfterStep(int, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestStopAfterStep(Field<T>, int, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestStRD(StatisticalReferenceDataset, double, double) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractSequentialLeastSquaresOptimizerAbstractTest
- doTestStRD(StatisticalReferenceDataset, LeastSquaresOptimizer, double, double) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractLeastSquaresOptimizerAbstractTest
- doTestTooLargeFirstStep() - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestTooLargeFirstStep(Field<T>) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestTorqueFreeMotion(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestTorqueFreeMotion(Field<T>, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestTorqueFreeMotionIssue230(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestTorqueFreeMotionIssue230(Field<T>, double, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestTorqueFreeMotionOmegaOnly(double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestTorqueFreeMotionOmegaOnly(Field<T>, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegratorAbstractTest
- doTestUnstableDerivative(double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- doTestUnstableDerivative(double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegratorAbstractTest
- doTestUnstableDerivative(Field<T>, double) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegratorAbstractTest
- doTestVariableSteps(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegratorAbstractTest
- dotProduct(Quaternion) - 类中的方法 org.hipparchus.complex.Quaternion
-
Computes the dot-product of the instance by a quaternion.
- dotProduct(Quaternion, Quaternion) - 类中的静态方法 org.hipparchus.complex.Quaternion
-
Computes the dot-product of two quaternions.
- dotProduct(FieldVector3D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the dot-product of the instance and another vector.
- dotProduct(FieldVector3D<T>, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the dot-product of two vectors.
- dotProduct(FieldVector3D<T>, Vector3D) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the dot-product of two vectors.
- dotProduct(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector3D, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the dot-product of two vectors.
- dotProduct(Vector3D, Vector3D) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the dot-product of two vectors.
- dotProduct(FieldVector2D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector2D) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector<Euclidean1D, Vector1D>) - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector<Euclidean3D, Vector3D>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector<Euclidean2D, Vector2D>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the dot-product of the instance and another vector.
- dotProduct(Vector<S, V>) - 接口中的方法 org.hipparchus.geometry.Vector
-
Compute the dot-product of the instance and another vector.
- dotProduct(ArrayFieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Compute the dot product.
- dotProduct(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Compute the dot product.
- dotProduct(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- dotProduct(FieldVector<T>) - 接口中的方法 org.hipparchus.linear.FieldVector
-
Compute the dot product.
- dotProduct(FieldVector<T>) - 类中的方法 org.hipparchus.linear.SparseFieldVector
-
Compute the dot product.
- dotProduct(RealVector) - 类中的方法 org.hipparchus.linear.ArrayRealVector
-
Compute the dot product of this vector with
v
. - dotProduct(RealVector) - 类中的方法 org.hipparchus.linear.RealVector
-
Compute the dot product of this vector with
v
. - dotProduct(T[]) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- dotrap(int, String, Dfp, Dfp) - 类中的方法 org.hipparchus.dfp.Dfp
-
Raises a trap.
- DoublePoint - org.hipparchus.clustering中的类
-
A simple implementation of
Clusterable
for points with double coordinates. - DoublePoint(double[]) - 类的构造器 org.hipparchus.clustering.DoublePoint
-
Build an instance wrapping an double array.
- DoublePoint(int[]) - 类的构造器 org.hipparchus.clustering.DoublePoint
-
Build an instance wrapping an integer array.
- doubleToString(double) - 类中的静态方法 org.hipparchus.util.RyuDouble
-
Convert a double to shortest string representation, preserving full accuracy.
- doubleToString(double, int, int) - 类中的静态方法 org.hipparchus.util.RyuDouble
-
Convert a double to shortest string representation, preserving full accuracy.
- doubleValue() - 类中的方法 org.hipparchus.fraction.BigFraction
-
Gets the fraction as a
double
. - doubleValue() - 类中的方法 org.hipparchus.fraction.Fraction
-
Gets the fraction as a
double
. - doubleValue() - 类中的方法 org.hipparchus.util.BigReal
-
Get the double value corresponding to the instance.
- doubleValue() - 类中的方法 org.hipparchus.util.Binary64
- DOWNSIDE - 枚举类 中的枚举常量 org.hipparchus.stat.descriptive.moment.SemiVariance.Direction
-
The DOWNSIDE Direction is used to specify that the observations below the cutoff point will be used to calculate SemiVariance
- DOWNSIDE_VARIANCE - 类中的静态变量 org.hipparchus.stat.descriptive.moment.SemiVariance
-
The DOWNSIDE Direction is used to specify that the observations below the cutoff point will be used to calculate SemiVariance
- dp - 类中的变量 org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunctionTest
-
Derivative of test polynomials -- 2x + 1
- dp - 类中的变量 org.hipparchus.analysis.polynomials.PolynomialSplineFunctionTest
-
Derivative of test polynomials -- 2x + 1
- ds() - 类中的方法 org.hipparchus.special.elliptic.jacobi.CopolarS
-
Get the value of the ds function.
- ds() - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldCopolarS
-
Get the value of the ds function.
- DSCompiler - org.hipparchus.analysis.differentiation中的类
-
Class holding "compiled" computation rules for derivative structures.
- DSCompilerTest - org.hipparchus.analysis.differentiation中的类
-
Test for class
DSCompiler
. - DSCompilerTest() - 类的构造器 org.hipparchus.analysis.differentiation.DSCompilerTest
- DSFactory - org.hipparchus.analysis.differentiation中的类
-
Factory for
DerivativeStructure
. - DSFactory(int, int) - 类的构造器 org.hipparchus.analysis.differentiation.DSFactory
-
Simple constructor.
- DSFactory.DSField - org.hipparchus.analysis.differentiation中的类
-
Field for {link DerivativeStructure} instances.
- DstNormalization - org.hipparchus.transform中的枚举类
-
This enumeration defines the various types of normalizations that can be applied to discrete sine transforms (DST).
- DummyFieldStepInterpolator<T> - org.hipparchus.ode.sampling中的类
- DummyFieldStepInterpolator(boolean, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - 类的构造器 org.hipparchus.ode.sampling.DummyFieldStepInterpolator
- DummyLocalizable - org.hipparchus.exception中的类
-
Dummy implementation of the
Localizable
interface, without localization. - DummyLocalizable(String) - 类的构造器 org.hipparchus.exception.DummyLocalizable
-
Simple constructor.
- DummyLocalizableTest - org.hipparchus.exception中的类
- DummyLocalizableTest() - 类的构造器 org.hipparchus.exception.DummyLocalizableTest
- DummyStepHandler - org.hipparchus.migration.ode.sampling中的类
-
已过时。as of 1.0, this class is not used anymore
- DummyStepInterpolator - org.hipparchus.ode.sampling中的类
-
This class is a step interpolator that does nothing.
- DummyStepInterpolator(boolean, ODEStateAndDerivative, ODEStateAndDerivative, ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - 类的构造器 org.hipparchus.ode.sampling.DummyStepInterpolator
-
Simple constructor.
- dump(IntervalsSet) - 类中的静态方法 org.hipparchus.geometry.partitioning.RegionDumper
-
Get a string representation of an
IntervalsSet
. - dump(PolyhedronsSet) - 类中的静态方法 org.hipparchus.geometry.partitioning.RegionDumper
-
Get a string representation of a
PolyhedronsSet
. - dump(PolygonsSet) - 类中的静态方法 org.hipparchus.geometry.partitioning.RegionDumper
-
Get a string representation of a
PolygonsSet
. - dump(ArcsSet) - 类中的静态方法 org.hipparchus.geometry.partitioning.RegionDumper
-
Get a string representation of an
ArcsSet
. - dump(SphericalPolygonsSet) - 类中的静态方法 org.hipparchus.geometry.partitioning.RegionDumper
-
Get a string representation of a
SphericalPolygonsSet
. - DUPLICATED_ABSCISSA_DIVISION_BY_ZERO - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
DUPLICATED_ABSCISSA_DIVISION_BY_ZERO.
- DUPLICATED_ABSCISSA_DIVISION_BY_ZERO - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。DUPLICATED_ABSCISSA_DIVISION_BY_ZERO.
- dvec1 - 类中的变量 org.hipparchus.linear.ArrayFieldVectorTest
- dvec1 - 类中的变量 org.hipparchus.linear.SparseFieldVectorTest
常量字段值|所有程序包|所有类和接口|序列化表格
MathIllegalArgumentException