索引
常量字段值|所有程序包|所有类和接口|序列化表格
O
- OBJECT_TRANSFORMATION - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OBJECT_TRANSFORMATION.
- OBJECT_TRANSFORMATION - 枚举类 中的枚举常量 org.hipparchus.migration.LocalizedMigrationFormats
-
已过时。OBJECT_TRANSFORMATION.
- ObjectiveFunction - org.hipparchus.optim.nonlinear.scalar中的类
-
Scalar function to be optimized.
- ObjectiveFunction(MultivariateFunction) - 类的构造器 org.hipparchus.optim.nonlinear.scalar.ObjectiveFunction
-
Simple constructor.
- ObjectiveFunctionGradient - org.hipparchus.optim.nonlinear.scalar中的类
-
Gradient of the scalar function to be optimized.
- ObjectiveFunctionGradient(MultivariateVectorFunction) - 类的构造器 org.hipparchus.optim.nonlinear.scalar.ObjectiveFunctionGradient
-
Simple constructor.
- OBSERVED_COUNTS_ALL_ZERO - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OBSERVED_COUNTS_ALL_ZERO.
- OBSERVED_COUNTS_ALL_ZERO - 枚举类 中的枚举常量 org.hipparchus.migration.LocalizedMigrationFormats
-
已过时。OBSERVED_COUNTS_ALL_ZERO.
- OBSERVED_COUNTS_BOTTH_ZERO_FOR_ENTRY - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
OBSERVED_COUNTS_BOTTH_ZERO_FOR_ENTRY.
- OBSERVED_COUNTS_BOTTH_ZERO_FOR_ENTRY - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OBSERVED_COUNTS_BOTTH_ZERO_FOR_ENTRY.
- OCTAVE_FORMAT - 类中的静态变量 org.hipparchus.linear.MatrixUtils
-
A format for
RealMatrix
objects compatible with octave. - ODEEventDetector - org.hipparchus.ode.events中的接口
-
This interface represents a detector for discrete events triggered during ODE integration.
- ODEEventHandler - org.hipparchus.ode.events中的接口
-
This interface represents a handler for discrete events triggered during ODE integration.
- ODEFixedStepHandler - org.hipparchus.ode.sampling中的接口
-
This interface represents a handler that should be called after each successful fixed step.
- ODEIntegrator - org.hipparchus.ode中的接口
-
This interface represents a first order integrator for differential equations.
- ODEJacobiansProvider - org.hipparchus.ode中的接口
-
Interface expanding
first order differential equations
in order to compute exactly the Jacobian matrices forpartial derivatives equations
. - ODEState - org.hipparchus.ode中的类
-
Container for time, main and secondary state vectors.
- ODEState(double, double[]) - 类的构造器 org.hipparchus.ode.ODEState
-
Simple constructor.
- ODEState(double, double[], double[][]) - 类的构造器 org.hipparchus.ode.ODEState
-
Simple constructor.
- ODEStateAndDerivative - org.hipparchus.ode中的类
-
Container for time, main and secondary state vectors as well as their derivatives.
- ODEStateAndDerivative(double, double[], double[]) - 类的构造器 org.hipparchus.ode.ODEStateAndDerivative
-
Simple constructor.
- ODEStateAndDerivative(double, double[], double[], double[][], double[][]) - 类的构造器 org.hipparchus.ode.ODEStateAndDerivative
-
Simple constructor.
- ODEStateInterpolator - org.hipparchus.ode.sampling中的接口
-
This interface represents an interpolator over the last step during an ODE integration.
- ODEStateInterpolatorAbstractTest - org.hipparchus.ode.nonstiff中的类
- ODEStateInterpolatorAbstractTest() - 类的构造器 org.hipparchus.ode.nonstiff.ODEStateInterpolatorAbstractTest
- ODEStateInterpolatorAbstractTest.ReferenceODE - org.hipparchus.ode.nonstiff中的接口
- ODEStepEndHandler - org.hipparchus.ode.events中的接口
-
This interface represents a handler for discrete events triggered during ODE integration at each step end.
- ODEStepHandler - org.hipparchus.ode.sampling中的接口
-
This interface represents a handler that should be called after each successful step.
- of(LeastSquaresProblem.Evaluation, int, int) - 接口中的静态方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresOptimizer.Optimum
-
Create a new optimum from an evaluation and the values of the counters.
- of(RandomGenerator) - 类中的静态方法 org.hipparchus.random.RandomAdaptor
-
Factory method to create a
Random
using the suppliedRandomGenerator
. - of(RandomGenerator) - 类中的静态方法 org.hipparchus.random.RandomDataGenerator
-
Factory method to create a
RandomData
instance using the suppliedRandomGenerator
. - OLSMultipleLinearRegression - org.hipparchus.stat.regression中的类
-
Implements ordinary least squares (OLS) to estimate the parameters of a multiple linear regression model.
- OLSMultipleLinearRegression() - 类的构造器 org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Create an empty OLSMultipleLinearRegression instance.
- OLSMultipleLinearRegression(double) - 类的构造器 org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Create an empty OLSMultipleLinearRegression instance, using the given singularity threshold for the QR decomposition.
- OLSMultipleLinearRegressionTest - org.hipparchus.stat.regression中的类
- OLSMultipleLinearRegressionTest() - 类的构造器 org.hipparchus.stat.regression.OLSMultipleLinearRegressionTest
- ONE - 类中的静态变量 org.hipparchus.complex.Complex
-
A complex number representing "1.0 + 0.0i".
- ONE - 类中的静态变量 org.hipparchus.fraction.BigFraction
-
A fraction representing "1".
- ONE - 类中的静态变量 org.hipparchus.fraction.Fraction
-
A fraction representing "1".
- ONE - 类中的静态变量 org.hipparchus.geometry.euclidean.oned.Vector1D
-
Unit (coordinates: 1).
- ONE - 类中的静态变量 org.hipparchus.util.BigReal
-
A big real representing 1.
- ONE - 类中的静态变量 org.hipparchus.util.Binary64
-
The constant value of
1d
as aBinary64
. - ONE_FIFTH - 类中的静态变量 org.hipparchus.fraction.BigFraction
-
A fraction representing "1/5".
- ONE_FIFTH - 类中的静态变量 org.hipparchus.fraction.Fraction
-
A fraction representing "1/5".
- ONE_HALF - 类中的静态变量 org.hipparchus.fraction.BigFraction
-
A fraction representing "1/2".
- ONE_HALF - 类中的静态变量 org.hipparchus.fraction.Fraction
-
A fraction representing "1/2".
- ONE_QUARTER - 类中的静态变量 org.hipparchus.fraction.BigFraction
-
A fraction representing "1/4".
- ONE_QUARTER - 类中的静态变量 org.hipparchus.fraction.Fraction
-
A fraction representing "1/4".
- ONE_THIRD - 类中的静态变量 org.hipparchus.fraction.BigFraction
-
A fraction representing "1/3".
- ONE_THIRD - 类中的静态变量 org.hipparchus.fraction.Fraction
-
A fraction representing "1/3".
- OneWayAnova - org.hipparchus.stat.inference中的类
-
Implements one-way ANOVA (analysis of variance) statistics.
- OneWayAnova() - 类的构造器 org.hipparchus.stat.inference.OneWayAnova
-
Empty constructor.
- oneWayAnovaFValue(Collection<double[]>) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
-
Computes the ANOVA F-value for a collection of
double[]
arrays. - oneWayAnovaPValue(Collection<double[]>) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
-
Computes the ANOVA P-value for a collection of
double[]
arrays. - oneWayAnovaTest(Collection<double[]>, double) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
-
Performs an ANOVA test, evaluating the null hypothesis that there is no difference among the means of the data categories.
- OneWayAnovaTest - org.hipparchus.stat.inference中的类
-
Test cases for the OneWayAnovaImpl class.
- OneWayAnovaTest() - 类的构造器 org.hipparchus.stat.inference.OneWayAnovaTest
- OpenIntToDoubleHashMap - org.hipparchus.util中的类
-
Open addressed map from int to double.
- OpenIntToDoubleHashMap() - 类的构造器 org.hipparchus.util.OpenIntToDoubleHashMap
-
Build an empty map with default size and using NaN for missing entries.
- OpenIntToDoubleHashMap(double) - 类的构造器 org.hipparchus.util.OpenIntToDoubleHashMap
-
Build an empty map with default size
- OpenIntToDoubleHashMap(int) - 类的构造器 org.hipparchus.util.OpenIntToDoubleHashMap
-
Build an empty map with specified size and using NaN for missing entries.
- OpenIntToDoubleHashMap(int, double) - 类的构造器 org.hipparchus.util.OpenIntToDoubleHashMap
-
Build an empty map with specified size.
- OpenIntToDoubleHashMap(OpenIntToDoubleHashMap) - 类的构造器 org.hipparchus.util.OpenIntToDoubleHashMap
-
Copy constructor.
- OpenIntToDoubleHashMap.Iterator - org.hipparchus.util中的类
-
Iterator class for the map.
- OpenIntToDoubleHashMapTest - org.hipparchus.util中的类
-
Test cases for the
OpenIntToDoubleHashMap
. - OpenIntToDoubleHashMapTest() - 类的构造器 org.hipparchus.util.OpenIntToDoubleHashMapTest
- OpenIntToFieldHashMap<T> - org.hipparchus.util中的类
-
Open addressed map from int to FieldElement.
- OpenIntToFieldHashMap(Field<T>) - 类的构造器 org.hipparchus.util.OpenIntToFieldHashMap
-
Build an empty map with default size and using zero for missing entries.
- OpenIntToFieldHashMap(Field<T>, int) - 类的构造器 org.hipparchus.util.OpenIntToFieldHashMap
-
Build an empty map with specified size and using zero for missing entries.
- OpenIntToFieldHashMap(Field<T>, int, T) - 类的构造器 org.hipparchus.util.OpenIntToFieldHashMap
-
Build an empty map with specified size.
- OpenIntToFieldHashMap(Field<T>, T) - 类的构造器 org.hipparchus.util.OpenIntToFieldHashMap
-
Build an empty map with default size
- OpenIntToFieldHashMap(OpenIntToFieldHashMap<T>) - 类的构造器 org.hipparchus.util.OpenIntToFieldHashMap
-
Copy constructor.
- OpenIntToFieldHashMap.Iterator - org.hipparchus.util中的类
-
Iterator class for the map.
- OpenIntToFieldTest - org.hipparchus.util中的类
- OpenIntToFieldTest() - 类的构造器 org.hipparchus.util.OpenIntToFieldTest
- OpenMapEntry(OpenIntToDoubleHashMap.Iterator) - 类的构造器 org.hipparchus.linear.OpenMapRealVector.OpenMapEntry
-
Build an entry from an iterator point to an element.
- OpenMapRealMatrix - org.hipparchus.linear中的类
-
Sparse matrix implementation based on an open addressed map.
- OpenMapRealMatrix(int, int) - 类的构造器 org.hipparchus.linear.OpenMapRealMatrix
-
Build a sparse matrix with the supplied row and column dimensions.
- OpenMapRealMatrix(OpenMapRealMatrix) - 类的构造器 org.hipparchus.linear.OpenMapRealMatrix
-
Build a matrix by copying another one.
- OpenMapRealMatrixTest - org.hipparchus.linear中的类
- OpenMapRealMatrixTest() - 类的构造器 org.hipparchus.linear.OpenMapRealMatrixTest
- OpenMapRealVector - org.hipparchus.linear中的类
-
This class implements the
RealVector
interface with aOpenIntToDoubleHashMap
backing store. - OpenMapRealVector() - 类的构造器 org.hipparchus.linear.OpenMapRealVector
-
Build a 0-length vector.
- OpenMapRealVector(double[]) - 类的构造器 org.hipparchus.linear.OpenMapRealVector
-
Create from an array.
- OpenMapRealVector(double[], double) - 类的构造器 org.hipparchus.linear.OpenMapRealVector
-
Create from an array, specifying zero tolerance.
- OpenMapRealVector(int) - 类的构造器 org.hipparchus.linear.OpenMapRealVector
-
Construct a vector of zeroes.
- OpenMapRealVector(int, double) - 类的构造器 org.hipparchus.linear.OpenMapRealVector
-
Construct a vector of zeroes, specifying zero tolerance.
- OpenMapRealVector(int, int) - 类的构造器 org.hipparchus.linear.OpenMapRealVector
-
Build a vector with known the sparseness (for advanced use only).
- OpenMapRealVector(int, int, double) - 类的构造器 org.hipparchus.linear.OpenMapRealVector
-
Build a vector with known the sparseness and zero tolerance setting (for advanced use only).
- OpenMapRealVector(Double[]) - 类的构造器 org.hipparchus.linear.OpenMapRealVector
-
Create from an array.
- OpenMapRealVector(Double[], double) - 类的构造器 org.hipparchus.linear.OpenMapRealVector
-
Create from an array.
- OpenMapRealVector(OpenMapRealVector) - 类的构造器 org.hipparchus.linear.OpenMapRealVector
-
Copy constructor.
- OpenMapRealVector(OpenMapRealVector, int) - 类的构造器 org.hipparchus.linear.OpenMapRealVector
-
Build a resized vector, for use with append.
- OpenMapRealVector(RealVector) - 类的构造器 org.hipparchus.linear.OpenMapRealVector
-
Generic copy constructor.
- OpenMapRealVector.OpenMapEntry - org.hipparchus.linear中的类
-
Implementation of
Entry
optimized for OpenMap. - OpenMapRealVector.OpenMapSparseIterator - org.hipparchus.linear中的类
-
Iterator class to do iteration over just the non-zero elements.
- OpenMapSparseIterator() - 类的构造器 org.hipparchus.linear.OpenMapRealVector.OpenMapSparseIterator
-
Simple constructor.
- operate(double[]) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(double[]) - 类中的方法 org.hipparchus.linear.Array2DRowRealMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(double[]) - 类中的方法 org.hipparchus.linear.BlockRealMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(double[]) - 类中的方法 org.hipparchus.linear.DiagonalMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(double[]) - 接口中的方法 org.hipparchus.linear.RealMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(FieldVector<T>) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(FieldVector<T>) - 接口中的方法 org.hipparchus.linear.FieldMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(RealVector) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(RealVector) - 类中的方法 org.hipparchus.linear.HilbertMatrix
-
Returns the result of multiplying
this
by the vectorx
. - operate(RealVector) - 类中的方法 org.hipparchus.linear.InverseHilbertMatrix
-
Returns the result of multiplying
this
by the vectorx
. - operate(RealVector) - 类中的方法 org.hipparchus.linear.JacobiPreconditioner
-
Returns the result of multiplying
this
by the vectorx
. - operate(RealVector) - 接口中的方法 org.hipparchus.linear.RealLinearOperator
-
Returns the result of multiplying
this
by the vectorx
. - operate(RealVector) - 接口中的方法 org.hipparchus.linear.RealMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(T[]) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(T[]) - 类中的方法 org.hipparchus.linear.Array2DRowFieldMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(T[]) - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
-
Returns the result of multiplying this by the vector
v
. - operate(T[]) - 接口中的方法 org.hipparchus.linear.FieldMatrix
-
Returns the result of multiplying this by the vector
v
. - operateTranspose(RealVector) - 接口中的方法 org.hipparchus.linear.RealLinearOperator
-
Returns the result of multiplying the transpose of
this
operator by the vectorx
(optional operation). - OPERATOR - 类中的静态变量 org.hipparchus.linear.ConjugateGradient
-
Key for the exception context.
- oppositeRelationship() - 枚举类中的方法 org.hipparchus.optim.linear.Relationship
-
Gets the relationship obtained when multiplying all coefficients by -1.
- OptimizationData - org.hipparchus.optim中的接口
-
Marker interface.
- OptimizationProblem<P> - org.hipparchus.optim中的接口
-
Common settings for all optimization problems.
- optimize() - 类中的方法 org.hipparchus.optim.BaseOptimizer
-
Performs the optimization.
- optimize(LeastSquaresProblem) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
-
Solve the non-linear least squares problem.
- optimize(LeastSquaresProblem) - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresOptimizer
-
Solve the non-linear least squares problem.
- optimize(LeastSquaresProblem) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Solve the non-linear least squares problem.
- optimize(LeastSquaresProblem) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
-
Solve the non-linear least squares problem.
- optimize(OptimizationData...) - 类中的方法 org.hipparchus.optim.BaseMultiStartMultivariateOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - 类中的方法 org.hipparchus.optim.BaseMultivariateOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - 类中的方法 org.hipparchus.optim.BaseOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - 类中的方法 org.hipparchus.optim.linear.LinearOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - 类中的方法 org.hipparchus.optim.linear.SimplexSolver
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.GradientMultivariateOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.MultivariateOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.SimplexOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - 类中的方法 org.hipparchus.optim.univariate.MultiStartUnivariateOptimizer
-
Stores data and performs the optimization.
- optimize(OptimizationData...) - 类中的方法 org.hipparchus.optim.univariate.UnivariateOptimizer
-
Stores data and performs the optimization.
- optimizer - 类中的变量 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractLeastSquaresOptimizerAbstractTest
-
The subject under test.
- optimizer - 类中的变量 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractSequentialLeastSquaresOptimizerAbstractTest
-
The subject under test.
- OrderedComplexEigenDecomposition - org.hipparchus.linear中的类
-
Given a matrix A, it computes a complex eigen decomposition A = VDV^{T}.
- OrderedComplexEigenDecomposition(RealMatrix) - 类的构造器 org.hipparchus.linear.OrderedComplexEigenDecomposition
-
Constructor for the decomposition.
- OrderedComplexEigenDecomposition(RealMatrix, double, double, double) - 类的构造器 org.hipparchus.linear.OrderedComplexEigenDecomposition
-
Constructor for decomposition.
- OrderedComplexEigenDecomposition(RealMatrix, double, double, double, Comparator<Complex>) - 类的构造器 org.hipparchus.linear.OrderedComplexEigenDecomposition
-
Constructor for decomposition.
- OrderedComplexEigenDecompositionTest - org.hipparchus.linear中的类
- OrderedComplexEigenDecompositionTest() - 类的构造器 org.hipparchus.linear.OrderedComplexEigenDecompositionTest
- OrdinaryDifferentialEquation - org.hipparchus.ode中的接口
-
This interface represents a first order differential equations set.
- org.hipparchus - 程序包 org.hipparchus
-
Common classes used throughout the Hipparchus library.
- org.hipparchus.analysis - 程序包 org.hipparchus.analysis
-
Parent package for common numerical analysis procedures, including root finding, function interpolation and integration.
- org.hipparchus.analysis.differentiation - 程序包 org.hipparchus.analysis.differentiation
-
This package holds the main interfaces and basic building block classes dealing with differentiation.
- org.hipparchus.analysis.function - 程序包 org.hipparchus.analysis.function
-
The
function
package contains function objects that wrap the methods contained inMath
, as well as common mathematical functions such as the gaussian and sinc functions. - org.hipparchus.analysis.integration - 程序包 org.hipparchus.analysis.integration
-
Numerical integration (quadrature) algorithms for univariate real functions.
- org.hipparchus.analysis.integration.gauss - 程序包 org.hipparchus.analysis.integration.gauss
-
Gauss family of quadrature schemes.
- org.hipparchus.analysis.interpolation - 程序包 org.hipparchus.analysis.interpolation
-
Univariate real functions interpolation algorithms.
- org.hipparchus.analysis.polynomials - 程序包 org.hipparchus.analysis.polynomials
-
Univariate real polynomials implementations, seen as differentiable univariate real functions.
- org.hipparchus.analysis.solvers - 程序包 org.hipparchus.analysis.solvers
-
Root finding algorithms, for univariate real functions.
- org.hipparchus.clustering - 程序包 org.hipparchus.clustering
-
Clustering algorithms.
- org.hipparchus.clustering.distance - 程序包 org.hipparchus.clustering.distance
-
Common distance measures.
- org.hipparchus.clustering.evaluation - 程序包 org.hipparchus.clustering.evaluation
-
Cluster evaluation methods.
- org.hipparchus.complex - 程序包 org.hipparchus.complex
-
Complex number type and implementations of complex transcendental functions.
- org.hipparchus.dfp - 程序包 org.hipparchus.dfp
-
Decimal floating point library for Java
- org.hipparchus.distribution - 程序包 org.hipparchus.distribution
-
Interfaces and implementations of common discrete and continuous distributions.
- org.hipparchus.distribution.continuous - 程序包 org.hipparchus.distribution.continuous
-
Implementations of common continuous distributions.
- org.hipparchus.distribution.discrete - 程序包 org.hipparchus.distribution.discrete
-
Implementations of common discrete distributions.
- org.hipparchus.distribution.multivariate - 程序包 org.hipparchus.distribution.multivariate
-
Implementations of multivariate distributions.
- org.hipparchus.exception - 程序包 org.hipparchus.exception
-
Specialized exceptions for algorithms errors.
- org.hipparchus.filtering.kalman - 程序包 org.hipparchus.filtering.kalman
-
Kalman filter.
- org.hipparchus.filtering.kalman.extended - 程序包 org.hipparchus.filtering.kalman.extended
-
Kalman filter implementation for non-linear processes.
- org.hipparchus.filtering.kalman.linear - 程序包 org.hipparchus.filtering.kalman.linear
-
Kalman filter implementation for linear processes.
- org.hipparchus.filtering.kalman.unscented - 程序包 org.hipparchus.filtering.kalman.unscented
-
Unscented Kalman filter implementation.
- org.hipparchus.fitting - 程序包 org.hipparchus.fitting
-
Classes to perform curve fitting.
- org.hipparchus.fraction - 程序包 org.hipparchus.fraction
-
Fraction number type and fraction number formatting.
- org.hipparchus.geometry - 程序包 org.hipparchus.geometry
-
This package is the top level package for geometry.
- org.hipparchus.geometry.enclosing - 程序包 org.hipparchus.geometry.enclosing
-
This package provides interfaces and classes related to the smallest enclosing ball problem.
- org.hipparchus.geometry.euclidean.oned - 程序包 org.hipparchus.geometry.euclidean.oned
-
This package provides basic 1D geometry components.
- org.hipparchus.geometry.euclidean.threed - 程序包 org.hipparchus.geometry.euclidean.threed
-
This package provides basic 3D geometry components.
- org.hipparchus.geometry.euclidean.twod - 程序包 org.hipparchus.geometry.euclidean.twod
-
This package provides basic 2D geometry components.
- org.hipparchus.geometry.euclidean.twod.hull - 程序包 org.hipparchus.geometry.euclidean.twod.hull
-
This package provides algorithms to generate the convex hull for a set of points in an two-dimensional euclidean space.
- org.hipparchus.geometry.hull - 程序包 org.hipparchus.geometry.hull
-
This package provides interfaces and classes related to the convex hull problem.
- org.hipparchus.geometry.partitioning - 程序包 org.hipparchus.geometry.partitioning
-
This package provides classes to implement Binary Space Partition trees.
- org.hipparchus.geometry.spherical.oned - 程序包 org.hipparchus.geometry.spherical.oned
-
This package provides basic geometry components on the 1-sphere.
- org.hipparchus.geometry.spherical.twod - 程序包 org.hipparchus.geometry.spherical.twod
-
This package provides basic geometry components on the 2-sphere.
- org.hipparchus.linear - 程序包 org.hipparchus.linear
-
Linear algebra support.
- org.hipparchus.migration - 程序包 org.hipparchus.migration
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.exception - 程序包 org.hipparchus.migration.exception
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.exception.util - 程序包 org.hipparchus.migration.exception.util
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.genetics - 程序包 org.hipparchus.migration.genetics
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.geometry.euclidean - 程序包 org.hipparchus.migration.geometry.euclidean
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.geometry.euclidean.threed - 程序包 org.hipparchus.migration.geometry.euclidean.threed
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.linear - 程序包 org.hipparchus.migration.linear
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.ode - 程序包 org.hipparchus.migration.ode
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.ode.events - 程序包 org.hipparchus.migration.ode.events
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.ode.sampling - 程序包 org.hipparchus.migration.ode.sampling
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.optim.linear - 程序包 org.hipparchus.migration.optim.linear
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.migration.stat.regression - 程序包 org.hipparchus.migration.stat.regression
-
This package provides migration classes from Apache Commons Math to Hipparchus.
- org.hipparchus.ode - 程序包 org.hipparchus.ode
-
This package provides classes to solve Ordinary Differential Equations problems.
- org.hipparchus.ode.events - 程序包 org.hipparchus.ode.events
-
Events
- org.hipparchus.ode.nonstiff - 程序包 org.hipparchus.ode.nonstiff
-
This package provides classes to solve non-stiff Ordinary Differential Equations problems.
- org.hipparchus.ode.sampling - 程序包 org.hipparchus.ode.sampling
-
This package provides classes to handle sampling steps during Ordinary Differential Equations integration.
- org.hipparchus.optim - 程序包 org.hipparchus.optim
-
Generally, optimizers are algorithms that will either
minimize
ormaximize
a scalar function, called theobjective function
. - org.hipparchus.optim.linear - 程序包 org.hipparchus.optim.linear
-
Optimization algorithms for linear constrained problems.
- org.hipparchus.optim.nonlinear.scalar - 程序包 org.hipparchus.optim.nonlinear.scalar
-
Algorithms for optimizing a scalar function.
- org.hipparchus.optim.nonlinear.scalar.gradient - 程序包 org.hipparchus.optim.nonlinear.scalar.gradient
-
This package provides optimization algorithms that require derivatives.
- org.hipparchus.optim.nonlinear.scalar.noderiv - 程序包 org.hipparchus.optim.nonlinear.scalar.noderiv
-
This package provides optimization algorithms that do not require derivatives.
- org.hipparchus.optim.nonlinear.vector.leastsquares - 程序包 org.hipparchus.optim.nonlinear.vector.leastsquares
-
This package provides algorithms that minimize the residuals between observations and model values.
- org.hipparchus.optim.univariate - 程序包 org.hipparchus.optim.univariate
-
One-dimensional optimization algorithms.
- org.hipparchus.random - 程序包 org.hipparchus.random
-
Random number and random data generators.
- org.hipparchus.samples - 程序包 org.hipparchus.samples
-
Various examples.
- org.hipparchus.samples.clustering - 程序包 org.hipparchus.samples.clustering
-
Clustering examples.
- org.hipparchus.samples.complex - 程序包 org.hipparchus.samples.complex
-
Complex functions plots.
- org.hipparchus.samples.geometry - 程序包 org.hipparchus.samples.geometry
-
Geometry examples.
- org.hipparchus.special - 程序包 org.hipparchus.special
-
Implementations of special functions such as Beta and Gamma.
- org.hipparchus.special.elliptic.carlson - 程序包 org.hipparchus.special.elliptic.carlson
-
Implementations of Carlson elliptic integrals.
- org.hipparchus.special.elliptic.jacobi - 程序包 org.hipparchus.special.elliptic.jacobi
-
Implementations of Jacobi elliptic functions.
- org.hipparchus.special.elliptic.legendre - 程序包 org.hipparchus.special.elliptic.legendre
-
Implementations of Legendre elliptic integrals.
- org.hipparchus.stat - 程序包 org.hipparchus.stat
-
Data storage, manipulation and summary routines.
- org.hipparchus.stat.correlation - 程序包 org.hipparchus.stat.correlation
-
Correlations/Covariance computations.
- org.hipparchus.stat.data - 程序包 org.hipparchus.stat.data
- org.hipparchus.stat.descriptive - 程序包 org.hipparchus.stat.descriptive
-
Generic univariate and multivariate summary statistic objects.
- org.hipparchus.stat.descriptive.moment - 程序包 org.hipparchus.stat.descriptive.moment
-
Summary statistics based on moments.
- org.hipparchus.stat.descriptive.rank - 程序包 org.hipparchus.stat.descriptive.rank
-
Summary statistics based on ranks.
- org.hipparchus.stat.descriptive.summary - 程序包 org.hipparchus.stat.descriptive.summary
-
Other summary statistics.
- org.hipparchus.stat.descriptive.vector - 程序包 org.hipparchus.stat.descriptive.vector
-
Multivariate statistics.
- org.hipparchus.stat.fitting - 程序包 org.hipparchus.stat.fitting
-
Statistical methods for fitting distributions.
- org.hipparchus.stat.inference - 程序包 org.hipparchus.stat.inference
-
Classes providing hypothesis testing.
- org.hipparchus.stat.interval - 程序包 org.hipparchus.stat.interval
-
Utilities to calculate binomial proportion confidence intervals.
- org.hipparchus.stat.projection - 程序包 org.hipparchus.stat.projection
-
Parent package for projections like decomposition (principal component analysis).
- org.hipparchus.stat.ranking - 程序包 org.hipparchus.stat.ranking
-
Classes providing rank transformations.
- org.hipparchus.stat.regression - 程序包 org.hipparchus.stat.regression
-
Statistical routines involving multivariate data.
- org.hipparchus.transform - 程序包 org.hipparchus.transform
-
Implementations of transform methods, including Fast Fourier transforms.
- org.hipparchus.util - 程序包 org.hipparchus.util
-
Convenience routines and common data structures used throughout the Hipparchus library.
- orientation(FieldVector2D<T>, FieldVector2D<T>, FieldVector2D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the orientation of a triplet of points.
- orientation(Vector2D, Vector2D, Vector2D) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the orientation of a triplet of points.
- OrientedPoint - org.hipparchus.geometry.euclidean.oned中的类
-
This class represents a 1D oriented hyperplane.
- OrientedPoint(Vector1D, boolean, double) - 类的构造器 org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Simple constructor.
- orthogonal() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get a vector orthogonal to the instance.
- orthogonal() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get a vector orthogonal to the instance.
- ORTHOGONAL_DCT_I - 枚举类 中的枚举常量 org.hipparchus.transform.DctNormalization
-
Should be passed to the constructor of
FastCosineTransformer
to use the orthogonal normalization convention. - ORTHOGONAL_DST_I - 枚举类 中的枚举常量 org.hipparchus.transform.DstNormalization
-
Should be passed to the constructor of
FastSineTransformer
to use the orthogonal normalization convention. - orthonormalize(List<RealVector>, double, DependentVectorsHandler) - 类中的静态方法 org.hipparchus.linear.MatrixUtils
-
Orthonormalize a list of vectors.
- orthonormalize(Field<T>, List<FieldVector<T>>, T, DependentVectorsHandler) - 类中的静态方法 org.hipparchus.linear.MatrixUtils
-
Orthonormalize a list of vectors.
- OUT_OF_BOUND_SIGNIFICANCE_LEVEL - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OUT_OF_BOUND_SIGNIFICANCE_LEVEL.
- OUT_OF_BOUND_SIGNIFICANCE_LEVEL - 枚举类 中的枚举常量 org.hipparchus.stat.LocalizedStatFormats
-
OUT_OF_BOUND_SIGNIFICANCE_LEVEL.
- OUT_OF_BOUNDS_CONFIDENCE_LEVEL - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OUT_OF_BOUNDS_CONFIDENCE_LEVEL.
- OUT_OF_BOUNDS_CONFIDENCE_LEVEL - 枚举类 中的枚举常量 org.hipparchus.stat.LocalizedStatFormats
-
OUT_OF_BOUNDS_CONFIDENCE_LEVEL.
- OUT_OF_BOUNDS_QUANTILE_VALUE - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OUT_OF_BOUNDS_QUANTILE_VALUE.
- OUT_OF_BOUNDS_QUANTILE_VALUE - 枚举类 中的枚举常量 org.hipparchus.stat.LocalizedStatFormats
-
OUT_OF_BOUNDS_QUANTILE_VALUE.
- OUT_OF_ORDER_ABSCISSA_ARRAY - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OUT_OF_ORDER_ABSCISSA_ARRAY.
- OUT_OF_ORDER_ABSCISSA_ARRAY - 枚举类 中的枚举常量 org.hipparchus.migration.LocalizedMigrationFormats
-
已过时。OUT_OF_ORDER_ABSCISSA_ARRAY.
- OUT_OF_PLANE - 枚举类 中的枚举常量 org.hipparchus.geometry.LocalizedGeometryFormats
-
OUT_OF_PLANE.
- OUT_OF_PLANE - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OUT_OF_PLANE.
- OUT_OF_RANGE - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
OUT_OF_RANGE.
- OUT_OF_RANGE - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OUT_OF_RANGE.
- OUT_OF_RANGE_LEFT - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
OUT_OF_RANGE_LEFT.
- OUT_OF_RANGE_LEFT - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OUT_OF_RANGE_LEFT.
- OUT_OF_RANGE_RIGHT - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OUT_OF_RANGE_RIGHT.
- OUT_OF_RANGE_RIGHT - 枚举类 中的枚举常量 org.hipparchus.migration.LocalizedMigrationFormats
-
已过时。OUT_OF_RANGE_RIGHT.
- OUT_OF_RANGE_ROOT_OF_UNITY_INDEX - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
OUT_OF_RANGE_ROOT_OF_UNITY_INDEX.
- OUT_OF_RANGE_ROOT_OF_UNITY_INDEX - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OUT_OF_RANGE_ROOT_OF_UNITY_INDEX.
- OUT_OF_RANGE_SIMPLE - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
OUT_OF_RANGE_SIMPLE.
- OUT_OF_RANGE_SIMPLE - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OUT_OF_RANGE_SIMPLE.
- outerProduct(ArrayFieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Compute the outer product.
- outerProduct(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Compute the outer product.
- outerProduct(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- outerProduct(FieldVector<T>) - 接口中的方法 org.hipparchus.linear.FieldVector
-
Compute the outer product.
- outerProduct(FieldVector<T>) - 类中的方法 org.hipparchus.linear.SparseFieldVector
-
Compute the outer product.
- outerProduct(RealVector) - 类中的方法 org.hipparchus.linear.ArrayRealVector
-
Compute the outer product.
- outerProduct(RealVector) - 类中的方法 org.hipparchus.linear.RealVector
-
Compute the outer product.
- outerProduct(SparseFieldVector<T>) - 类中的方法 org.hipparchus.linear.SparseFieldVector
-
Optimized method to compute outer product when both vectors are sparse.
- outerProduct(T[]) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- OUTLINE_BOUNDARY_LOOP_OPEN - 枚举类 中的枚举常量 org.hipparchus.geometry.LocalizedGeometryFormats
-
OUTLINE_BOUNDARY_LOOP_OPEN.
- OUTLINE_BOUNDARY_LOOP_OPEN - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OUTLINE_BOUNDARY_LOOP_OPEN.
- OutlineExtractor - org.hipparchus.geometry.euclidean.threed中的类
-
Extractor for
polyhedrons sets
outlines. - OutlineExtractor(Vector3D, Vector3D) - 类的构造器 org.hipparchus.geometry.euclidean.threed.OutlineExtractor
-
Build an extractor for a specific projection plane.
- OutlineExtractorTest - org.hipparchus.geometry.euclidean.threed中的类
- OutlineExtractorTest() - 类的构造器 org.hipparchus.geometry.euclidean.threed.OutlineExtractorTest
- OutOfRangeException - org.hipparchus.migration.exception中的异常错误类
-
已过时。
- OutOfRangeException(Number, Number, Number) - 异常错误类的构造器 org.hipparchus.migration.exception.OutOfRangeException
-
已过时。Construct an exception from the mismatched dimensions.
- OutOfRangeException(Localizable, Number, Number, Number) - 异常错误类的构造器 org.hipparchus.migration.exception.OutOfRangeException
-
已过时。Construct an exception from the mismatched dimensions with a specific context information.
- OUTSIDE - 枚举类 中的枚举常量 org.hipparchus.geometry.partitioning.Region.Location
-
Code for points outside of the partition.
- OVERFLOW - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
OVERFLOW.
- OVERFLOW - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OVERFLOW.
- OVERFLOW_IN_ADDITION - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
OVERFLOW_IN_ADDITION.
- OVERFLOW_IN_ADDITION - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OVERFLOW_IN_ADDITION.
- OVERFLOW_IN_FRACTION - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
OVERFLOW_IN_FRACTION.
- OVERFLOW_IN_FRACTION - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OVERFLOW_IN_FRACTION.
- OVERFLOW_IN_MULTIPLICATION - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
OVERFLOW_IN_MULTIPLICATION.
- OVERFLOW_IN_MULTIPLICATION - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OVERFLOW_IN_MULTIPLICATION.
- OVERFLOW_IN_SUBTRACTION - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
OVERFLOW_IN_SUBTRACTION.
- OVERFLOW_IN_SUBTRACTION - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。OVERFLOW_IN_SUBTRACTION.
- OverlappingEventsTest - org.hipparchus.ode.events中的类
-
Tests for overlapping state events.
- OverlappingEventsTest() - 类的构造器 org.hipparchus.ode.events.OverlappingEventsTest
常量字段值|所有程序包|所有类和接口|序列化表格
MathIllegalArgumentException