索引
常量字段值|所有程序包|所有类和接口|序列化表格
F
- F(Complex, Complex) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralComplexTest
- F(FieldComplex<Binary64>, FieldComplex<Binary64>) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralFieldComplexTest
- F(T, T) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralAbstractComplexTest
- FACET_ORIENTATION_MISMATCH - 枚举类 中的枚举常量 org.hipparchus.geometry.LocalizedGeometryFormats
-
FACET_ORIENTATION_MISMATCH.
- FACET_ORIENTATION_MISMATCH - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。FACET_ORIENTATION_MISMATCH.
- FACET_WITH_SEVERAL_BOUNDARY_LOOPS - 枚举类 中的枚举常量 org.hipparchus.geometry.LocalizedGeometryFormats
-
FACET_WITH_SEVERAL_BOUNDARY_LOOPS.
- factorial(int) - 类中的静态方法 org.hipparchus.util.CombinatoricsUtils
-
Returns n!.
- FACTORIAL_NEGATIVE_PARAMETER - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
FACTORIAL_NEGATIVE_PARAMETER.
- FACTORIAL_NEGATIVE_PARAMETER - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。FACTORIAL_NEGATIVE_PARAMETER.
- factorialDouble(int) - 类中的静态方法 org.hipparchus.util.CombinatoricsUtils
-
Compute n!
- factorialLog(int) - 类中的静态方法 org.hipparchus.util.CombinatoricsUtils
-
Compute the natural logarithm of the factorial of
n
. - FactorialLogTest - org.hipparchus.util中的类
-
Test cases for the
CombinatoricsUtils.FactorialLog
class. - FactorialLogTest() - 类的构造器 org.hipparchus.util.FactorialLogTest
- fail(LeastSquaresOptimizer) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractLeastSquaresOptimizerAbstractTest
- fail(LeastSquaresOptimizer) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractSequentialLeastSquaresOptimizerAbstractTest
- FAILED - 枚举类 中的枚举常量 org.hipparchus.stat.ranking.NaNStrategy
-
NaNs result in an exception
- FAILED_BRACKETING - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
FAILED_BRACKETING.
- FAILED_BRACKETING - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。FAILED_BRACKETING.
- FAILED_DECOMPOSITION - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
FAILED_DECOMPOSITION.
- FAILED_FRACTION_CONVERSION - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
FAILED_FRACTION_CONVERSION.
- FAILED_FRACTION_CONVERSION - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。FAILED_FRACTION_CONVERSION.
- FARTHEST_POINT - 枚举类 中的枚举常量 org.hipparchus.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
-
Create a cluster around the point farthest from its centroid.
- FastCosineTransformer - org.hipparchus.transform中的类
-
Implements the Fast Cosine Transform for transformation of one-dimensional real data sets.
- FastCosineTransformer(DctNormalization) - 类的构造器 org.hipparchus.transform.FastCosineTransformer
-
Creates a new instance of this class, with various normalization conventions.
- FastCosineTransformerTest - org.hipparchus.transform中的类
-
Test case for fast cosine transformer.
- FastCosineTransformerTest(DctNormalization) - 类的构造器 org.hipparchus.transform.FastCosineTransformerTest
- FastFourierTransformer - org.hipparchus.transform中的类
-
Implements the Fast Fourier Transform for transformation of one-dimensional real or complex data sets.
- FastFourierTransformer(DftNormalization) - 类的构造器 org.hipparchus.transform.FastFourierTransformer
-
Creates a new instance of this class, with various normalization conventions.
- FastFourierTransformerTest - org.hipparchus.transform中的类
-
Test case for fast Fourier transformer.
- FastFourierTransformerTest() - 类的构造器 org.hipparchus.transform.FastFourierTransformerTest
- FastHadamardTransformer - org.hipparchus.transform中的类
-
Implements the Fast Hadamard Transform (FHT).
- FastHadamardTransformer() - 类的构造器 org.hipparchus.transform.FastHadamardTransformer
-
Empty constructor.
- FastHadamardTransformerTest - org.hipparchus.transform中的类
-
JUnit Test for HadamardTransformerTest
- FastHadamardTransformerTest() - 类的构造器 org.hipparchus.transform.FastHadamardTransformerTest
- FastMath - org.hipparchus.util中的类
-
Faster, more accurate, portable alternative to
Math
andStrictMath
for large scale computation. - FastMathCalcTest - org.hipparchus.util中的类
- FastMathCalcTest() - 类的构造器 org.hipparchus.util.FastMathCalcTest
- FastMathStrictComparisonTest - org.hipparchus.util中的类
-
Test to compare FastMath results against StrictMath results for boundary values.
- FastMathStrictComparisonTest(Method, Method, Type[], Object[][]) - 类的构造器 org.hipparchus.util.FastMathStrictComparisonTest
- FastMathTest - org.hipparchus.util中的类
- FastMathTest() - 类的构造器 org.hipparchus.util.FastMathTest
- FastSineTransformer - org.hipparchus.transform中的类
-
Implements the Fast Sine Transform for transformation of one-dimensional real data sets.
- FastSineTransformer(DstNormalization) - 类的构造器 org.hipparchus.transform.FastSineTransformer
-
Creates a new instance of this class, with various normalization conventions.
- FastSineTransformerTest - org.hipparchus.transform中的类
-
Test case for fast sine transformer.
- FastSineTransformerTest(DstNormalization) - 类的构造器 org.hipparchus.transform.FastSineTransformerTest
- fct(double[]) - 类中的方法 org.hipparchus.transform.FastCosineTransformer
-
Perform the FCT algorithm (including inverse).
- FDistribution - org.hipparchus.distribution.continuous中的类
-
Implementation of the F-distribution.
- FDistribution(double, double) - 类的构造器 org.hipparchus.distribution.continuous.FDistribution
-
Creates an F distribution using the given degrees of freedom.
- FDistribution(double, double, double) - 类的构造器 org.hipparchus.distribution.continuous.FDistribution
-
Creates an F distribution.
- FDistributionTest - org.hipparchus.distribution.continuous中的类
-
Test cases for FDistribution.
- FDistributionTest() - 类的构造器 org.hipparchus.distribution.continuous.FDistributionTest
- FDSFactory<T> - org.hipparchus.analysis.differentiation中的类
-
Factory for
FieldDerivativeStructure
. - FDSFactory(Field<T>, int, int) - 类的构造器 org.hipparchus.analysis.differentiation.FDSFactory
-
Simple constructor.
- FDSFactory.DerivativeField<T> - org.hipparchus.analysis.differentiation中的类
-
Field for {link FieldDerivativeStructure} instances.
- fht(double[]) - 类中的方法 org.hipparchus.transform.FastHadamardTransformer
-
The FHT (Fast Hadamard Transformation) which uses only subtraction and addition.
- fht(int[]) - 类中的方法 org.hipparchus.transform.FastHadamardTransformer
-
Returns the forward transform of the specified integer data set.
- field - 类中的变量 org.hipparchus.linear.SparseFieldMatrixTest
- field - 类中的变量 org.hipparchus.linear.SparseFieldVectorTest
- Field<T> - org.hipparchus中的接口
-
Interface representing a field.
- FieldAbstractRuleFactory<T> - org.hipparchus.analysis.integration.gauss中的类
-
Base class for rules that determines the integration nodes and their weights.
- FieldAbstractRuleFactory(Field<T>) - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldAbstractRuleFactory
-
Simple constructor
- FieldAdaptableInterval<T> - org.hipparchus.ode.events中的接口
-
This interface represents an event checking interval that depends on state.
- FieldBivariateFunction - org.hipparchus.analysis中的接口
-
An interface representing a bivariate field function.
- FieldBlendable<B,
T> - org.hipparchus.util中的接口 -
Interface representing classes that can blend with other instances of themselves using a given blending value.
- FieldBracketingNthOrderBrentSolver<T> - org.hipparchus.analysis.solvers中的类
-
This class implements a modification of the Brent algorithm.
- FieldBracketingNthOrderBrentSolver(T, T, T, int) - 类的构造器 org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
-
Construct a solver.
- FieldBracketingNthOrderBrentSolverTest - org.hipparchus.analysis.solvers中的类
-
Test case for
bracketing nth order Brent
solver. - FieldBracketingNthOrderBrentSolverTest() - 类的构造器 org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolverTest
- FieldButcherArrayProvider<T> - org.hipparchus.ode.nonstiff中的接口
-
This interface represents an integrator based on Butcher arrays.
- FieldCloseEventsTest - org.hipparchus.ode.events中的类
-
Check events are detected correctly when the event times are close.
- FieldCloseEventsTest() - 类的构造器 org.hipparchus.ode.events.FieldCloseEventsTest
- FieldCloseEventsTest.Equation - org.hipparchus.ode.events中的类
-
Some basic equations to integrate.
- FieldCloseEventsTest.EquationODE - org.hipparchus.ode.events中的类
-
Some basic equations to integrate.
- FieldComplex<T> - org.hipparchus.complex中的类
-
Representation of a Complex number, i.e. a number which has both a real and imaginary part.
- FieldComplex(T) - 类的构造器 org.hipparchus.complex.FieldComplex
-
Create a complex number given only the real part.
- FieldComplex(T, T) - 类的构造器 org.hipparchus.complex.FieldComplex
-
Create a complex number given the real and imaginary parts.
- FieldComplexField<T> - org.hipparchus.complex中的类
-
Representation of the complex numbers field.
- FieldComplexFieldTest - org.hipparchus.complex中的类
- FieldComplexFieldTest() - 类的构造器 org.hipparchus.complex.FieldComplexFieldTest
- FieldComplexTest - org.hipparchus.complex中的类
- FieldComplexTest() - 类的构造器 org.hipparchus.complex.FieldComplexTest
- FieldComplexTest.TestComplex - org.hipparchus.complex中的类
-
Class to test extending Complex
- FieldComplexUnivariateIntegrator<T> - org.hipparchus.complex中的类
-
Wrapper to perform univariate complex integration using an underlying real integration algorithms.
- FieldComplexUnivariateIntegrator(FieldUnivariateIntegrator<T>) - 类的构造器 org.hipparchus.complex.FieldComplexUnivariateIntegrator
-
Crate a complex integrator from a real integrator.
- FieldComplexUnivariateIntegratorTest - org.hipparchus.complex中的类
- FieldComplexUnivariateIntegratorTest() - 类的构造器 org.hipparchus.complex.FieldComplexUnivariateIntegratorTest
- FieldContinuedFraction - org.hipparchus.util中的类
-
Provides a generic means to evaluate continued fractions.
- FieldContinuedFraction() - 类的构造器 org.hipparchus.util.FieldContinuedFraction
-
Default constructor.
- FieldContinuedFractionTest - org.hipparchus.util中的类
-
Tests for ContinuedFraction.
- FieldContinuedFractionTest() - 类的构造器 org.hipparchus.util.FieldContinuedFractionTest
- FieldCopolarC<T> - org.hipparchus.special.elliptic.jacobi中的类
-
Copolar trio with pole at point c in Glaisher’s Notation.
- FieldCopolarD<T> - org.hipparchus.special.elliptic.jacobi中的类
-
Copolar trio with pole at point d in Glaisher’s Notation.
- FieldCopolarN<T> - org.hipparchus.special.elliptic.jacobi中的类
-
Copolar trio with pole at point n in Glaisher’s Notation.
- FieldCopolarS<T> - org.hipparchus.special.elliptic.jacobi中的类
-
Copolar trio with pole at point s in Glaisher’s Notation.
- FieldDecompositionSolver<T> - org.hipparchus.linear中的接口
-
Interface handling decomposition algorithms that can solve A × X = B.
- FieldDenseOutputModel<T> - org.hipparchus.ode中的类
-
This class stores all information provided by an ODE integrator during the integration process and build a continuous model of the solution from this.
- FieldDenseOutputModel() - 类的构造器 org.hipparchus.ode.FieldDenseOutputModel
-
Simple constructor.
- FieldDenseOutputModelTest - org.hipparchus.ode中的类
- FieldDenseOutputModelTest() - 类的构造器 org.hipparchus.ode.FieldDenseOutputModelTest
- FieldDerivative<S,
T> - org.hipparchus.analysis.differentiation中的接口 -
Interface representing both the value and the differentials of a function.
- FieldDerivativeStructure<T> - org.hipparchus.analysis.differentiation中的类
-
Class representing both the value and the differentials of a function.
- FieldDerivativeStructureAbstractTest<T> - org.hipparchus.analysis.differentiation中的类
-
Abstract test for class
FieldDerivativeStructure
. - FieldDerivativeStructureAbstractTest() - 类的构造器 org.hipparchus.analysis.differentiation.FieldDerivativeStructureAbstractTest
- FieldDerivativeStructureBinary64Test - org.hipparchus.analysis.differentiation中的类
-
Test for class
FieldDerivativeStructure
onBinary64
. - FieldDerivativeStructureBinary64Test() - 类的构造器 org.hipparchus.analysis.differentiation.FieldDerivativeStructureBinary64Test
- FieldDerivativeStructureComplexTest - org.hipparchus.analysis.differentiation中的类
-
Test for class
FieldDerivativeStructure
onComplex
. - FieldDerivativeStructureComplexTest() - 类的构造器 org.hipparchus.analysis.differentiation.FieldDerivativeStructureComplexTest
- FieldDerivativeStructureDfpTest - org.hipparchus.analysis.differentiation中的类
-
Test for class
FieldDerivativeStructure
onDfp
. - FieldDerivativeStructureDfpTest() - 类的构造器 org.hipparchus.analysis.differentiation.FieldDerivativeStructureDfpTest
- FieldDetectorBasedEventState<T> - org.hipparchus.ode.events中的类
-
This class handles the state for one
event handler
during integration steps. - FieldDetectorBasedEventState(FieldODEEventDetector<T>) - 类的构造器 org.hipparchus.ode.events.FieldDetectorBasedEventState
-
Simple constructor.
- FieldElement<T> - org.hipparchus中的接口
-
Interface representing field elements.
- FieldEquationsMapper<T> - org.hipparchus.ode中的类
-
Class mapping the part of a complete state or derivative that pertains to a set of differential equations.
- FieldEvent(double, T, int, boolean, boolean) - 类的构造器 org.hipparchus.ode.events.EventSlopeFilterTest.FieldEvent
- FieldEventOccurrence<T> - org.hipparchus.ode.events中的类
-
Class to hold the data related to an event occurrence that is needed to decide how to modify integration.
- FieldEventOccurrence(Action, FieldODEState<T>, T) - 类的构造器 org.hipparchus.ode.events.FieldEventOccurrence
-
Create a new occurrence of an event.
- FieldEventSlopeFilter<T,
E> - org.hipparchus.ode.events中的类 -
Wrapper used to detect only increasing or decreasing events.
- FieldEventSlopeFilter(Field<E>, T, FilterType) - 类的构造器 org.hipparchus.ode.events.FieldEventSlopeFilter
-
Wrap a
eve,t detector
. - FieldEventState<T> - org.hipparchus.ode.events中的接口
-
This interface handles the state for either one
event handler
or onestep end handler
during integration steps. - FieldExpandableODE<T> - org.hipparchus.ode中的类
-
This class represents a combined set of first order differential equations, with at least a primary set of equations expandable by some sets of secondary equations.
- FieldExpandableODE(FieldOrdinaryDifferentialEquation<T>) - 类的构造器 org.hipparchus.ode.FieldExpandableODE
-
Build an expandable set from its primary ODE set.
- FieldExpandableODETest - org.hipparchus.ode中的类
- FieldExpandableODETest() - 类的构造器 org.hipparchus.ode.FieldExpandableODETest
- FieldFunctionsTest - org.hipparchus.analysis中的类
- FieldFunctionsTest() - 类的构造器 org.hipparchus.analysis.FieldFunctionsTest
- FieldGaussianQuadratureAbstractTest - org.hipparchus.analysis.integration.gauss中的类
-
Base class for standard testing of Gaussian quadrature rules, which are exact for polynomials up to a certain degree.
- FieldGaussianQuadratureAbstractTest(FieldGaussIntegrator<Binary64>, int, double, double) - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldGaussianQuadratureAbstractTest
-
Creates a new instance of this abstract test with the specified quadrature rule.
- FieldGaussIntegrator<T> - org.hipparchus.analysis.integration.gauss中的类
-
Class that implements the Gaussian rule for
integrating
a weighted function. - FieldGaussIntegrator(Pair<T[], T[]>) - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldGaussIntegrator
-
Creates an integrator from the given pair of points (first element of the pair) and weights (second element of the pair.
- FieldGaussIntegrator(T[], T[]) - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldGaussIntegrator
-
Creates an integrator from the given
points
andweights
. - FieldGaussIntegratorFactory<T> - org.hipparchus.analysis.integration.gauss中的类
-
Class that provides different ways to compute the nodes and weights to be used by the
Gaussian integration rule
. - FieldGaussIntegratorFactory(Field<T>) - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldGaussIntegratorFactory
-
Simple constructor.
- FieldGaussIntegratorTest - org.hipparchus.analysis.integration.gauss中的类
-
Test for
GaussIntegrator
class. - FieldGaussIntegratorTest() - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldGaussIntegratorTest
- FieldGradient<T> - org.hipparchus.analysis.differentiation中的类
-
Class representing both the value and the differentials of a function.
- FieldGradient(FieldDerivativeStructure<T>) - 类的构造器 org.hipparchus.analysis.differentiation.FieldGradient
-
Build an instance from a
DerivativeStructure
. - FieldGradient(T, T...) - 类的构造器 org.hipparchus.analysis.differentiation.FieldGradient
-
Build an instance with values and derivative.
- FieldGradientAbstractTest<T> - org.hipparchus.analysis.differentiation中的类
-
Test for class
引用无效
FieldGradiant
- FieldGradientAbstractTest() - 类的构造器 org.hipparchus.analysis.differentiation.FieldGradientAbstractTest
- FieldGradientBinary64Test - org.hipparchus.analysis.differentiation中的类
-
Test for class
FieldGradient
onBinary64
. - FieldGradientBinary64Test() - 类的构造器 org.hipparchus.analysis.differentiation.FieldGradientBinary64Test
- FieldGradientDfpTest - org.hipparchus.analysis.differentiation中的类
-
Test for class
FieldGradient
onDfp
. - FieldGradientDfpTest() - 类的构造器 org.hipparchus.analysis.differentiation.FieldGradientDfpTest
- FieldGradientField<T> - org.hipparchus.analysis.differentiation中的类
-
Field for
Gradient
instances. - FieldHermiteInterpolator<T> - org.hipparchus.analysis.interpolation中的类
-
Polynomial interpolator using both sample values and sample derivatives.
- FieldHermiteInterpolator() - 类的构造器 org.hipparchus.analysis.interpolation.FieldHermiteInterpolator
-
Create an empty interpolator.
- FieldHermiteInterpolatorTest - org.hipparchus.analysis.interpolation中的类
- FieldHermiteInterpolatorTest() - 类的构造器 org.hipparchus.analysis.interpolation.FieldHermiteInterpolatorTest
- FieldHermiteParametricTest - org.hipparchus.analysis.integration.gauss中的类
-
Test of the
FieldHermiteRuleFactory
. - FieldHermiteParametricTest(int, int, double, double) - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldHermiteParametricTest
-
Creates a new instance of this test, with the specified number of nodes for the Gauss-Hermite quadrature rule.
- FieldHermiteRuleFactory<T> - org.hipparchus.analysis.integration.gauss中的类
-
Factory that creates a Gauss-type quadrature rule using Hermite polynomials of the first kind.
- FieldHermiteRuleFactory(Field<T>) - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldHermiteRuleFactory
-
Simple constructor
- FieldHermiteTest - org.hipparchus.analysis.integration.gauss中的类
-
Test of the
HermiteRuleFactory
. - FieldHermiteTest() - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldHermiteTest
- FieldIterativeLegendreGaussIntegratorTest - org.hipparchus.analysis.integration中的类
- FieldIterativeLegendreGaussIntegratorTest() - 类的构造器 org.hipparchus.analysis.integration.FieldIterativeLegendreGaussIntegratorTest
- FieldJacobiElliptic<T> - org.hipparchus.special.elliptic.jacobi中的类
-
Computation of Jacobi elliptic functions.
- FieldJacobiElliptic(T) - 类的构造器 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
-
Simple constructor.
- FieldJacobiEllipticTest - org.hipparchus.special.elliptic.jacobi中的类
- FieldJacobiEllipticTest() - 类的构造器 org.hipparchus.special.elliptic.jacobi.FieldJacobiEllipticTest
- FieldJacobiTheta<T> - org.hipparchus.special.elliptic.jacobi中的类
-
Algorithm computing Jacobi theta functions.
- FieldJacobiTheta(T) - 类的构造器 org.hipparchus.special.elliptic.jacobi.FieldJacobiTheta
-
Simple constructor.
- FieldJacobiThetaTest - org.hipparchus.special.elliptic.jacobi中的类
- FieldJacobiThetaTest() - 类的构造器 org.hipparchus.special.elliptic.jacobi.FieldJacobiThetaTest
- FieldLaguerreRuleFactory<T> - org.hipparchus.analysis.integration.gauss中的类
-
Factory that creates Gauss-type quadrature rule using Laguerre polynomials.
- FieldLaguerreRuleFactory(Field<T>) - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldLaguerreRuleFactory
-
Simple constructor
- FieldLaguerreTest - org.hipparchus.analysis.integration.gauss中的类
-
Test of the
FieldLaguerreRuleFactory
. - FieldLaguerreTest() - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldLaguerreTest
- FieldLegendreEllipticIntegralTest - org.hipparchus.special.elliptic.legendre中的类
- FieldLegendreEllipticIntegralTest() - 类的构造器 org.hipparchus.special.elliptic.legendre.FieldLegendreEllipticIntegralTest
- FieldLegendreParametricTest - org.hipparchus.analysis.integration.gauss中的类
-
Test of the
FieldLegendreRuleFactory
. - FieldLegendreParametricTest(int, int, double, double) - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldLegendreParametricTest
-
Creates a new instance of this test, with the specified number of nodes for the Gauss-Legendre quadrature rule.
- FieldLegendreRuleFactory<T> - org.hipparchus.analysis.integration.gauss中的类
-
Factory that creates Gauss-type quadrature rule using Legendre polynomials.
- FieldLegendreRuleFactory(Field<T>) - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldLegendreRuleFactory
-
Simple constructor
- FieldLegendreTest - org.hipparchus.analysis.integration.gauss中的类
-
Test of the
FieldLegendreRuleFactory
. - FieldLegendreTest() - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldLegendreTest
- FieldLine<T> - org.hipparchus.geometry.euclidean.threed中的类
-
The class represent lines in a three dimensional space.
- FieldLine(FieldLine<T>) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldLine
-
Copy constructor.
- FieldLine(FieldVector3D<T>, FieldVector3D<T>, double) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldLine
-
Build a line from two points.
- FieldLineTest - org.hipparchus.geometry.euclidean.threed中的类
- FieldLineTest() - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldLineTest
- FieldLUDecomposer<T> - org.hipparchus.linear中的类
-
Matrix decomposer using LU-decomposition.
- FieldLUDecomposer(Predicate<T>) - 类的构造器 org.hipparchus.linear.FieldLUDecomposer
-
Creates a LU decomposer with specific zero checker for several matrices.
- FieldLUDecomposition<T> - org.hipparchus.linear中的类
-
Calculates the LUP-decomposition of a square matrix.
- FieldLUDecomposition(FieldMatrix<T>) - 类的构造器 org.hipparchus.linear.FieldLUDecomposition
-
Calculates the LU-decomposition of the given matrix.
- FieldLUDecomposition(FieldMatrix<T>, Predicate<T>) - 类的构造器 org.hipparchus.linear.FieldLUDecomposition
-
Calculates the LU-decomposition of the given matrix.
- FieldLUDecomposition(FieldMatrix<T>, Predicate<T>, boolean) - 类的构造器 org.hipparchus.linear.FieldLUDecomposition
-
Calculates the LU-decomposition of the given matrix.
- FieldLUDecompositionTest - org.hipparchus.linear中的类
- FieldLUDecompositionTest() - 类的构造器 org.hipparchus.linear.FieldLUDecompositionTest
- FieldLUSolverTest - org.hipparchus.linear中的类
- FieldLUSolverTest() - 类的构造器 org.hipparchus.linear.FieldLUSolverTest
- FieldMatrix<T> - org.hipparchus.linear中的接口
-
Interface defining field-valued matrix with basic algebraic operations.
- FieldMatrixChangingVisitor<T> - org.hipparchus.linear中的接口
-
Interface defining a visitor for matrix entries.
- FieldMatrixDecomposer<T> - org.hipparchus.linear中的接口
-
Interface for all algorithms providing matrix decomposition.
- FieldMatrixPreservingVisitor<T> - org.hipparchus.linear中的接口
-
Interface defining a visitor for matrix entries.
- FieldMatrixTest - org.hipparchus.linear中的类
- FieldMatrixTest() - 类的构造器 org.hipparchus.linear.FieldMatrixTest
- FieldMidPointIntegrator<T> - org.hipparchus.analysis.integration中的类
-
Implements the Midpoint Rule for integration of real univariate functions.
- FieldMidPointIntegrator(Field<T>) - 类的构造器 org.hipparchus.analysis.integration.FieldMidPointIntegrator
-
Construct a midpoint integrator with default settings.
- FieldMidPointIntegrator(Field<T>, double, double, int, int) - 类的构造器 org.hipparchus.analysis.integration.FieldMidPointIntegrator
-
Build a midpoint integrator with given accuracies and iterations counts.
- FieldMidPointIntegrator(Field<T>, int, int) - 类的构造器 org.hipparchus.analysis.integration.FieldMidPointIntegrator
-
Build a midpoint integrator with given iteration counts.
- FieldMidPointIntegratorTest - org.hipparchus.analysis.integration中的类
-
Test case for midpoint integrator.
- FieldMidPointIntegratorTest() - 类的构造器 org.hipparchus.analysis.integration.FieldMidPointIntegratorTest
- FieldMultivariateFunction - org.hipparchus.analysis中的接口
-
An interface representing a scalar multivariate function for any field type.
- FieldMultivariateMatrixFunction - org.hipparchus.analysis中的接口
-
An interface representing a matrix multivariate function for any field type.
- FieldMultivariateVectorFunction - org.hipparchus.analysis中的接口
-
An interface representing a vector multivariate function for any field type.
- FieldODEEventDetector<T> - org.hipparchus.ode.events中的接口
-
This interface represents a handler for discrete events triggered during ODE integration.
- FieldODEEventHandler<T> - org.hipparchus.ode.events中的接口
-
This interface represents a handler for discrete events triggered during ODE integration.
- FieldODEFixedStepHandler<T> - org.hipparchus.ode.sampling中的接口
-
This interface represents a handler that should be called after each successful fixed step.
- FieldODEIntegrator<T> - org.hipparchus.ode中的接口
-
This interface represents a first order integrator for differential equations.
- FieldODEState<T> - org.hipparchus.ode中的类
-
Container for time, main and secondary state vectors.
- FieldODEState(T, T[]) - 类的构造器 org.hipparchus.ode.FieldODEState
-
Simple constructor.
- FieldODEState(T, T[], T[][]) - 类的构造器 org.hipparchus.ode.FieldODEState
-
Simple constructor.
- FieldODEStateAndDerivative<T> - org.hipparchus.ode中的类
-
Container for time, main and secondary state vectors as well as their derivatives.
- FieldODEStateAndDerivative(T, T[], T[]) - 类的构造器 org.hipparchus.ode.FieldODEStateAndDerivative
-
Simple constructor.
- FieldODEStateAndDerivative(T, T[], T[], T[][], T[][]) - 类的构造器 org.hipparchus.ode.FieldODEStateAndDerivative
-
Simple constructor.
- FieldODEStateInterpolator<T> - org.hipparchus.ode.sampling中的接口
-
This interface represents an interpolator over the last step during an ODE integration.
- FieldODEStateInterpolatorAbstractTest - org.hipparchus.ode.nonstiff中的类
- FieldODEStateInterpolatorAbstractTest() - 类的构造器 org.hipparchus.ode.nonstiff.FieldODEStateInterpolatorAbstractTest
- FieldODEStateInterpolatorAbstractTest.ReferenceFieldODE<T> - org.hipparchus.ode.nonstiff中的接口
- FieldODEStepEndHandler<T> - org.hipparchus.ode.events中的接口
-
This interface represents a handler for discrete events triggered during ODE integration at each step end.
- FieldODEStepHandler<T> - org.hipparchus.ode.sampling中的接口
-
This interface represents a handler that should be called after each successful step.
- FieldOrdinaryDifferentialEquation<T> - org.hipparchus.ode中的接口
-
This interface represents a first order differential equations set.
- FieldPolynomialFunction<T> - org.hipparchus.analysis.polynomials中的类
-
Immutable representation of a real polynomial function with real coefficients.
- FieldPolynomialFunction(T[]) - 类的构造器 org.hipparchus.analysis.polynomials.FieldPolynomialFunction
-
Construct a polynomial with the given coefficients.
- FieldPolynomialFunctionTest - org.hipparchus.analysis.polynomials中的类
-
Tests the FieldPolynomialFunction implementation of a UnivariateFunction.
- FieldPolynomialFunctionTest() - 类的构造器 org.hipparchus.analysis.polynomials.FieldPolynomialFunctionTest
- FieldPolynomialSplineFunction<T> - org.hipparchus.analysis.polynomials中的类
-
Represents a polynomial spline function.
- FieldPolynomialSplineFunction(T[], FieldPolynomialFunction<T>[]) - 类的构造器 org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
-
Construct a polynomial spline function with the given segment delimiters and interpolating polynomials.
- FieldPolynomialSplineFunctionTest - org.hipparchus.analysis.polynomials中的类
-
Tests the FieldFieldPolynomialSplineFunction implementation.
- FieldPolynomialSplineFunctionTest() - 类的构造器 org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunctionTest
- FieldQRDecomposer<T> - org.hipparchus.linear中的类
-
Matrix decomposer using QR-decomposition.
- FieldQRDecomposer(T) - 类的构造器 org.hipparchus.linear.FieldQRDecomposer
-
Creates a QR decomposer with specify threshold for several matrices.
- FieldQRDecomposition<T> - org.hipparchus.linear中的类
-
Calculates the QR-decomposition of a field matrix.
- FieldQRDecomposition(FieldMatrix<T>) - 类的构造器 org.hipparchus.linear.FieldQRDecomposition
-
Calculates the QR-decomposition of the given matrix.
- FieldQRDecomposition(FieldMatrix<T>, T) - 类的构造器 org.hipparchus.linear.FieldQRDecomposition
-
Calculates the QR-decomposition of the given matrix.
- FieldQRDecomposition(FieldMatrix<T>, T, Predicate<T>) - 类的构造器 org.hipparchus.linear.FieldQRDecomposition
-
Calculates the QR-decomposition of the given matrix.
- FieldQRDecompositionTest - org.hipparchus.linear中的类
- FieldQRDecompositionTest() - 类的构造器 org.hipparchus.linear.FieldQRDecompositionTest
- FieldRombergIntegrator<T> - org.hipparchus.analysis.integration中的类
-
Implements the Romberg Algorithm for integration of real univariate functions.
- FieldRombergIntegrator(Field<T>) - 类的构造器 org.hipparchus.analysis.integration.FieldRombergIntegrator
-
Construct a Romberg integrator with default settings
- FieldRombergIntegrator(Field<T>, double, double, int, int) - 类的构造器 org.hipparchus.analysis.integration.FieldRombergIntegrator
-
Build a Romberg integrator with given accuracies and iterations counts.
- FieldRombergIntegrator(Field<T>, int, int) - 类的构造器 org.hipparchus.analysis.integration.FieldRombergIntegrator
-
Build a Romberg integrator with given iteration counts.
- FieldRombergIntegratorTest - org.hipparchus.analysis.integration中的类
-
Test case for Romberg integrator.
- FieldRombergIntegratorTest() - 类的构造器 org.hipparchus.analysis.integration.FieldRombergIntegratorTest
- FieldRotation<T> - org.hipparchus.geometry.euclidean.threed中的类
-
This class is a re-implementation of
Rotation
usingCalculusFieldElement
. - FieldRotation(Field<T>, Rotation) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build a
FieldRotation
from aRotation
. - FieldRotation(FieldVector3D<T>, FieldVector3D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build one of the rotations that transform one vector into another one.
- FieldRotation(FieldVector3D<T>, FieldVector3D<T>, FieldVector3D<T>, FieldVector3D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build the rotation that transforms a pair of vectors into another pair.
- FieldRotation(FieldVector3D<T>, T, RotationConvention) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build a rotation from an axis and an angle.
- FieldRotation(RotationOrder, RotationConvention, T, T, T) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build a rotation from three Cardan or Euler elementary rotations.
- FieldRotation(T[][], double) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build a rotation from a 3X3 matrix.
- FieldRotation(T, T, T, T, boolean) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Build a rotation from the quaternion coordinates.
- FieldRotationDfpTest - org.hipparchus.geometry.euclidean.threed中的类
- FieldRotationDfpTest() - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldRotationDfpTest
- FieldRotationDSTest - org.hipparchus.geometry.euclidean.threed中的类
- FieldRotationDSTest() - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldRotationDSTest
- FieldRuleFactory<T> - org.hipparchus.analysis.integration.gauss中的接口
-
Interface for rules that determines the integration nodes and their weights.
- FieldRuleFactoryTest - org.hipparchus.analysis.integration.gauss中的类
-
Test for
FieldAbstractRuleFactory
. - FieldRuleFactoryTest() - 类的构造器 org.hipparchus.analysis.integration.gauss.FieldRuleFactoryTest
- FieldSecondaryODE<T> - org.hipparchus.ode中的接口
-
This interface allows users to add secondary differential equations to a primary set of differential equations.
- FieldSimpsonIntegrator<T> - org.hipparchus.analysis.integration中的类
-
Implements Simpson's Rule for integration of real univariate functions.
- FieldSimpsonIntegrator(Field<T>) - 类的构造器 org.hipparchus.analysis.integration.FieldSimpsonIntegrator
-
Construct an integrator with default settings.
- FieldSimpsonIntegrator(Field<T>, double, double, int, int) - 类的构造器 org.hipparchus.analysis.integration.FieldSimpsonIntegrator
-
Build a Simpson integrator with given accuracies and iterations counts.
- FieldSimpsonIntegrator(Field<T>, int, int) - 类的构造器 org.hipparchus.analysis.integration.FieldSimpsonIntegrator
-
Build a Simpson integrator with given iteration counts.
- FieldSimpsonIntegratorTest - org.hipparchus.analysis.integration中的类
-
Test case for Simpson integrator.
- FieldSimpsonIntegratorTest() - 类的构造器 org.hipparchus.analysis.integration.FieldSimpsonIntegratorTest
- FieldSinCos<T> - org.hipparchus.util中的类
-
Holder for both sine and cosine values.
- FieldSinCos(T, T) - 类的构造器 org.hipparchus.util.FieldSinCos
-
Simple constructor.
- FieldSinhCosh<T> - org.hipparchus.util中的类
-
Holder for both hyperbolic sine and hyperbolic cosine values.
- FieldSinhCosh(T, T) - 类的构造器 org.hipparchus.util.FieldSinhCosh
-
Simple constructor.
- FieldStepEndEventState<T> - org.hipparchus.ode.events中的类
-
This class handles the state for one
event handler
that triggers at step end. - FieldStepEndEventState(FieldODEStepEndHandler<T>) - 类的构造器 org.hipparchus.ode.events.FieldStepEndEventState
-
Simple constructor.
- FieldStepNormalizer<T> - org.hipparchus.ode.sampling中的类
-
This class wraps an object implementing
FieldODEFixedStepHandler
into aFieldODEStepHandler
. - FieldStepNormalizer(double, FieldODEFixedStepHandler<T>) - 类的构造器 org.hipparchus.ode.sampling.FieldStepNormalizer
-
Simple constructor.
- FieldStepNormalizer(double, FieldODEFixedStepHandler<T>, StepNormalizerBounds) - 类的构造器 org.hipparchus.ode.sampling.FieldStepNormalizer
-
Simple constructor.
- FieldStepNormalizer(double, FieldODEFixedStepHandler<T>, StepNormalizerMode) - 类的构造器 org.hipparchus.ode.sampling.FieldStepNormalizer
-
Simple constructor.
- FieldStepNormalizer(double, FieldODEFixedStepHandler<T>, StepNormalizerMode, StepNormalizerBounds) - 类的构造器 org.hipparchus.ode.sampling.FieldStepNormalizer
-
Simple constructor.
- FieldStepNormalizerTest - org.hipparchus.ode.sampling中的类
- FieldStepNormalizerTest() - 类的构造器 org.hipparchus.ode.sampling.FieldStepNormalizerTest
- FieldTaylorMap<T> - org.hipparchus.analysis.differentiation中的类
-
Container for a Taylor map.
- FieldTaylorMap(Field<T>, int, int, int) - 类的构造器 org.hipparchus.analysis.differentiation.FieldTaylorMap
-
Constructor for identity map.
- FieldTaylorMap(T[], FieldDerivativeStructure<T>[]) - 类的构造器 org.hipparchus.analysis.differentiation.FieldTaylorMap
-
Simple constructor.
- FieldTaylorMapTest - org.hipparchus.analysis.differentiation中的类
-
Test for class .
- FieldTaylorMapTest() - 类的构造器 org.hipparchus.analysis.differentiation.FieldTaylorMapTest
- FieldTheta<T> - org.hipparchus.special.elliptic.jacobi中的类
-
Values of
Jacobi theta
functions. - FieldTrapezoidIntegrator<T> - org.hipparchus.analysis.integration中的类
-
Implements the Trapezoid Rule for integration of real univariate functions.
- FieldTrapezoidIntegrator(Field<T>) - 类的构造器 org.hipparchus.analysis.integration.FieldTrapezoidIntegrator
-
Construct a trapezoid integrator with default settings.
- FieldTrapezoidIntegrator(Field<T>, double, double, int, int) - 类的构造器 org.hipparchus.analysis.integration.FieldTrapezoidIntegrator
-
Build a trapezoid integrator with given accuracies and iterations counts.
- FieldTrapezoidIntegrator(Field<T>, int, int) - 类的构造器 org.hipparchus.analysis.integration.FieldTrapezoidIntegrator
-
Build a trapezoid integrator with given iteration counts.
- FieldTrapezoidIntegratorTest - org.hipparchus.analysis.integration中的类
-
Test case for trapezoid integrator.
- FieldTrapezoidIntegratorTest() - 类的构造器 org.hipparchus.analysis.integration.FieldTrapezoidIntegratorTest
- FieldTuple<T> - org.hipparchus.util中的类
-
This class allows to perform the same computation of all components of a Tuple at once.
- FieldTuple(T...) - 类的构造器 org.hipparchus.util.FieldTuple
-
Creates a new instance from its components.
- FieldTupleTest - org.hipparchus.util中的类
- FieldTupleTest() - 类的构造器 org.hipparchus.util.FieldTupleTest
- FieldUnivariateDerivative<S,
T> - org.hipparchus.analysis.differentiation中的类 -
Abstract class representing both the value and the differentials of a function.
- FieldUnivariateDerivative() - 类的构造器 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative
-
Empty constructor.
- FieldUnivariateDerivative1<T> - org.hipparchus.analysis.differentiation中的类
-
Class representing both the value and the differentials of a function.
- FieldUnivariateDerivative1(FieldDerivativeStructure<T>) - 类的构造器 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Build an instance from a
DerivativeStructure
. - FieldUnivariateDerivative1(T, T) - 类的构造器 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Build an instance with values and derivative.
- FieldUnivariateDerivative1AbstractTest<T> - org.hipparchus.analysis.differentiation中的类
-
Test for class
FieldUnivariateDerivative1
. - FieldUnivariateDerivative1AbstractTest() - 类的构造器 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1AbstractTest
- FieldUnivariateDerivative1Binary64Test - org.hipparchus.analysis.differentiation中的类
-
Test for class
FieldUnivariateDerivative1
onBinary64
. - FieldUnivariateDerivative1Binary64Test() - 类的构造器 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1Binary64Test
- FieldUnivariateDerivative1DfpTest - org.hipparchus.analysis.differentiation中的类
-
Test for class
FieldUnivariateDerivative1
onDfp
. - FieldUnivariateDerivative1DfpTest() - 类的构造器 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1DfpTest
- FieldUnivariateDerivative1Field<T> - org.hipparchus.analysis.differentiation中的类
-
Field for
FieldUnivariateDerivative1
instances. - FieldUnivariateDerivative2<T> - org.hipparchus.analysis.differentiation中的类
-
Class representing both the value and the differentials of a function.
- FieldUnivariateDerivative2(FieldDerivativeStructure<T>) - 类的构造器 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Build an instance from a
DerivativeStructure
. - FieldUnivariateDerivative2(T, T, T) - 类的构造器 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Build an instance with values and derivative.
- FieldUnivariateDerivative2AbstractTest<T> - org.hipparchus.analysis.differentiation中的类
-
Test for class
FieldUnivariateDerivative2
. - FieldUnivariateDerivative2AbstractTest() - 类的构造器 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2AbstractTest
- FieldUnivariateDerivative2Binary64Test - org.hipparchus.analysis.differentiation中的类
-
Test for class
FieldUnivariateDerivative2
onBinary64
. - FieldUnivariateDerivative2Binary64Test() - 类的构造器 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2Binary64Test
- FieldUnivariateDerivative2DfpTest - org.hipparchus.analysis.differentiation中的类
-
Test for class
FieldUnivariateDerivative2
onDfp
. - FieldUnivariateDerivative2DfpTest() - 类的构造器 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2DfpTest
- FieldUnivariateDerivative2Field<T> - org.hipparchus.analysis.differentiation中的类
-
Field for
FieldUnivariateDerivative2
instances. - FieldUnivariateFunction - org.hipparchus.analysis中的接口
-
An interface representing a univariate real function for any field type.
- FieldUnivariateIntegrator<T> - org.hipparchus.analysis.integration中的接口
-
Interface for univariate real integration algorithms.
- FieldUnivariateInterpolator - org.hipparchus.analysis.interpolation中的接口
-
Interface representing a univariate field interpolating function.
- FieldUnivariateMatrixFunction - org.hipparchus.analysis中的接口
-
An interface representing a univariate matrix function for any field type.
- FieldUnivariateVectorFunction - org.hipparchus.analysis中的接口
-
An interface representing a univariate vectorial function for any field type.
- FieldVariableCheckInterval - org.hipparchus.ode.events中的类
-
Tests for variable check interval.
- FieldVariableCheckInterval() - 类的构造器 org.hipparchus.ode.events.FieldVariableCheckInterval
- FieldVector<T> - org.hipparchus.linear中的接口
-
Interface defining a field-valued vector with basic algebraic operations.
- FieldVector2D<T> - org.hipparchus.geometry.euclidean.twod中的类
-
This class is a re-implementation of
Vector2D
usingCalculusFieldElement
. - FieldVector2D(double, FieldVector2D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Multiplicative constructor Build a vector from another one and a scale factor.
- FieldVector2D(double, FieldVector2D<T>, double, FieldVector2D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(double, FieldVector2D<T>, double, FieldVector2D<T>, double, FieldVector2D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(double, FieldVector2D<T>, double, FieldVector2D<T>, double, FieldVector2D<T>, double, FieldVector2D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(Field<T>, Vector2D) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Build a
FieldVector2D
from aVector2D
. - FieldVector2D(T[]) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Simple constructor.
- FieldVector2D(T, FieldVector2D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Multiplicative constructor Build a vector from another one and a scale factor.
- FieldVector2D(T, FieldVector2D<T>, T, FieldVector2D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor Build a vector from two other ones and corresponding scale factors.
- FieldVector2D(T, FieldVector2D<T>, T, FieldVector2D<T>, T, FieldVector2D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(T, FieldVector2D<T>, T, FieldVector2D<T>, T, FieldVector2D<T>, T, FieldVector2D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(T, Vector2D) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Multiplicative constructor Build a vector from another one and a scale factor.
- FieldVector2D(T, Vector2D, T, Vector2D) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(T, Vector2D, T, Vector2D, T, Vector2D) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(T, Vector2D, T, Vector2D, T, Vector2D, T, Vector2D) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Linear constructor.
- FieldVector2D(T, T) - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2D
-
Simple constructor.
- FieldVector2DTest - org.hipparchus.geometry.euclidean.twod中的类
- FieldVector2DTest() - 类的构造器 org.hipparchus.geometry.euclidean.twod.FieldVector2DTest
- FieldVector3D<T> - org.hipparchus.geometry.euclidean.threed中的类
-
This class is a re-implementation of
Vector3D
usingCalculusFieldElement
. - FieldVector3D(double, FieldVector3D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Multiplicative constructor.
- FieldVector3D(double, FieldVector3D<T>, double, FieldVector3D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(double, FieldVector3D<T>, double, FieldVector3D<T>, double, FieldVector3D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(double, FieldVector3D<T>, double, FieldVector3D<T>, double, FieldVector3D<T>, double, FieldVector3D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(Field<T>, Vector3D) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Build a
FieldVector3D
from aVector3D
. - FieldVector3D(T[]) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Simple constructor.
- FieldVector3D(T, FieldVector3D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Multiplicative constructor.
- FieldVector3D(T, FieldVector3D<T>, T, FieldVector3D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(T, FieldVector3D<T>, T, FieldVector3D<T>, T, FieldVector3D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(T, FieldVector3D<T>, T, FieldVector3D<T>, T, FieldVector3D<T>, T, FieldVector3D<T>) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(T, Vector3D) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Multiplicative constructor.
- FieldVector3D(T, Vector3D, T, Vector3D) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(T, Vector3D, T, Vector3D, T, Vector3D) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(T, Vector3D, T, Vector3D, T, Vector3D, T, Vector3D) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Linear constructor.
- FieldVector3D(T, T) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Simple constructor.
- FieldVector3D(T, T, T) - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Simple constructor.
- FieldVector3DTest - org.hipparchus.geometry.euclidean.threed中的类
- FieldVector3DTest() - 类的构造器 org.hipparchus.geometry.euclidean.threed.FieldVector3DTest
- FieldVectorChangingVisitor<T> - org.hipparchus.linear中的接口
-
This interface defines a visitor for the entries of a vector.
- FieldVectorPreservingVisitor<T> - org.hipparchus.linear中的接口
-
This interface defines a visitor for the entries of a vector.
- FieldVectorTestImpl(T[]) - 类的构造器 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
- file - 类中的变量 org.hipparchus.stat.fitting.EmpiricalDistributionTest
- fillUpper(RealMatrix, double) - 类中的方法 org.hipparchus.stat.correlation.PearsonsCorrelationTest
- filterStep(double, boolean, boolean) - 类中的方法 org.hipparchus.ode.nonstiff.StepsizeHelper
-
Filter the integration step.
- filterStep(T, boolean, boolean) - 类中的方法 org.hipparchus.ode.nonstiff.StepsizeHelper
-
Filter the integration step.
- FilterType - org.hipparchus.ode.events中的枚举类
-
Enumerate for
filtering events
. - finalizeStep(double, double[], double[], Array2DRowRealMatrix, boolean, ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsBashforthIntegrator
-
Finalize the step.
- finalizeStep(double, double[], double[], Array2DRowRealMatrix, boolean, ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Finalize the step.
- finalizeStep(double, double[], double[], Array2DRowRealMatrix, boolean, ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsMoultonIntegrator
-
Finalize the step.
- finalizeStep(T, T[], T[], Array2DRowFieldMatrix<T>, boolean, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegrator
-
Finalize the step.
- finalizeStep(T, T[], T[], Array2DRowFieldMatrix<T>, boolean, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Finalize the step.
- finalizeStep(T, T[], T[], Array2DRowFieldMatrix<T>, boolean, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - 类中的方法 org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegrator
-
Finalize the step.
- FIND_ROOT - 枚举类 中的枚举常量 org.hipparchus.ode.LocalizedODEFormats
-
FIND_ROOT.
- findEigenValues(RealMatrix) - 类中的方法 org.hipparchus.linear.ComplexEigenDecomposition
-
Compute eigen values using the Schur transform.
- findEigenVectors(FieldMatrix<Complex>) - 类中的方法 org.hipparchus.linear.ComplexEigenDecomposition
-
Compute the eigen vectors using the inverse power method.
- findHullVertices(Collection<Vector2D>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.hull.MonotoneChain
-
Find the convex hull vertices from the set of input points.
- findKnot(double[], double) - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialSplineFunctionTest
-
Do linear search to find largest knot point less than or equal to x.
- findKnot(Binary64[], double) - 类中的方法 org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunctionTest
-
Do linear search to find largest knot point less than or equal to x.
- findRoots(int, CalculusFieldUnivariateFunction<T>) - 类中的方法 org.hipparchus.analysis.integration.gauss.FieldAbstractRuleFactory
-
Computes roots of the associated orthogonal polynomials.
- findRoots(int, UnivariateFunction) - 类中的方法 org.hipparchus.analysis.integration.gauss.AbstractRuleFactory
-
Computes roots of the associated orthogonal polynomials.
- finish(FieldODEStateAndDerivative<T>) - 类中的方法 org.hipparchus.ode.FieldDenseOutputModel
-
Finalize integration.
- finish(FieldODEStateAndDerivative<T>) - 接口中的方法 org.hipparchus.ode.sampling.FieldODEStepHandler
-
Finalize integration.
- finish(FieldODEStateAndDerivative<T>) - 类中的方法 org.hipparchus.ode.sampling.FieldStepNormalizer
-
Finalize integration.
- finish(FieldODEStateAndDerivative<T>) - 类中的方法 org.hipparchus.ode.TestFieldProblemHandler
- finish(ODEStateAndDerivative) - 类中的方法 org.hipparchus.ode.DenseOutputModel
-
Finalize integration.
- finish(ODEStateAndDerivative) - 类中的方法 org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegratorTest.VariableStepHandler
- finish(ODEStateAndDerivative) - 接口中的方法 org.hipparchus.ode.sampling.ODEStepHandler
-
Finalize integration.
- finish(ODEStateAndDerivative) - 类中的方法 org.hipparchus.ode.sampling.StepNormalizer
-
Finalize integration.
- finish(ODEStateAndDerivative) - 类中的方法 org.hipparchus.ode.TestProblemHandler
- FINITE - 类中的静态变量 org.hipparchus.dfp.Dfp
-
Indicator value for normal finite numbers.
- FiniteDifferencesDifferentiator - org.hipparchus.analysis.differentiation中的类
-
Univariate functions differentiator using finite differences.
- FiniteDifferencesDifferentiator(int, double) - 类的构造器 org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
Build a differentiator with number of points and step size when independent variable is unbounded.
- FiniteDifferencesDifferentiator(int, double, double, double) - 类的构造器 org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
Build a differentiator with number of points and step size when independent variable is bounded.
- FiniteDifferencesDifferentiatorTest - org.hipparchus.analysis.differentiation中的类
-
Test for class
FiniteDifferencesDifferentiator
. - FiniteDifferencesDifferentiatorTest() - 类的构造器 org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiatorTest
- fireInitializationEvent(IterationEvent) - 类中的方法 org.hipparchus.util.IterationManager
-
Informs all registered listeners that the initial phase (prior to the main iteration loop) has been completed.
- fireIterationPerformedEvent(IterationEvent) - 类中的方法 org.hipparchus.util.IterationManager
-
Informs all registered listeners that a new iteration (in the main iteration loop) has been performed.
- fireIterationStartedEvent(IterationEvent) - 类中的方法 org.hipparchus.util.IterationManager
-
Informs all registered listeners that a new iteration (in the main iteration loop) has been started.
- fireTerminationEvent(IterationEvent) - 类中的方法 org.hipparchus.util.IterationManager
-
Informs all registered listeners that the final phase (post-iterations) has been completed.
- FIRST - 枚举类 中的枚举常量 org.hipparchus.ode.sampling.StepNormalizerBounds
-
Include the first point, but not the last point.
- FIRST_COLUMNS_NOT_INITIALIZED_YET - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
FIRST_COLUMNS_NOT_INITIALIZED_YET.
- FIRST_COLUMNS_NOT_INITIALIZED_YET - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。FIRST_COLUMNS_NOT_INITIALIZED_YET.
- FIRST_ELEMENT_NOT_ZERO - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。FIRST_ELEMENT_NOT_ZERO.
- FIRST_ELEMENT_NOT_ZERO - 枚举类 中的枚举常量 org.hipparchus.transform.LocalizedFFTFormats
-
FIRST_ELEMENT_NOT_ZERO.
- FIRST_ROWS_NOT_INITIALIZED_YET - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
FIRST_ROWS_NOT_INITIALIZED_YET.
- FIRST_ROWS_NOT_INITIALIZED_YET - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。FIRST_ROWS_NOT_INITIALIZED_YET.
- firstIncluded() - 枚举类中的方法 org.hipparchus.ode.sampling.StepNormalizerBounds
-
Returns a value indicating whether the first point should be passed to the underlying fixed step size step handler.
- firstIntersection(Vector3D, Line) - 类中的方法 org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Get the first sub-hyperplane crossed by a semi-infinite line.
- FirstMomentTest - org.hipparchus.stat.descriptive.moment中的类
-
Test cases for the
FirstMoment
class. - FirstMomentTest() - 类的构造器 org.hipparchus.stat.descriptive.moment.FirstMomentTest
- FirstOrderConverter - org.hipparchus.ode中的类
-
This class converts second order differential equations to first order ones.
- FirstOrderConverter(SecondOrderODE) - 类的构造器 org.hipparchus.ode.FirstOrderConverter
-
Simple constructor.
- FirstOrderConverterTest - org.hipparchus.ode中的类
- FirstOrderConverterTest() - 类的构造器 org.hipparchus.ode.FirstOrderConverterTest
- FirstOrderDifferentialEquations - org.hipparchus.migration.ode中的接口
-
已过时。
- fit(double[][]) - 类中的方法 org.hipparchus.stat.projection.PCA
-
Fit our model to the data, ready for subsequence transforms.
- fit(Collection<WeightedObservedPoint>) - 类中的方法 org.hipparchus.fitting.AbstractCurveFitter
-
Fits a curve.
- fit(MixtureMultivariateNormalDistribution) - 类中的方法 org.hipparchus.stat.fitting.MultivariateNormalMixtureExpectationMaximization
-
Fit a mixture model to the data supplied to the constructor.
- fit(MixtureMultivariateNormalDistribution, int, double) - 类中的方法 org.hipparchus.stat.fitting.MultivariateNormalMixtureExpectationMaximization
-
Fit a mixture model to the data supplied to the constructor.
- fitAndTransform(double[][]) - 类中的方法 org.hipparchus.stat.projection.PCA
-
Fit our model to the data and then transform it to the reduced dimensions.
- fix1stArgument(BivariateFunction, double) - 类中的静态方法 org.hipparchus.analysis.FunctionUtils
-
Creates a unary function by fixing the first argument of a binary function.
- fix2ndArgument(BivariateFunction, double) - 类中的静态方法 org.hipparchus.analysis.FunctionUtils
-
Creates a unary function by fixing the second argument of a binary function.
- FIXED - 枚举类 中的枚举常量 org.hipparchus.stat.ranking.NaNStrategy
-
NaNs are left in place
- FixedStepHandler - org.hipparchus.migration.ode.sampling中的接口
-
已过时。as of 1.0, replaced with
ODEFixedStepHandler
- fixNode(BSPTree<S>) - 接口中的方法 org.hipparchus.geometry.partitioning.BSPTree.VanishingCutHandler
-
Fix a node with both vanished cut and children.
- FLAG_DIV_ZERO - 类中的静态变量 org.hipparchus.dfp.DfpField
-
IEEE 854-1987 flag for division by zero.
- FLAG_INEXACT - 类中的静态变量 org.hipparchus.dfp.DfpField
-
IEEE 854-1987 flag for inexact result.
- FLAG_INVALID - 类中的静态变量 org.hipparchus.dfp.DfpField
-
IEEE 854-1987 flag for invalid operation.
- FLAG_OVERFLOW - 类中的静态变量 org.hipparchus.dfp.DfpField
-
IEEE 854-1987 flag for overflow.
- FLAG_UNDERFLOW - 类中的静态变量 org.hipparchus.dfp.DfpField
-
IEEE 854-1987 flag for underflow.
- FLETCHER_REEVES - 枚举类 中的枚举常量 org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.Formula
-
Fletcher-Reeves formula.
- floatValue() - 类中的方法 org.hipparchus.fraction.BigFraction
-
Gets the fraction as a
float
. - floatValue() - 类中的方法 org.hipparchus.fraction.Fraction
-
Gets the fraction as a
float
. - floatValue() - 类中的方法 org.hipparchus.util.Binary64
-
The current implementation performs casting to a
float
. - floor() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get the largest whole number smaller than instance.
- floor() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Get the largest whole number smaller than instance.
- floor() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
-
Get the largest whole number smaller than instance.
- floor() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
-
Get the largest whole number smaller than instance.
- floor() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
-
Get the largest whole number smaller than instance.
- floor() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
-
Get the largest whole number smaller than instance.
- floor() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
-
Get the largest whole number smaller than instance.
- floor() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
-
Get the largest whole number smaller than instance.
- floor() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
-
Get the largest whole number smaller than instance.
- floor() - 接口中的方法 org.hipparchus.CalculusFieldElement
-
Get the largest whole number smaller than instance.
- floor() - 类中的方法 org.hipparchus.complex.Complex
-
Get the largest whole number smaller than instance.
- floor() - 类中的方法 org.hipparchus.complex.FieldComplex
-
Get the largest whole number smaller than instance.
- floor() - 类中的方法 org.hipparchus.dfp.Dfp
-
Round to an integer using the round floor mode.
- floor() - 类中的方法 org.hipparchus.util.Binary64
-
Get the largest whole number smaller than instance.
- floor() - 类中的方法 org.hipparchus.util.FieldTuple
-
Get the largest whole number smaller than instance.
- floor() - 类中的方法 org.hipparchus.util.Tuple
-
Get the largest whole number smaller than instance.
- floor(double) - 类中的静态方法 org.hipparchus.util.FastMath
-
Get the largest whole number smaller than x.
- floor(T) - 类中的静态方法 org.hipparchus.util.FastMath
-
Get the largest whole number smaller than x.
- Floor - org.hipparchus.analysis.function中的类
-
floor
function. - Floor() - 类的构造器 org.hipparchus.analysis.function.Floor
-
Empty constructor.
- floorDiv(int, int) - 类中的静态方法 org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorDiv(long, int) - 类中的静态方法 org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorDiv(long, long) - 类中的静态方法 org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorDivExact(int, int) - 类中的静态方法 org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorDivExact(long, long) - 类中的静态方法 org.hipparchus.util.FastMath
-
Finds q such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorMod(int, int) - 类中的静态方法 org.hipparchus.util.FastMath
-
Finds r such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorMod(long, int) - 类中的静态方法 org.hipparchus.util.FastMath
-
Finds r such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - floorMod(long, long) - 类中的静态方法 org.hipparchus.util.FastMath
-
Finds r such that
a = q b + r
with0 <= r < b
ifb > 0
andb < r <= 0
ifb < 0
. - fma(double, double, double) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute Fused-multiply-add operation a * b + c.
- fma(float, float, float) - 类中的静态方法 org.hipparchus.util.FastMath
-
Compute Fused-multiply-add operation a * b + c.
- forceSide(int, UnivariateFunction, BracketedUnivariateSolver<UnivariateFunction>, double, double, double, AllowedSolution) - 类中的静态方法 org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
Force a root found by a non-bracketing solver to lie on a specified side, as if the solver were a bracketing one.
- format(double, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.BigFractionFormat
-
Formats a double value as a fraction and appends the result to a StringBuffer.
- format(double, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.FractionFormat
-
Formats a double value as a fraction and appends the result to a StringBuffer.
- format(double, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.ProperBigFractionFormat
-
Formats a double value as a fraction and appends the result to a StringBuffer.
- format(double, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.ProperFractionFormat
-
Formats a double value as a fraction and appends the result to a StringBuffer.
- format(long, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.BigFractionFormat
-
Formats a long value as a fraction and appends the result to a StringBuffer.
- format(long, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.FractionFormat
-
Formats a long value as a fraction and appends the result to a StringBuffer.
- format(long, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.ProperBigFractionFormat
-
Formats a long value as a fraction and appends the result to a StringBuffer.
- format(long, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.ProperFractionFormat
-
Formats a long value as a fraction and appends the result to a StringBuffer.
- format(Double) - 类中的方法 org.hipparchus.complex.ComplexFormat
-
This method calls
ComplexFormat.format(Object,StringBuffer,FieldPosition)
. - format(Object, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.complex.ComplexFormat
-
Formats a object to produce a string.
- format(Object, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.BigFractionFormat
-
Formats an object and appends the result to a StringBuffer.
- format(Object, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.FractionFormat
-
Formats an object and appends the result to a StringBuffer.
- format(StringBuffer, FieldPosition, double...) - 类中的方法 org.hipparchus.geometry.VectorFormat
-
Formats the coordinates of a
Vector
to produce a string. - format(Complex) - 类中的方法 org.hipparchus.complex.ComplexFormat
-
This method calls
ComplexFormat.format(Object,StringBuffer,FieldPosition)
. - format(Complex, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.complex.ComplexFormat
-
Formats a
Complex
object to produce a string. - format(BigFraction, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.BigFractionFormat
-
Formats a
BigFraction
object to produce a string. - format(BigFraction, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.ProperBigFractionFormat
-
Formats a
BigFraction
object to produce a string. - format(Fraction, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.FractionFormat
-
Formats a
Fraction
object to produce a string. - format(Fraction, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.fraction.ProperFractionFormat
-
Formats a
Fraction
object to produce a string. - format(Vector<Euclidean1D, Vector1D>, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1DFormat
-
Formats a
Vector
object to produce a string. - format(Vector<Euclidean3D, Vector3D>, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3DFormat
-
Formats a
Vector3D
object to produce a string. - format(Vector<Euclidean2D, Vector2D>, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2DFormat
-
Formats a
Vector
object to produce a string. - format(Vector<S, V>) - 类中的方法 org.hipparchus.geometry.VectorFormat
-
Formats a
Vector
object to produce a string. - format(Vector<S, V>, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.geometry.VectorFormat
-
Formats a
Vector
object to produce a string. - format(RealMatrix) - 类中的方法 org.hipparchus.linear.RealMatrixFormat
-
This method calls
RealMatrixFormat.format(RealMatrix,StringBuffer,FieldPosition)
. - format(RealMatrix, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.linear.RealMatrixFormat
-
Formats a
RealMatrix
object to produce a string. - format(RealVector) - 类中的方法 org.hipparchus.linear.RealVectorFormat
-
This method calls
RealVectorFormat.format(RealVector,StringBuffer,FieldPosition)
. - format(RealVector, StringBuffer, FieldPosition) - 类中的方法 org.hipparchus.linear.RealVectorFormat
-
Formats a
RealVector
object to produce a string. - formatBigFraction(BigFraction) - 类中的静态方法 org.hipparchus.fraction.BigFractionFormat
-
This static method calls formatBigFraction() on a default instance of BigFractionFormat.
- formatDouble(double, NumberFormat, StringBuffer, FieldPosition) - 类中的静态方法 org.hipparchus.util.CompositeFormat
-
Formats a double value to produce a string.
- formatFraction(Fraction) - 类中的静态方法 org.hipparchus.fraction.FractionFormat
-
This static method calls formatFraction() on a default instance of FractionFormat.
- FORWARD - 枚举类 中的枚举常量 org.hipparchus.transform.TransformType
-
The type to be specified for forward transforms.
- FOUR_FIFTHS - 类中的静态变量 org.hipparchus.fraction.BigFraction
-
A fraction representing "4/5".
- FOUR_FIFTHS - 类中的静态变量 org.hipparchus.fraction.Fraction
-
A fraction representing "4/5".
- fourthMoment - 类中的变量 org.hipparchus.stat.descriptive.UnivariateStatisticAbstractTest
- FourthMomentTest - org.hipparchus.stat.descriptive.moment中的类
-
Test cases for the
FourthMoment
class. - FourthMomentTest() - 类的构造器 org.hipparchus.stat.descriptive.moment.FourthMomentTest
- fraction(double, double) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Create a fraction.
- fraction(int, int) - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Create a fraction.
- fraction(int, int) - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegrator
-
Create a fraction.
- Fraction - org.hipparchus.fraction中的类
-
Representation of a rational number.
- Fraction(double) - 类的构造器 org.hipparchus.fraction.Fraction
-
Create a fraction given the double value.
- Fraction(double, double, int) - 类的构造器 org.hipparchus.fraction.Fraction
-
Create a fraction given the double value and maximum error allowed.
- Fraction(double, int) - 类的构造器 org.hipparchus.fraction.Fraction
-
Create a fraction given the double value and maximum denominator.
- Fraction(int) - 类的构造器 org.hipparchus.fraction.Fraction
-
Create a fraction from an int.
- Fraction(int, int) - 类的构造器 org.hipparchus.fraction.Fraction
-
Create a fraction given the numerator and denominator.
- FRACTION - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
FRACTION.
- FRACTION - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。FRACTION.
- FRACTION_CONVERSION_OVERFLOW - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
FRACTION_CONVERSION_OVERFLOW.
- FRACTION_CONVERSION_OVERFLOW - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。FRACTION_CONVERSION_OVERFLOW.
- Fraction.ConvergenceTest - org.hipparchus.fraction中的接口
-
A test to determine if a series of fractions has converged.
- fractionCol - 类中的变量 org.hipparchus.linear.MatrixUtilsTest
- fractionColMatrix - 类中的变量 org.hipparchus.linear.MatrixUtilsTest
- FractionField - org.hipparchus.fraction中的类
-
Representation of the fractional numbers field.
- FractionFieldTest - org.hipparchus.fraction中的类
- FractionFieldTest() - 类的构造器 org.hipparchus.fraction.FractionFieldTest
- FractionFormat - org.hipparchus.fraction中的类
-
Formats a Fraction number in proper format or improper format.
- FractionFormat() - 类的构造器 org.hipparchus.fraction.FractionFormat
-
Create an improper formatting instance with the default number format for the numerator and denominator.
- FractionFormat(NumberFormat) - 类的构造器 org.hipparchus.fraction.FractionFormat
-
Create an improper formatting instance with a custom number format for both the numerator and denominator.
- FractionFormat(NumberFormat, NumberFormat) - 类的构造器 org.hipparchus.fraction.FractionFormat
-
Create an improper formatting instance with a custom number format for the numerator and a custom number format for the denominator.
- FractionFormatTest - org.hipparchus.fraction中的类
- FractionFormatTest() - 类的构造器 org.hipparchus.fraction.FractionFormatTest
- fractionMatrixToRealMatrix(FieldMatrix<Fraction>) - 类中的静态方法 org.hipparchus.linear.MatrixUtils
- fractionRow - 类中的变量 org.hipparchus.linear.MatrixUtilsTest
- fractionRowMatrix - 类中的变量 org.hipparchus.linear.MatrixUtilsTest
- FractionTest - org.hipparchus.fraction中的类
- FractionTest() - 类的构造器 org.hipparchus.fraction.FractionTest
- FRAME_TRANSFORM - 枚举类 中的枚举常量 org.hipparchus.geometry.euclidean.threed.RotationConvention
-
Constant for rotation that have the semantics of a frame conversion.
- FREE - 类中的静态变量 org.hipparchus.util.OpenIntToDoubleHashMap
-
Status indicator for free table entries.
- FREE - 类中的静态变量 org.hipparchus.util.OpenIntToFieldHashMap
-
Status indicator for free table entries.
- FrenchComplexFormatTest - org.hipparchus.complex中的类
- FrenchComplexFormatTest() - 类的构造器 org.hipparchus.complex.FrenchComplexFormatTest
- FrenchRealVectorFormatTest - org.hipparchus.linear中的类
- FrenchRealVectorFormatTest() - 类的构造器 org.hipparchus.linear.FrenchRealVectorFormatTest
- FrenchVector1DFormatTest - org.hipparchus.geometry.euclidean.oned中的类
- FrenchVector1DFormatTest() - 类的构造器 org.hipparchus.geometry.euclidean.oned.FrenchVector1DFormatTest
- FrenchVector2DFormatTest - org.hipparchus.geometry.euclidean.twod中的类
- FrenchVector2DFormatTest() - 类的构造器 org.hipparchus.geometry.euclidean.twod.FrenchVector2DFormatTest
- FrenchVector3DFormatTest - org.hipparchus.geometry.euclidean.threed中的类
- FrenchVector3DFormatTest() - 类的构造器 org.hipparchus.geometry.euclidean.threed.FrenchVector3DFormatTest
- Frequency<T> - org.hipparchus.stat中的类
-
Maintains a frequency distribution of Comparable values.
- Frequency() - 类的构造器 org.hipparchus.stat.Frequency
-
Default constructor.
- Frequency() - 类的构造器 org.hipparchus.UnitTestUtils.Frequency
- Frequency(Comparator<? super T>) - 类的构造器 org.hipparchus.stat.Frequency
-
Constructor allowing values Comparator to be specified.
- FrequencyTest - org.hipparchus.stat中的类
-
Test cases for the
Frequency
class. - FrequencyTest() - 类的构造器 org.hipparchus.stat.FrequencyTest
- fromDirection(Vector3D, Vector3D, double) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.Line
-
Create a line from a point and a direction.
- fst(double[]) - 类中的方法 org.hipparchus.transform.FastSineTransformer
-
Perform the FST algorithm (including inverse).
- FULL - 类中的静态变量 org.hipparchus.util.OpenIntToDoubleHashMap
-
Status indicator for full table entries.
- FULL - 类中的静态变量 org.hipparchus.util.OpenIntToFieldHashMap
-
Status indicator for full table entries.
- FUNCTION - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
-
FUNCTION.
- FUNCTION - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。FUNCTION.
- FUNCTION_NOT_DIFFERENTIABLE - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。FUNCTION_NOT_DIFFERENTIABLE.
- FUNCTION_NOT_DIFFERENTIABLE - 枚举类 中的枚举常量 org.hipparchus.migration.LocalizedMigrationFormats
-
已过时。FUNCTION_NOT_DIFFERENTIABLE.
- FUNCTION_NOT_POLYNOMIAL - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
-
已过时。FUNCTION_NOT_POLYNOMIAL.
- FUNCTION_NOT_POLYNOMIAL - 枚举类 中的枚举常量 org.hipparchus.migration.LocalizedMigrationFormats
-
已过时。FUNCTION_NOT_POLYNOMIAL.
- FunctionsWithFastMathVersionTest - org.hipparchus.analysis.function中的类
- FunctionsWithFastMathVersionTest() - 类的构造器 org.hipparchus.analysis.function.FunctionsWithFastMathVersionTest
- FunctionUtils - org.hipparchus.analysis中的类
-
Utilities for manipulating function objects.
- FunctionUtilsTest - org.hipparchus.analysis中的类
-
Test for
FunctionUtils
. - FunctionUtilsTest() - 类的构造器 org.hipparchus.analysis.FunctionUtilsTest
- FuzzyKMeansClusterer<T> - org.hipparchus.clustering中的类
-
Fuzzy K-Means clustering algorithm.
- FuzzyKMeansClusterer(int, double) - 类的构造器 org.hipparchus.clustering.FuzzyKMeansClusterer
-
Creates a new instance of a FuzzyKMeansClusterer.
- FuzzyKMeansClusterer(int, double, int, DistanceMeasure) - 类的构造器 org.hipparchus.clustering.FuzzyKMeansClusterer
-
Creates a new instance of a FuzzyKMeansClusterer.
- FuzzyKMeansClusterer(int, double, int, DistanceMeasure, double, RandomGenerator) - 类的构造器 org.hipparchus.clustering.FuzzyKMeansClusterer
-
Creates a new instance of a FuzzyKMeansClusterer.
- FuzzyKMeansClustererTest - org.hipparchus.clustering中的类
-
Test cases for FuzzyKMeansClusterer.
- FuzzyKMeansClustererTest() - 类的构造器 org.hipparchus.clustering.FuzzyKMeansClustererTest
常量字段值|所有程序包|所有类和接口|序列化表格
OrdinaryDifferentialEquation