索引
常量字段值|所有程序包|所有类和接口|序列化表格
A
- ABOVE_SIDE - 枚举类 中的枚举常量 org.hipparchus.analysis.solvers.AllowedSolution
-
Only solutions for which values are greater than or equal to zero are acceptable as solutions for root-finding.
- abs() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
absolute value.
- abs() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
absolute value.
- abs() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
absolute value.
- abs() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
absolute value.
- abs() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
absolute value.
- abs() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
absolute value.
- abs() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
absolute value.
- abs() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
absolute value.
- abs() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
absolute value.
- abs() - 接口中的方法 org.hipparchus.CalculusFieldElement
-
absolute value.
- abs() - 类中的方法 org.hipparchus.complex.Complex
-
Return the absolute value of this complex number.
- abs() - 类中的方法 org.hipparchus.complex.FieldComplex
-
Return the absolute value of this complex number.
- abs() - 类中的方法 org.hipparchus.dfp.Dfp
-
absolute value.
- abs() - 类中的方法 org.hipparchus.fraction.BigFraction
-
Returns the absolute value of this
BigFraction
. - abs() - 类中的方法 org.hipparchus.fraction.Fraction
-
Returns the absolute value of this fraction.
- abs() - 类中的方法 org.hipparchus.util.Binary64
-
absolute value.
- abs() - 类中的方法 org.hipparchus.util.FieldTuple
-
absolute value.
- abs() - 类中的方法 org.hipparchus.util.Tuple
-
absolute value.
- abs(double) - 类中的静态方法 org.hipparchus.util.FastMath
-
Absolute value.
- abs(float) - 类中的静态方法 org.hipparchus.util.FastMath
-
Absolute value.
- abs(int) - 类中的静态方法 org.hipparchus.util.FastMath
-
Absolute value.
- abs(long) - 类中的静态方法 org.hipparchus.util.FastMath
-
Absolute value.
- abs(T) - 类中的静态方法 org.hipparchus.util.FastMath
-
Absolute value.
- Abs - org.hipparchus.analysis.function中的类
-
Absolute value function.
- Abs() - 类的构造器 org.hipparchus.analysis.function.Abs
-
Empty constructor.
- absExact(int) - 类中的静态方法 org.hipparchus.util.FastMath
-
Absolute value.
- absExact(long) - 类中的静态方法 org.hipparchus.util.FastMath
-
Absolute value.
- AbstractConvergenceChecker<P> - org.hipparchus.optim中的类
-
Base class for all convergence checker implementations.
- AbstractConvergenceChecker(double, double) - 类的构造器 org.hipparchus.optim.AbstractConvergenceChecker
-
Build an instance with a specified thresholds.
- AbstractCurveFitter - org.hipparchus.fitting中的类
-
Base class that contains common code for fitting parametric univariate real functions
y = f(pi;x)
, wherex
is the independent variable and thepi
are the parameters. - AbstractCurveFitter() - 类的构造器 org.hipparchus.fitting.AbstractCurveFitter
-
Empty constructor.
- AbstractCurveFitter.TheoreticalValuesFunction - org.hipparchus.fitting中的类
-
Vector function for computing function theoretical values.
- AbstractEvaluation - org.hipparchus.optim.nonlinear.vector.leastsquares中的类
-
An implementation of
LeastSquaresProblem.Evaluation
that is designed for extension. - AbstractEvaluation(int) - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
-
Constructor.
- AbstractFieldIntegrator<T> - org.hipparchus.ode中的类
-
Base class managing common boilerplate for all integrators.
- AbstractFieldIntegrator(Field<T>, String) - 类的构造器 org.hipparchus.ode.AbstractFieldIntegrator
-
Build an instance.
- AbstractFieldMatrix<T> - org.hipparchus.linear中的类
-
Basic implementation of
FieldMatrix
methods regardless of the underlying storage. - AbstractFieldMatrix() - 类的构造器 org.hipparchus.linear.AbstractFieldMatrix
-
Constructor for use with Serializable
- AbstractFieldMatrix(Field<T>) - 类的构造器 org.hipparchus.linear.AbstractFieldMatrix
-
Creates a matrix with no data
- AbstractFieldMatrix(Field<T>, int, int) - 类的构造器 org.hipparchus.linear.AbstractFieldMatrix
-
Create a new
FieldMatrix
with the supplied row and column dimensions. - AbstractFieldODEDetector<T,
E> - org.hipparchus.ode.events中的类 -
Base class for #@link
FieldODEEventDetector
. - AbstractFieldODEDetector(FieldAdaptableInterval<E>, int, BracketedRealFieldUnivariateSolver<E>, FieldODEEventHandler<E>) - 类的构造器 org.hipparchus.ode.events.AbstractFieldODEDetector
-
Build a new instance.
- AbstractFieldODEStateInterpolator<T> - org.hipparchus.ode.sampling中的类
-
This abstract class represents an interpolator over the last step during an ODE integration.
- AbstractFieldODEStateInterpolator(boolean, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - 类的构造器 org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Simple constructor.
- AbstractIntegerDistribution - org.hipparchus.distribution.discrete中的类
-
Base class for integer-valued discrete distributions.
- AbstractIntegerDistribution() - 类的构造器 org.hipparchus.distribution.discrete.AbstractIntegerDistribution
-
Empty constructor.
- AbstractIntegrator - org.hipparchus.ode中的类
-
Base class managing common boilerplate for all integrators.
- AbstractIntegrator(String) - 类的构造器 org.hipparchus.ode.AbstractIntegrator
-
Build an instance.
- AbstractKalmanFilter<T> - org.hipparchus.filtering.kalman中的类
-
Shared parts between linear and non-linear Kalman filters.
- AbstractKalmanFilter(MatrixDecomposer, ProcessEstimate) - 类的构造器 org.hipparchus.filtering.kalman.AbstractKalmanFilter
-
Simple constructor.
- AbstractLeastSquaresOptimizerAbstractTest - org.hipparchus.optim.nonlinear.vector.leastsquares中的类
- AbstractLeastSquaresOptimizerAbstractTest() - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractLeastSquaresOptimizerAbstractTest
- AbstractMultipleLinearRegression - org.hipparchus.stat.regression中的类
-
Abstract base class for implementations of MultipleLinearRegression.
- AbstractMultipleLinearRegression() - 类的构造器 org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Empty constructor.
- AbstractMultivariateRealDistribution - org.hipparchus.distribution.multivariate中的类
-
Base class for multivariate probability distributions.
- AbstractMultivariateRealDistribution(RandomGenerator, int) - 类的构造器 org.hipparchus.distribution.multivariate.AbstractMultivariateRealDistribution
-
Simple constructor.
- AbstractODEDetector<T> - org.hipparchus.ode.events中的类
-
Base class for #@link
ODEEventDetector
. - AbstractODEDetector(AdaptableInterval, int, BracketedUnivariateSolver<UnivariateFunction>, ODEEventHandler) - 类的构造器 org.hipparchus.ode.events.AbstractODEDetector
-
Build a new instance.
- AbstractODEStateInterpolator - org.hipparchus.ode.sampling中的类
-
This abstract class represents an interpolator over the last step during an ODE integration.
- AbstractODEStateInterpolator(boolean, ODEStateAndDerivative, ODEStateAndDerivative, ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - 类的构造器 org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Simple constructor.
- AbstractOptimizationProblem<P> - org.hipparchus.optim中的类
-
Base class for implementing optimization problems.
- AbstractOptimizationProblem(int, int, ConvergenceChecker<P>) - 类的构造器 org.hipparchus.optim.AbstractOptimizationProblem
-
Create an
AbstractOptimizationProblem
from the given data. - AbstractParameterizable - org.hipparchus.ode中的类
-
This abstract class provides boilerplate parameters list.
- AbstractParameterizable(String...) - 类的构造器 org.hipparchus.ode.AbstractParameterizable
-
Simple constructor.
- AbstractParameterizable(Collection<String>) - 类的构造器 org.hipparchus.ode.AbstractParameterizable
-
Simple constructor.
- AbstractPolynomialSolver - org.hipparchus.analysis.solvers中的类
-
Base class for solvers.
- AbstractPolynomialSolver(double) - 类的构造器 org.hipparchus.analysis.solvers.AbstractPolynomialSolver
-
Construct a solver with given absolute accuracy.
- AbstractPolynomialSolver(double, double) - 类的构造器 org.hipparchus.analysis.solvers.AbstractPolynomialSolver
-
Construct a solver with given accuracies.
- AbstractPolynomialSolver(double, double, double) - 类的构造器 org.hipparchus.analysis.solvers.AbstractPolynomialSolver
-
Construct a solver with given accuracies.
- AbstractRealDistribution - org.hipparchus.distribution.continuous中的类
-
Base class for probability distributions on the reals.
- AbstractRealDistribution() - 类的构造器 org.hipparchus.distribution.continuous.AbstractRealDistribution
-
Create a real distribution with default solver absolute accuracy.
- AbstractRealDistribution(double) - 类的构造器 org.hipparchus.distribution.continuous.AbstractRealDistribution
-
Simple constructor.
- AbstractRealMatrix - org.hipparchus.linear中的类
-
Basic implementation of RealMatrix methods regardless of the underlying storage.
- AbstractRealMatrix() - 类的构造器 org.hipparchus.linear.AbstractRealMatrix
-
Creates a matrix with no data
- AbstractRealMatrix(int, int) - 类的构造器 org.hipparchus.linear.AbstractRealMatrix
-
Create a new RealMatrix with the supplied row and column dimensions.
- AbstractRegion<S,
T> - org.hipparchus.geometry.partitioning中的类 -
Abstract class for all regions, independently of geometry type or dimension.
- AbstractRegion(double) - 类的构造器 org.hipparchus.geometry.partitioning.AbstractRegion
-
Build a region representing the whole space.
- AbstractRegion(Collection<SubHyperplane<S>>, double) - 类的构造器 org.hipparchus.geometry.partitioning.AbstractRegion
-
Build a Region from a Boundary REPresentation (B-rep).
- AbstractRegion(BSPTree<S>, double) - 类的构造器 org.hipparchus.geometry.partitioning.AbstractRegion
-
Build a region from an inside/outside BSP tree.
- AbstractRegion(Hyperplane<S>[], double) - 类的构造器 org.hipparchus.geometry.partitioning.AbstractRegion
-
Build a convex region from an array of bounding hyperplanes.
- AbstractRuleFactory - org.hipparchus.analysis.integration.gauss中的类
-
Base class for rules that determines the integration nodes and their weights.
- AbstractRuleFactory() - 类的构造器 org.hipparchus.analysis.integration.gauss.AbstractRuleFactory
-
Empty constructor.
- AbstractSequentialLeastSquaresOptimizerAbstractTest - org.hipparchus.optim.nonlinear.vector.leastsquares中的类
- AbstractSequentialLeastSquaresOptimizerAbstractTest() - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractSequentialLeastSquaresOptimizerAbstractTest
- AbstractSimplex - org.hipparchus.optim.nonlinear.scalar.noderiv中的类
-
This class implements the simplex concept.
- AbstractSimplex(double[]) - 类的构造器 org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
The start configuration for simplex is built from a box parallel to the canonical axes of the space.
- AbstractSimplex(double[][]) - 类的构造器 org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
The real initial simplex will be set up by moving the reference simplex such that its first point is located at the start point of the optimization.
- AbstractSimplex(int) - 类的构造器 org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Build a unit hypercube simplex.
- AbstractSimplex(int, double) - 类的构造器 org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Build a hypercube simplex with the given side length.
- AbstractStorelessUnivariateStatistic - org.hipparchus.stat.descriptive中的类
-
Abstract base class for implementations of the
StorelessUnivariateStatistic
interface. - AbstractStorelessUnivariateStatistic() - 类的构造器 org.hipparchus.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Empty constructor.
- AbstractSubHyperplane<S,
T> - org.hipparchus.geometry.partitioning中的类 -
This class implements the dimension-independent parts of
SubHyperplane
. - AbstractSubHyperplane(Hyperplane<S>, Region<T>) - 类的构造器 org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Build a sub-hyperplane from an hyperplane and a region.
- AbstractUnivariateDifferentiableSolver - org.hipparchus.analysis.solvers中的类
-
Provide a default implementation for several functions useful to generic solvers.
- AbstractUnivariateDifferentiableSolver(double) - 类的构造器 org.hipparchus.analysis.solvers.AbstractUnivariateDifferentiableSolver
-
Construct a solver with given absolute accuracy.
- AbstractUnivariateDifferentiableSolver(double, double, double) - 类的构造器 org.hipparchus.analysis.solvers.AbstractUnivariateDifferentiableSolver
-
Construct a solver with given accuracies.
- AbstractUnivariateSolver - org.hipparchus.analysis.solvers中的类
-
Base class for solvers.
- AbstractUnivariateSolver(double) - 类的构造器 org.hipparchus.analysis.solvers.AbstractUnivariateSolver
-
Construct a solver with given absolute accuracy.
- AbstractUnivariateSolver(double, double) - 类的构造器 org.hipparchus.analysis.solvers.AbstractUnivariateSolver
-
Construct a solver with given accuracies.
- AbstractUnivariateSolver(double, double, double) - 类的构造器 org.hipparchus.analysis.solvers.AbstractUnivariateSolver
-
Construct a solver with given accuracies.
- AbstractUnivariateStatistic - org.hipparchus.stat.descriptive中的类
-
Abstract base class for implementations of the
UnivariateStatistic
interface. - AbstractUnivariateStatistic() - 类的构造器 org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Default constructor.
- AbstractUnivariateStatistic(AbstractUnivariateStatistic) - 类的构造器 org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Copy constructor, creates an identical copy of the
original
. - AbstractUnscentedTransform - org.hipparchus.util中的类
-
Base class for unscented transform providers.
- AbstractUnscentedTransform(int) - 类的构造器 org.hipparchus.util.AbstractUnscentedTransform
-
Constructor.
- AbstractWell - org.hipparchus.random中的类
-
This abstract class implements the WELL class of pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
- AbstractWell(int) - 类的构造器 org.hipparchus.random.AbstractWell
-
Creates a new random number generator.
- AbstractWell(int, int) - 类的构造器 org.hipparchus.random.AbstractWell
-
Creates a new random number generator using a single int seed.
- AbstractWell(int, int[]) - 类的构造器 org.hipparchus.random.AbstractWell
-
Creates a new random number generator using an int array seed.
- AbstractWell(int, long) - 类的构造器 org.hipparchus.random.AbstractWell
-
Creates a new random number generator using a single long seed.
- AbstractWell.IndexTable - org.hipparchus.random中的类
-
Inner class used to store the indirection index table which is fixed for a given type of WELL class of pseudo-random number generator.
- accept(double) - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
- accept(double) - 接口中的方法 org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
- accept(double) - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
- acceptStep(AbstractFieldODEStateInterpolator<T>, T) - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
-
Accept a step, triggering events and step handlers.
- acceptStep(AbstractODEStateInterpolator, double) - 类中的方法 org.hipparchus.ode.AbstractIntegrator
-
Accept a step, triggering events and step handlers.
- acos() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Arc cosine operation.
- acos() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Arc cosine operation.
- acos() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
Arc cosine operation.
- acos() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Arc cosine operation.
- acos() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Arc cosine operation.
- acos() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
Arc cosine operation.
- acos() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Arc cosine operation.
- acos() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Arc cosine operation.
- acos() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Arc cosine operation.
- acos() - 接口中的方法 org.hipparchus.CalculusFieldElement
-
Arc cosine operation.
- acos() - 类中的方法 org.hipparchus.complex.Complex
-
Compute the inverse cosine of this complex number.
- acos() - 类中的方法 org.hipparchus.complex.FieldComplex
-
Compute the inverse cosine of this complex number.
- acos() - 类中的方法 org.hipparchus.dfp.Dfp
-
Arc cosine operation.
- acos() - 类中的方法 org.hipparchus.util.Binary64
-
Arc cosine operation.
- acos() - 类中的方法 org.hipparchus.util.FieldTuple
-
Arc cosine operation.
- acos() - 类中的方法 org.hipparchus.util.Tuple
-
Arc cosine operation.
- acos(double) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute the arc cosine of a number.
- acos(double[], int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc cosine of a derivative structure.
- acos(Dfp) - 类中的静态方法 org.hipparchus.dfp.DfpMath
-
computes the arc-cosine of the argument.
- acos(T) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute the arc cosine of a number.
- acos(T[], int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc cosine of a derivative structure.
- Acos - org.hipparchus.analysis.function中的类
-
Arc-cosine function.
- Acos() - 类的构造器 org.hipparchus.analysis.function.Acos
-
Empty constructor.
- acosh() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Inverse hyperbolic cosine operation.
- acosh() - 接口中的方法 org.hipparchus.CalculusFieldElement
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.complex.Complex
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.complex.FieldComplex
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.dfp.Dfp
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.util.Binary64
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.util.FieldTuple
-
Inverse hyperbolic cosine operation.
- acosh() - 类中的方法 org.hipparchus.util.Tuple
-
Inverse hyperbolic cosine operation.
- acosh(double) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic cosine of a number.
- acosh(double[], int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic cosine of a derivative structure.
- acosh(T) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic cosine of a number.
- acosh(T[], int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic cosine of a derivative structure.
- Acosh - org.hipparchus.analysis.function中的类
-
Hyperbolic arc-cosine function.
- Acosh() - 类的构造器 org.hipparchus.analysis.function.Acosh
-
Empty constructor.
- Action - org.hipparchus.ode.events中的枚举类
-
Enumerate for actions to be performed when an event occurs during ODE integration.
- AdamsBashforthFieldIntegrator<T> - org.hipparchus.ode.nonstiff中的类
-
This class implements explicit Adams-Bashforth integrators for Ordinary Differential Equations.
- AdamsBashforthFieldIntegrator(Field<T>, int, double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegrator
-
Build an Adams-Bashforth integrator with the given order and step control parameters.
- AdamsBashforthFieldIntegrator(Field<T>, int, double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegrator
-
Build an Adams-Bashforth integrator with the given order and step control parameters.
- AdamsBashforthFieldIntegratorTest - org.hipparchus.ode.nonstiff中的类
- AdamsBashforthFieldIntegratorTest() - 类的构造器 org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegratorTest
- AdamsBashforthIntegrator - org.hipparchus.ode.nonstiff中的类
-
This class implements explicit Adams-Bashforth integrators for Ordinary Differential Equations.
- AdamsBashforthIntegrator(int, double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.AdamsBashforthIntegrator
-
Build an Adams-Bashforth integrator with the given order and step control parameters.
- AdamsBashforthIntegrator(int, double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.AdamsBashforthIntegrator
-
Build an Adams-Bashforth integrator with the given order and step control parameters.
- AdamsBashforthIntegratorTest - org.hipparchus.ode.nonstiff中的类
- AdamsBashforthIntegratorTest() - 类的构造器 org.hipparchus.ode.nonstiff.AdamsBashforthIntegratorTest
- AdamsFieldIntegrator<T> - org.hipparchus.ode.nonstiff中的类
-
Base class for
Adams-Bashforth
andAdams-Moulton
integrators. - AdamsFieldIntegrator(Field<T>, String, int, int, double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Build an Adams integrator with the given order and step control parameters.
- AdamsFieldIntegrator(Field<T>, String, int, int, double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Build an Adams integrator with the given order and step control parameters.
- AdamsFieldIntegratorAbstractTest - org.hipparchus.ode.nonstiff中的类
- AdamsFieldIntegratorAbstractTest() - 类的构造器 org.hipparchus.ode.nonstiff.AdamsFieldIntegratorAbstractTest
- AdamsIntegrator - org.hipparchus.ode.nonstiff中的类
-
Base class for
Adams-Bashforth
andAdams-Moulton
integrators. - AdamsIntegrator(String, int, int, double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Build an Adams integrator with the given order and step control parameters.
- AdamsIntegrator(String, int, int, double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Build an Adams integrator with the given order and step control parameters.
- AdamsIntegratorAbstractTest - org.hipparchus.ode.nonstiff中的类
- AdamsIntegratorAbstractTest() - 类的构造器 org.hipparchus.ode.nonstiff.AdamsIntegratorAbstractTest
- AdamsMoultonFieldIntegrator<T> - org.hipparchus.ode.nonstiff中的类
-
This class implements implicit Adams-Moulton integrators for Ordinary Differential Equations.
- AdamsMoultonFieldIntegrator(Field<T>, int, double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegrator
-
Build an Adams-Moulton integrator with the given order and error control parameters.
- AdamsMoultonFieldIntegrator(Field<T>, int, double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegrator
-
Build an Adams-Moulton integrator with the given order and error control parameters.
- AdamsMoultonFieldIntegratorTest - org.hipparchus.ode.nonstiff中的类
- AdamsMoultonFieldIntegratorTest() - 类的构造器 org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegratorTest
- AdamsMoultonIntegrator - org.hipparchus.ode.nonstiff中的类
-
This class implements implicit Adams-Moulton integrators for Ordinary Differential Equations.
- AdamsMoultonIntegrator(int, double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.AdamsMoultonIntegrator
-
Build an Adams-Moulton integrator with the given order and error control parameters.
- AdamsMoultonIntegrator(int, double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.AdamsMoultonIntegrator
-
Build an Adams-Moulton integrator with the given order and error control parameters.
- AdamsMoultonIntegratorTest - org.hipparchus.ode.nonstiff中的类
- AdamsMoultonIntegratorTest() - 类的构造器 org.hipparchus.ode.nonstiff.AdamsMoultonIntegratorTest
- AdamsNordsieckFieldTransformer<T> - org.hipparchus.ode.nonstiff中的类
-
Transformer to Nordsieck vectors for Adams integrators.
- AdamsNordsieckTransformer - org.hipparchus.ode.nonstiff中的类
-
Transformer to Nordsieck vectors for Adams integrators.
- AdamsNordsieckTransformerTest - org.hipparchus.ode.nonstiff中的类
- AdamsNordsieckTransformerTest() - 类的构造器 org.hipparchus.ode.nonstiff.AdamsNordsieckTransformerTest
- AdamsStateInterpolatorTest - org.hipparchus.ode.nonstiff中的类
- AdamsStateInterpolatorTest() - 类的构造器 org.hipparchus.ode.nonstiff.AdamsStateInterpolatorTest
- AdaptableInterval - org.hipparchus.ode.events中的接口
-
This interface represents an event checking interval that depends on state.
- AdaptiveStepsizeFieldIntegrator<T> - org.hipparchus.ode.nonstiff中的类
-
This abstract class holds the common part of all adaptive stepsize integrators for Ordinary Differential Equations.
- AdaptiveStepsizeFieldIntegrator(Field<T>, String, double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Build an integrator with the given stepsize bounds.
- AdaptiveStepsizeFieldIntegrator(Field<T>, String, double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Build an integrator with the given stepsize bounds.
- AdaptiveStepsizeIntegrator - org.hipparchus.ode.nonstiff中的类
-
This abstract class holds the common part of all adaptive stepsize integrators for Ordinary Differential Equations.
- AdaptiveStepsizeIntegrator(String, double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Build an integrator with the given stepsize bounds.
- AdaptiveStepsizeIntegrator(String, double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Build an integrator with the given stepsize bounds.
- add(double) - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
'+' operator.
- add(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'+' operator.
- add(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
'+' operator.
- add(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'+' operator.
- add(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'+' operator.
- add(double) - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
'+' operator.
- add(double) - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
'+' operator.
- add(double) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
'+' operator.
- add(double) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
'+' operator.
- add(double) - 接口中的方法 org.hipparchus.CalculusFieldElement
-
'+' operator.
- add(double) - 类中的方法 org.hipparchus.complex.Complex
-
Returns a
Complex
whose value is(this + addend)
, withaddend
interpreted as a real number. - add(double) - 类中的方法 org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value is(this + addend)
, withaddend
interpreted as a real number. - add(double) - 类中的方法 org.hipparchus.dfp.Dfp
-
'+' operator.
- add(double) - 类中的方法 org.hipparchus.util.Binary64
-
'+' operator.
- add(double) - 类中的方法 org.hipparchus.util.FieldTuple
-
'+' operator.
- add(double) - 类中的方法 org.hipparchus.util.Tuple
-
'+' operator.
- add(double[], boolean) - 类中的方法 org.hipparchus.analysis.interpolation.InterpolatingMicrosphere
-
Replace
i
-th facet of the microsphere. - add(double[], int, double[], int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Perform addition of two derivative structures.
- add(double, double) - 类中的方法 org.hipparchus.fitting.WeightedObservedPoints
-
Adds a point to the sample.
- add(double, double, double) - 类中的方法 org.hipparchus.fitting.WeightedObservedPoints
-
Adds a point to the sample.
- add(double, FieldVector3D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Add a scaled vector to the instance.
- add(double, Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Add a scaled vector to the instance.
- add(double, FieldVector2D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Add a scaled vector to the instance.
- add(double, Vector2D) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Add a scaled vector to the instance.
- add(double, Vector<Euclidean1D, Vector1D>) - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
-
Add a scaled vector to the instance.
- add(double, Vector<Euclidean3D, Vector3D>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Add a scaled vector to the instance.
- add(double, Vector<Euclidean2D, Vector2D>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Add a scaled vector to the instance.
- add(double, Vector<S, V>) - 接口中的方法 org.hipparchus.geometry.Vector
-
Add a scaled vector to the instance.
- add(int) - 类中的方法 org.hipparchus.fraction.BigFraction
-
Adds the value of this fraction to the passed
integer
, returning the result in reduced form. - add(int) - 类中的方法 org.hipparchus.fraction.Fraction
-
Add an integer to the fraction.
- add(long) - 类中的方法 org.hipparchus.fraction.BigFraction
-
Adds the value of this fraction to the passed
long
, returning the result in reduced form. - add(BigInteger) - 类中的方法 org.hipparchus.fraction.BigFraction
-
Adds the value of this fraction to the passed
BigInteger
, returning the result in reduced form. - add(DerivativeStructure) - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute this + a.
- add(FieldDerivativeStructure<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute this + a.
- add(FieldGradient<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
Compute this + a.
- add(FieldUnivariateDerivative1<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Compute this + a.
- add(FieldUnivariateDerivative2<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Compute this + a.
- add(Gradient) - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
Compute this + a.
- add(SparseGradient) - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Compute this + a.
- add(UnivariateDerivative1) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Compute this + a.
- add(UnivariateDerivative2) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Compute this + a.
- add(UnivariateDifferentiableFunction...) - 类中的静态方法 org.hipparchus.analysis.FunctionUtils
-
Adds functions.
- add(FieldPolynomialFunction<T>) - 类中的方法 org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Add a polynomial to the instance.
- add(PolynomialFunction) - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunction
-
Add a polynomial to the instance.
- add(UnivariateFunction...) - 类中的静态方法 org.hipparchus.analysis.FunctionUtils
-
Adds functions.
- add(Complex) - 类中的方法 org.hipparchus.complex.Complex
-
Returns a
Complex
whose value is(this + addend)
. - add(FieldComplex<T>) - 类中的方法 org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value is(this + addend)
. - add(Quaternion) - 类中的方法 org.hipparchus.complex.Quaternion
-
Computes the sum of the instance and another quaternion.
- add(Quaternion, Quaternion) - 类中的静态方法 org.hipparchus.complex.Quaternion
-
Computes the sum of two quaternions.
- add(Dfp) - 类中的方法 org.hipparchus.dfp.Dfp
-
Add x to this.
- add(WeightedObservedPoint) - 类中的方法 org.hipparchus.fitting.WeightedObservedPoints
-
Adds a point to the sample.
- add(BigFraction) - 类中的方法 org.hipparchus.fraction.BigFraction
-
Adds the value of this fraction to another, returning the result in reduced form.
- add(Fraction) - 类中的方法 org.hipparchus.fraction.Fraction
-
Adds the value of this fraction to another, returning the result in reduced form.
- add(FieldVector3D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Add a vector to the instance.
- add(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Add a vector to the instance.
- add(FieldVector2D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Add a vector to the instance.
- add(Vector2D) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Add a vector to the instance.
- add(BSPTree<S>) - 类中的方法 org.hipparchus.geometry.partitioning.NodesSet
-
Add a node if not already known.
- add(Vector<Euclidean1D, Vector1D>) - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
-
Add a vector to the instance.
- add(Vector<Euclidean3D, Vector3D>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Add a vector to the instance.
- add(Vector<Euclidean2D, Vector2D>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Add a vector to the instance.
- add(Vector<S, V>) - 接口中的方法 org.hipparchus.geometry.Vector
-
Add a vector to the instance.
- add(Array2DRowFieldMatrix<T>) - 类中的方法 org.hipparchus.linear.Array2DRowFieldMatrix
-
Add
m
to this matrix. - add(Array2DRowRealMatrix) - 类中的方法 org.hipparchus.linear.Array2DRowRealMatrix
-
Compute the sum of
this
andm
. - add(ArrayFieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Compute the sum of
this
andv
. - add(BlockFieldMatrix<T>) - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
-
Compute the sum of
this
andm
. - add(BlockRealMatrix) - 类中的方法 org.hipparchus.linear.BlockRealMatrix
-
Compute the sum of this matrix and
m
. - add(DiagonalMatrix) - 类中的方法 org.hipparchus.linear.DiagonalMatrix
-
Compute the sum of
this
andm
. - add(FieldMatrix<T>) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
-
Compute the sum of this and m.
- add(FieldMatrix<T>) - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
-
Compute the sum of this and m.
- add(FieldMatrix<T>) - 接口中的方法 org.hipparchus.linear.FieldMatrix
-
Compute the sum of this and m.
- add(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Compute the sum of
this
andv
. - add(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- add(FieldVector<T>) - 接口中的方法 org.hipparchus.linear.FieldVector
-
Compute the sum of
this
andv
. - add(FieldVector<T>) - 类中的方法 org.hipparchus.linear.SparseFieldVector
-
Compute the sum of
this
andv
. - add(OpenMapRealMatrix) - 类中的方法 org.hipparchus.linear.OpenMapRealMatrix
-
Compute the sum of this matrix and
m
. - add(OpenMapRealVector) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
-
Optimized method to add two OpenMapRealVectors.
- add(RealMatrix) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
-
Returns the sum of
this
andm
. - add(RealMatrix) - 类中的方法 org.hipparchus.linear.BlockRealMatrix
-
Returns the sum of
this
andm
. - add(RealMatrix) - 接口中的方法 org.hipparchus.linear.RealMatrix
-
Returns the sum of
this
andm
. - add(RealVector) - 类中的方法 org.hipparchus.linear.ArrayRealVector
-
Compute the sum of this vector and
v
. - add(RealVector) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
-
Compute the sum of this vector and
v
. - add(RealVector) - 类中的方法 org.hipparchus.linear.RealVector
-
Compute the sum of this vector and
v
. - add(SparseFieldVector<T>) - 类中的方法 org.hipparchus.linear.SparseFieldVector
-
Optimized method to add sparse vectors.
- add(BigReal) - 类中的方法 org.hipparchus.util.BigReal
-
Compute this + a.
- add(Binary64) - 类中的方法 org.hipparchus.util.Binary64
-
Compute this + a.
- add(FieldTuple<T>) - 类中的方法 org.hipparchus.util.FieldTuple
-
Compute this + a.
- add(Tuple) - 类中的方法 org.hipparchus.util.Tuple
-
Compute this + a.
- add(T) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'+' operator.
- add(T) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
'+' operator.
- add(T) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
'+' operator.
- add(T) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
'+' operator.
- add(T) - 类中的方法 org.hipparchus.complex.FieldComplex
-
Returns a
Complex
whose value is(this + addend)
, withaddend
interpreted as a real number. - add(T) - 接口中的方法 org.hipparchus.FieldElement
-
Compute this + a.
- add(T[]) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- add(T[], int, T[], int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Perform addition of two derivative structures.
- add(T, FieldVector3D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Add a scaled vector to the instance.
- add(T, Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Add a scaled vector to the instance.
- add(T, FieldVector2D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Add a scaled vector to the instance.
- add(T, Vector2D) - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Add a scaled vector to the instance.
- Add - org.hipparchus.analysis.function中的类
-
Add the two operands.
- Add() - 类的构造器 org.hipparchus.analysis.function.Add
-
Empty constructor.
- ADD - 枚举类 中的枚举常量 org.hipparchus.linear.RealVectorAbstractTest.BinaryOperation
- ADD_ZERO_VECTOR - 枚举类 中的枚举常量 org.hipparchus.linear.DependentVectorsHandler
-
Replace dependent vectors by vectors with norm 0.
- addAll(Iterable<BSPTree<S>>) - 类中的方法 org.hipparchus.geometry.partitioning.NodesSet
-
Add nodes if they are not already known.
- addAndCheck(int, int) - 类中的静态方法 org.hipparchus.util.ArithmeticUtils
-
Add two integers, checking for overflow.
- addAndCheck(long, long) - 类中的静态方法 org.hipparchus.util.ArithmeticUtils
-
Add two long integers, checking for overflow.
- addCDFSeries(Chart, IntegerDistribution, String, int, int) - 类中的静态方法 org.hipparchus.samples.IntegerDistributionComparison
-
Add a CDF series.
- addCDFSeries(Chart, RealDistribution, String, int, int) - 类中的静态方法 org.hipparchus.samples.RealDistributionComparison
-
Add a CDF series.
- addData(double[][]) - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
-
Adds the observations represented by the elements in
data
. - addData(double, double) - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
-
Adds the observation (x,y) to the regression data set.
- addData(double, double) - 类中的方法 org.hipparchus.UnitTestUtils.SimpleRegression
- addElement(double) - 类中的方法 org.hipparchus.util.ResizableDoubleArray
-
Adds an element to the end of this expandable array.
- addElementRolling(double) - 类中的方法 org.hipparchus.util.ResizableDoubleArray
-
Adds an element to the end of the array and removes the first element in the array.
- addElements(double[]) - 类中的方法 org.hipparchus.util.ResizableDoubleArray
-
Adds several element to the end of this expandable array.
- addEventDetector(FieldODEEventDetector<T>) - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
-
Add an event detector to the integrator.
- addEventDetector(FieldODEEventDetector<T>) - 接口中的方法 org.hipparchus.ode.FieldODEIntegrator
-
Add an event detector to the integrator.
- addEventDetector(ODEEventDetector) - 类中的方法 org.hipparchus.ode.AbstractIntegrator
-
Add an event detector to the integrator.
- addEventDetector(ODEEventDetector) - 接口中的方法 org.hipparchus.ode.ODEIntegrator
-
Add an event detector to the integrator.
- addExact(int, int) - 类中的静态方法 org.hipparchus.util.FastMath
-
Add two numbers, detecting overflows.
- addExact(long, long) - 类中的静态方法 org.hipparchus.util.FastMath
-
Add two numbers, detecting overflows.
- addInPlace(SparseGradient) - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Add in place.
- addIterationListener(IterationListener) - 类中的方法 org.hipparchus.util.IterationManager
-
Attaches a listener to this manager.
- ADDITIVE - 枚举类 中的枚举常量 org.hipparchus.util.ResizableDoubleArray.ExpansionMode
-
Additive expansion mode.
- addObservation(double[], double) - 类中的方法 org.hipparchus.stat.regression.MillerUpdatingRegression
-
Adds an observation to the regression model.
- addObservation(double[], double) - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
-
Adds one observation to the regression model.
- addObservation(double[], double) - 接口中的方法 org.hipparchus.stat.regression.UpdatingMultipleLinearRegression
-
Adds one observation to the regression model.
- addObservations(double[][], double[]) - 类中的方法 org.hipparchus.stat.regression.MillerUpdatingRegression
-
Adds multiple observations to the model.
- addObservations(double[][], double[]) - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
-
Adds a series of observations to the regression model.
- addObservations(double[][], double[]) - 接口中的方法 org.hipparchus.stat.regression.UpdatingMultipleLinearRegression
-
Adds a series of observations to the regression model.
- addParameterJacobianProvider(NamedParameterJacobianProvider) - 类中的方法 org.hipparchus.migration.ode.JacobianMatrices
-
已过时。Add a parameter Jacobian provider.
- addPDFSeries(Chart, IntegerDistribution, String, int, int) - 类中的静态方法 org.hipparchus.samples.IntegerDistributionComparison
-
Add a PDF series.
- addPDFSeries(Chart, RealDistribution, String, int, int) - 类中的静态方法 org.hipparchus.samples.RealDistributionComparison
-
Add a PDF series.
- addPoint(double, double) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.gradient.CircleScalar
- addPoint(T) - 类中的方法 org.hipparchus.clustering.Cluster
-
Add a point to this cluster.
- addSamplePoint(double, double[]...) - 类中的方法 org.hipparchus.analysis.interpolation.HermiteInterpolator
-
Add a sample point.
- addSamplePoint(T, T[]...) - 类中的方法 org.hipparchus.analysis.interpolation.FieldHermiteInterpolator
-
Add a sample point.
- addSecondaryEquations(FieldSecondaryODE<T>) - 类中的方法 org.hipparchus.ode.FieldExpandableODE
-
Add a set of secondary equations to be integrated along with the primary set.
- addSecondaryEquations(SecondaryODE) - 类中的方法 org.hipparchus.ode.ExpandableODE
-
Add a set of secondary equations to be integrated along with the primary set.
- addStepEndHandler(FieldODEStepEndHandler<T>) - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
-
Add a handler for step ends to the integrator.
- addStepEndHandler(FieldODEStepEndHandler<T>) - 接口中的方法 org.hipparchus.ode.FieldODEIntegrator
-
Add a handler for step ends to the integrator.
- addStepEndHandler(ODEStepEndHandler) - 类中的方法 org.hipparchus.ode.AbstractIntegrator
-
Add a handler for step ends to the integrator.
- addStepEndHandler(ODEStepEndHandler) - 接口中的方法 org.hipparchus.ode.ODEIntegrator
-
Add a handler for step ends to the integrator.
- addStepHandler(FieldODEStepHandler<T>) - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
-
Add a step handler to this integrator.
- addStepHandler(FieldODEStepHandler<T>) - 接口中的方法 org.hipparchus.ode.FieldODEIntegrator
-
Add a step handler to this integrator.
- addStepHandler(ODEStepHandler) - 类中的方法 org.hipparchus.ode.AbstractIntegrator
-
Add a step handler to this integrator.
- addStepHandler(ODEStepHandler) - 接口中的方法 org.hipparchus.ode.ODEIntegrator
-
Add a step handler to this integrator.
- addToEntry(int, double) - 类中的方法 org.hipparchus.linear.ArrayRealVector
-
Change an entry at the specified index.
- addToEntry(int, double) - 类中的方法 org.hipparchus.linear.RealVector
-
Change an entry at the specified index.
- addToEntry(int, int, double) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
-
Adds (in place) the specified value to the specified entry of
this
matrix. - addToEntry(int, int, double) - 类中的方法 org.hipparchus.linear.Array2DRowRealMatrix
-
Adds (in place) the specified value to the specified entry of
this
matrix. - addToEntry(int, int, double) - 类中的方法 org.hipparchus.linear.BlockRealMatrix
-
Adds (in place) the specified value to the specified entry of
this
matrix. - addToEntry(int, int, double) - 类中的方法 org.hipparchus.linear.DiagonalMatrix
-
Adds (in place) the specified value to the specified entry of
this
matrix. - addToEntry(int, int, double) - 类中的方法 org.hipparchus.linear.OpenMapRealMatrix
-
Adds (in place) the specified value to the specified entry of
this
matrix. - addToEntry(int, int, double) - 接口中的方法 org.hipparchus.linear.RealMatrix
-
Adds (in place) the specified value to the specified entry of
this
matrix. - addToEntry(int, int, T) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, T) - 类中的方法 org.hipparchus.linear.Array2DRowFieldMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, T) - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, T) - 接口中的方法 org.hipparchus.linear.FieldMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, T) - 类中的方法 org.hipparchus.linear.SparseFieldMatrix
-
Change an entry in the specified row and column.
- addValue(double) - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Adds the value to the dataset.
- addValue(double) - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
-
Add a value to the data
- addValue(double) - 类中的方法 org.hipparchus.UnitTestUtils.SimpleStatistics
- addValue(double[]) - 类中的方法 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Add an n-tuple to the data
- addValue(int) - 类中的方法 org.hipparchus.stat.LongFrequency
-
Adds 1 to the frequency count for v.
- addValue(T) - 类中的方法 org.hipparchus.stat.Frequency
-
Adds 1 to the frequency count for v.
- addValue(T) - 类中的方法 org.hipparchus.UnitTestUtils.Frequency
- advance() - 类中的方法 org.hipparchus.util.OpenIntToDoubleHashMap.Iterator
-
Advance iterator one step further.
- advance() - 类中的方法 org.hipparchus.util.OpenIntToFieldHashMap.Iterator
-
Advance iterator one step further.
- advance(RealVector.Entry) - 类中的方法 org.hipparchus.linear.RealVector.SparseEntryIterator
-
Advance an entry up to the next nonzero one.
- AggregatableStatistic<T> - org.hipparchus.stat.descriptive中的接口
-
An interface for statistics that can aggregate results.
- aggregate(Iterable<? extends StatisticalSummary>) - 接口中的静态方法 org.hipparchus.stat.descriptive.StatisticalSummary
-
Computes aggregated statistical summaries.
- aggregate(Iterable<T>) - 接口中的方法 org.hipparchus.stat.descriptive.AggregatableStatistic
-
Aggregates the results from the provided instances into this instance.
- aggregate(FirstMoment) - 类中的方法 org.hipparchus.stat.descriptive.moment.SecondMoment
-
Aggregates the results of the provided instance into this instance.
- aggregate(GeometricMean) - 类中的方法 org.hipparchus.stat.descriptive.moment.GeometricMean
-
Aggregates the provided instance into this instance.
- aggregate(Mean) - 类中的方法 org.hipparchus.stat.descriptive.moment.Mean
-
Aggregates the provided instance into this instance.
- aggregate(SecondMoment) - 类中的方法 org.hipparchus.stat.descriptive.moment.SecondMoment
-
Aggregates the provided instance into this instance.
- aggregate(Variance) - 类中的方法 org.hipparchus.stat.descriptive.moment.Variance
-
Aggregates the provided instance into this instance.
- aggregate(Max) - 类中的方法 org.hipparchus.stat.descriptive.rank.Max
-
Aggregates the provided instance into this instance.
- aggregate(Min) - 类中的方法 org.hipparchus.stat.descriptive.rank.Min
-
Aggregates the provided instance into this instance.
- aggregate(RandomPercentile) - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Aggregates the provided instance into this instance.
- aggregate(StatisticalSummary...) - 接口中的静态方法 org.hipparchus.stat.descriptive.StatisticalSummary
-
Computes aggregated statistical summaries.
- aggregate(StreamingStatistics) - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
-
Aggregates the provided instance into this instance.
- aggregate(Product) - 类中的方法 org.hipparchus.stat.descriptive.summary.Product
-
Aggregates the provided instance into this instance.
- aggregate(Sum) - 类中的方法 org.hipparchus.stat.descriptive.summary.Sum
-
Aggregates the provided instance into this instance.
- aggregate(SumOfLogs) - 类中的方法 org.hipparchus.stat.descriptive.summary.SumOfLogs
-
Aggregates the provided instance into this instance.
- aggregate(SumOfSquares) - 类中的方法 org.hipparchus.stat.descriptive.summary.SumOfSquares
-
Aggregates the provided instance into this instance.
- aggregate(T) - 接口中的方法 org.hipparchus.stat.descriptive.AggregatableStatistic
-
Aggregates the provided instance into this instance.
- aggregate(T...) - 接口中的方法 org.hipparchus.stat.descriptive.AggregatableStatistic
-
Aggregates the results from the provided instances into this instance.
- AgrestiCoullIntervalTest - org.hipparchus.stat.interval中的类
-
Test cases for the AgrestiCoullInterval.
- AgrestiCoullIntervalTest() - 类的构造器 org.hipparchus.stat.interval.AgrestiCoullIntervalTest
- AkimaSplineInterpolator - org.hipparchus.analysis.interpolation中的类
-
Computes a cubic spline interpolation for the data set using the Akima algorithm, as originally formulated by Hiroshi Akima in his 1970 paper "A New Method of Interpolation and Smooth Curve Fitting Based on Local Procedures."
- AkimaSplineInterpolator() - 类的构造器 org.hipparchus.analysis.interpolation.AkimaSplineInterpolator
-
Simple constructor.
- AkimaSplineInterpolator(boolean) - 类的构造器 org.hipparchus.analysis.interpolation.AkimaSplineInterpolator
-
Simple constructor.
- AkimaSplineInterpolatorTest - org.hipparchus.analysis.interpolation中的类
- AkimaSplineInterpolatorTest() - 类的构造器 org.hipparchus.analysis.interpolation.AkimaSplineInterpolatorTest
- AklToussaintHeuristic - org.hipparchus.geometry.euclidean.twod.hull中的类
-
A simple heuristic to improve the performance of convex hull algorithms.
- AklToussaintHeuristicTest - org.hipparchus.geometry.euclidean.twod.hull中的类
-
Test class for AklToussaintHeuristic.
- AklToussaintHeuristicTest() - 类的构造器 org.hipparchus.geometry.euclidean.twod.hull.AklToussaintHeuristicTest
- align(int) - 类中的方法 org.hipparchus.dfp.Dfp
-
Make our exp equal to the supplied one, this may cause rounding.
- AllowedSolution - org.hipparchus.analysis.solvers中的枚举类
-
The kinds of solutions that a
(bracketed univariate real) root-finding algorithm
may accept as solutions. - AlternativeHypothesis - org.hipparchus.stat.inference中的枚举类
-
Represents an alternative hypothesis for a hypothesis test.
- altPolar(double, double) - 类中的方法 org.hipparchus.complex.ComplexUtilsTest
- angle(FieldVector3D<T>, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the angular separation between two vectors.
- angle(FieldVector3D<T>, Vector3D) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the angular separation between two vectors.
- angle(Vector3D, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the angular separation between two vectors.
- angle(Vector3D, Vector3D) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the angular separation between two vectors.
- angle(FieldVector2D<T>, FieldVector2D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the angular separation between two vectors.
- angle(FieldVector2D<T>, Vector2D) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the angular separation between two vectors.
- angle(Vector2D, FieldVector2D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Compute the angular separation between two vectors.
- angle(Vector2D, Vector2D) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the angular separation between two vectors.
- anovaFValue(Collection<double[]>) - 类中的方法 org.hipparchus.stat.inference.OneWayAnova
-
Computes the ANOVA F-value for a collection of
double[]
arrays. - anovaPValue(Collection<double[]>) - 类中的方法 org.hipparchus.stat.inference.OneWayAnova
-
Computes the ANOVA P-value for a collection of
double[]
arrays. - anovaPValue(Collection<StreamingStatistics>, boolean) - 类中的方法 org.hipparchus.stat.inference.OneWayAnova
-
Computes the ANOVA P-value for a collection of
StreamingStatistics
. - anovaTest(Collection<double[]>, double) - 类中的方法 org.hipparchus.stat.inference.OneWayAnova
-
Performs an ANOVA test, evaluating the null hypothesis that there is no difference among the means of the data categories.
- antiDerivative() - 类中的方法 org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Returns an anti-derivative of this polynomial, with 0 constant term.
- antiDerivative() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunction
-
Returns an anti-derivative of this polynomial, with 0 constant term.
- ANY_SIDE - 枚举类 中的枚举常量 org.hipparchus.analysis.solvers.AllowedSolution
-
There are no additional side restriction on the solutions for root-finding.
- AnyMatrix - org.hipparchus.linear中的接口
-
Interface defining very basic matrix operations.
- append(double) - 类中的方法 org.hipparchus.linear.ArrayRealVector
-
Construct a new vector by appending a double to this vector.
- append(double) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
-
Construct a new vector by appending a double to this vector.
- append(double) - 类中的方法 org.hipparchus.linear.RealVector
-
Construct a new vector by appending a double to this vector.
- append(double) - 类中的方法 org.hipparchus.linear.RealVectorAbstractTest.RealVectorTestImpl
- append(ArrayFieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending a vector to this vector.
- append(ArrayRealVector) - 类中的方法 org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending a vector to this vector.
- append(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending a vector to this vector.
- append(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- append(FieldVector<T>) - 接口中的方法 org.hipparchus.linear.FieldVector
-
Construct a vector by appending a vector to this vector.
- append(FieldVector<T>) - 类中的方法 org.hipparchus.linear.SparseFieldVector
-
Construct a vector by appending a vector to this vector.
- append(OpenMapRealVector) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
-
Optimized method to append a OpenMapRealVector.
- append(RealVector) - 类中的方法 org.hipparchus.linear.ArrayRealVector
-
Construct a new vector by appending a vector to this vector.
- append(RealVector) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
-
Construct a new vector by appending a vector to this vector.
- append(RealVector) - 类中的方法 org.hipparchus.linear.RealVector
-
Construct a new vector by appending a vector to this vector.
- append(RealVector) - 类中的方法 org.hipparchus.linear.RealVectorAbstractTest.RealVectorTestImpl
- append(SparseFieldVector<T>) - 类中的方法 org.hipparchus.linear.SparseFieldVector
-
Construct a vector by appending a vector to this vector.
- append(DenseOutputModel) - 类中的方法 org.hipparchus.ode.DenseOutputModel
-
Append another model at the end of the instance.
- append(FieldDenseOutputModel<T>) - 类中的方法 org.hipparchus.ode.FieldDenseOutputModel
-
Append another model at the end of the instance.
- append(StorelessCovariance) - 类中的方法 org.hipparchus.stat.correlation.StorelessCovariance
-
Appends
sc
to this, effectively aggregating the computations insc
with this. - append(SimpleRegression) - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
-
Appends data from another regression calculation to this one.
- append(T) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending a T to this vector.
- append(T) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- append(T) - 接口中的方法 org.hipparchus.linear.FieldVector
-
Construct a vector by appending a T to this vector.
- append(T) - 类中的方法 org.hipparchus.linear.SparseFieldVector
-
Construct a vector by appending a T to this vector.
- append(T[]) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- apply(Hyperplane<S>) - 接口中的方法 org.hipparchus.geometry.partitioning.Transform
-
Transform an hyperplane of a space.
- apply(SubHyperplane<T>, Hyperplane<S>, Hyperplane<S>) - 接口中的方法 org.hipparchus.geometry.partitioning.Transform
-
Transform a sub-hyperplane embedded in an hyperplane.
- apply(Point<S>) - 接口中的方法 org.hipparchus.geometry.partitioning.Transform
-
Transform a point of a space.
- apply(UnivariateStatistic) - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Apply the given statistic to the data associated with this set of statistics.
- applyInverseTo(double[], double[]) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the inverse of the rotation to a vector stored in an array.
- applyInverseTo(double[], T[]) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of the rotation to a vector stored in an array.
- applyInverseTo(FieldRotation<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of the instance to another rotation.
- applyInverseTo(FieldVector3D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of the rotation to a vector.
- applyInverseTo(Rotation) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of the instance to another rotation.
- applyInverseTo(Rotation) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the inverse of the instance to another rotation.
- applyInverseTo(Rotation, FieldRotation<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of a rotation to another rotation.
- applyInverseTo(Rotation, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of a rotation to a vector.
- applyInverseTo(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of the rotation to a vector.
- applyInverseTo(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the inverse of the rotation to a vector.
- applyInverseTo(T[], T[]) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of the rotation to a vector stored in an array.
- applyTo(double[], double[]) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the rotation to a vector stored in an array.
- applyTo(double[], T[]) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the rotation to a vector stored in an array.
- applyTo(FieldRotation<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the instance to another rotation.
- applyTo(FieldVector3D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the rotation to a vector.
- applyTo(Rotation) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the instance to another rotation.
- applyTo(Rotation) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the instance to another rotation.
- applyTo(Rotation, FieldRotation<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply a rotation to another rotation.
- applyTo(Rotation, FieldVector3D<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply a rotation to a vector.
- applyTo(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the rotation to a vector.
- applyTo(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the rotation to a vector.
- applyTo(T[], T[]) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the rotation to a vector stored in an array.
- applyTransform(Transform<S, T>) - 类中的方法 org.hipparchus.geometry.partitioning.AbstractRegion
-
Transform a region.
- applyTransform(Transform<S, T>) - 类中的方法 org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Apply a transform to the instance.
- approximateP(double, int, int) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
-
Uses the Kolmogorov-Smirnov distribution to approximate \(P(D_{n,m} > d)\) where \(D_{n,m}\) is the 2-sample Kolmogorov-Smirnov statistic.
- approximateP(double, int, int) - 类中的方法 org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Uses the Kolmogorov-Smirnov distribution to approximate \(P(D_{n,m} > d)\) where \(D_{n,m}\) is the 2-sample Kolmogorov-Smirnov statistic.
- Arc - org.hipparchus.geometry.spherical.oned中的类
-
This class represents an arc on a circle.
- Arc(double, double, double) - 类的构造器 org.hipparchus.geometry.spherical.oned.Arc
-
Simple constructor.
- arccd(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cd.
- arccd(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cd.
- arccd(T) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cd.
- arccn(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cn.
- arccn(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cn.
- arccn(T) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cn.
- arccs(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cs.
- arccs(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cs.
- arccs(T) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function cs.
- arcdc(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function dc.
- arcdc(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function dc.
- arcdc(T) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function dc.
- arcdn(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function dn.
- arcdn(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function dn.
- arcdn(T) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function dn.
- arcds(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function ds.
- arcds(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function ds.
- arcds(T) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function ds.
- arcnc(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function nc.
- arcnc(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function nc.
- arcnc(T) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function nc.
- arcnd(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function nd.
- arcnd(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function nd.
- arcnd(T) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function nd.
- arcns(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function ns.
- arcns(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function ns.
- arcns(T) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function ns.
- arcsc(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sc.
- arcsc(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sc.
- arcsc(T) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sc.
- arcsd(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sd.
- arcsd(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sd.
- arcsd(T) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sd.
- arcsn(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sn.
- arcsn(double) - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sn.
- arcsn(T) - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Evaluate inverse of Jacobi elliptic function sn.
- ArcsSet - org.hipparchus.geometry.spherical.oned中的类
-
This class represents a region of a circle: a set of arcs.
- ArcsSet(double) - 类的构造器 org.hipparchus.geometry.spherical.oned.ArcsSet
-
Build an arcs set representing the whole circle.
- ArcsSet(double, double, double) - 类的构造器 org.hipparchus.geometry.spherical.oned.ArcsSet
-
Build an arcs set corresponding to a single arc.
- ArcsSet(Collection<SubHyperplane<Sphere1D>>, double) - 类的构造器 org.hipparchus.geometry.spherical.oned.ArcsSet
-
Build an arcs set from a Boundary REPresentation (B-rep).
- ArcsSet(BSPTree<Sphere1D>, double) - 类的构造器 org.hipparchus.geometry.spherical.oned.ArcsSet
-
Build an arcs set from an inside/outside BSP tree.
- ArcsSet.InconsistentStateAt2PiWrapping - org.hipparchus.geometry.spherical.oned中的异常错误类
-
Specialized exception for inconsistent BSP tree state inconsistency.
- ArcsSet.Split - org.hipparchus.geometry.spherical.oned中的类
-
Class holding the results of the
split
method. - ArcsSetTest - org.hipparchus.geometry.spherical.oned中的类
- ArcsSetTest() - 类的构造器 org.hipparchus.geometry.spherical.oned.ArcsSetTest
- ArcTest - org.hipparchus.geometry.spherical.oned中的类
- ArcTest() - 类的构造器 org.hipparchus.geometry.spherical.oned.ArcTest
- ARGUMENT_OUTSIDE_DOMAIN - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。ARGUMENT_OUTSIDE_DOMAIN.
- ARGUMENT_OUTSIDE_DOMAIN - 枚举类 中的枚举常量 org.hipparchus.migration.LocalizedMigrationFormats
-
已过时。ARGUMENT_OUTSIDE_DOMAIN.
- ARITHMETIC_EXCEPTION - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
ARITHMETIC_EXCEPTION.
- ARITHMETIC_EXCEPTION - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。ARITHMETIC_EXCEPTION.
- ArithmeticUtils - org.hipparchus.util中的类
-
Some useful, arithmetics related, additions to the built-in functions in
Math
. - ArithmeticUtilsTest - org.hipparchus.util中的类
-
Test cases for the
ArithmeticUtils
class. - ArithmeticUtilsTest() - 类的构造器 org.hipparchus.util.ArithmeticUtilsTest
- ARRAY_ELEMENT - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
ARRAY_ELEMENT.
- ARRAY_ELEMENT - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。ARRAY_ELEMENT.
- ARRAY_SIZE_EXCEEDS_MAX_VARIABLES - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
ARRAY_SIZE_EXCEEDS_MAX_VARIABLES.
- ARRAY_SIZE_EXCEEDS_MAX_VARIABLES - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。ARRAY_SIZE_EXCEEDS_MAX_VARIABLES.
- ARRAY_SIZES_SHOULD_HAVE_DIFFERENCE_1 - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
ARRAY_SIZES_SHOULD_HAVE_DIFFERENCE_1.
- ARRAY_SIZES_SHOULD_HAVE_DIFFERENCE_1 - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。ARRAY_SIZES_SHOULD_HAVE_DIFFERENCE_1.
- ARRAY_SUMS_TO_ZERO - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
ARRAY_SUMS_TO_ZERO.
- ARRAY_SUMS_TO_ZERO - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。ARRAY_SUMS_TO_ZERO.
- ARRAY_ZERO_LENGTH_OR_NULL_NOT_ALLOWED - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
ARRAY_ZERO_LENGTH_OR_NULL_NOT_ALLOWED.
- ARRAY_ZERO_LENGTH_OR_NULL_NOT_ALLOWED - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。ARRAY_ZERO_LENGTH_OR_NULL_NOT_ALLOWED.
- Array2DRowFieldMatrix<T> - org.hipparchus.linear中的类
-
Implementation of
FieldMatrix
using aFieldElement
[][] array to store entries. - Array2DRowFieldMatrix(Field<T>) - 类的构造器 org.hipparchus.linear.Array2DRowFieldMatrix
-
Creates a matrix with no data
- Array2DRowFieldMatrix(Field<T>, int, int) - 类的构造器 org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new
FieldMatrix<T>
with the supplied row and column dimensions. - Array2DRowFieldMatrix(Field<T>, T[]) - 类的构造器 org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new (column)
FieldMatrix<T>
usingv
as the data for the unique column of the created matrix. - Array2DRowFieldMatrix(Field<T>, T[][]) - 类的构造器 org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new
FieldMatrix<T>
using the input array as the underlying data array. - Array2DRowFieldMatrix(Field<T>, T[][], boolean) - 类的构造器 org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new
FieldMatrix<T>
using the input array as the underlying data array. - Array2DRowFieldMatrix(T[]) - 类的构造器 org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new (column)
FieldMatrix<T>
usingv
as the data for the unique column of the created matrix. - Array2DRowFieldMatrix(T[][]) - 类的构造器 org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new
FieldMatrix<T>
using the input array as the underlying data array. - Array2DRowFieldMatrix(T[][], boolean) - 类的构造器 org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new
FieldMatrix<T>
using the input array as the underlying data array. - Array2DRowFieldMatrixTest - org.hipparchus.linear中的类
-
Test cases for the
Array2DRowFieldMatrix
class. - Array2DRowFieldMatrixTest() - 类的构造器 org.hipparchus.linear.Array2DRowFieldMatrixTest
- Array2DRowRealMatrix - org.hipparchus.linear中的类
-
Implementation of
RealMatrix
using adouble[][]
array to store entries. - Array2DRowRealMatrix() - 类的构造器 org.hipparchus.linear.Array2DRowRealMatrix
-
Creates a matrix with no data
- Array2DRowRealMatrix(double[]) - 类的构造器 org.hipparchus.linear.Array2DRowRealMatrix
-
Create a new (column) RealMatrix using
v
as the data for the unique column of the created matrix. - Array2DRowRealMatrix(double[][]) - 类的构造器 org.hipparchus.linear.Array2DRowRealMatrix
-
Create a new
RealMatrix
using the input array as the underlying data array. - Array2DRowRealMatrix(double[][], boolean) - 类的构造器 org.hipparchus.linear.Array2DRowRealMatrix
-
Create a new RealMatrix using the input array as the underlying data array.
- Array2DRowRealMatrix(int, int) - 类的构造器 org.hipparchus.linear.Array2DRowRealMatrix
-
Create a new RealMatrix with the supplied row and column dimensions.
- Array2DRowRealMatrixTest - org.hipparchus.linear中的类
-
Test cases for the
Array2DRowRealMatrix
class. - Array2DRowRealMatrixTest() - 类的构造器 org.hipparchus.linear.Array2DRowRealMatrixTest
- ArrayFieldVector<T> - org.hipparchus.linear中的类
-
This class implements the
FieldVector
interface with aFieldElement
array. - ArrayFieldVector(int, T) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector with preset values.
- ArrayFieldVector(Field<T>) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Build a 0-length vector.
- ArrayFieldVector(Field<T>, int) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector of zeroes.
- ArrayFieldVector(Field<T>, T[]) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from an array, copying the input array.
- ArrayFieldVector(Field<T>, T[], boolean) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Create a new ArrayFieldVector using the input array as the underlying data array.
- ArrayFieldVector(Field<T>, T[], int, int) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from part of a array.
- ArrayFieldVector(Field<T>, T[], T[]) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayFieldVector(ArrayFieldVector<T>) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from another vector, using a deep copy.
- ArrayFieldVector(ArrayFieldVector<T>, boolean) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from another vector.
- ArrayFieldVector(FieldVector<T>) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from another vector, using a deep copy.
- ArrayFieldVector(FieldVector<T>, FieldVector<T>) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayFieldVector(FieldVector<T>, T[]) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayFieldVector(T[]) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from an array, copying the input array.
- ArrayFieldVector(T[], boolean) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Create a new ArrayFieldVector using the input array as the underlying data array.
- ArrayFieldVector(T[], int, int) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from part of a array.
- ArrayFieldVector(T[], FieldVector<T>) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayFieldVector(T[], T[]) - 类的构造器 org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayFieldVectorTest - org.hipparchus.linear中的类
-
Test cases for the
ArrayFieldVector
class. - ArrayFieldVectorTest() - 类的构造器 org.hipparchus.linear.ArrayFieldVectorTest
- ArrayFieldVectorTest.FieldVectorTestImpl<T> - org.hipparchus.linear中的类
- ArrayRealVector - org.hipparchus.linear中的类
-
This class implements the
RealVector
interface with a double array. - ArrayRealVector() - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Build a 0-length vector.
- ArrayRealVector(double[]) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector from an array, copying the input array.
- ArrayRealVector(double[], boolean) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Create a new ArrayRealVector using the input array as the underlying data array.
- ArrayRealVector(double[], double[]) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(double[], int, int) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector from part of a array.
- ArrayRealVector(double[], ArrayRealVector) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(int) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector of zeroes.
- ArrayRealVector(int, double) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector with preset values.
- ArrayRealVector(Double[]) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector from an array.
- ArrayRealVector(Double[], int, int) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector from part of an array.
- ArrayRealVector(ArrayRealVector) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector from another vector, using a deep copy.
- ArrayRealVector(ArrayRealVector, boolean) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector from another vector.
- ArrayRealVector(ArrayRealVector, double[]) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(ArrayRealVector, ArrayRealVector) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(ArrayRealVector, RealVector) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(RealVector) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector from another vector, using a deep copy.
- ArrayRealVector(RealVector, ArrayRealVector) - 类的构造器 org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVectorTest - org.hipparchus.linear中的类
-
Test cases for the
ArrayRealVector
class. - ArrayRealVectorTest() - 类的构造器 org.hipparchus.linear.ArrayRealVectorTest
- asFraction(double[]) - 类中的静态方法 org.hipparchus.linear.MatrixUtilsTest
- asFraction(double[][]) - 类中的静态方法 org.hipparchus.linear.MatrixUtilsTest
- asin() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Arc sine operation.
- asin() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Arc sine operation.
- asin() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
Arc sine operation.
- asin() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Arc sine operation.
- asin() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Arc sine operation.
- asin() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
Arc sine operation.
- asin() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Arc sine operation.
- asin() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Arc sine operation.
- asin() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Arc sine operation.
- asin() - 接口中的方法 org.hipparchus.CalculusFieldElement
-
Arc sine operation.
- asin() - 类中的方法 org.hipparchus.complex.Complex
-
Compute the inverse sine of this complex number.
- asin() - 类中的方法 org.hipparchus.complex.FieldComplex
-
Compute the inverse sine of this complex number.
- asin() - 类中的方法 org.hipparchus.dfp.Dfp
-
Arc sine operation.
- asin() - 类中的方法 org.hipparchus.util.Binary64
-
Arc sine operation.
- asin() - 类中的方法 org.hipparchus.util.FieldTuple
-
Arc sine operation.
- asin() - 类中的方法 org.hipparchus.util.Tuple
-
Arc sine operation.
- asin(double) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute the arc sine of a number.
- asin(double[], int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc sine of a derivative structure.
- asin(Dfp) - 类中的静态方法 org.hipparchus.dfp.DfpMath
-
computes the arc-sine of the argument.
- asin(T) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute the arc sine of a number.
- asin(T[], int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc sine of a derivative structure.
- Asin - org.hipparchus.analysis.function中的类
-
Arc-sine function.
- Asin() - 类的构造器 org.hipparchus.analysis.function.Asin
-
Empty constructor.
- asinh() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Inverse hyperbolic sine operation.
- asinh() - 接口中的方法 org.hipparchus.CalculusFieldElement
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.complex.Complex
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.complex.FieldComplex
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.dfp.Dfp
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.util.Binary64
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.util.FieldTuple
-
Inverse hyperbolic sine operation.
- asinh() - 类中的方法 org.hipparchus.util.Tuple
-
Inverse hyperbolic sine operation.
- asinh(double) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic sine of a number.
- asinh(double[], int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic sine of a derivative structure.
- asinh(T) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic sine of a number.
- asinh(T[], int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic sine of a derivative structure.
- Asinh - org.hipparchus.analysis.function中的类
-
Hyperbolic arc-sine function.
- Asinh() - 类的构造器 org.hipparchus.analysis.function.Asinh
-
Empty constructor.
- asList() - 类中的方法 org.hipparchus.geometry.euclidean.oned.IntervalsSet
-
Build an ordered list of intervals representing the instance.
- asList() - 类中的方法 org.hipparchus.geometry.spherical.oned.ArcsSet
-
Build an ordered list of arcs representing the instance.
- assertChiSquareAccept(double[], long[], double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Asserts the null hypothesis for a ChiSquare test.
- assertChiSquareAccept(int[], double[], long[], double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Asserts the null hypothesis for a ChiSquare test.
- assertChiSquareAccept(String[], double[], long[], double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Asserts the null hypothesis for a ChiSquare test.
- assertClose(double[], double[], double) - 类中的方法 org.hipparchus.linear.BlockRealMatrixTest
-
verifies that two vectors are close (sup norm)
- assertClose(String, double[], double[], double) - 类中的方法 org.hipparchus.linear.SparseRealMatrixTest
-
verifies that two vectors are close (sup norm)
- assertClose(String, Fraction[], Fraction[], double) - 类中的方法 org.hipparchus.linear.SparseFieldMatrixTest
-
verifies that two vectors are close (sup norm)
- assertClose(String, Fraction[], Fraction[], double) - 类中的方法 org.hipparchus.linear.SparseFieldVectorTest
-
verifies that two vectors are close (sup norm)
- assertClose(String, FieldMatrix<Fraction>, FieldMatrix<Fraction>, double) - 类中的方法 org.hipparchus.linear.SparseFieldMatrixTest
-
verifies that two matrices are close (1-norm)
- assertClose(String, RealMatrix, RealMatrix, double) - 类中的方法 org.hipparchus.linear.SparseRealMatrixTest
-
verifies that two matrices are close (1-norm)
- assertClose(RealMatrix, RealMatrix, double) - 类中的方法 org.hipparchus.linear.BlockRealMatrixTest
-
verifies that two matrices are close (1-norm)
- assertContains(double[][], double[], double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
verifies that for i = 0,..., observed.length, observed[i] is within epsilon of one of the values in expected[i] or observed[i] is NaN and expected[i] contains a NaN.
- assertContains(double[], double, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Fails iff values does not contain a number within epsilon of x.
- assertContains(String, double[], double, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Fails iff values does not contain a number within epsilon of x.
- assertContains(String, Complex[], Complex, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Fails iff values does not contain a number within epsilon of z.
- assertContains(Complex[], Complex, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Fails iff values does not contain a number within epsilon of z.
- assertEquals(double[], double[], double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Verifies that two double arrays have equal entries, up to tolerance
- assertEquals(double, double, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Verifies that expected and actual are within delta, or are both NaN or infinities of the same sign.
- assertEquals(double, RealVector, double...) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractLeastSquaresOptimizerAbstractTest
-
Check the value of a vector.
- assertEquals(double, RealVector, double...) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractSequentialLeastSquaresOptimizerAbstractTest
-
Check the value of a vector.
- assertEquals(int[], int[]) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
verifies that two int arrays are equal
- assertEquals(long[], long[]) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
verifies that two int arrays are equal
- assertEquals(String, double[], double[], double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
verifies that two arrays are close (sup norm)
- assertEquals(String, double[], RealVector, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Asserts that all entries of the specified vectors are equal to within a positive
delta
. - assertEquals(String, double, double, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Verifies that expected and actual are within delta, or are both NaN or infinities of the same sign.
- assertEquals(String, Fraction[], Fraction[]) - 类中的方法 org.hipparchus.linear.SparseFieldVectorTest
-
verifies that two vectors are close (sup norm)
- assertEquals(String, RealMatrix, RealMatrix, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
verifies that two matrices are close (1-norm)
- assertEquals(String, RealVector, RealVector, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Asserts that all entries of the specified vectors are equal to within a positive
delta
. - assertEquals(Complex, Complex, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Verifies that real and imaginary parts of the two complex arguments differ by at most delta.
- assertEquals(FieldComplex<Binary64>, FieldComplex<Binary64>, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Verifies that real and imaginary parts of the two complex arguments differ by at most delta.
- assertEquals(FieldMatrix<? extends FieldElement<?>>, FieldMatrix<? extends FieldElement<?>>) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
verifies that two matrices are equal
- assertEquals(T[], T[]) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
verifies that two arrays are equal
- assertGTest(double[], long[], double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Asserts the null hypothesis that the observed counts follow the given distribution implied by expected, using a G-test
- assertGTest(RealDistribution, double[], double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Asserts the null hypothesis that the sample follows the given distribution, using a G-test
- assertRelativelyEquals(double, double, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Verifies that the relative error in actual vs. expected is less than or equal to relativeError.
- assertRelativelyEquals(String, double, double, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Verifies that the relative error in actual vs. expected is less than or equal to relativeError.
- assertSame(double, double) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Verifies that the two arguments are exactly the same, either both NaN or infinities of same sign, or identical floating point values.
- assertSame(Complex, Complex) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Verifies that real and imaginary parts of the two complex arguments are exactly the same.
- assertSame(FieldComplex<Binary64>, FieldComplex<Binary64>) - 类中的静态方法 org.hipparchus.UnitTestUtils
-
Verifies that real and imaginary parts of the two complex arguments are exactly the same.
- assertStatisticalSummaryEquals(StatisticalSummary, StatisticalSummary, double) - 类中的静态方法 org.hipparchus.stat.descriptive.StatisticalSummaryTest
-
Verifies that a StatisticalSummary and a StatisticalSummaryValues are equal up to delta, with NaNs, infinities returned in the same spots.
- assertSummaryStatisticsEquals(StreamingStatistics, StreamingStatistics, double) - 类中的静态方法 org.hipparchus.stat.descriptive.StreamingStatisticsTest
-
Verifies that a StatisticalSummary and a StatisticalSummaryValues are equal up to delta, with NaNs, infinities returned in the same spots.
- ASSYMETRIC_EIGEN_NOT_SUPPORTED - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。ASSYMETRIC_EIGEN_NOT_SUPPORTED.
- ASSYMETRIC_EIGEN_NOT_SUPPORTED - 枚举类 中的枚举常量 org.hipparchus.migration.LocalizedMigrationFormats
-
已过时。ASSYMETRIC_EIGEN_NOT_SUPPORTED.
- AT_LEAST_ONE_COLUMN - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
AT_LEAST_ONE_COLUMN.
- AT_LEAST_ONE_COLUMN - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。AT_LEAST_ONE_COLUMN.
- AT_LEAST_ONE_ROW - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
AT_LEAST_ONE_ROW.
- AT_LEAST_ONE_ROW - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。AT_LEAST_ONE_ROW.
- atan() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Arc tangent operation.
- atan() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Arc tangent operation.
- atan() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
Arc tangent operation.
- atan() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Arc tangent operation.
- atan() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Arc tangent operation.
- atan() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
Arc tangent operation.
- atan() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Arc tangent operation.
- atan() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Arc tangent operation.
- atan() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Arc tangent operation.
- atan() - 接口中的方法 org.hipparchus.CalculusFieldElement
-
Arc tangent operation.
- atan() - 类中的方法 org.hipparchus.complex.Complex
-
Compute the inverse tangent of this complex number.
- atan() - 类中的方法 org.hipparchus.complex.FieldComplex
-
Compute the inverse tangent of this complex number.
- atan() - 类中的方法 org.hipparchus.dfp.Dfp
-
Arc tangent operation.
- atan() - 类中的方法 org.hipparchus.util.Binary64
-
Arc tangent operation.
- atan() - 类中的方法 org.hipparchus.util.FieldTuple
-
Arc tangent operation.
- atan() - 类中的方法 org.hipparchus.util.Tuple
-
Arc tangent operation.
- atan(double) - 类中的静态方法 org.hipparchus.util.FastMath
-
Arctangent function
- atan(double[], int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc tangent of a derivative structure.
- atan(Dfp) - 类中的静态方法 org.hipparchus.dfp.DfpMath
-
computes the arc tangent of the argument Uses the typical taylor series but may reduce arguments using the following identity tan(x+y) = (tan(x) + tan(y)) / (1 - tan(x)*tan(y)) since tan(PI/8) = sqrt(2)-1, atan(x) = atan( (x - sqrt(2) + 1) / (1+x*sqrt(2) - x) + PI/8.0
- atan(T) - 类中的静态方法 org.hipparchus.util.FastMath
-
Arctangent function
- atan(T[], int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc tangent of a derivative structure.
- Atan - org.hipparchus.analysis.function中的类
-
Arc-tangent function.
- Atan() - 类的构造器 org.hipparchus.analysis.function.Atan
-
Empty constructor.
- atan2(double[], int, double[], int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute two arguments arc tangent of a derivative structure.
- atan2(double, double) - 类中的静态方法 org.hipparchus.util.FastMath
-
Two arguments arctangent function
- atan2(DerivativeStructure) - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Two arguments arc tangent operation.
- atan2(DerivativeStructure, DerivativeStructure) - 类中的静态方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Two arguments arc tangent operation.
- atan2(FieldDerivativeStructure<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Two arguments arc tangent operation.
- atan2(FieldDerivativeStructure<T>, FieldDerivativeStructure<T>) - 类中的静态方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Two arguments arc tangent operation.
- atan2(FieldGradient<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
Two arguments arc tangent operation.
- atan2(FieldUnivariateDerivative1<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Two arguments arc tangent operation.
- atan2(FieldUnivariateDerivative2<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Two arguments arc tangent operation.
- atan2(Gradient) - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
Two arguments arc tangent operation.
- atan2(SparseGradient) - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Two arguments arc tangent operation.
- atan2(SparseGradient, SparseGradient) - 类中的静态方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Two arguments arc tangent operation.
- atan2(UnivariateDerivative1) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Two arguments arc tangent operation.
- atan2(UnivariateDerivative2) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Two arguments arc tangent operation.
- atan2(Complex) - 类中的方法 org.hipparchus.complex.Complex
-
Two arguments arc tangent operation.
- atan2(FieldComplex<T>) - 类中的方法 org.hipparchus.complex.FieldComplex
-
Two arguments arc tangent operation.
- atan2(Dfp) - 类中的方法 org.hipparchus.dfp.Dfp
-
Two arguments arc tangent operation.
- atan2(Binary64) - 类中的方法 org.hipparchus.util.Binary64
-
Two arguments arc tangent operation.
- atan2(FieldTuple<T>) - 类中的方法 org.hipparchus.util.FieldTuple
-
Two arguments arc tangent operation.
- atan2(Tuple) - 类中的方法 org.hipparchus.util.Tuple
-
Two arguments arc tangent operation.
- atan2(T) - 接口中的方法 org.hipparchus.CalculusFieldElement
-
Two arguments arc tangent operation.
- atan2(T[], int, T[], int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute two arguments arc tangent of a derivative structure.
- atan2(T, T) - 类中的静态方法 org.hipparchus.util.FastMath
-
Two arguments arctangent function
- Atan2 - org.hipparchus.analysis.function中的类
-
Arc-tangent function.
- Atan2() - 类的构造器 org.hipparchus.analysis.function.Atan2
-
Empty constructor.
- atanh() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Inverse hyperbolic tangent operation.
- atanh() - 接口中的方法 org.hipparchus.CalculusFieldElement
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.complex.Complex
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.complex.FieldComplex
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.dfp.Dfp
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.util.Binary64
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.util.FieldTuple
-
Inverse hyperbolic tangent operation.
- atanh() - 类中的方法 org.hipparchus.util.Tuple
-
Inverse hyperbolic tangent operation.
- atanh(double) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic tangent of a number.
- atanh(double[], int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic tangent of a derivative structure.
- atanh(T) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic tangent of a number.
- atanh(T[], int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic tangent of a derivative structure.
- Atanh - org.hipparchus.analysis.function中的类
-
Hyperbolic arc-tangent function.
- Atanh() - 类的构造器 org.hipparchus.analysis.function.Atanh
-
Empty constructor.
- atanInternal(Dfp) - 类中的静态方法 org.hipparchus.dfp.DfpMath
-
computes the arc-tangent of the argument.
- AVERAGE - 枚举类 中的枚举常量 org.hipparchus.stat.ranking.TiesStrategy
-
Ties get the average of applicable ranks
常量字段值|所有程序包|所有类和接口|序列化表格