索引

A B C D E F G H I J K L M N O P Q R S T U V W X Y Z 
常量字段值|所有程序包|所有类和接口|序列化表格

G

g(double[], long[]) - 类中的方法 org.hipparchus.stat.inference.GTest
Computes the G statistic for Goodness of Fit comparing observed and expected frequency counts.
g(double[], long[]) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
Computes the G statistic for Goodness of Fit comparing observed and expected frequency counts.
g(double, double[]) - 接口中的方法 org.hipparchus.migration.ode.events.EventHandler
已过时。
Compute the value of the switching function.
g(FieldODEStateAndDerivative<E>) - 类中的方法 org.hipparchus.ode.events.AbstractFieldODEDetector
Compute the value of the switching function.
g(FieldODEStateAndDerivative<E>) - 类中的方法 org.hipparchus.ode.events.FieldEventSlopeFilter
Compute the value of the switching function.
g(FieldODEStateAndDerivative<T>) - 类中的方法 org.hipparchus.ode.events.EventSlopeFilterTest.FieldEvent
 
g(FieldODEStateAndDerivative<T>) - 接口中的方法 org.hipparchus.ode.events.FieldODEEventDetector
Compute the value of the switching function.
g(FieldODEStateAndDerivative<T>) - 类中的方法 org.hipparchus.ode.nonstiff.StepFieldProblem
 
g(ODEStateAndDerivative) - 接口中的方法 org.hipparchus.migration.ode.events.EventHandler
已过时。
Compute the value of the switching function.
g(ODEStateAndDerivative) - 类中的方法 org.hipparchus.ode.events.AbstractODEDetector
Compute the value of the switching function.
g(ODEStateAndDerivative) - 类中的方法 org.hipparchus.ode.events.EventSlopeFilter
Compute the value of the switching function.
g(ODEStateAndDerivative) - 类中的方法 org.hipparchus.ode.events.EventSlopeFilterTest.Event
 
g(ODEStateAndDerivative) - 接口中的方法 org.hipparchus.ode.events.ODEEventDetector
Compute the value of the switching function.
g(ODEStateAndDerivative) - 类中的方法 org.hipparchus.ode.events.ReappearingEventTest.Event
 
g(ODEStateAndDerivative) - 类中的方法 org.hipparchus.ode.nonstiff.StepProblem
 
gamma(double) - 类中的静态方法 org.hipparchus.special.Gamma
Returns the value of Γ(x).
gamma(T) - 类中的静态方法 org.hipparchus.special.Gamma
Returns the value of Γ(x).
Gamma - org.hipparchus.special中的类
This is a utility class that provides computation methods related to the Γ (Gamma) family of functions.
GAMMA - 类中的静态变量 org.hipparchus.special.Gamma
GammaDistribution - org.hipparchus.distribution.continuous中的类
Implementation of the Gamma distribution.
GammaDistribution(double, double) - 类的构造器 org.hipparchus.distribution.continuous.GammaDistribution
Creates a new gamma distribution with specified values of the shape and scale parameters.
GammaDistribution(double, double, double) - 类的构造器 org.hipparchus.distribution.continuous.GammaDistribution
Creates a Gamma distribution.
GammaDistributionTest - org.hipparchus.distribution.continuous中的类
Test cases for GammaDistribution.
GammaDistributionTest() - 类的构造器 org.hipparchus.distribution.continuous.GammaDistributionTest
 
GammaTest - org.hipparchus.special中的类
 
GammaTest() - 类的构造器 org.hipparchus.special.GammaTest
 
gaussian - 类中的静态变量 org.hipparchus.stat.inference.KolmogorovSmirnovTestTest
 
Gaussian - org.hipparchus.analysis.function中的类
Gaussian function.
Gaussian() - 类的构造器 org.hipparchus.analysis.function.Gaussian
Normalized gaussian with zero mean and unit standard deviation.
Gaussian(double, double) - 类的构造器 org.hipparchus.analysis.function.Gaussian
Normalized gaussian with given mean and standard deviation.
Gaussian(double, double, double) - 类的构造器 org.hipparchus.analysis.function.Gaussian
Gaussian with given normalization factor, mean and standard deviation.
Gaussian.Parametric - org.hipparchus.analysis.function中的类
Parametric function where the input array contains the parameters of the Gaussian, ordered as follows: Norm Mean Standard deviation
gaussian2 - 类中的静态变量 org.hipparchus.stat.inference.KolmogorovSmirnovTestTest
 
GaussianCurveFitter - org.hipparchus.fitting中的类
Fits points to a Gaussian function.
GaussianCurveFitter.ParameterGuesser - org.hipparchus.fitting中的类
Guesses the parameters norm, mean, and sigma of a Gaussian.Parametric based on the specified observed points.
GaussianCurveFitterTest - org.hipparchus.fitting中的类
GaussianCurveFitterTest() - 类的构造器 org.hipparchus.fitting.GaussianCurveFitterTest
 
GaussianQuadratureAbstractTest - org.hipparchus.analysis.integration.gauss中的类
Base class for standard testing of Gaussian quadrature rules, which are exact for polynomials up to a certain degree.
GaussianQuadratureAbstractTest(GaussIntegrator, int, double, double) - 类的构造器 org.hipparchus.analysis.integration.gauss.GaussianQuadratureAbstractTest
Creates a new instance of this abstract test with the specified quadrature rule.
GaussianRandomGenerator - org.hipparchus.random中的类
This class is a gaussian normalized random generator for scalars.
GaussianRandomGenerator(RandomGenerator) - 类的构造器 org.hipparchus.random.GaussianRandomGenerator
Create a new generator.
GaussianRandomGeneratorTest - org.hipparchus.random中的类
 
GaussianRandomGeneratorTest() - 类的构造器 org.hipparchus.random.GaussianRandomGeneratorTest
 
GaussianTest - org.hipparchus.analysis.function中的类
Test for class Gaussian.
GaussianTest() - 类的构造器 org.hipparchus.analysis.function.GaussianTest
 
GaussIntegrator - org.hipparchus.analysis.integration.gauss中的类
Class that implements the Gaussian rule for integrating a weighted function.
GaussIntegrator(double[], double[]) - 类的构造器 org.hipparchus.analysis.integration.gauss.GaussIntegrator
Creates an integrator from the given points and weights.
GaussIntegrator(Pair<double[], double[]>) - 类的构造器 org.hipparchus.analysis.integration.gauss.GaussIntegrator
Creates an integrator from the given pair of points (first element of the pair) and weights (second element of the pair.
GaussIntegratorFactory - org.hipparchus.analysis.integration.gauss中的类
Class that provides different ways to compute the nodes and weights to be used by the Gaussian integration rule.
GaussIntegratorFactory() - 类的构造器 org.hipparchus.analysis.integration.gauss.GaussIntegratorFactory
Simple constructor.
GaussIntegratorFactory(int) - 类的构造器 org.hipparchus.analysis.integration.gauss.GaussIntegratorFactory
Simple constructor.
GaussIntegratorTest - org.hipparchus.analysis.integration.gauss中的类
Test for GaussIntegrator class.
GaussIntegratorTest() - 类的构造器 org.hipparchus.analysis.integration.gauss.GaussIntegratorTest
 
GaussNewtonOptimizer - org.hipparchus.optim.nonlinear.vector.leastsquares中的类
Gauss-Newton least-squares solver.
GaussNewtonOptimizer() - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
Creates a Gauss Newton optimizer.
GaussNewtonOptimizer(MatrixDecomposer, boolean) - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
Create a Gauss Newton optimizer that uses the given matrix decomposition algorithm to solve the normal equations.
GaussNewtonOptimizerWithCholeskyTest - org.hipparchus.optim.nonlinear.vector.leastsquares中的类
Some of the unit tests are re-implementations of the MINPACK file17 and file22 test files.
GaussNewtonOptimizerWithCholeskyTest() - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithCholeskyTest
 
GaussNewtonOptimizerWithLUTest - org.hipparchus.optim.nonlinear.vector.leastsquares中的类
Some of the unit tests are re-implementations of the MINPACK file17 and file22 test files.
GaussNewtonOptimizerWithLUTest() - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithLUTest
 
GaussNewtonOptimizerWithQRNormalTest - org.hipparchus.optim.nonlinear.vector.leastsquares中的类
Some of the unit tests are re-implementations of the MINPACK file17 and file22 test files.
GaussNewtonOptimizerWithQRNormalTest() - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithQRNormalTest
 
GaussNewtonOptimizerWithQRTest - org.hipparchus.optim.nonlinear.vector.leastsquares中的类
Some of the unit tests are re-implementations of the MINPACK file17 and file22 test files.
GaussNewtonOptimizerWithQRTest() - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithQRTest
 
GaussNewtonOptimizerWithSVDTest - org.hipparchus.optim.nonlinear.vector.leastsquares中的类
Some of the unit tests are re-implementations of the MINPACK file17 and file22 test files.
GaussNewtonOptimizerWithSVDTest() - 类的构造器 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithSVDTest
 
gcd(int, int) - 类中的静态方法 org.hipparchus.util.ArithmeticUtils
Computes the greatest common divisor of the absolute value of two numbers, using a modified version of the "binary gcd" method.
gcd(long, long) - 类中的静态方法 org.hipparchus.util.ArithmeticUtils
Gets the greatest common divisor of the absolute value of two numbers, using the "binary gcd" method which avoids division and modulo operations.
GCD_OVERFLOW_32_BITS - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
GCD_OVERFLOW_32_BITS.
GCD_OVERFLOW_32_BITS - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
已过时。
GCD_OVERFLOW_32_BITS.
GCD_OVERFLOW_64_BITS - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
GCD_OVERFLOW_64_BITS.
GCD_OVERFLOW_64_BITS - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
已过时。
GCD_OVERFLOW_64_BITS.
gDataSetsComparison(long[], long[]) - 类中的方法 org.hipparchus.stat.inference.GTest
Computes a G (Log-Likelihood Ratio) two sample test statistic for independence comparing frequency counts in observed1 and observed2.
gDataSetsComparison(long[], long[]) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
Computes a G (Log-Likelihood Ratio) two sample test statistic for independence comparing frequency counts in observed1 and observed2.
generate(int) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.RandomCirclePointGenerator
Point generator.
generate(int) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.RandomStraightLinePointGenerator
Point generator.
generate(Collection<Vector2D>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.hull.MonotoneChain
Builds the convex hull from the set of input points.
generate(Collection<Vector2D>) - 接口中的方法 org.hipparchus.geometry.euclidean.twod.hull.ConvexHullGenerator2D
Builds the convex hull from the set of input points.
generate(Collection<P>) - 接口中的方法 org.hipparchus.geometry.hull.ConvexHullGenerator
Builds the convex hull from the set of input points.
GENERATE_EXCEPTION - 枚举类 中的枚举常量 org.hipparchus.linear.DependentVectorsHandler
Generate a MathIllegalArgumentException if dependent vectors are found.
generateNoiseVector(RandomGenerator, double) - 类中的静态方法 org.hipparchus.samples.ClusterAlgorithmComparison
Generate a random vector.
generator - 类中的变量 org.hipparchus.geometry.euclidean.twod.hull.ConvexHullGenerator2DAbstractTest
 
generator - 类中的变量 org.hipparchus.random.RandomGeneratorAbstractTest
RandomGenerator under test
geoMean - 类中的变量 org.hipparchus.stat.descriptive.UnivariateStatisticAbstractTest
 
GeometricDistribution - org.hipparchus.distribution.discrete中的类
Implementation of the geometric distribution.
GeometricDistribution(double) - 类的构造器 org.hipparchus.distribution.discrete.GeometricDistribution
Create a geometric distribution with the given probability of success.
GeometricDistributionTest - org.hipparchus.distribution.discrete中的类
Test cases for GeometricDistribution.
GeometricDistributionTest() - 类的构造器 org.hipparchus.distribution.discrete.GeometricDistributionTest
Constructor to override default tolerance.
geometricMean(double...) - 类中的静态方法 org.hipparchus.stat.StatUtils
Returns the geometric mean of the entries in the input array, or Double.NaN if the array is empty.
geometricMean(double[], int, int) - 类中的静态方法 org.hipparchus.stat.StatUtils
Returns the geometric mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
GeometricMean - org.hipparchus.stat.descriptive.moment中的类
Returns the geometric mean of the available values.
GeometricMean() - 类的构造器 org.hipparchus.stat.descriptive.moment.GeometricMean
Create a GeometricMean instance.
GeometricMean(GeometricMean) - 类的构造器 org.hipparchus.stat.descriptive.moment.GeometricMean
Copy constructor, creates a new GeometricMean identical to the original.
GeometricMean(SumOfLogs) - 类的构造器 org.hipparchus.stat.descriptive.moment.GeometricMean
Create a GeometricMean instance using the given SumOfLogs instance.
GeometricMeanTest - org.hipparchus.stat.descriptive.moment中的类
Test cases for the GeometricMean class.
GeometricMeanTest() - 类的构造器 org.hipparchus.stat.descriptive.moment.GeometricMeanTest
 
GeometryExample - org.hipparchus.samples.geometry中的类
Simple example illustrating some parts of the geometry package.
GeometryExample() - 类的构造器 org.hipparchus.samples.geometry.GeometryExample
Empty constructor.
GeometryExample.Display - org.hipparchus.samples.geometry中的类
Main frame for geometry examples.
GEQ - 枚举类 中的枚举常量 org.hipparchus.optim.linear.Relationship
Greater than or equal relationship.
get(int) - 类中的方法 org.hipparchus.util.OpenIntToDoubleHashMap
Get the stored value associated with the given key
get(int) - 类中的方法 org.hipparchus.util.OpenIntToFieldHashMap
Get the stored value associated with the given key
getA() - 接口中的方法 org.hipparchus.ode.nonstiff.ButcherArrayProvider
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.ClassicalRungeKuttaIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince54Integrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince853Integrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.EulerFieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.EulerIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 接口中的方法 org.hipparchus.ode.nonstiff.FieldButcherArrayProvider
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.GillFieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.GillIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.HighamHall54Integrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.LutherFieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.LutherIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.MidpointFieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.MidpointIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.ThreeEighthesFieldIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.nonstiff.ThreeEighthesIntegrator
Get the internal weights from Butcher array (without the first empty row).
getA() - 类中的方法 org.hipparchus.ode.TestFieldProblem8.InertiaAxis
Get the inertia axis.
getA() - 类中的方法 org.hipparchus.ode.TestProblem8.InertiaAxis
Get the inertia axis.
getA(int, double) - 类中的方法 org.hipparchus.util.ContinuedFraction
Access the n-th a coefficient of the continued fraction.
getA(int, T) - 类中的方法 org.hipparchus.util.FieldContinuedFraction
Access the n-th a coefficient of the continued fraction.
getA1() - 枚举类中的方法 org.hipparchus.geometry.euclidean.threed.RotationOrder
Get the axis of the first rotation.
getA2() - 枚举类中的方法 org.hipparchus.geometry.euclidean.threed.RotationOrder
Get the axis of the second rotation.
getA3() - 枚举类中的方法 org.hipparchus.geometry.euclidean.threed.RotationOrder
Get the axis of the second rotation.
getAbscissa(FieldVector3D<T>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldLine
Get the abscissa of a point with respect to the line.
getAbscissa(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldLine
Get the abscissa of a point with respect to the line.
getAbscissa(Vector3D) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Line
Get the abscissa of a point with respect to the line.
getAbsoluteAccuracy() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
Get the absolute accuracy.
getAbsoluteAccuracy() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
Get the absolute accuracy.
getAbsoluteAccuracy() - 接口中的方法 org.hipparchus.analysis.integration.FieldUnivariateIntegrator
Get the absolute accuracy.
getAbsoluteAccuracy() - 接口中的方法 org.hipparchus.analysis.integration.UnivariateIntegrator
Get the absolute accuracy.
getAbsoluteAccuracy() - 类中的方法 org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
Get the absolute accuracy of the solver.
getAbsoluteAccuracy() - 接口中的方法 org.hipparchus.analysis.solvers.BaseUnivariateSolver
Get the absolute accuracy of the solver.
getAbsoluteAccuracy() - 接口中的方法 org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
Get the absolute accuracy of the solver.
getAbsoluteAccuracy() - 类中的方法 org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
Get the absolute accuracy.
getAbsoluteThreshold() - 类中的方法 org.hipparchus.optim.AbstractConvergenceChecker
Get absolute threshold.
getAction() - 类中的方法 org.hipparchus.ode.events.EventOccurrence
Get the user requested action.
getAction() - 类中的方法 org.hipparchus.ode.events.FieldEventOccurrence
Get the user requested action.
getAdjustedRSquared() - 类中的方法 org.hipparchus.stat.regression.RegressionResults
Returns the adjusted R-squared statistic, defined by the formula \( R_\mathrm{adj}^2 = 1 - \frac{\mathrm{SSR} (n - 1)}{\mathrm{SSTO} (n - p)} \) where SSR is the sum of squared residuals}, SSTO is the total sum of squares}, n is the number of observations and p is the number of parameters estimated (including the intercept).
getAggregateN(Collection<RandomPercentile>) - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentile
Returns the total number of values that have been consumed by the aggregates.
getAggregateQuantileRank(double, Collection<RandomPercentile>) - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentile
Returns the estimated quantile position of value in the combined dataset of the aggregates.
getAggregateRank(double, Collection<RandomPercentile>) - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentile
Computes the estimated rank of value in the combined dataset of the aggregates.
getAgrestiCoullInterval(int, double, double) - 类中的静态方法 org.hipparchus.stat.interval.BinomialProportion
Create an Agresti-Coull binomial confidence interval for the true probability of success of an unknown binomial distribution with the given observed number of trials, probability of success and confidence level.
getAllDerivatives() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
Get all partial derivatives.
getAllDerivatives() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
Get all partial derivatives.
getAlpha() - 类中的方法 org.hipparchus.distribution.continuous.BetaDistribution
Access the first shape parameter, alpha.
getAlpha() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get the azimuth of the vector.
getAlpha() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
Get the azimuth of the vector.
getAlpha() - 类中的方法 org.hipparchus.geometry.spherical.oned.S1Point
Get the azimuthal angle \( \alpha \).
getAngle() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
Get the angle of the rotation.
getAngle() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
Get the angle of the rotation.
getAngle() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Line
Get the angle of the line.
getAngles(RotationOrder, RotationConvention) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
Get the Cardan or Euler angles corresponding to the instance.
getAngles(RotationOrder, RotationConvention) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
Get the Cardan or Euler angles corresponding to the instance.
getArc(S2Point, S2Point) - 类中的方法 org.hipparchus.geometry.spherical.twod.Circle
Get the arc on this circle between two defining points.
getArgument() - 类中的方法 org.hipparchus.complex.Complex
Compute the argument of this complex number.
getArgument() - 类中的方法 org.hipparchus.complex.FieldComplex
Compute the argument of this complex number.
getArgument() - 异常错误类中的方法 org.hipparchus.migration.exception.MathIllegalNumberException
已过时。
Get argument.
getArrayRef() - 类中的方法 org.hipparchus.util.ResizableDoubleArray
Provides direct access to the internal storage array.
getAttribute() - 类中的方法 org.hipparchus.geometry.partitioning.BSPTree
Get the attribute associated with the instance.
getAvailableLocales() - 类中的静态方法 org.hipparchus.complex.ComplexFormat
Get the set of locales for which complex formats are available.
getAvailableLocales() - 类中的静态方法 org.hipparchus.fraction.BigFractionFormat
Get the set of locales for which complex formats are available.
getAvailableLocales() - 类中的静态方法 org.hipparchus.fraction.FractionFormat
Get the set of locales for which complex formats are available.
getAvailableLocales() - 类中的静态方法 org.hipparchus.geometry.VectorFormat
Get the set of locales for which point/vector formats are available.
getAvailableLocales() - 类中的静态方法 org.hipparchus.linear.RealMatrixFormat
Get the set of locales for which real vectors formats are available.
getAvailableLocales() - 类中的静态方法 org.hipparchus.linear.RealVectorFormat
Get the set of locales for which real vectors formats are available.
getAxis(RotationConvention) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
Get the normalized axis of the rotation.
getAxis(RotationConvention) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
Get the normalized axis of the rotation.
getB() - 接口中的方法 org.hipparchus.ode.nonstiff.ButcherArrayProvider
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.ClassicalRungeKuttaIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince54Integrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince853Integrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.EulerFieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.EulerIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 接口中的方法 org.hipparchus.ode.nonstiff.FieldButcherArrayProvider
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.GillFieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.GillIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.HighamHall54Integrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.LutherFieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.LutherIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.MidpointFieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.MidpointIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.ThreeEighthesFieldIntegrator
Get the external weights for the high order method from Butcher array.
getB() - 类中的方法 org.hipparchus.ode.nonstiff.ThreeEighthesIntegrator
Get the external weights for the high order method from Butcher array.
getB(int, double) - 类中的方法 org.hipparchus.util.ContinuedFraction
Access the n-th b coefficient of the continued fraction.
getB(int, T) - 类中的方法 org.hipparchus.util.FieldContinuedFraction
Access the n-th b coefficient of the continued fraction.
getBarycenter() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Interval
Get the barycenter of the interval.
getBarycenter() - 类中的方法 org.hipparchus.geometry.partitioning.AbstractRegion
Get the barycenter of the instance.
getBarycenter() - 接口中的方法 org.hipparchus.geometry.partitioning.Region
Get the barycenter of the instance.
getBarycenter() - 类中的方法 org.hipparchus.geometry.spherical.oned.Arc
Get the barycenter of the arc.
getBeta() - 类中的方法 org.hipparchus.distribution.continuous.BetaDistribution
Access the second shape parameter, beta.
getBinCount() - 类中的方法 org.hipparchus.stat.fitting.EmpiricalDistribution
Returns the number of bins.
getBinomialProportionMethod() - 类中的方法 org.hipparchus.stat.interval.AgrestiCoullIntervalTest
 
getBinomialProportionMethod() - 类中的方法 org.hipparchus.stat.interval.BinomialProportionAbstractTest
 
getBinomialProportionMethod() - 类中的方法 org.hipparchus.stat.interval.ClopperPearsonIntervalTest
 
getBinomialProportionMethod() - 类中的方法 org.hipparchus.stat.interval.NormalApproximationIntervalTest
 
getBinomialProportionMethod() - 类中的方法 org.hipparchus.stat.interval.WilsonScoreIntervalTest
 
getBinStats() - 类中的方法 org.hipparchus.stat.fitting.EmpiricalDistribution
Returns a List of StreamingStatistics instances containing statistics describing the values in each of the bins.
getBoundaryLoops() - 类中的方法 org.hipparchus.geometry.spherical.twod.SphericalPolygonsSet
Get the boundary loops of the polygon.
getBoundarySize() - 类中的方法 org.hipparchus.geometry.partitioning.AbstractRegion
Get the size of the boundary.
getBoundarySize() - 接口中的方法 org.hipparchus.geometry.partitioning.Region
Get the size of the boundary.
getBoundIsAllowed() - 异常错误类中的方法 org.hipparchus.migration.exception.NumberIsTooLargeException
已过时。
Check if the maximum is included in the allowed range.
getBoundIsAllowed() - 异常错误类中的方法 org.hipparchus.migration.exception.NumberIsTooSmallException
已过时。
Check if the minimum is included in the allowed range.
getBRep() - 类中的方法 org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
Get the boundary representation of the instance.
getC() - 接口中的方法 org.hipparchus.ode.nonstiff.ButcherArrayProvider
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.ClassicalRungeKuttaIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince54Integrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince853Integrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.EulerFieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.EulerIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 接口中的方法 org.hipparchus.ode.nonstiff.FieldButcherArrayProvider
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.GillFieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.GillIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.HighamHall54Integrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.LutherFieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.LutherIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.MidpointFieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.MidpointIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.ThreeEighthesFieldIntegrator
Get the time steps from Butcher array (without the first zero).
getC() - 类中的方法 org.hipparchus.ode.nonstiff.ThreeEighthesIntegrator
Get the time steps from Butcher array (without the first zero).
getCalls() - 类中的方法 org.hipparchus.ode.TestFieldProblemAbstract
Get the number of calls.
getCalls() - 类中的方法 org.hipparchus.ode.TestProblemAbstract
Get the number of calls.
getCalls() - 类中的方法 org.hipparchus.ode.TestProblemHandler
 
getCallsCount() - 类中的方法 org.hipparchus.analysis.MonitoredFunction
 
getCapacity() - 类中的方法 org.hipparchus.util.ResizableDoubleArray
Gets the currently allocated size of the internal data structure used for storing elements.
getCartesian() - 类中的方法 org.hipparchus.geometry.euclidean.threed.SphericalCoordinates
Get the Cartesian coordinates.
getCell(Point<S>, double) - 类中的方法 org.hipparchus.geometry.partitioning.BSPTree
Get the cell to which a point belongs.
getCenter() - 类中的方法 org.hipparchus.clustering.CentroidCluster
Get the point chosen to be the center of this cluster.
getCenter() - 类中的方法 org.hipparchus.geometry.enclosing.EnclosingBall
Get the center of the ball.
getCenter() - 类中的方法 org.hipparchus.stat.projection.PCA
Get by column center (or mean) of the fitted data.
getCenters() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
Returns a copy of the centers array.
getChiSquare() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
Get the sum of the squares of the residuals.
getChiSquare() - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
Get the sum of the squares of the residuals.
getCircle() - 类中的方法 org.hipparchus.geometry.spherical.twod.Edge
Get the circle supporting this edge.
getClamp() - 类中的静态方法 org.hipparchus.analysis.polynomials.SmoothStepFactory
getClamp(Field<T>) - 类中的静态方法 org.hipparchus.analysis.polynomials.SmoothStepFactory
getClopperPearsonInterval(int, double, double) - 类中的静态方法 org.hipparchus.stat.interval.BinomialProportion
Create a Clopper-Pearson binomial confidence interval for the true probability of success of an unknown binomial distribution with the given observed number of trials, probability of success and confidence level.
getCloseCuts(Point<S>, double) - 类中的方法 org.hipparchus.geometry.partitioning.BSPTree
Get the cells whose cut sub-hyperplanes are close to the point.
getClusterer() - 类中的方法 org.hipparchus.clustering.MultiKMeansPlusPlusClusterer
Returns the embedded k-means clusterer used by this instance.
getClusterEvaluator() - 类中的方法 org.hipparchus.clustering.MultiKMeansPlusPlusClusterer
Returns the ClusterEvaluator used to determine the "best" clustering.
getClusters() - 类中的方法 org.hipparchus.clustering.FuzzyKMeansClusterer
Returns the list of clusters resulting from the last call to FuzzyKMeansClusterer.cluster(Collection).
getCoefficients() - 类中的方法 org.hipparchus.analysis.polynomials.FieldPolynomialFunction
Returns a copy of the coefficients array.
getCoefficients() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunction
Returns a copy of the coefficients array.
getCoefficients() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns a copy of the coefficients array.
getCoefficients() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
Returns a copy of the coefficients array.
getCoefficients() - 类中的方法 org.hipparchus.analysis.solvers.AbstractPolynomialSolver
Get the coefficients of the polynomial function.
getCoefficients() - 类中的方法 org.hipparchus.optim.linear.LinearConstraint
Gets the coefficients of the constraint (left hand side).
getCoefficients() - 类中的方法 org.hipparchus.optim.linear.LinearObjectiveFunction
Gets the coefficients of the linear equation being optimized.
getColumn() - 异常错误类中的方法 org.hipparchus.migration.linear.NonPositiveDefiniteMatrixException
已过时。
Get column index.
getColumn() - 异常错误类中的方法 org.hipparchus.migration.linear.NonSymmetricMatrixException
已过时。
Get column index of the entry.
getColumn(int) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Get the entries in column number col as an array.
getColumn(int) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Get the entries at the given column index as an array.
getColumn(int) - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
Get the entries in column number col as an array.
getColumn(int) - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Get the entries at the given column index as an array.
getColumn(int) - 接口中的方法 org.hipparchus.linear.FieldMatrix
Get the entries in column number col as an array.
getColumn(int) - 接口中的方法 org.hipparchus.linear.RealMatrix
Get the entries at the given column index as an array.
getColumnDimension() - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Returns the number of columns in the matrix.
getColumnDimension() - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Returns the number of columns of this matrix.
getColumnDimension() - 接口中的方法 org.hipparchus.linear.AnyMatrix
Returns the number of columns in the matrix.
getColumnDimension() - 类中的方法 org.hipparchus.linear.Array2DRowFieldMatrix
Returns the number of columns in the matrix.
getColumnDimension() - 类中的方法 org.hipparchus.linear.Array2DRowRealMatrix
Returns the number of columns of this matrix.
getColumnDimension() - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
Returns the number of columns in the matrix.
getColumnDimension() - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Returns the number of columns of this matrix.
getColumnDimension() - 接口中的方法 org.hipparchus.linear.DecompositionSolver
Returns the number of columns in the matrix.
getColumnDimension() - 类中的方法 org.hipparchus.linear.DiagonalMatrix
Returns the number of columns of this matrix.
getColumnDimension() - 接口中的方法 org.hipparchus.linear.FieldDecompositionSolver
Returns the number of columns in the matrix.
getColumnDimension() - 类中的方法 org.hipparchus.linear.HilbertMatrix
Returns the dimension of the domain of this operator.
getColumnDimension() - 类中的方法 org.hipparchus.linear.InverseHilbertMatrix
Returns the dimension of the domain of this operator.
getColumnDimension() - 类中的方法 org.hipparchus.linear.JacobiPreconditioner
Returns the dimension of the domain of this operator.
getColumnDimension() - 类中的方法 org.hipparchus.linear.OpenMapRealMatrix
Returns the number of columns of this matrix.
getColumnDimension() - 接口中的方法 org.hipparchus.linear.RealLinearOperator
Returns the dimension of the domain of this operator.
getColumnDimension() - 类中的方法 org.hipparchus.linear.SparseFieldMatrix
Returns the number of columns in the matrix.
getColumnMatrix(int) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Get the entries in column number column as a column matrix.
getColumnMatrix(int) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Get the entries at the given column index as a column matrix.
getColumnMatrix(int) - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
Get the entries in column number column as a column matrix.
getColumnMatrix(int) - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Get the entries at the given column index as a column matrix.
getColumnMatrix(int) - 接口中的方法 org.hipparchus.linear.FieldMatrix
Get the entries in column number column as a column matrix.
getColumnMatrix(int) - 接口中的方法 org.hipparchus.linear.RealMatrix
Get the entries at the given column index as a column matrix.
getColumnSeparator() - 类中的方法 org.hipparchus.linear.RealMatrixFormat
Get the format separator between components.
getColumnVector(int) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Get the entries at the given column index as a vector.
getColumnVector(int) - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Get the entries at the given column index as a vector.
getColumnVector(int) - 接口中的方法 org.hipparchus.linear.FieldMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - 接口中的方法 org.hipparchus.linear.RealMatrix
Get the entries at the given column index as a vector.
getCommand() - 类中的方法 org.hipparchus.filtering.kalman.linear.LinearEvolution
Get the command uk-1.
getCompiler() - 类中的方法 org.hipparchus.analysis.differentiation.DSFactory
Get the compiler for the current dimensions.
getCompiler() - 类中的方法 org.hipparchus.analysis.differentiation.FDSFactory
Get the compiler for the current dimensions.
getCompiler(int, int) - 类中的静态方法 org.hipparchus.analysis.differentiation.DSCompiler
Get the compiler for number of free parameters and order.
getComplement(Region<S>) - 类中的方法 org.hipparchus.geometry.partitioning.RegionFactory
Get the complement of the region (exchanged interior/exterior).
getCompleteDerivative() - 类中的方法 org.hipparchus.ode.ComplexODEStateAndDerivative
Get complete derivative at time.
getCompleteDerivative() - 类中的方法 org.hipparchus.ode.FieldODEStateAndDerivative
Get complete derivative at time.
getCompleteDerivative() - 类中的方法 org.hipparchus.ode.ODEStateAndDerivative
Get complete derivative at time.
getCompleteState() - 类中的方法 org.hipparchus.ode.ComplexODEState
Get complete state at time.
getCompleteState() - 类中的方法 org.hipparchus.ode.FieldODEState
Get complete state at time.
getCompleteState() - 类中的方法 org.hipparchus.ode.ODEState
Get complete state at time.
getCompleteStateDimension() - 类中的方法 org.hipparchus.ode.ComplexODEState
Return the dimension of the complete set of equations.
getCompleteStateDimension() - 类中的方法 org.hipparchus.ode.FieldODEState
Return the dimension of the complete set of equations.
getCompleteStateDimension() - 类中的方法 org.hipparchus.ode.ODEState
Return the dimension of the complete set of equations.
getComplexFormat() - 类中的静态方法 org.hipparchus.complex.ComplexFormat
Returns the default complex format for the current locale.
getComplexFormat(String, Locale) - 类中的静态方法 org.hipparchus.complex.ComplexFormat
Returns the default complex format for the given locale.
getComplexFormat(Locale) - 类中的静态方法 org.hipparchus.complex.ComplexFormat
Returns the default complex format for the given locale.
getComponent(int) - 类中的方法 org.hipparchus.util.FieldTuple
Get one component of the tuple.
getComponent(int) - 类中的方法 org.hipparchus.util.Tuple
Get one component of the tuple.
getComponents() - 类中的方法 org.hipparchus.distribution.multivariate.MixtureMultivariateRealDistribution
Gets the distributions that make up the mixture model.
getComponents() - 类中的方法 org.hipparchus.stat.projection.PCA
Returns the principal components of our projection model.
getComponents() - 类中的方法 org.hipparchus.util.FieldTuple
Get all components of the tuple.
getComponents() - 类中的方法 org.hipparchus.util.Tuple
Get all components of the tuple.
getConditionNumber() - 类中的方法 org.hipparchus.linear.SingularValueDecomposition
Return the condition number of the matrix.
getConfidenceLevel() - 类中的方法 org.hipparchus.stat.interval.ConfidenceInterval
Get asserted probability that the interval contains the population parameter.
getConjugate() - 类中的方法 org.hipparchus.complex.Quaternion
Returns the conjugate quaternion of the instance.
getConstantTerm() - 类中的方法 org.hipparchus.optim.linear.LinearObjectiveFunction
Gets the constant of the linear equation being optimized.
getConstraints() - 类中的方法 org.hipparchus.optim.linear.LinearConstraintSet
Gets the set of linear constraints.
getConstraints() - 类中的方法 org.hipparchus.optim.linear.LinearOptimizer
Get constraints.
getContractionCriterion() - 类中的方法 org.hipparchus.util.ResizableDoubleArray
The contraction criterion defines when the internal array will contract to store only the number of elements in the element array.
getControlMatrix() - 类中的方法 org.hipparchus.filtering.kalman.linear.LinearEvolution
Get the control matrix Bk-1.
getConvergenceChecker() - 类中的方法 org.hipparchus.optim.AbstractOptimizationProblem
Gets the convergence checker.
getConvergenceChecker() - 类中的方法 org.hipparchus.optim.BaseOptimizer
Gets the convergence checker.
getConvergenceChecker() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
Gets the convergence checker.
getConvergenceChecker() - 接口中的方法 org.hipparchus.optim.OptimizationProblem
Gets the convergence checker.
getCorrected() - 类中的方法 org.hipparchus.filtering.kalman.AbstractKalmanFilter
Get the corrected state.
getCorrected() - 接口中的方法 org.hipparchus.filtering.kalman.KalmanFilter
Get the current corrected state.
getCorrected() - 类中的方法 org.hipparchus.filtering.kalman.unscented.UnscentedKalmanFilter
Get the corrected state.
getCorrelationMatrix() - 类中的方法 org.hipparchus.stat.correlation.KendallsCorrelation
Returns the correlation matrix.
getCorrelationMatrix() - 类中的方法 org.hipparchus.stat.correlation.PearsonsCorrelation
Returns the correlation matrix.
getCorrelationMatrix() - 类中的方法 org.hipparchus.stat.correlation.SpearmansCorrelation
Calculate the Spearman Rank Correlation Matrix.
getCorrelationPValues() - 类中的方法 org.hipparchus.stat.correlation.PearsonsCorrelation
Returns a matrix of p-values associated with the (two-sided) null hypothesis that the corresponding correlation coefficient is zero.
getCorrelationStandardErrors() - 类中的方法 org.hipparchus.stat.correlation.PearsonsCorrelation
Returns a matrix of standard errors associated with the estimates in the correlation matrix.
getCorrelationStandardErrors().getEntry(i,j) is the standard error associated with getCorrelationMatrix.getEntry(i,j)
getCost() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
Get the cost.
getCost() - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
Get the cost.
getCostRelativeTolerance() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
Gets the value of a tuning parameter.
getCount() - 类中的方法 org.hipparchus.util.Incrementor
Gets the current count.
getCount() - 类中的方法 org.hipparchus.util.MultidimensionalCounter.Iterator
Get the current unidimensional counter slot.
getCount(int) - 类中的方法 org.hipparchus.stat.LongFrequency
Returns the number of values equal to v.
getCount(int) - 类中的方法 org.hipparchus.util.MultidimensionalCounter.Iterator
Get the current count in the selected dimension.
getCount(int...) - 类中的方法 org.hipparchus.util.MultidimensionalCounter
Convert to unidimensional counter.
getCount(T) - 类中的方法 org.hipparchus.stat.Frequency
Returns the number of values equal to v.
getCount(T) - 类中的方法 org.hipparchus.UnitTestUtils.Frequency
 
getCounts() - 类中的方法 org.hipparchus.util.MultidimensionalCounter.Iterator
Get the current multidimensional counter slots.
getCounts(int) - 类中的方法 org.hipparchus.util.MultidimensionalCounter
Convert to multidimensional counter.
getCovariance() - 接口中的方法 org.hipparchus.filtering.kalman.Measurement
Get the measurement covariance.
getCovariance() - 类中的方法 org.hipparchus.filtering.kalman.ProcessEstimate
Get the state covariance.
getCovariance() - 类中的方法 org.hipparchus.filtering.kalman.SimpleMeasurement
 
getCovariance() - 类中的方法 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
Returns the covariance of the available values.
getCovariance() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
Returns the covariance of the available values.
getCovariance(double) - 类中的方法 org.hipparchus.linear.SingularValueDecomposition
Returns the n × n covariance matrix.
getCovariance(int, int) - 类中的方法 org.hipparchus.stat.correlation.StorelessCovariance
Get the covariance for an individual element of the covariance matrix.
getCovarianceMatrix() - 类中的方法 org.hipparchus.stat.correlation.Covariance
Returns the covariance matrix
getCovarianceMatrix() - 类中的方法 org.hipparchus.stat.correlation.StorelessCovariance
Returns the covariance matrix
getCovarianceOfParameters(int, int) - 类中的方法 org.hipparchus.stat.regression.RegressionResults
Returns the covariance between regression parameters i and j.
getCovariances() - 类中的方法 org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
Gets the covariance matrix.
getCovariances(double) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
Get the covariance matrix of the optimized parameters.
getCovariances(double) - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
Get the covariance matrix of the optimized parameters.
getCubic() - 类中的静态方法 org.hipparchus.analysis.polynomials.SmoothStepFactory
getCubic(Field<T>) - 类中的静态方法 org.hipparchus.analysis.polynomials.SmoothStepFactory
getCumFreq(int) - 类中的方法 org.hipparchus.stat.LongFrequency
Returns the cumulative frequency of values less than or equal to v.
getCumFreq(T) - 类中的方法 org.hipparchus.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumPct(int) - 类中的方法 org.hipparchus.stat.LongFrequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCumPct(T) - 类中的方法 org.hipparchus.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCumulativeTestPoints() - 类中的方法 org.hipparchus.distribution.continuous.RealDistributionAbstractTest
 
getCumulativeTestPoints() - 类中的方法 org.hipparchus.distribution.discrete.IntegerDistributionAbstractTest
 
getCumulativeTestValues() - 类中的方法 org.hipparchus.distribution.continuous.RealDistributionAbstractTest
 
getCumulativeTestValues() - 类中的方法 org.hipparchus.distribution.discrete.IntegerDistributionAbstractTest
 
getCurrentSignedStepsize() - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
Get the current signed value of the integration stepsize.
getCurrentSignedStepsize() - 类中的方法 org.hipparchus.ode.AbstractIntegrator
Get the current signed value of the integration stepsize.
getCurrentSignedStepsize() - 接口中的方法 org.hipparchus.ode.FieldODEIntegrator
Get the current signed value of the integration stepsize.
getCurrentSignedStepsize() - 接口中的方法 org.hipparchus.ode.ODEIntegrator
Get the current signed value of the integration stepsize.
getCurrentState() - 类中的方法 org.hipparchus.filtering.kalman.extended.NonLinearEvolution
Get current state.
getCurrentState() - 类中的方法 org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
Get the state at current grid point time.
getCurrentState() - 类中的方法 org.hipparchus.ode.sampling.AbstractODEStateInterpolator
Get the state at current grid point time.
getCurrentState() - 接口中的方法 org.hipparchus.ode.sampling.FieldODEStateInterpolator
Get the state at current grid point time.
getCurrentState() - 接口中的方法 org.hipparchus.ode.sampling.ODEStateInterpolator
Get the state at current grid point time.
getCurrentStates() - 类中的方法 org.hipparchus.filtering.kalman.unscented.UnscentedEvolution
Get current states.
getCurrentTime() - 类中的方法 org.hipparchus.filtering.kalman.extended.NonLinearEvolution
Get current time.
getCurrentTime() - 类中的方法 org.hipparchus.filtering.kalman.unscented.UnscentedEvolution
Get current time.
getCurrentTime() - 接口中的方法 org.hipparchus.migration.ode.sampling.StepInterpolator
已过时。
getCut() - 类中的方法 org.hipparchus.geometry.partitioning.BSPTree
Get the cut sub-hyperplane.
getD() - 类中的方法 org.hipparchus.linear.ComplexEigenDecomposition
Getter D.
getD() - 类中的方法 org.hipparchus.linear.EigenDecompositionNonSymmetric
Gets the block diagonal matrix D of the decomposition.
getD() - 类中的方法 org.hipparchus.linear.EigenDecompositionSymmetric
Gets the diagonal matrix D of the decomposition.
getData() - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Returns matrix entries as a two-dimensional array.
getData() - 类中的方法 org.hipparchus.linear.Array2DRowFieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - 类中的方法 org.hipparchus.linear.Array2DRowRealMatrix
Returns matrix entries as a two-dimensional array.
getData() - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
 
getData() - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Returns matrix entries as a two-dimensional array.
getData() - 类中的方法 org.hipparchus.linear.DiagonalMatrix
Returns matrix entries as a two-dimensional array.
getData() - 接口中的方法 org.hipparchus.linear.FieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - 接口中的方法 org.hipparchus.linear.RealMatrix
Returns matrix entries as a two-dimensional array.
getData() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns a copy of the data arrays.
getData() - 类中的方法 org.hipparchus.stat.correlation.StorelessCovariance
Return the covariance matrix as two-dimensional array.
getData() - 类中的方法 org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
Get a copy of the stored data array.
getDataPoints() - 类中的方法 org.hipparchus.clustering.FuzzyKMeansClusterer
Returns an unmodifiable list of the data points used in the last call to FuzzyKMeansClusterer.cluster(Collection).
getDataRef() - 类中的方法 org.hipparchus.linear.Array2DRowFieldMatrix
Get a reference to the underlying data array.
getDataRef() - 类中的方法 org.hipparchus.linear.Array2DRowRealMatrix
Get a reference to the underlying data array.
getDataRef() - 类中的方法 org.hipparchus.linear.ArrayFieldVector
Returns a reference to the underlying data array.
getDataRef() - 类中的方法 org.hipparchus.linear.ArrayRealVector
Get a reference to the underlying data array.
getDataRef() - 类中的方法 org.hipparchus.linear.DiagonalMatrix
Gets a reference to the underlying data array.
getDataRef() - 类中的方法 org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
Get a reference to the stored data array.
getDecimalCharacter() - 类中的方法 org.hipparchus.complex.ComplexFormatAbstractTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.complex.ComplexFormatTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.complex.FrenchComplexFormatTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.geometry.euclidean.oned.FrenchVector1DFormatTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1DFormatAbstractTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1DFormatTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FrenchVector3DFormatTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3DFormatAbstractTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3DFormatTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.geometry.euclidean.twod.FrenchVector2DFormatTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2DFormatAbstractTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2DFormatTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.linear.FrenchRealVectorFormatTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.linear.RealMatrixFormatAbstractTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.linear.RealMatrixFormatTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.linear.RealVectorFormatAbstractTest
 
getDecimalCharacter() - 类中的方法 org.hipparchus.linear.RealVectorFormatTest
 
getDecimalDigits() - 类中的方法 org.hipparchus.dfp.Decimal10
 
getDecimalDigits() - 类中的方法 org.hipparchus.dfp.DfpDec
Get the number of decimal digits this class is going to represent.
getDecomposer() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
Get the matrix decomposition algorithm.
getDecomposer() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
Get the matrix decomposition algorithm.
getDefaultNumberFormat() - 类中的静态方法 org.hipparchus.fraction.BigFractionFormat
Create a default number format.
getDefaultNumberFormat() - 类中的静态方法 org.hipparchus.fraction.ProperBigFractionFormat
Create a default number format.
getDefaultNumberFormat() - 类中的静态方法 org.hipparchus.fraction.FractionFormat
Create a default number format.
getDefaultNumberFormat() - 类中的静态方法 org.hipparchus.util.CompositeFormat
Create a default number format.
getDefaultNumberFormat(Locale) - 类中的静态方法 org.hipparchus.fraction.BigFractionFormat
Create a default number format.
getDefaultNumberFormat(Locale) - 类中的静态方法 org.hipparchus.fraction.FractionFormat
Create a default number format.
getDefaultNumberFormat(Locale) - 类中的静态方法 org.hipparchus.fraction.ProperBigFractionFormat
Create a default number format.
getDefaultNumberFormat(Locale) - 类中的静态方法 org.hipparchus.fraction.ProperFractionFormat
Create a default number format.
getDefaultNumberFormat(Locale) - 类中的静态方法 org.hipparchus.util.CompositeFormat
Create a default number format.
getDefaultStep() - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegrator
Getter for the default, positive step-size assigned at constructor level.
getDefaultStep() - 类中的方法 org.hipparchus.ode.nonstiff.RungeKuttaIntegrator
Getter for the default, positive step-size assigned at constructor level.
getDegreesOfFreedom() - 类中的方法 org.hipparchus.distribution.continuous.ChiSquaredDistribution
Access the number of degrees of freedom.
getDegreesOfFreedom() - 类中的方法 org.hipparchus.distribution.continuous.TDistribution
Access the degrees of freedom.
getDegToRad() - 类中的方法 org.hipparchus.dfp.DfpField
Get the degrees to radians conversion factor.
getDelta() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get the elevation of the vector.
getDelta() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
Get the elevation of the vector.
getDenominator() - 类中的方法 org.hipparchus.fraction.BigFraction
Access the denominator as a BigInteger.
getDenominator() - 类中的方法 org.hipparchus.fraction.Fraction
Access the denominator.
getDenominatorAsInt() - 类中的方法 org.hipparchus.fraction.BigFraction
Access the denominator as a int.
getDenominatorAsLong() - 类中的方法 org.hipparchus.fraction.BigFraction
Access the denominator as a long.
getDenominatorDegreesOfFreedom() - 类中的方法 org.hipparchus.distribution.continuous.FDistribution
Access the denominator degrees of freedom.
getDenominatorFormat() - 类中的方法 org.hipparchus.fraction.BigFractionFormat
Access the denominator format.
getDenominatorFormat() - 类中的方法 org.hipparchus.fraction.FractionFormat
Access the denominator format.
getDenominatorFormat() - 类中的方法 org.hipparchus.fraction.ProperBigFractionFormat
Access the denominator format.
getDenominatorFormat() - 类中的方法 org.hipparchus.fraction.ProperFractionFormat
Access the denominator format.
getDensityTestPoints() - 类中的方法 org.hipparchus.distribution.discrete.IntegerDistributionAbstractTest
 
getDensityTestValues() - 类中的方法 org.hipparchus.distribution.continuous.RealDistributionAbstractTest
 
getDensityTestValues() - 类中的方法 org.hipparchus.distribution.discrete.IntegerDistributionAbstractTest
 
getDerivative(int) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative
Get a derivative from the univariate derivative.
getDerivative(int) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
Get a derivative from the univariate derivative.
getDerivative(int) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Get a derivative from the univariate derivative.
getDerivative(int) - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
Get the derivative with respect to a particular index variable.
getDerivative(int) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative
Get a derivative from the univariate derivative.
getDerivative(int) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
Get a derivative from the univariate derivative.
getDerivative(int) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
Get a derivative from the univariate derivative.
getDerivativeField() - 类中的方法 org.hipparchus.analysis.differentiation.DSFactory
Get the Field the DerivativeStructure instances belong to.
getDerivativeField() - 类中的方法 org.hipparchus.analysis.differentiation.FDSFactory
Get the Field the FieldDerivativeStructure instances belong to.
getDetector() - 类中的方法 org.hipparchus.ode.events.EventSlopeFilter
Get the wrapped raw detector.
getDetector() - 类中的方法 org.hipparchus.ode.events.FieldEventSlopeFilter
Get the wrapped raw detector.
getDeterminant() - 类中的方法 org.hipparchus.linear.CholeskyDecomposition
Return the determinant of the matrix
getDeterminant() - 类中的方法 org.hipparchus.linear.ComplexEigenDecomposition
Computes the determinant.
getDeterminant() - 类中的方法 org.hipparchus.linear.EigenDecompositionNonSymmetric
Computes the determinant of the matrix.
getDeterminant() - 类中的方法 org.hipparchus.linear.EigenDecompositionSymmetric
Computes the determinant of the matrix.
getDeterminant() - 类中的方法 org.hipparchus.linear.FieldLUDecomposition
Return the determinant of the matrix.
getDeterminant() - 类中的方法 org.hipparchus.linear.LUDecomposition
Return the determinant of the matrix
getDiagonalOfHatMatrix(double[]) - 类中的方法 org.hipparchus.stat.regression.MillerUpdatingRegression
Gets the diagonal of the Hat matrix also known as the leverage matrix.
getDimension() - 类中的方法 org.hipparchus.analysis.interpolation.InterpolatingMicrosphere
Get the space dimensionality.
getDimension() - 类中的方法 org.hipparchus.distribution.multivariate.AbstractMultivariateRealDistribution
Gets the number of random variables of the distribution.
getDimension() - 接口中的方法 org.hipparchus.distribution.MultivariateRealDistribution
Gets the number of random variables of the distribution.
getDimension() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Euclidean1D
Get the dimension of the space.
getDimension() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Euclidean3D
Get the dimension of the space.
getDimension() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Euclidean2D
Get the dimension of the space.
getDimension() - 接口中的方法 org.hipparchus.geometry.Space
Get the dimension of the space.
getDimension() - 类中的方法 org.hipparchus.geometry.spherical.oned.Sphere1D
Get the dimension of the space.
getDimension() - 类中的方法 org.hipparchus.geometry.spherical.twod.Sphere2D
Get the dimension of the space.
getDimension() - 类中的方法 org.hipparchus.linear.ArrayFieldVector
Returns the size of the vector.
getDimension() - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
 
getDimension() - 类中的方法 org.hipparchus.linear.ArrayRealVector
Returns the size of the vector.
getDimension() - 接口中的方法 org.hipparchus.linear.FieldVector
Returns the size of the vector.
getDimension() - 类中的方法 org.hipparchus.linear.OpenMapRealVector
Returns the size of the vector.
getDimension() - 类中的方法 org.hipparchus.linear.RealVector
Returns the size of the vector.
getDimension() - 类中的方法 org.hipparchus.linear.RealVectorAbstractTest.RealVectorTestImpl
 
getDimension() - 类中的方法 org.hipparchus.linear.SparseFieldVector
Returns the size of the vector.
getDimension() - 异常错误类中的方法 org.hipparchus.migration.exception.DimensionMismatchException
已过时。
Get expected dimension.
getDimension() - 接口中的方法 org.hipparchus.ode.ComplexOrdinaryDifferentialEquation
Get the dimension of the problem.
getDimension() - 接口中的方法 org.hipparchus.ode.ComplexSecondaryODE
Get the dimension of the secondary state parameters.
getDimension() - 类中的方法 org.hipparchus.ode.events.CloseEventsTest.Equation
 
getDimension() - 类中的方法 org.hipparchus.ode.events.FieldCloseEventsTest.EquationODE
 
getDimension() - 类中的方法 org.hipparchus.ode.events.FieldVariableCheckInterval
Get the dimension of the problem.
getDimension() - 类中的方法 org.hipparchus.ode.events.OverlappingEventsTest
Get the dimension of the problem.
getDimension() - 类中的方法 org.hipparchus.ode.events.VariableCheckInterval
Get the dimension of the problem.
getDimension() - 接口中的方法 org.hipparchus.ode.FieldOrdinaryDifferentialEquation
Get the dimension of the problem.
getDimension() - 接口中的方法 org.hipparchus.ode.FieldSecondaryODE
Get the dimension of the secondary state parameters.
getDimension() - 类中的方法 org.hipparchus.ode.FirstOrderConverter
Get the dimension of the problem.
getDimension() - 类中的方法 org.hipparchus.ode.nonstiff.Ellipse
 
getDimension() - 类中的方法 org.hipparchus.ode.nonstiff.StepFieldProblem
 
getDimension() - 类中的方法 org.hipparchus.ode.nonstiff.StepProblem
 
getDimension() - 接口中的方法 org.hipparchus.ode.OrdinaryDifferentialEquation
Get the dimension of the problem.
getDimension() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTestBase
Get the dimension of the problem.
getDimension() - 接口中的方法 org.hipparchus.ode.SecondaryODE
Get the dimension of the secondary state parameters.
getDimension() - 接口中的方法 org.hipparchus.ode.SecondOrderODE
Get the dimension of the problem.
getDimension() - 类中的方法 org.hipparchus.ode.TestFieldProblemAbstract
Get the problem dimension.
getDimension() - 类中的方法 org.hipparchus.ode.TestProblemAbstract
 
getDimension() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
Get simplex dimension.
getDimension() - 类中的方法 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
Returns the dimension of the data
getDimension() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
Returns the dimension of the data
getDimension() - 接口中的方法 org.hipparchus.stat.descriptive.StorelessMultivariateStatistic
Returns the dimension of the statistic.
getDimension() - 类中的方法 org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic
Returns the dimension of the statistic.
getDimension() - 类中的方法 org.hipparchus.util.FieldTuple
Get the dimension of the tuple.
getDimension() - 类中的方法 org.hipparchus.util.MultidimensionalCounter
Get the number of dimensions of the multidimensional counter.
getDimension() - 类中的方法 org.hipparchus.util.Tuple
Get the dimension of the tuple.
getDirection() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldLine
Get the normalized direction vector.
getDirection() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Line
Get the normalized direction vector.
getDirection() - 异常错误类中的方法 org.hipparchus.migration.exception.NonMonotonicSequenceException
已过时。
Get order direction.
getDistance(OpenMapRealVector) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
Optimized method to compute distance.
getDistance(RealVector) - 类中的方法 org.hipparchus.linear.ArrayRealVector
Distance between two vectors.
getDistance(RealVector) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
Distance between two vectors.
getDistance(RealVector) - 类中的方法 org.hipparchus.linear.RealVector
Distance between two vectors.
getDistanceMeasure() - 类中的方法 org.hipparchus.clustering.Clusterer
Returns the DistanceMeasure instance used by this clusterer.
getDistribution() - 类中的方法 org.hipparchus.distribution.continuous.RealDistributionAbstractTest
 
getDistribution() - 类中的方法 org.hipparchus.distribution.discrete.IntegerDistributionAbstractTest
 
getDistributionQuartiles(RealDistribution) - 类中的静态方法 org.hipparchus.UnitTestUtils
Computes the 25th, 50th and 75th percentiles of the given distribution and returns these values in an array.
getDummyStepsize() - 类中的方法 org.hipparchus.ode.nonstiff.StepsizeHelper
Get a dummy step size.
getE() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant e.
getEigenvalue(int) - 类中的方法 org.hipparchus.linear.EigenDecompositionNonSymmetric
Returns the ith eigenvalue of the original matrix.
getEigenvalue(int) - 类中的方法 org.hipparchus.linear.EigenDecompositionSymmetric
Returns the ith eigenvalue of the original matrix.
getEigenvalues() - 类中的方法 org.hipparchus.linear.ComplexEigenDecomposition
Getter of the eigen values.
getEigenvalues() - 类中的方法 org.hipparchus.linear.EigenDecompositionNonSymmetric
Gets a copy of the eigenvalues of the original matrix.
getEigenvalues() - 类中的方法 org.hipparchus.linear.EigenDecompositionSymmetric
Gets a copy of the eigenvalues of the original matrix.
getEigenvector(int) - 类中的方法 org.hipparchus.linear.ComplexEigenDecomposition
Getter of the eigen vectors.
getEigenvector(int) - 类中的方法 org.hipparchus.linear.EigenDecompositionNonSymmetric
Gets a copy of the ith eigenvector of the original matrix.
getEigenvector(int) - 类中的方法 org.hipparchus.linear.EigenDecompositionSymmetric
Gets a copy of the ith eigenvector of the original matrix.
getElement(int) - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the element at the specified index
getElement(int) - 类中的方法 org.hipparchus.util.ResizableDoubleArray
Returns the element at the specified index.
getElements() - 类中的方法 org.hipparchus.util.ResizableDoubleArray
Returns a double array containing the elements of this ResizableArray.
getEmptyClusterStrategy() - 类中的方法 org.hipparchus.clustering.KMeansPlusPlusClusterer
Returns the KMeansPlusPlusClusterer.EmptyClusterStrategy used by this instance.
getEnclosingCap() - 类中的方法 org.hipparchus.geometry.spherical.twod.SphericalPolygonsSet
Get a spherical cap enclosing the polygon.
getEnd() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Segment
Get the end point of the segment.
getEnd() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Segment
Get the end point of the segment.
getEnd() - 类中的方法 org.hipparchus.geometry.spherical.twod.Edge
Get end vertex.
getEnd() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputOverlapTest
 
getEnd() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTest
 
getEnd() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTestBase
Returns the end time.
getEntry(int) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
Returns the entry in the specified index.
getEntry(int) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
 
getEntry(int) - 类中的方法 org.hipparchus.linear.ArrayRealVector
Return the entry at the specified index.
getEntry(int) - 接口中的方法 org.hipparchus.linear.FieldVector
Returns the entry in the specified index.
getEntry(int) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
Return the entry at the specified index.
getEntry(int) - 类中的方法 org.hipparchus.linear.RealVector
Return the entry at the specified index.
getEntry(int) - 类中的方法 org.hipparchus.linear.RealVectorAbstractTest.RealVectorTestImpl
 
getEntry(int) - 类中的方法 org.hipparchus.linear.SparseFieldVector
Returns the entry in the specified index.
getEntry(int, int) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Get the entry in the specified row and column.
getEntry(int, int) - 类中的方法 org.hipparchus.linear.Array2DRowFieldMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - 类中的方法 org.hipparchus.linear.Array2DRowRealMatrix
Get the entry in the specified row and column.
getEntry(int, int) - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Get the entry in the specified row and column.
getEntry(int, int) - 类中的方法 org.hipparchus.linear.DiagonalMatrix
Get the entry in the specified row and column.
getEntry(int, int) - 接口中的方法 org.hipparchus.linear.FieldMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - 类中的方法 org.hipparchus.linear.InverseHilbertMatrix
Returns the (i, j) entry of the inverse Hilbert matrix.
getEntry(int, int) - 类中的方法 org.hipparchus.linear.OpenMapRealMatrix
Get the entry in the specified row and column.
getEntry(int, int) - 接口中的方法 org.hipparchus.linear.RealMatrix
Get the entry in the specified row and column.
getEntry(int, int) - 类中的方法 org.hipparchus.linear.SparseFieldMatrix
Returns the entry in the specified row and column.
getEps() - 类中的方法 org.hipparchus.clustering.DBSCANClusterer
Returns the maximum radius of the neighborhood to be considered.
getEpsilon() - 类中的方法 org.hipparchus.clustering.FuzzyKMeansClusterer
Returns the convergence criteria used by this instance.
getEpsilon() - 类中的方法 org.hipparchus.linear.EigenDecompositionNonSymmetric
Get's the value for epsilon which is used for internal tests (e.g. is singular, eigenvalue ratio, etc.)
getEpsilon() - 类中的方法 org.hipparchus.linear.EigenDecompositionSymmetric
Get's the value for epsilon which is used for internal tests (e.g. is singular, eigenvalue ratio, etc.)
getEquations() - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
Get the differential equations to integrate.
getEquations() - 类中的方法 org.hipparchus.ode.AbstractIntegrator
Get the differential equations to integrate.
getErrorScale() - 类中的方法 org.hipparchus.ode.TestFieldProblemAbstract
Get the error scale.
getErrorScale() - 类中的方法 org.hipparchus.ode.TestProblemAbstract
Get the error scale.
getErrorSumSquares() - 类中的方法 org.hipparchus.stat.regression.RegressionResults
Returns the sum of squared errors (SSE) associated with the regression model.
getESplit() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant e split in two pieces.
getEstimationType() - 类中的方法 org.hipparchus.stat.descriptive.rank.Median
Get the estimation type used for computation.
getEstimationType() - 类中的方法 org.hipparchus.stat.descriptive.rank.Percentile
Get the estimation type used for computation.
getEvaluationCounter() - 类中的方法 org.hipparchus.optim.AbstractOptimizationProblem
Get a independent Incrementor that counts up to the maximum number of evaluations and then throws an exception.
getEvaluationCounter() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
Get a independent Incrementor that counts up to the maximum number of evaluations and then throws an exception.
getEvaluationCounter() - 接口中的方法 org.hipparchus.optim.OptimizationProblem
Get a independent Incrementor that counts up to the maximum number of evaluations and then throws an exception.
getEvaluations() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
Get the number of function evaluations of the last run of the integrator.
getEvaluations() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
Get the number of function evaluations of the last run of the integrator.
getEvaluations() - 接口中的方法 org.hipparchus.analysis.integration.FieldUnivariateIntegrator
Get the number of function evaluations of the last run of the integrator.
getEvaluations() - 接口中的方法 org.hipparchus.analysis.integration.UnivariateIntegrator
Get the number of function evaluations of the last run of the integrator.
getEvaluations() - 类中的方法 org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
Get the number of evaluations of the objective function.
getEvaluations() - 接口中的方法 org.hipparchus.analysis.solvers.BaseUnivariateSolver
Get the number of evaluations of the objective function.
getEvaluations() - 接口中的方法 org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
Get the number of evaluations of the objective function.
getEvaluations() - 类中的方法 org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
Get the number of evaluations of the objective function.
getEvaluations() - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
Get the number of evaluations of the differential equations function.
getEvaluations() - 类中的方法 org.hipparchus.ode.AbstractIntegrator
Get the number of evaluations of the differential equations function.
getEvaluations() - 接口中的方法 org.hipparchus.ode.FieldODEIntegrator
Get the number of evaluations of the differential equations function.
getEvaluations() - 接口中的方法 org.hipparchus.ode.ODEIntegrator
Get the number of evaluations of the differential equations function.
getEvaluations() - 类中的方法 org.hipparchus.optim.BaseMultiStartMultivariateOptimizer
Gets the number of evaluations of the objective function.
getEvaluations() - 类中的方法 org.hipparchus.optim.BaseOptimizer
Gets the number of evaluations of the objective function.
getEvaluations() - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresOptimizer.Optimum
Get the number of times the model was evaluated in order to produce this optimum.
getEvaluations() - 类中的方法 org.hipparchus.optim.univariate.BracketFinder
Get number of evaluations.
getEvaluations() - 类中的方法 org.hipparchus.optim.univariate.MultiStartUnivariateOptimizer
Gets the number of evaluations of the objective function.
getEvaluationsCounter() - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
Get the evaluations counter.
getEvaluationsCounter() - 类中的方法 org.hipparchus.ode.AbstractIntegrator
Get the evaluations counter.
getEventCount() - 类中的方法 org.hipparchus.ode.events.EventSlopeFilterTest.Event
 
getEventCount() - 类中的方法 org.hipparchus.ode.events.EventSlopeFilterTest.FieldEvent
 
getEventDetector() - 类中的方法 org.hipparchus.ode.events.DetectorBasedEventState
Get the underlying event detector.
getEventDetector() - 类中的方法 org.hipparchus.ode.events.FieldDetectorBasedEventState
Get the underlying event detector.
getEventDetectors() - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
Get all the event detectors that have been added to the integrator.
getEventDetectors() - 类中的方法 org.hipparchus.ode.AbstractIntegrator
Get all the event detectors that have been added to the integrator.
getEventDetectors() - 接口中的方法 org.hipparchus.ode.FieldODEIntegrator
Get all the event detectors that have been added to the integrator.
getEventDetectors() - 接口中的方法 org.hipparchus.ode.ODEIntegrator
Get all the event detectors that have been added to the integrator.
getEventDetectors(double, double, int) - 类中的方法 org.hipparchus.ode.TestProblem4
 
getEventDetectors(double, double, int) - 类中的方法 org.hipparchus.ode.TestProblemAbstract
Get the event detectors.
getEventDetectors(double, T, int) - 类中的方法 org.hipparchus.ode.TestFieldProblem4
 
getEventDetectors(double, T, int) - 类中的方法 org.hipparchus.ode.TestFieldProblemAbstract
Get the event detectors.
getEventTime() - 类中的方法 org.hipparchus.ode.events.DetectorBasedEventState
Get the occurrence time of the event triggered in the current step.
getEventTime() - 接口中的方法 org.hipparchus.ode.events.EventState
Get the occurrence time of the event triggered in the current step.
getEventTime() - 类中的方法 org.hipparchus.ode.events.FieldDetectorBasedEventState
Get the occurrence time of the event triggered in the current step.
getEventTime() - 接口中的方法 org.hipparchus.ode.events.FieldEventState
Get the occurrence time of the event triggered in the current step.
getEventTime() - 类中的方法 org.hipparchus.ode.events.FieldStepEndEventState
Get the occurrence time of the event triggered in the current step.
getEventTime() - 类中的方法 org.hipparchus.ode.events.StepEndEventState
Get the occurrence time of the event triggered in the current step.
getEvolution(double, RealVector[], T) - 接口中的方法 org.hipparchus.filtering.kalman.unscented.UnscentedProcess
Get the state evolution between two times.
getEvolution(double, RealVector, T) - 接口中的方法 org.hipparchus.filtering.kalman.extended.NonLinearProcess
Get the state evolution between two times.
getEvolution(T) - 接口中的方法 org.hipparchus.filtering.kalman.linear.LinearProcess
Get the state evolution between two times.
getExpansionFactor() - 类中的方法 org.hipparchus.util.ResizableDoubleArray
The expansion factor controls the size of a new array when an array needs to be expanded.
getExpansionMode() - 类中的方法 org.hipparchus.util.ResizableDoubleArray
The expansion mode determines whether the internal storage array grows additively or multiplicatively when it is expanded.
getExpectedColumnDimension() - 异常错误类中的方法 org.hipparchus.migration.linear.MatrixDimensionMismatchException
已过时。
Get expected column dimension.
getExpectedDimension(int) - 异常错误类中的方法 org.hipparchus.migration.exception.MultiDimensionMismatchException
已过时。
Get expected dimension at index.
getExpectedDimensions() - 异常错误类中的方法 org.hipparchus.migration.exception.MultiDimensionMismatchException
已过时。
Get array containing the expected dimensions.
getExpectedNumber() - 类中的方法 org.hipparchus.clustering.LocalizedClusteringFormatsTest
 
getExpectedNumber() - 类中的方法 org.hipparchus.exception.LocalizedCoreFormatsTest
 
getExpectedNumber() - 类中的方法 org.hipparchus.exception.LocalizedFormatsAbstractTest
 
getExpectedNumber() - 类中的方法 org.hipparchus.geometry.LocalizedGeometryFormatsTest
 
getExpectedNumber() - 类中的方法 org.hipparchus.migration.LocalizedMigrationFormatsTest
已过时。
 
getExpectedNumber() - 类中的方法 org.hipparchus.ode.LocalizedODEFormatsTest
 
getExpectedNumber() - 类中的方法 org.hipparchus.optim.LocalizedOptimFormatsTest
 
getExpectedNumber() - 类中的方法 org.hipparchus.transform.LocalizedFFTFormatsTest
 
getExpectedRowDimension() - 异常错误类中的方法 org.hipparchus.migration.linear.MatrixDimensionMismatchException
已过时。
Get expected row dimension.
getExpectedValue(int) - 类中的方法 org.hipparchus.analysis.integration.gauss.FieldGaussianQuadratureAbstractTest
Returns the expected value of the integral of the specified monomial.
getExpectedValue(int) - 类中的方法 org.hipparchus.analysis.integration.gauss.FieldHermiteParametricTest
 
getExpectedValue(int) - 类中的方法 org.hipparchus.analysis.integration.gauss.FieldLegendreParametricTest
 
getExpectedValue(int) - 类中的方法 org.hipparchus.analysis.integration.gauss.GaussianQuadratureAbstractTest
Returns the expected value of the integral of the specified monomial.
getExpectedValue(int) - 类中的方法 org.hipparchus.analysis.integration.gauss.HermiteParametricTest
 
getExpectedValue(int) - 类中的方法 org.hipparchus.analysis.integration.gauss.LegendreHighPrecisionParametricTest
 
getExpectedValue(int) - 类中的方法 org.hipparchus.analysis.integration.gauss.LegendreParametricTest
 
getExpInc() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputOverlapTest
 
getExpInc() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTest
 
getExpInc() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTestBase
Returns the expected normalized output time values for increment mode.
getExpIncRev() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputOverlapTest
 
getExpIncRev() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTest
 
getExpIncRev() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTestBase
Returns the expected reversed normalized output time values for increment mode.
getExpMul() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputOverlapTest
 
getExpMul() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTest
 
getExpMul() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTestBase
Returns the expected normalized output time values for multiples mode.
getExpMulRev() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputOverlapTest
 
getExpMulRev() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTest
 
getExpMulRev() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTestBase
Returns the expected reversed normalized output time values for multiples mode.
getExponent() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
Return the exponent of the instance value, removing the bias.
getExponent() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
Return the exponent of the instance value, removing the bias.
getExponent() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Return the exponent of the instance, removing the bias.
getExponent() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
Return the exponent of the instance, removing the bias.
getExponent() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Return the exponent of the instance, removing the bias.
getExponent() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
Return the exponent of the instance, removing the bias.
getExponent() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
Return the exponent of the instance, removing the bias.
getExponent() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
Return the exponent of the instance, removing the bias.
getExponent() - 接口中的方法 org.hipparchus.CalculusFieldElement
Return the exponent of the instance, removing the bias.
getExponent() - 类中的方法 org.hipparchus.dfp.Dfp
Return the exponent of the instance, removing the bias.
getExponent() - 类中的方法 org.hipparchus.distribution.discrete.ZipfDistribution
Get the exponent characterizing the distribution.
getExponent(double) - 类中的静态方法 org.hipparchus.util.FastMath
Return the exponent of a double number, removing the bias.
getExponent(float) - 类中的静态方法 org.hipparchus.util.FastMath
Return the exponent of a float number, removing the bias.
getExtendedField(int, boolean) - 类中的方法 org.hipparchus.dfp.DfpField
Get extended field for accuracy conversion.
getFaces() - 类中的方法 org.hipparchus.geometry.euclidean.threed.PLYParser
Get the parsed faces.
getFacets() - 类中的方法 org.hipparchus.geometry.euclidean.threed.PolyhedronsSet.BRep
Get the extracted facets.
getFactory() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
Get the factory that built the instance.
getFactory() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
Get the factory that built the instance.
getFHi() - 异常错误类中的方法 org.hipparchus.migration.exception.NoBracketingException
已过时。
Get the value at the higher end of the interval.
getFHi() - 类中的方法 org.hipparchus.optim.univariate.BracketFinder
Get function value at BracketFinder.getHi().
getField() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructureAbstractTest
 
getField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructureBinary64Test
 
getField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructureComplexTest
 
getField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructureDfpTest
 
getField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
Get the field to which function argument and value belong.
getField() - 类中的方法 org.hipparchus.analysis.integration.gauss.FieldAbstractRuleFactory
Get the field to which rule coefficients belong.
getField() - 类中的方法 org.hipparchus.analysis.polynomials.FieldPolynomialFunction
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.complex.Complex
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.complex.FieldComplex
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.dfp.Dfp
Get the Field (really a DfpField) to which the instance belongs.
getField() - 接口中的方法 org.hipparchus.FieldElement
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.fraction.BigFraction
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.fraction.Fraction
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Get the type of field elements of the matrix.
getField() - 类中的方法 org.hipparchus.linear.ArrayFieldVector
Get the type of field elements of the vector.
getField() - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
 
getField() - 接口中的方法 org.hipparchus.linear.FieldMatrix
Get the type of field elements of the matrix.
getField() - 接口中的方法 org.hipparchus.linear.FieldVector
Get the type of field elements of the vector.
getField() - 类中的方法 org.hipparchus.linear.SparseFieldVector
Get the type of field elements of the vector.
getField() - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
Get the field to which state vector elements belong.
getField() - 类中的方法 org.hipparchus.ode.TestFieldProblemAbstract
get the filed to which elements belong.
getField() - 类中的方法 org.hipparchus.util.BigReal
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.util.Binary64
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.util.FieldTuple
Get the Field to which the instance belongs.
getField() - 类中的方法 org.hipparchus.util.Tuple
Get the Field to which the instance belongs.
getField(int) - 类中的静态方法 org.hipparchus.analysis.differentiation.GradientField
Get the field for number of free parameters.
getField(Field<T>) - 类中的静态方法 org.hipparchus.complex.FieldComplexField
Get the field for complex numbers.
getField(Field<T>, int) - 类中的静态方法 org.hipparchus.analysis.differentiation.FieldGradientField
Get the field for number of free parameters.
getFieldGeneralOrder(Field<T>, int) - 类中的静态方法 org.hipparchus.analysis.polynomials.SmoothStepFactory
Create a smoothstep function of order 2N + 1.
getFinalTime() - 类中的方法 org.hipparchus.ode.DenseOutputModel
Get the final integration time.
getFinalTime() - 类中的方法 org.hipparchus.ode.FieldDenseOutputModel
Get the final integration time.
getFinalTime() - 类中的方法 org.hipparchus.ode.TestFieldProblemAbstract
Get the final time.
getFinalTime() - 类中的方法 org.hipparchus.ode.TestProblemAbstract
Get the final time.
getFirst() - 类中的方法 org.hipparchus.util.Pair
Get the first element of the pair.
getFirstDerivative() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
Get the first derivative.
getFirstDerivative() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Get the first derivative.
getFirstDerivative() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
Get the first derivative.
getFirstDerivative() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
Get the first derivative.
getFittedModel() - 类中的方法 org.hipparchus.stat.fitting.MultivariateNormalMixtureExpectationMaximization
Gets the fitted model.
getFLo() - 异常错误类中的方法 org.hipparchus.migration.exception.NoBracketingException
已过时。
Get the value at the lower end of the interval.
getFLo() - 类中的方法 org.hipparchus.optim.univariate.BracketFinder
Get function value at BracketFinder.getLo().
getFMid() - 类中的方法 org.hipparchus.optim.univariate.BracketFinder
Get function value at BracketFinder.getMid().
getFormat() - 类中的方法 org.hipparchus.geometry.VectorFormat
Get the components format.
getFormat() - 类中的方法 org.hipparchus.linear.RealMatrixFormat
Get the components format.
getFormat() - 类中的方法 org.hipparchus.linear.RealVectorFormat
Get the components format.
getFormatsClass() - 类中的方法 org.hipparchus.clustering.LocalizedClusteringFormatsTest
 
getFormatsClass() - 类中的方法 org.hipparchus.exception.LocalizedCoreFormatsTest
 
getFormatsClass() - 类中的方法 org.hipparchus.exception.LocalizedFormatsAbstractTest
 
getFormatsClass() - 类中的方法 org.hipparchus.geometry.LocalizedGeometryFormatsTest
 
getFormatsClass() - 类中的方法 org.hipparchus.migration.LocalizedMigrationFormatsTest
已过时。
 
getFormatsClass() - 类中的方法 org.hipparchus.ode.LocalizedODEFormatsTest
 
getFormatsClass() - 类中的方法 org.hipparchus.optim.LocalizedOptimFormatsTest
 
getFormatsClass() - 类中的方法 org.hipparchus.transform.LocalizedFFTFormatsTest
 
getFreeParameters() - 接口中的方法 org.hipparchus.analysis.differentiation.Derivative
Get the number of free parameters.
getFreeParameters() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
 
getFreeParameters() - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Get the number of free parameters.
getFreeParameters() - 接口中的方法 org.hipparchus.analysis.differentiation.FieldDerivative
Get the number of free parameters.
getFreeParameters() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
 
getFreeParameters() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Get the number of free parameters.
getFreeParameters() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative
Get the number of free parameters.
getFreeParameters() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
Get the number of free parameters.
getFreeParameters() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative
Get the number of free parameters.
getFrobeniusNorm() - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Returns the Frobenius norm of the matrix.
getFrobeniusNorm() - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Returns the Frobenius norm of the matrix.
getFrobeniusNorm() - 接口中的方法 org.hipparchus.linear.RealMatrix
Returns the Frobenius norm of the matrix.
getFunction() - 类中的方法 org.hipparchus.optim.linear.LinearOptimizer
Get optimization type.
getFunction(int) - 类中的方法 org.hipparchus.analysis.differentiation.FieldTaylorMap
Get a function from the map.
getFunction(int) - 类中的方法 org.hipparchus.analysis.differentiation.TaylorMap
Get a function from the map.
getFunctionValueAccuracy() - 类中的方法 org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
Get the function value accuracy of the solver.
getFunctionValueAccuracy() - 接口中的方法 org.hipparchus.analysis.solvers.BaseUnivariateSolver
Get the function value accuracy of the solver.
getFunctionValueAccuracy() - 接口中的方法 org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
Get the function value accuracy of the solver.
getFunctionValueAccuracy() - 类中的方法 org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
Get the function accuracy.
getFuzziness() - 类中的方法 org.hipparchus.clustering.FuzzyKMeansClusterer
Returns the fuzziness factor used by this instance.
getGeneralOrder(int) - 类中的静态方法 org.hipparchus.analysis.polynomials.SmoothStepFactory
Create a smoothstep function of order 2N + 1.
getGenerator() - 类中的方法 org.hipparchus.random.CorrelatedRandomVectorGenerator
Get the underlying normalized components generator.
getGeneratorUpperBounds() - 类中的方法 org.hipparchus.stat.fitting.EmpiricalDistribution
Returns a fresh copy of the array of upper bounds of the subintervals of [0,1] used in generating data from the empirical distribution.
getGeometricMean() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the geometric mean of the available values.
getGeometricMean() - 类中的方法 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the geometric mean of the ith entries of the arrays that correspond to each multivariate sample
getGeometricMean() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the geometric mean of the ith entries of the arrays that correspond to each multivariate sample
getGeometricMean() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns the geometric mean of the values that have been added.
getGlobalCurrentState() - 类中的方法 org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
Get the current global grid point state.
getGlobalCurrentState() - 类中的方法 org.hipparchus.ode.sampling.AbstractODEStateInterpolator
Get the current global grid point state.
getGlobalPreviousState() - 类中的方法 org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
Get the previous global grid point state.
getGlobalPreviousState() - 类中的方法 org.hipparchus.ode.sampling.AbstractODEStateInterpolator
Get the previous global grid point state.
getGoalType() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.MultivariateOptimizer
Get optimization type.
getGoalType() - 类中的方法 org.hipparchus.optim.univariate.UnivariateOptimizer
Get optimization type.
getGradient() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Get the gradient part of the function.
getGradient() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
Get the gradient part of the function.
getH() - 类中的方法 org.hipparchus.linear.FieldQRDecomposition
Returns the Householder reflector vectors.
getH() - 类中的方法 org.hipparchus.linear.HessenbergTransformer
Returns the Hessenberg matrix H of the transform.
getH() - 类中的方法 org.hipparchus.linear.QRDecomposition
Returns the Householder reflector vectors.
getHandler() - 接口中的方法 org.hipparchus.migration.ode.events.EventHandler
已过时。
Get the underlying event handler.
getHandler() - 类中的方法 org.hipparchus.ode.events.AbstractFieldODEDetector
Get the underlying event handler.
getHandler() - 类中的方法 org.hipparchus.ode.events.AbstractODEDetector
Get the underlying event handler.
getHandler() - 类中的方法 org.hipparchus.ode.events.EventSlopeFilterTest.Event
 
getHandler() - 类中的方法 org.hipparchus.ode.events.EventSlopeFilterTest.FieldEvent
 
getHandler() - 接口中的方法 org.hipparchus.ode.events.FieldODEEventDetector
Get the underlying event handler.
getHandler() - 类中的方法 org.hipparchus.ode.events.FieldStepEndEventState
Get the underlying step end handler.
getHandler() - 接口中的方法 org.hipparchus.ode.events.ODEEventDetector
Get the underlying event handler.
getHandler() - 类中的方法 org.hipparchus.ode.events.ReappearingEventTest.Event
 
getHandler() - 类中的方法 org.hipparchus.ode.events.StepEndEventState
Get the underlying step end handler.
getHi() - 异常错误类中的方法 org.hipparchus.migration.exception.NoBracketingException
已过时。
Get the higher end of the interval.
getHi() - 异常错误类中的方法 org.hipparchus.migration.exception.OutOfRangeException
已过时。
Get higher bound.
getHi() - 类中的方法 org.hipparchus.optim.univariate.BracketFinder
Get higher bound of the bracket.
getHP() - 类中的方法 org.hipparchus.ode.ParameterConfiguration
Get parameter step.
getHyperplane() - 类中的方法 org.hipparchus.geometry.partitioning.AbstractSubHyperplane
Get the underlying hyperplane.
getHyperplane() - 接口中的方法 org.hipparchus.geometry.partitioning.SubHyperplane
Get the underlying hyperplane.
getI() - 类中的方法 org.hipparchus.ode.TestFieldProblem8.InertiaAxis
Get the moment of inertia.
getI() - 类中的方法 org.hipparchus.ode.TestProblem8.InertiaAxis
Get the moment of inertia.
getI(Field<T>) - 类中的静态方法 org.hipparchus.complex.FieldComplex
Get the square root of -1.
getIdentity(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
Get identity rotation.
getIEEEFlags() - 类中的方法 org.hipparchus.dfp.DfpField
Get the IEEE 854 status flags.
getImaginary() - 类中的方法 org.hipparchus.complex.Complex
Access the imaginary part.
getImaginary() - 类中的方法 org.hipparchus.complex.FieldComplex
Access the imaginary part.
getImaginary(int) - 类中的方法 org.hipparchus.complex.RootsOfUnity
Get the imaginary part of the k-th n-th root of unity.
getImaginaryCharacter() - 类中的方法 org.hipparchus.complex.ComplexFormat
Access the imaginaryCharacter.
getImaginaryFormat() - 类中的方法 org.hipparchus.complex.ComplexFormat
Access the imaginaryFormat.
getImaginaryPart() - 类中的方法 org.hipparchus.complex.Complex
Access the imaginary part.
getImaginaryPart() - 类中的方法 org.hipparchus.complex.FieldComplex
Access the imaginary part.
getImproperInstance() - 类中的静态方法 org.hipparchus.fraction.BigFractionFormat
Returns the default complex format for the current locale.
getImproperInstance() - 类中的静态方法 org.hipparchus.fraction.FractionFormat
Returns the default complex format for the current locale.
getImproperInstance(Locale) - 类中的静态方法 org.hipparchus.fraction.BigFractionFormat
Returns the default complex format for the given locale.
getImproperInstance(Locale) - 类中的静态方法 org.hipparchus.fraction.FractionFormat
Returns the default complex format for the given locale.
getIncoming() - 类中的方法 org.hipparchus.geometry.spherical.twod.Vertex
Get incoming edge.
getIndex() - 类中的方法 org.hipparchus.linear.OpenMapRealVector.OpenMapEntry
Get the index of the entry.
getIndex() - 类中的方法 org.hipparchus.linear.RealVector.Entry
Get the index of the entry.
getIndex() - 异常错误类中的方法 org.hipparchus.migration.exception.NonMonotonicSequenceException
已过时。
Get the index of the wrong value.
getIndexM1(int) - 类中的方法 org.hipparchus.random.AbstractWell.IndexTable
Returns index + M1 modulo the table size.
getIndexM2(int) - 类中的方法 org.hipparchus.random.AbstractWell.IndexTable
Returns index + M2 modulo the table size.
getIndexM3(int) - 类中的方法 org.hipparchus.random.AbstractWell.IndexTable
Returns index + M3 modulo the table size.
getIndexPred(int) - 类中的方法 org.hipparchus.random.AbstractWell.IndexTable
Returns the predecessor of the given index modulo the table size.
getIndexPred2(int) - 类中的方法 org.hipparchus.random.AbstractWell.IndexTable
Returns the second predecessor of the given index modulo the table size.
getInertiaAxis1() - 类中的方法 org.hipparchus.ode.TestFieldProblem8.Inertia
Get inertia along first axis.
getInertiaAxis1() - 类中的方法 org.hipparchus.ode.TestProblem8.Inertia
Get inertia along first axis.
getInertiaAxis2() - 类中的方法 org.hipparchus.ode.TestFieldProblem8.Inertia
Get inertia along second axis.
getInertiaAxis2() - 类中的方法 org.hipparchus.ode.TestProblem8.Inertia
Get inertia along second axis.
getInertiaAxis3() - 类中的方法 org.hipparchus.ode.TestFieldProblem8.Inertia
Get inertia along third axis.
getInertiaAxis3() - 类中的方法 org.hipparchus.ode.TestProblem8.Inertia
Get inertia along third axis.
getInf() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Interval
Get the lower bound of the interval.
getInf() - 类中的方法 org.hipparchus.geometry.euclidean.oned.IntervalsSet
Get the lowest value belonging to the instance.
getInf() - 类中的方法 org.hipparchus.geometry.spherical.oned.Arc
Get the lower angular bound of the arc.
getInf(Field<T>) - 类中的静态方法 org.hipparchus.complex.FieldComplex
Get a complex number representing "+INF + INFi".
getInitialGuess() - 类中的方法 org.hipparchus.optim.InitialGuess
Gets the initial guess.
getInitialState() - 类中的方法 org.hipparchus.ode.TestFieldProblemAbstract
Get the initial state.
getInitialState() - 类中的方法 org.hipparchus.ode.TestProblemAbstract
Get the initial state vector.
getInitialStep() - 类中的方法 org.hipparchus.ode.nonstiff.StepsizeHelper
Get the initial step.
getInitialStepBoundFactor() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
Gets the value of a tuning parameter.
getInitialTime() - 类中的方法 org.hipparchus.ode.DenseOutputModel
Get the initial integration time.
getInitialTime() - 类中的方法 org.hipparchus.ode.FieldDenseOutputModel
Get the initial integration time.
getInitialTime() - 类中的方法 org.hipparchus.ode.TestFieldProblemAbstract
Get the initial time.
getInitialTime() - 类中的方法 org.hipparchus.ode.TestProblemAbstract
Get the initial time.
getInnovation(T, NonLinearEvolution, RealMatrix) - 接口中的方法 org.hipparchus.filtering.kalman.extended.NonLinearProcess
Get the innovation brought by a measurement.
getInnovation(T, RealVector, RealVector, RealMatrix) - 接口中的方法 org.hipparchus.filtering.kalman.unscented.UnscentedProcess
Get the innovation brought by a measurement.
getInnovationCovariance() - 类中的方法 org.hipparchus.filtering.kalman.ProcessEstimate
Get the innovation covariance matrix.
getInsideArc(Circle) - 类中的方法 org.hipparchus.geometry.spherical.twod.Circle
Get the arc of the instance that lies inside the other circle.
getInstance() - 类中的静态方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1Field
Get the unique instance.
getInstance() - 类中的静态方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2Field
Get the unique instance.
getInstance() - 类中的静态方法 org.hipparchus.complex.ComplexField
Get the unique instance.
getInstance() - 类中的静态方法 org.hipparchus.fraction.BigFractionField
Get the unique instance.
getInstance() - 类中的静态方法 org.hipparchus.fraction.FractionField
Get the unique instance.
getInstance() - 类中的静态方法 org.hipparchus.geometry.euclidean.oned.Euclidean1D
Get the unique instance.
getInstance() - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.Euclidean3D
Get the unique instance.
getInstance() - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.Euclidean2D
Get the unique instance.
getInstance() - 类中的静态方法 org.hipparchus.geometry.spherical.oned.Sphere1D
Get the unique instance.
getInstance() - 类中的静态方法 org.hipparchus.geometry.spherical.twod.Sphere2D
Get the unique instance.
getInstance() - 类中的静态方法 org.hipparchus.migration.ode.sampling.DummyStepHandler
已过时。
Get the only instance.
getInstance() - 类中的静态方法 org.hipparchus.util.BigRealField
Get the unique instance.
getInstance() - 类中的静态方法 org.hipparchus.util.Binary64Field
Returns the unique instance of this class.
getInstance(int) - 类中的静态方法 org.hipparchus.ode.nonstiff.AdamsNordsieckTransformer
Get the Nordsieck transformer for a given number of steps.
getInstance(Field<T>, int) - 类中的静态方法 org.hipparchus.ode.nonstiff.AdamsNordsieckFieldTransformer
Get the Nordsieck transformer for a given field and number of steps.
getIntercept() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the intercept of the estimated regression line, if SimpleRegression.hasIntercept() is true; otherwise 0.
getIntercept() - 类中的方法 org.hipparchus.UnitTestUtils.SimpleRegression
 
getInterceptStdErr() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the standard error of the intercept estimate, usually denoted s(b0).
getInterpolatedDerivatives() - 类中的方法 org.hipparchus.migration.ode.ContinuousOutputModel
已过时。
Get the derivatives of the state vector of the interpolated point.
getInterpolatedDerivatives() - 接口中的方法 org.hipparchus.migration.ode.sampling.StepInterpolator
getInterpolatedSecondaryDerivatives(int) - 类中的方法 org.hipparchus.migration.ode.ContinuousOutputModel
已过时。
Get the interpolated secondary derivatives corresponding to the secondary equations.
getInterpolatedSecondaryDerivatives(int) - 接口中的方法 org.hipparchus.migration.ode.sampling.StepInterpolator
getInterpolatedSecondaryState(int) - 类中的方法 org.hipparchus.migration.ode.ContinuousOutputModel
已过时。
Get the interpolated secondary state corresponding to the secondary equations.
getInterpolatedSecondaryState(int) - 接口中的方法 org.hipparchus.migration.ode.sampling.StepInterpolator
getInterpolatedState() - 类中的方法 org.hipparchus.migration.ode.ContinuousOutputModel
已过时。
Get the state vector of the interpolated point.
getInterpolatedState() - 接口中的方法 org.hipparchus.migration.ode.sampling.StepInterpolator
getInterpolatedState(double) - 类中的方法 org.hipparchus.ode.DenseOutputModel
Get the state at interpolated time.
getInterpolatedState(double) - 类中的方法 org.hipparchus.ode.sampling.AbstractODEStateInterpolator
Get the state at interpolated time.
getInterpolatedState(double) - 接口中的方法 org.hipparchus.ode.sampling.ODEStateInterpolator
Get the state at interpolated time.
getInterpolatedState(T) - 类中的方法 org.hipparchus.ode.FieldDenseOutputModel
Get the state at interpolated time.
getInterpolatedState(T) - 类中的方法 org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
Get the state at interpolated time.
getInterpolatedState(T) - 接口中的方法 org.hipparchus.ode.sampling.FieldODEStateInterpolator
Get the state at interpolated time.
getInterpolatedTime() - 类中的方法 org.hipparchus.migration.ode.ContinuousOutputModel
已过时。
Get the time of the interpolated point.
getInterpolatedTime() - 接口中的方法 org.hipparchus.migration.ode.sampling.StepInterpolator
getInterpolatingPoints() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns a copy of the interpolating points array.
getInterpolatingValues() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns a copy of the interpolating values array.
getInverse() - 类中的方法 org.hipparchus.complex.Quaternion
Returns the inverse of this instance.
getInverse() - 接口中的方法 org.hipparchus.linear.DecompositionSolver
Get the pseudo-inverse of the decomposed matrix.
getInverse() - 接口中的方法 org.hipparchus.linear.FieldDecompositionSolver
Get the inverse (or pseudo-inverse) of the decomposed matrix.
getInverseConditionNumber() - 类中的方法 org.hipparchus.linear.SingularValueDecomposition
Computes the inverse of the condition number.
getInverseCumulativeTestPoints() - 类中的方法 org.hipparchus.distribution.continuous.RealDistributionAbstractTest
 
getInverseCumulativeTestPoints() - 类中的方法 org.hipparchus.distribution.discrete.IntegerDistributionAbstractTest
 
getInverseCumulativeTestValues() - 类中的方法 org.hipparchus.distribution.continuous.RealDistributionAbstractTest
 
getInverseCumulativeTestValues() - 类中的方法 org.hipparchus.distribution.discrete.IntegerDistributionAbstractTest
 
getIterationCounter() - 类中的方法 org.hipparchus.optim.AbstractOptimizationProblem
Get a independent Incrementor that counts up to the maximum number of iterations and then throws an exception.
getIterationCounter() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
Get a independent Incrementor that counts up to the maximum number of iterations and then throws an exception.
getIterationCounter() - 接口中的方法 org.hipparchus.optim.OptimizationProblem
Get a independent Incrementor that counts up to the maximum number of iterations and then throws an exception.
getIterationManager() - 类中的方法 org.hipparchus.linear.IterativeLinearSolver
Returns the iteration manager attached to this solver.
getIterations() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
Get the number of iterations of the last run of the integrator.
getIterations() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
Get the number of iterations of the last run of the integrator.
getIterations() - 接口中的方法 org.hipparchus.analysis.integration.FieldUnivariateIntegrator
Get the number of iterations of the last run of the integrator.
getIterations() - 接口中的方法 org.hipparchus.analysis.integration.UnivariateIntegrator
Get the number of iterations of the last run of the integrator.
getIterations() - 类中的方法 org.hipparchus.optim.BaseOptimizer
Gets the number of iterations performed by the algorithm.
getIterations() - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresOptimizer.Optimum
Get the number of times the algorithm iterated in order to produce this optimum.
getIterations() - 类中的方法 org.hipparchus.util.IterationEvent
Returns the number of iterations performed at the time this event is created.
getIterations() - 类中的方法 org.hipparchus.util.IterationManager
Returns the number of iterations of this solver, 0 if no iterations has been performed yet.
getJacobian() - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
Get the weighted Jacobian matrix.
getK() - 类中的方法 org.hipparchus.clustering.FuzzyKMeansClusterer
Return the number of clusters this instance will use.
getK() - 类中的方法 org.hipparchus.clustering.KMeansPlusPlusClusterer
Return the number of clusters this instance will use.
getK() - 接口中的方法 org.hipparchus.linear.RiccatiEquationSolver
Get the linear controller k.
getK() - 类中的方法 org.hipparchus.linear.RiccatiEquationSolverImpl
{inheritDoc}
getK() - 类中的方法 org.hipparchus.util.Combinations
Gets the number of elements in each combination.
getKalmanGain() - 类中的方法 org.hipparchus.filtering.kalman.ProcessEstimate
Get the Kalman gain matrix.
getKernel(StreamingStatistics) - 类中的方法 org.hipparchus.stat.fitting.EmpiricalDistribution
The within-bin smoothing kernel.
getKey() - 类中的方法 org.hipparchus.util.Pair
Get the key.
getKnots() - 类中的方法 org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
Get an array copy of the knot points.
getKnots() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialSplineFunction
Get an array copy of the knot points.
getKthSelector() - 类中的方法 org.hipparchus.stat.descriptive.rank.Median
Get the kthSelector used for computation.
getKthSelector() - 类中的方法 org.hipparchus.stat.descriptive.rank.Percentile
Get the kthSelector used for computation.
getKurtosis() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the Kurtosis of the available values.
getL() - 类中的方法 org.hipparchus.linear.CholeskyDecomposition
Returns the matrix L of the decomposition.
getL() - 类中的方法 org.hipparchus.linear.FieldLUDecomposition
Returns the matrix L of the decomposition.
getL() - 类中的方法 org.hipparchus.linear.LUDecomposition
Returns the matrix L of the decomposition.
getL() - 类中的方法 org.hipparchus.linear.SemiDefinitePositiveCholeskyDecomposition
Returns the matrix L of the decomposition.
getL1Distance(OpenMapRealVector) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
Distance between two vectors.
getL1Distance(RealVector) - 类中的方法 org.hipparchus.linear.ArrayRealVector
Distance between two vectors.
getL1Distance(RealVector) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
Distance between two vectors.
getL1Distance(RealVector) - 类中的方法 org.hipparchus.linear.RealVector
Distance between two vectors.
getL1Norm() - 类中的方法 org.hipparchus.linear.ArrayRealVector
Returns the L1 norm of the vector.
getL1Norm() - 类中的方法 org.hipparchus.linear.RealVector
Returns the L1 norm of the vector.
getLastError() - 类中的方法 org.hipparchus.ode.TestFieldProblemHandler
Get the error at the end of the integration.
getLastError() - 类中的方法 org.hipparchus.ode.TestProblemHandler
Get the error at the end of the integration.
getLastTime() - 类中的方法 org.hipparchus.ode.TestFieldProblemHandler
Get the time at the end of the integration.
getLastTime() - 类中的方法 org.hipparchus.ode.TestProblemHandler
Get the time at the end of the integration.
getLeastSquaresProblem() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the least-squares problem corresponding to fitting the model to the specified data.
getLeftAbscissa() - 类中的方法 org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver.Interval
Get the left abscissa.
getLeftAbscissa() - 类中的方法 org.hipparchus.analysis.solvers.BracketedUnivariateSolver.Interval
Get the left abscissa.
getLeftValue() - 类中的方法 org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver.Interval
getLeftValue() - 类中的方法 org.hipparchus.analysis.solvers.BracketedUnivariateSolver.Interval
getLength() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Segment
Get the length of the line segment.
getLength() - 类中的方法 org.hipparchus.geometry.spherical.twod.Edge
Get the length of the arc.
getLine() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Segment
Get the line containing the segment.
getLine() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Segment
Get the line containing the segment.
getLineSegments() - 类中的方法 org.hipparchus.geometry.euclidean.twod.hull.ConvexHull2D
Get the line segments of the convex hull, ordered.
getLInfDistance(RealVector) - 类中的方法 org.hipparchus.linear.ArrayRealVector
Distance between two vectors.
getLInfDistance(RealVector) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
Distance between two vectors.
getLInfDistance(RealVector) - 类中的方法 org.hipparchus.linear.RealVector
Distance between two vectors.
getLInfNorm() - 类中的方法 org.hipparchus.linear.ArrayRealVector
Returns the L norm of the vector.
getLInfNorm() - 类中的方法 org.hipparchus.linear.RealVector
Returns the L norm of the vector.
getLn10() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant ln(10).
getLn2() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant ln(2).
getLn2Split() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant ln(2) split in two pieces.
getLn5() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant ln(5).
getLn5Split() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant ln(5) split in two pieces.
getLo() - 异常错误类中的方法 org.hipparchus.migration.exception.NoBracketingException
已过时。
Get the lower end of the interval.
getLo() - 异常错误类中的方法 org.hipparchus.migration.exception.OutOfRangeException
已过时。
Get lower bound.
getLo() - 类中的方法 org.hipparchus.optim.univariate.BracketFinder
Get lower bound of the bracket.
getLocale() - 类中的方法 org.hipparchus.complex.ComplexFormatAbstractTest
 
getLocale() - 类中的方法 org.hipparchus.complex.ComplexFormatTest
 
getLocale() - 类中的方法 org.hipparchus.complex.FrenchComplexFormatTest
 
getLocale() - 类中的方法 org.hipparchus.fraction.BigFractionFormatTest
 
getLocale() - 类中的方法 org.hipparchus.fraction.FractionFormatTest
 
getLocale() - 类中的方法 org.hipparchus.geometry.euclidean.oned.FrenchVector1DFormatTest
 
getLocale() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1DFormatAbstractTest
 
getLocale() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1DFormatTest
 
getLocale() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FrenchVector3DFormatTest
 
getLocale() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3DFormatAbstractTest
 
getLocale() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3DFormatTest
 
getLocale() - 类中的方法 org.hipparchus.geometry.euclidean.twod.FrenchVector2DFormatTest
 
getLocale() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2DFormatAbstractTest
 
getLocale() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2DFormatTest
 
getLocale() - 类中的方法 org.hipparchus.linear.FrenchRealVectorFormatTest
 
getLocale() - 类中的方法 org.hipparchus.linear.RealMatrixFormatAbstractTest
 
getLocale() - 类中的方法 org.hipparchus.linear.RealMatrixFormatTest
 
getLocale() - 类中的方法 org.hipparchus.linear.RealVectorFormatAbstractTest
 
getLocale() - 类中的方法 org.hipparchus.linear.RealVectorFormatTest
 
getLocalizedMessage() - 异常错误类中的方法 org.hipparchus.exception.MathRuntimeException
getLocalizedMessage() - 异常错误类中的方法 org.hipparchus.exception.NullArgumentException
getLocalizedString(Locale) - 枚举类中的方法 org.hipparchus.clustering.LocalizedClusteringFormats
Gets the localized string.
getLocalizedString(Locale) - 类中的方法 org.hipparchus.exception.DummyLocalizable
Gets the localized string.
getLocalizedString(Locale) - 接口中的方法 org.hipparchus.exception.Localizable
Gets the localized string.
getLocalizedString(Locale) - 枚举类中的方法 org.hipparchus.exception.LocalizedCoreFormats
Gets the localized string.
getLocalizedString(Locale) - 枚举类中的方法 org.hipparchus.geometry.LocalizedGeometryFormats
Gets the localized string.
getLocalizedString(Locale) - 枚举类中的方法 org.hipparchus.migration.exception.util.LocalizedFormats
已过时。
Gets the localized string.
getLocalizedString(Locale) - 枚举类中的方法 org.hipparchus.migration.LocalizedMigrationFormats
已过时。
Gets the localized string.
getLocalizedString(Locale) - 枚举类中的方法 org.hipparchus.ode.LocalizedODEFormats
Gets the localized string.
getLocalizedString(Locale) - 枚举类中的方法 org.hipparchus.optim.LocalizedOptimFormats
Gets the localized string.
getLocalizedString(Locale) - 枚举类中的方法 org.hipparchus.stat.LocalizedStatFormats
Gets the localized string.
getLocalizedString(Locale) - 枚举类中的方法 org.hipparchus.transform.LocalizedFFTFormats
Gets the localized string.
getLocation() - 类中的方法 org.hipparchus.distribution.continuous.GumbelDistribution
Access the location parameter, mu.
getLocation() - 类中的方法 org.hipparchus.distribution.continuous.LaplaceDistribution
Access the location parameter, mu.
getLocation() - 类中的方法 org.hipparchus.distribution.continuous.LevyDistribution
Get the location parameter of the distribution.
getLocation() - 类中的方法 org.hipparchus.distribution.continuous.LogisticDistribution
Access the location parameter, mu.
getLocation() - 类中的方法 org.hipparchus.distribution.continuous.LogNormalDistribution
Returns the location parameter of this distribution.
getLocation() - 类中的方法 org.hipparchus.geometry.euclidean.oned.OrientedPoint
Get the hyperplane location on the real line.
getLocation() - 类中的方法 org.hipparchus.geometry.spherical.oned.LimitAngle
Get the hyperplane location on the circle.
getLocation() - 类中的方法 org.hipparchus.geometry.spherical.twod.Vertex
Get Vertex location.
getLogLikelihood() - 类中的方法 org.hipparchus.stat.fitting.MultivariateNormalMixtureExpectationMaximization
Gets the log likelihood of the data under the fitted model.
getLower() - 类中的方法 org.hipparchus.optim.SimpleBounds
Gets the lower bounds.
getLowerBound() - 类中的方法 org.hipparchus.optim.BaseMultivariateOptimizer
Get lower bounds.
getLowerBound() - 类中的方法 org.hipparchus.stat.interval.ConfidenceInterval
Get lower endpoint of the interval.
getLT() - 类中的方法 org.hipparchus.linear.CholeskyDecomposition
Returns the transpose of the matrix L of the decomposition.
getLT() - 类中的方法 org.hipparchus.linear.SemiDefinitePositiveCholeskyDecomposition
Returns the transpose of the matrix L of the decomposition.
getM() - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiElliptic
Get the parameter of the function.
getM() - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiElliptic
Get the parameter of the function.
getMainPanel() - 类中的方法 org.hipparchus.samples.ExampleUtils.ExampleFrame
Returns the main panel which should be printed by the screenshot action.
getMainPanel() - 类中的方法 org.hipparchus.samples.geometry.GeometryExample.Display
Returns the main panel which should be printed by the screenshot action.
getMainPanel() - 类中的方法 org.hipparchus.samples.IntegerDistributionComparison.Display
Returns the main panel which should be printed by the screenshot action.
getMainPanel() - 类中的方法 org.hipparchus.samples.RealDistributionComparison.Display
Returns the main panel which should be printed by the screenshot action.
getMainSetDimension() - 类中的方法 org.hipparchus.ode.nonstiff.StepsizeHelper
Get the main set dimension.
getMapper() - 类中的方法 org.hipparchus.ode.ExpandableODE
Get the mapper for the set of equations.
getMapper() - 类中的方法 org.hipparchus.ode.FieldExpandableODE
Get the mapper for the set of equations.
getMapper() - 类中的方法 org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
Get the mapper for ODE equations primary and secondary components.
getMapper() - 类中的方法 org.hipparchus.ode.sampling.AbstractODEStateInterpolator
Get the mapper for ODE equations primary and secondary components.
getMatrix() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
Get the 3X3 matrix corresponding to the instance
getMatrix() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
Get the 3X3 matrix corresponding to the instance
getMax() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
Get the upper bound.
getMax() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
Get the upper bound.
getMax() - 类中的方法 org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
Get higher end of the search interval.
getMax() - 异常错误类中的方法 org.hipparchus.migration.exception.MaxCountExceededException
已过时。
Get maximum number of evaluations.
getMax() - 异常错误类中的方法 org.hipparchus.migration.exception.NumberIsTooLargeException
已过时。
Get the maximum.
getMax() - 类中的方法 org.hipparchus.optim.univariate.SearchInterval
Gets the upper bound.
getMax() - 类中的方法 org.hipparchus.optim.univariate.UnivariateOptimizer
Get upper bounds.
getMax() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the maximum of the available values
getMax() - 类中的方法 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the maximum of the ith entries of the arrays that correspond to each multivariate sample
getMax() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the maximum of the ith entries of the arrays that correspond to each multivariate sample
getMax() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalSummary
Returns the maximum of the available values
getMax() - 类中的方法 org.hipparchus.stat.descriptive.StatisticalSummaryValues
 
getMax() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns the maximum of the available values
getMax() - 类中的方法 org.hipparchus.UnitTestUtils.SimpleStatistics
 
getMaxCheckInterval() - 类中的方法 org.hipparchus.ode.events.AbstractFieldODEDetector
Get the maximal time interval between events handler checks.
getMaxCheckInterval() - 类中的方法 org.hipparchus.ode.events.AbstractODEDetector
Get the maximal time interval between events handler checks.
getMaxCheckInterval() - 类中的方法 org.hipparchus.ode.events.EventSlopeFilterTest.Event
 
getMaxCheckInterval() - 类中的方法 org.hipparchus.ode.events.EventSlopeFilterTest.FieldEvent
 
getMaxCheckInterval() - 接口中的方法 org.hipparchus.ode.events.FieldODEEventDetector
Get the maximal time interval between events handler checks.
getMaxCheckInterval() - 接口中的方法 org.hipparchus.ode.events.ODEEventDetector
Get the maximal time interval between events handler checks.
getMaxCheckInterval() - 类中的方法 org.hipparchus.ode.events.ReappearingEventTest.Event
 
getMaxEval() - 类中的方法 org.hipparchus.optim.MaxEval
Gets the maximum number of evaluations.
getMaxEvaluations() - 接口中的方法 org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
Get the maximum number of function evaluations.
getMaxEvaluations() - 类中的方法 org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
Get the maximal number of function evaluations.
getMaxEvaluations() - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
Get the maximal number of functions evaluations.
getMaxEvaluations() - 类中的方法 org.hipparchus.ode.AbstractIntegrator
Get the maximal number of functions evaluations.
getMaxEvaluations() - 接口中的方法 org.hipparchus.ode.FieldODEIntegrator
Get the maximal number of functions evaluations.
getMaxEvaluations() - 接口中的方法 org.hipparchus.ode.ODEIntegrator
Get the maximal number of functions evaluations.
getMaxEvaluations() - 类中的方法 org.hipparchus.optim.BaseOptimizer
Gets the maximal number of function evaluations.
getMaxEvaluations() - 类中的方法 org.hipparchus.optim.univariate.BracketFinder
Get maximum number of evaluations.
getMaxGrowth() - 类中的方法 org.hipparchus.ode.MultistepFieldIntegrator
Get the maximal growth factor for stepsize control.
getMaxGrowth() - 类中的方法 org.hipparchus.ode.MultistepIntegrator
Get the maximal growth factor for stepsize control.
getMaxGrowth() - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
Get the maximal growth factor for stepsize control.
getMaxGrowth() - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the maximal growth factor for stepsize control.
getMaximalCount() - 类中的方法 org.hipparchus.util.Incrementor
Gets the upper limit of the counter.
getMaximalIterationCount() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
Get the upper limit for the number of iterations.
getMaximalIterationCount() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
Get the upper limit for the number of iterations.
getMaximalIterationCount() - 接口中的方法 org.hipparchus.analysis.integration.FieldUnivariateIntegrator
Get the upper limit for the number of iterations.
getMaximalIterationCount() - 接口中的方法 org.hipparchus.analysis.integration.UnivariateIntegrator
Get the upper limit for the number of iterations.
getMaximalOrder() - 类中的方法 org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolver
Get the maximal order.
getMaximalOrder() - 类中的方法 org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
Get the maximal order.
getMaximalTimeError() - 类中的方法 org.hipparchus.ode.TestFieldProblemHandler
Get the maximal time error encountered during integration.
getMaximalTimeError() - 类中的方法 org.hipparchus.ode.TestProblemHandler
Get the maximal time error encountered during integration.
getMaximalValueError() - 类中的方法 org.hipparchus.ode.TestFieldProblemHandler
Get the maximal value error encountered during integration.
getMaximalValueError() - 类中的方法 org.hipparchus.ode.TestProblemHandler
Get the maximal value error encountered during integration.
getMaximumAbsoluteError() - 类中的方法 org.hipparchus.stat.data.CertifiedDataAbstractTest
 
getMaxIndex() - 类中的方法 org.hipparchus.linear.RealVector
Get the index of the maximum entry.
getMaxIter() - 类中的方法 org.hipparchus.optim.MaxIter
Gets the maximum number of evaluations.
getMaxIterationCount() - 类中的方法 org.hipparchus.ode.events.AbstractFieldODEDetector
Get the upper limit in the iteration count for event localization.
getMaxIterationCount() - 类中的方法 org.hipparchus.ode.events.AbstractODEDetector
Get the upper limit in the iteration count for event localization.
getMaxIterationCount() - 类中的方法 org.hipparchus.ode.events.EventSlopeFilterTest.Event
 
getMaxIterationCount() - 类中的方法 org.hipparchus.ode.events.EventSlopeFilterTest.FieldEvent
 
getMaxIterationCount() - 接口中的方法 org.hipparchus.ode.events.FieldODEEventDetector
Get the upper limit in the iteration count for event localization.
getMaxIterationCount() - 接口中的方法 org.hipparchus.ode.events.ODEEventDetector
Get the upper limit in the iteration count for event localization.
getMaxIterationCount() - 类中的方法 org.hipparchus.ode.events.ReappearingEventTest.Event
 
getMaxIterations() - 类中的方法 org.hipparchus.clustering.FuzzyKMeansClusterer
Returns the maximum number of iterations this instance will use.
getMaxIterations() - 类中的方法 org.hipparchus.clustering.KMeansPlusPlusClusterer
Returns the maximum number of iterations this instance will use.
getMaxIterations() - 类中的方法 org.hipparchus.optim.BaseOptimizer
Gets the maximal number of iterations.
getMaxIterations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractLeastSquaresOptimizerAbstractTest
 
getMaxIterations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractSequentialLeastSquaresOptimizerAbstractTest
 
getMaxIterations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithCholeskyTest
 
getMaxIterations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithLUTest
 
getMaxIterations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithQRNormalTest
 
getMaxIterations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithQRTest
 
getMaxIterations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithSVDTest
 
getMaxIterations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizerTest
 
getMaxIterations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizerWithCholeskyTest
 
getMaxIterations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizerWithLUTest
 
getMaxIterations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizerWithQRNormalTest
 
getMaxIterations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizerWithQRTest
 
getMaxIterations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizerWithSVDTest
 
getMaxIterations() - 类中的方法 org.hipparchus.util.IterationManager
Returns the maximum number of iterations.
getMaxOrder() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1Test
 
getMaxOrder() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2Test
 
getMaxOrder() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivativeAbstractTest
 
getMaxStep() - 类中的方法 org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
Get the maximal step.
getMaxStep() - 类中的方法 org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
Get the maximal step.
getMaxStep() - 类中的方法 org.hipparchus.ode.nonstiff.StepsizeHelper
Get the maximal step.
getMaxValue() - 类中的方法 org.hipparchus.linear.RealVector
Get the value of the maximum entry.
getMean() - 类中的方法 org.hipparchus.distribution.continuous.ExponentialDistribution
Access the mean.
getMean() - 类中的方法 org.hipparchus.distribution.continuous.NormalDistribution
Access the mean.
getMean() - 类中的方法 org.hipparchus.distribution.discrete.PoissonDistribution
Get the mean for the distribution.
getMean() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the arithmetic mean of the available values
getMean() - 类中的方法 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the mean of the ith entries of the arrays that correspond to each multivariate sample
getMean() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the mean of the ith entries of the arrays that correspond to each multivariate sample
getMean() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalSummary
Returns the arithmetic mean of the available values
getMean() - 类中的方法 org.hipparchus.stat.descriptive.StatisticalSummaryValues
 
getMean() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns the arithmetic mean of the available values
getMean() - 类中的方法 org.hipparchus.UnitTestUtils.SimpleStatistics
 
getMeans() - 类中的方法 org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
Gets the mean vector.
getMeanSquareError() - 类中的方法 org.hipparchus.stat.regression.RegressionResults
Returns the sum of squared errors divided by the degrees of freedom, usually abbreviated MSE.
getMeanSquareError() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the sum of squared errors divided by the degrees of freedom, usually abbreviated MSE.
getMeasurementJacobian() - 类中的方法 org.hipparchus.filtering.kalman.extended.NonLinearEvolution
Get measurement Jacobian.
getMeasurementJacobian() - 类中的方法 org.hipparchus.filtering.kalman.linear.LinearEvolution
Get measurement Jacobian.
getMeasurementJacobian() - 类中的方法 org.hipparchus.filtering.kalman.ProcessEstimate
Get the Jacobian of the measurement with respect to the state (H matrix).
getMedian() - 类中的方法 org.hipparchus.distribution.continuous.CauchyDistribution
Access the median.
getMedian() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns an estimate of the median of the values that have been entered.
getMedian() - 类中的方法 org.hipparchus.UnitTestUtils.SimpleStatistics
 
getMembershipMatrix() - 类中的方法 org.hipparchus.clustering.FuzzyKMeansClusterer
Returns the nxk membership matrix, where n is the number of data points and k the number of clusters.
getMessage() - 异常错误类中的方法 org.hipparchus.exception.MathRuntimeException
getMessage() - 异常错误类中的方法 org.hipparchus.exception.NullArgumentException
getMessage(Locale) - 接口中的方法 org.hipparchus.exception.LocalizedException
Gets the message in a specified locale.
getMessage(Locale) - 异常错误类中的方法 org.hipparchus.exception.MathRuntimeException
Gets the message in a specified locale.
getMessage(Locale) - 异常错误类中的方法 org.hipparchus.exception.NullArgumentException
Gets the message in a specified locale.
getMid() - 类中的方法 org.hipparchus.optim.univariate.BracketFinder
Get a point in the middle of the bracket.
getMin() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
Get the lower bound.
getMin() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
Get the lower bound.
getMin() - 类中的方法 org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
Get lower end of the search interval.
getMin() - 异常错误类中的方法 org.hipparchus.migration.exception.NumberIsTooSmallException
已过时。
Get minimum.
getMin() - 类中的方法 org.hipparchus.optim.univariate.SearchInterval
Gets the lower bound.
getMin() - 类中的方法 org.hipparchus.optim.univariate.UnivariateOptimizer
Get lower bounds.
getMin() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the minimum of the available values
getMin() - 类中的方法 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the minimum of the ith entries of the arrays that correspond to each multivariate sample
getMin() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the minimum of the ith entries of the arrays that correspond to each multivariate sample
getMin() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalSummary
Returns the minimum of the available values
getMin() - 类中的方法 org.hipparchus.stat.descriptive.StatisticalSummaryValues
 
getMin() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns the minimum of the available values
getMin() - 类中的方法 org.hipparchus.UnitTestUtils.SimpleStatistics
 
getMinimalIterationCount() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
Get the min limit for the number of iterations.
getMinimalIterationCount() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
Get the min limit for the number of iterations.
getMinimalIterationCount() - 接口中的方法 org.hipparchus.analysis.integration.FieldUnivariateIntegrator
Get the min limit for the number of iterations.
getMinimalIterationCount() - 接口中的方法 org.hipparchus.analysis.integration.UnivariateIntegrator
Get the min limit for the number of iterations.
getMinIndex() - 类中的方法 org.hipparchus.linear.RealVector
Get the index of the minimum entry.
getMinPts() - 类中的方法 org.hipparchus.clustering.DBSCANClusterer
Returns the minimum number of points needed for a cluster.
getMinReduction() - 类中的方法 org.hipparchus.ode.MultistepFieldIntegrator
Get the minimal reduction factor for stepsize control.
getMinReduction() - 类中的方法 org.hipparchus.ode.MultistepIntegrator
Get the minimal reduction factor for stepsize control.
getMinReduction() - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
Get the minimal reduction factor for stepsize control.
getMinReduction() - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the minimal reduction factor for stepsize control.
getMinStep() - 类中的方法 org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
Get the minimal step.
getMinStep() - 类中的方法 org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
Get the minimal step.
getMinStep() - 类中的方法 org.hipparchus.ode.nonstiff.StepsizeHelper
Get the minimal step.
getMinus() - 类中的方法 org.hipparchus.geometry.partitioning.BSPTree
Get the tree on the minus side of the cut hyperplane.
getMinus() - 类中的方法 org.hipparchus.geometry.partitioning.SubHyperplane.SplitSubHyperplane
Get the part of the sub-hyperplane on the minus side of the splitting hyperplane.
getMinus() - 类中的方法 org.hipparchus.geometry.spherical.oned.ArcsSet.Split
Get the part of the arcs set on the minus side of the splitting arc.
getMinusI(Field<T>) - 类中的静态方法 org.hipparchus.complex.FieldComplex
Get the square root of -1.
getMinusI(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get opposite of the first canonical vector (coordinates: -1, 0, 0).
getMinusI(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get opposite of the first canonical vector (coordinates: -1).
getMinusJ(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get opposite of the second canonical vector (coordinates: 0, -1, 0).
getMinusJ(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get opposite of the second canonical vector (coordinates: 0, -1).
getMinusK(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get opposite of the third canonical vector (coordinates: 0, 0, -1).
getMinusOne(Field<T>) - 类中的静态方法 org.hipparchus.complex.FieldComplex
Get a complex number representing "-1.0 + 0.0i".
getMinValue() - 类中的方法 org.hipparchus.linear.RealVector
Get the value of the minimum entry.
getMode() - 类中的方法 org.hipparchus.distribution.continuous.TriangularDistribution
Returns the mode c of this distribution.
getMode() - 类中的方法 org.hipparchus.stat.Frequency
Returns the mode value(s) in comparator order.
getModelDerivatives(double, double[]) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the values of the partial derivatives of the model with respect to the parameters.
getModelFunction() - 类中的方法 org.hipparchus.fitting.AbstractCurveFitter.TheoreticalValuesFunction
Get model function value.
getModelFunctionJacobian() - 类中的方法 org.hipparchus.fitting.AbstractCurveFitter.TheoreticalValuesFunction
Get model function Jacobian.
getModelValue(double, double[]) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the value of the model for the specified values of the predictor variable and the parameters.
getMultiplicationFactor() - 类中的方法 org.hipparchus.util.AbstractUnscentedTransform
Get the factor applied to the covariance matrix during the unscented transform.
getMultiplicationFactor() - 类中的方法 org.hipparchus.util.JulierUnscentedTransform
Get the factor applied to the covariance matrix during the unscented transform.
getMultiplicationFactor() - 类中的方法 org.hipparchus.util.MerweUnscentedTransform
Get the factor applied to the covariance matrix during the unscented transform.
getN() - 类中的方法 org.hipparchus.analysis.interpolation.GridAxis
Get the number of points required for interpolation.
getN() - 类中的方法 org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
Get the number of spline segments.
getN() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialSplineFunction
Get the number of spline segments.
getN() - 类中的方法 org.hipparchus.stat.correlation.Covariance
Returns the number of observations (length of covariate vectors)
getN() - 类中的方法 org.hipparchus.stat.correlation.StorelessCovariance
This Covariance method is not supported by a StorelessCovariance, since the number of bivariate observations does not have to be the same for different pairs of covariates - i.e., N as defined in Covariance.getN() is undefined.
getN() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the number of available values
getN() - 类中的方法 org.hipparchus.stat.descriptive.moment.SecondMoment
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.moment.GeometricMean
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.moment.Kurtosis
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.moment.Mean
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.moment.Skewness
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.moment.StandardDeviation
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.moment.Variance
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
Returns the number of available values
getN() - 类中的方法 org.hipparchus.stat.descriptive.rank.Max
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.rank.Min
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.rank.PSquarePercentile
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentile
 
getN() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
Returns the number of available values
getN() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalSummary
Returns the number of available values
getN() - 类中的方法 org.hipparchus.stat.descriptive.StatisticalSummaryValues
 
getN() - 接口中的方法 org.hipparchus.stat.descriptive.StorelessMultivariateStatistic
Returns the number of values that have been added.
getN() - 接口中的方法 org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns the number of available values
getN() - 类中的方法 org.hipparchus.stat.descriptive.summary.Product
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.summary.Sum
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.summary.SumOfLogs
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.summary.SumOfSquares
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.descriptive.vector.VectorialCovariance
Get the number of vectors in the sample.
getN() - 类中的方法 org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic
Returns the number of values that have been added.
getN() - 类中的方法 org.hipparchus.stat.regression.MillerUpdatingRegression
Gets the number of observations added to the regression model.
getN() - 类中的方法 org.hipparchus.stat.regression.RegressionResults
Returns the number of observations added to the regression model.
getN() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the number of observations that have been added to the model.
getN() - 接口中的方法 org.hipparchus.stat.regression.UpdatingMultipleLinearRegression
Returns the number of observations added to the regression model.
getN() - 类中的方法 org.hipparchus.UnitTestUtils.SimpleStatistics
 
getN() - 类中的方法 org.hipparchus.util.Combinations
Gets the size of the set from which combinations are drawn.
getName() - 异常错误类中的方法 org.hipparchus.migration.ode.UnknownParameterException
已过时。
Get name of the unknown parameter.
getName() - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
Get the name of the method.
getName() - 类中的方法 org.hipparchus.ode.AbstractIntegrator
Get the name of the method.
getName() - 接口中的方法 org.hipparchus.ode.FieldODEIntegrator
Get the name of the method.
getName() - 接口中的方法 org.hipparchus.ode.ODEIntegrator
Get the name of the method.
getName() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the name of this dataset.
getNaN(Field<T>) - 类中的静态方法 org.hipparchus.complex.FieldComplex
Get a complex number representing "NaN + NaNi".
getNaN(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get a vector with all coordinates set to NaN.
getNaN(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get a vector with all coordinates set to NaN.
getNanStrategy() - 类中的方法 org.hipparchus.stat.ranking.NaturalRanking
Return the NaNStrategy
getNaNStrategy() - 类中的方法 org.hipparchus.stat.descriptive.rank.Median
Get the NaN Handling strategy used for computation.
getNaNStrategy() - 类中的方法 org.hipparchus.stat.descriptive.rank.Percentile
Get the NaN Handling strategy used for computation.
getNbFunctions() - 类中的方法 org.hipparchus.analysis.differentiation.FieldTaylorMap
Get the number of functions of the map.
getNbFunctions() - 类中的方法 org.hipparchus.analysis.differentiation.TaylorMap
Get the number of functions of the map.
getNbParameters() - 类中的方法 org.hipparchus.analysis.differentiation.FieldTaylorMap
Get the number of parameters of the map.
getNbParameters() - 类中的方法 org.hipparchus.analysis.differentiation.TaylorMap
Get the number of parameters of the map.
getNbPoints() - 类中的方法 org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
Get the number of points to use.
getNegativeInfinity(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get a vector with all coordinates set to negative infinity.
getNegativeInfinity(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get a vector with all coordinates set to negative infinity.
getNewState() - 类中的方法 org.hipparchus.ode.events.EventOccurrence
Get the new state for a reset action.
getNewState() - 类中的方法 org.hipparchus.ode.events.FieldEventOccurrence
Get the new state for a reset action.
getNewtonCoefficients() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
Returns a copy of coefficients in Newton form formula.
getNextIndex() - 类中的方法 org.hipparchus.random.HaltonSequenceGenerator
Returns the index i of the next point in the Halton sequence that will be returned by calling HaltonSequenceGenerator.nextVector().
getNextIndex() - 类中的方法 org.hipparchus.random.SobolSequenceGenerator
Returns the index i of the next point in the Sobol sequence that will be returned by calling SobolSequenceGenerator.nextVector().
getNextValue() - 类中的方法 org.hipparchus.stat.fitting.EmpiricalDistribution
Generates a random value from this distribution.
getNorm() - 类中的方法 org.hipparchus.complex.Quaternion
Computes the norm of the quaternion.
getNorm() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
Get the L2 norm for the vector.
getNorm() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get the L2 norm for the vector.
getNorm() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
Get the L2 norm for the vector.
getNorm() - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get the L2 norm for the vector.
getNorm() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
Get the L2 norm for the vector.
getNorm() - 接口中的方法 org.hipparchus.geometry.Vector
Get the L2 norm for the vector.
getNorm() - 类中的方法 org.hipparchus.linear.ArrayRealVector
Returns the L2 norm of the vector.
getNorm() - 类中的方法 org.hipparchus.linear.RealVector
Returns the L2 norm of the vector.
getNorm() - 类中的方法 org.hipparchus.linear.SingularValueDecomposition
Returns the L2 norm of the matrix.
getNorm1() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
Get the L1 norm for the vector.
getNorm1() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get the L1 norm for the vector.
getNorm1() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
Get the L1 norm for the vector.
getNorm1() - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get the L1 norm for the vector.
getNorm1() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
Get the L1 norm for the vector.
getNorm1() - 接口中的方法 org.hipparchus.geometry.Vector
Get the L1 norm for the vector.
getNorm1() - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Returns the maximum absolute column sum norm (L1) of the matrix.
getNorm1() - 接口中的方法 org.hipparchus.linear.RealMatrix
Returns the maximum absolute column sum norm (L1) of the matrix.
getNormal() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Plane
Get the normalized normal vector.
getNormalApproximationInterval(int, double, double) - 类中的静态方法 org.hipparchus.stat.interval.BinomialProportion
Create a binomial confidence interval using normal approximation for the true probability of success of an unknown binomial distribution with the given observed number of trials, probability of success and confidence level.
getNormInf() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
Get the L norm for the vector.
getNormInf() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get the L norm for the vector.
getNormInf() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
Get the L norm for the vector.
getNormInf() - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get the L norm for the vector.
getNormInf() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
Get the L norm for the vector.
getNormInf() - 接口中的方法 org.hipparchus.geometry.Vector
Get the L norm for the vector.
getNormInfty() - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Returns the maximum absolute row sum norm (L) of the matrix.
getNormInfty() - 接口中的方法 org.hipparchus.linear.RealMatrix
Returns the maximum absolute row sum norm (L) of the matrix.
getNormOfResidual() - 类中的方法 org.hipparchus.linear.DefaultIterativeLinearSolverEvent
Returns the norm of the residual.
getNormOfResidual() - 类中的方法 org.hipparchus.linear.IterativeLinearSolverEvent
Returns the norm of the residual.
getNormSq() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
Get the square of the norm for the vector.
getNormSq() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get the square of the norm for the vector.
getNormSq() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
Get the square of the norm for the vector.
getNormSq() - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get the square of the norm for the vector.
getNormSq() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
Get the square of the norm for the vector.
getNormSq() - 接口中的方法 org.hipparchus.geometry.Vector
Get the square of the norm for the vector.
getNSteps() - 类中的方法 org.hipparchus.ode.MultistepFieldIntegrator
Get the number of steps of the multistep method (excluding the one being computed).
getNSteps() - 类中的方法 org.hipparchus.ode.MultistepIntegrator
Get the number of steps of the multistep method (excluding the one being computed).
getNumberOfElements() - 类中的方法 org.hipparchus.distribution.discrete.ZipfDistribution
Get the number of elements (e.g. corpus size) for the distribution.
getNumberOfEquations() - 类中的方法 org.hipparchus.ode.EquationsMapper
Get the number of equations mapped.
getNumberOfEquations() - 类中的方法 org.hipparchus.ode.FieldEquationsMapper
Get the number of equations mapped.
getNumberOfParameters() - 类中的方法 org.hipparchus.stat.regression.RegressionResults
Returns the number of parameters estimated in the model.
getNumberOfPoints() - 类中的方法 org.hipparchus.analysis.integration.gauss.FieldGaussIntegrator
Get order of the integration rule.
getNumberOfPoints() - 类中的方法 org.hipparchus.analysis.integration.gauss.GaussIntegrator
Get the order of the integration rule.
getNumberOfRegressors() - 类中的方法 org.hipparchus.stat.regression.GLSMultipleLinearRegressionTest
 
getNumberOfRegressors() - 类中的方法 org.hipparchus.stat.regression.MultipleLinearRegressionAbstractTest
 
getNumberOfRegressors() - 类中的方法 org.hipparchus.stat.regression.OLSMultipleLinearRegressionTest
 
getNumberOfRoots() - 类中的方法 org.hipparchus.complex.RootsOfUnity
Returns the number of roots of unity currently stored.
getNumberOfSecondaryStates() - 类中的方法 org.hipparchus.ode.ComplexODEState
Get the number of secondary states.
getNumberOfSecondaryStates() - 类中的方法 org.hipparchus.ode.FieldODEState
Get the number of secondary states.
getNumberOfSecondaryStates() - 类中的方法 org.hipparchus.ode.ODEState
Get the number of secondary states.
getNumberOfSuccesses() - 类中的方法 org.hipparchus.distribution.discrete.HypergeometricDistribution
Access the number of successes.
getNumberOfSuccesses() - 类中的方法 org.hipparchus.distribution.discrete.PascalDistribution
Access the number of successes for this distribution.
getNumberOfTrials() - 类中的方法 org.hipparchus.distribution.discrete.BinomialDistribution
Access the number of trials for this distribution.
getNumComponents() - 类中的方法 org.hipparchus.stat.projection.PCA
GEt number of components.
getNumElements() - 类中的方法 org.hipparchus.util.ResizableDoubleArray
Returns the number of elements currently in the array.
getNumerator() - 类中的方法 org.hipparchus.fraction.BigFraction
Access the numerator as a BigInteger.
getNumerator() - 类中的方法 org.hipparchus.fraction.Fraction
Access the numerator.
getNumeratorAsInt() - 类中的方法 org.hipparchus.fraction.BigFraction
Access the numerator as a int.
getNumeratorAsLong() - 类中的方法 org.hipparchus.fraction.BigFraction
Access the numerator as a long.
getNumeratorDegreesOfFreedom() - 类中的方法 org.hipparchus.distribution.continuous.FDistribution
Access the numerator degrees of freedom.
getNumeratorFormat() - 类中的方法 org.hipparchus.fraction.BigFractionFormat
Access the numerator format.
getNumeratorFormat() - 类中的方法 org.hipparchus.fraction.FractionFormat
Access the numerator format.
getNumeratorFormat() - 类中的方法 org.hipparchus.fraction.ProperBigFractionFormat
Access the numerator format.
getNumeratorFormat() - 类中的方法 org.hipparchus.fraction.ProperFractionFormat
Access the numerator format.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.BetaDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.CauchyDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.ChiSquaredDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.ConstantRealDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.EnumeratedRealDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.ExponentialDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.FDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.GammaDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.GumbelDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.LaplaceDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.LevyDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.LogisticDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.LogNormalDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.NakagamiDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.NormalDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.ParetoDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.TDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.TriangularDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.UniformRealDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.continuous.WeibullDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.discrete.BinomialDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.discrete.GeometricDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.discrete.HypergeometricDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.discrete.PascalDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.discrete.PoissonDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.discrete.UniformIntegerDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.distribution.discrete.ZipfDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 接口中的方法 org.hipparchus.distribution.IntegerDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 接口中的方法 org.hipparchus.distribution.RealDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - 类中的方法 org.hipparchus.stat.fitting.EmpiricalDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.BetaDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.CauchyDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.ChiSquaredDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.ConstantRealDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.EnumeratedRealDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.ExponentialDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.FDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.GammaDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.GumbelDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.LaplaceDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.LevyDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.LogisticDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.LogNormalDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.NakagamiDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.NormalDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.ParetoDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.TDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.TriangularDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.UniformRealDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.continuous.WeibullDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.discrete.BinomialDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.discrete.GeometricDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.discrete.HypergeometricDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.discrete.PascalDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.discrete.PoissonDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.discrete.UniformIntegerDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.distribution.discrete.ZipfDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 接口中的方法 org.hipparchus.distribution.IntegerDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 接口中的方法 org.hipparchus.distribution.RealDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - 类中的方法 org.hipparchus.stat.fitting.EmpiricalDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumObservations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the total number of observations (data points).
getNumParameters() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the total number of parameters.
getNumStartingPoints() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the total number of starting points (initial guesses for the optimization process).
getNumTrials() - 类中的方法 org.hipparchus.clustering.MultiKMeansPlusPlusClusterer
Returns the number of trials this instance will do.
getnVals() - 类中的方法 org.hipparchus.special.BesselJ.BesselJResult
Get number of valid function values.
getO() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputOverlapTest
 
getO() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTest
 
getO() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTestBase
Returns the offsets for the unit tests below, in the order they are given below.
getObjectiveFunction() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.gradient.CircleScalar
 
getObjectiveFunction() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.ObjectiveFunction
Gets the function to be optimized.
getObjectiveFunction() - 类中的方法 org.hipparchus.optim.univariate.UnivariateObjectiveFunction
Gets the function to be optimized.
getObjectiveFunctionGradient() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.gradient.CircleScalar
 
getObjectiveFunctionGradient() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.ObjectiveFunctionGradient
Gets the gradient of the function to be optimized.
getObjectiveFunctionValue() - 类中的方法 org.hipparchus.clustering.FuzzyKMeansClusterer
Get the value of the objective function.
getObservationSize() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
Get the number of observations (rows in the Jacobian) in this problem.
getObservationSize() - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem
Get the number of observations (rows in the Jacobian) in this problem.
getOffset() - 类中的方法 org.hipparchus.geometry.partitioning.BoundaryProjection
Offset of the point with respect to the boundary it is projected on.
getOffset(double) - 类中的方法 org.hipparchus.geometry.spherical.oned.Arc
Get the distance (arc length) from a point to the edge of the arc.
getOffset(Plane) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Plane
Get the offset (oriented distance) of a parallel plane.
getOffset(Vector3D) - 类中的方法 org.hipparchus.geometry.spherical.twod.Circle
Get the offset (oriented distance) of a direction.
getOffset(Line) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Line
Get the offset (oriented distance) of a parallel line.
getOffset(Point<Euclidean1D>) - 类中的方法 org.hipparchus.geometry.euclidean.oned.OrientedPoint
Get the offset (oriented distance) of a point.
getOffset(Point<Euclidean3D>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Plane
Get the offset (oriented distance) of a point.
getOffset(Point<Euclidean2D>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Line
Get the offset (oriented distance) of a point.
getOffset(Point<Sphere1D>) - 类中的方法 org.hipparchus.geometry.spherical.oned.LimitAngle
Get the offset (oriented distance) of a point.
getOffset(Point<Sphere2D>) - 类中的方法 org.hipparchus.geometry.spherical.twod.Circle
Get the offset (oriented distance) of a point.
getOffset(Point<S>) - 接口中的方法 org.hipparchus.geometry.partitioning.Hyperplane
Get the offset (oriented distance) of a point.
getOffset(S1Point) - 类中的方法 org.hipparchus.geometry.spherical.oned.Arc
Get the distance (arc length) from a point to the edge of the arc.
getOffset(Vector<Euclidean1D, Vector1D>) - 类中的方法 org.hipparchus.geometry.euclidean.oned.OrientedPoint
Get the offset (oriented distance) of a vector.
getOffset(Vector<Euclidean3D, Vector3D>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Plane
Get the offset (oriented distance) of a vector.
getOffset(Vector<Euclidean2D, Vector2D>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Line
Get the offset (oriented distance) of a vector.
getOldEvaluation() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.SequentialGaussNewtonOptimizer
Get the previous evaluation used by the optimizer.
getOmegaInverse() - 类中的方法 org.hipparchus.stat.regression.GLSMultipleLinearRegression
Get the inverse of the covariance.
getOne() - 类中的方法 org.hipparchus.analysis.differentiation.DSFactory.DSField
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.analysis.differentiation.FDSFactory.DerivativeField
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradientField
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1Field
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2Field
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.analysis.differentiation.GradientField
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1Field
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2Field
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.complex.ComplexField
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.complex.FieldComplexField
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.dfp.Dfp
Get the constant 1.
getOne() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant 1.
getOne() - 接口中的方法 org.hipparchus.Field
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.fraction.BigFractionField
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.fraction.FractionField
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.util.BigRealField
Get the multiplicative identity of the field.
getOne() - 类中的方法 org.hipparchus.util.Binary64Field
Get the multiplicative identity of the field.
getOne(Field<T>) - 类中的静态方法 org.hipparchus.complex.FieldComplex
Get a complex number representing "1.0 + 0.0i".
getOptima() - 类中的方法 org.hipparchus.optim.BaseMultiStartMultivariateOptimizer
Gets all the optima found during the last call to optimize.
getOptima() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
Gets all the optima found during the last call to optimize.
getOptima() - 类中的方法 org.hipparchus.optim.univariate.MultiStartUnivariateOptimizer
Gets all the optima found during the last call to optimize.
getOptimizer() - 类中的方法 org.hipparchus.fitting.AbstractCurveFitter
Creates an optimizer set up to fit the appropriate curve.
getOptimizer() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractLeastSquaresOptimizerAbstractTest
Get an instance of the optimizer under test.
getOptimizer() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithCholeskyTest
 
getOptimizer() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithLUTest
 
getOptimizer() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithQRNormalTest
 
getOptimizer() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithQRTest
 
getOptimizer() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizerWithSVDTest
 
getOptimizer() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizerTest
 
getOrder() - 接口中的方法 org.hipparchus.analysis.differentiation.Derivative
Get the derivation order.
getOrder() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
 
getOrder() - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Get the derivation order.
getOrder() - 接口中的方法 org.hipparchus.analysis.differentiation.FieldDerivative
Get the derivation order.
getOrder() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
 
getOrder() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Get the derivation order.
getOrder() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
Get the derivation order.
getOrder() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Get the derivation order.
getOrder() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
Get the derivation order.
getOrder() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
Get the derivation order.
getOrder() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
Get the derivation order.
getOrder() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
Get the order of the method.
getOrder() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince54Integrator
Get the order of the method.
getOrder() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
Get the order of the method.
getOrder() - 类中的方法 org.hipparchus.ode.nonstiff.DormandPrince853Integrator
Get the order of the method.
getOrder() - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
Get the order of the method.
getOrder() - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the order of the method.
getOrder() - 类中的方法 org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
Get the order of the method.
getOrder() - 类中的方法 org.hipparchus.ode.nonstiff.HighamHall54Integrator
Get the order of the method.
getOrderOfRegressors() - 类中的方法 org.hipparchus.stat.regression.MillerUpdatingRegression
Gets the order of the regressors, useful if some type of reordering has been called.
getOrigin() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldLine
Get the line point closest to the origin.
getOrigin() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Line
Get the line point closest to the origin.
getOrigin() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Plane
Get the origin point of the plane frame.
getOriginal() - 类中的方法 org.hipparchus.geometry.partitioning.BoundaryProjection
Get the original point.
getOriginOffset() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Line
Get the offset of the origin.
getOrthoTolerance() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
Gets the value of a tuning parameter.
getOutgoing() - 类中的方法 org.hipparchus.geometry.spherical.twod.Vertex
Get outgoing edge.
getOutline(PolyhedronsSet) - 类中的方法 org.hipparchus.geometry.euclidean.threed.OutlineExtractor
Extract the outline of a polyhedrons set.
getP() - 类中的方法 org.hipparchus.linear.FieldLUDecomposition
Returns the P rows permutation matrix.
getP() - 类中的方法 org.hipparchus.linear.HessenbergTransformer
Returns the matrix P of the transform.
getP() - 类中的方法 org.hipparchus.linear.LUDecomposition
Returns the P rows permutation matrix.
getP() - 接口中的方法 org.hipparchus.linear.RiccatiEquationSolver
Get the solution.
getP() - 类中的方法 org.hipparchus.linear.RiccatiEquationSolverImpl
{inheritDoc}
getP() - 类中的方法 org.hipparchus.linear.RRQRDecomposition
Returns the pivot matrix, P, used in the QR Decomposition of matrix A such that AP = QR.
getP() - 类中的方法 org.hipparchus.linear.SchurTransformer
Returns the matrix P of the transform.
getParameter(int) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the certified value of the i-th parameter.
getParameter(String) - 接口中的方法 org.hipparchus.ode.ParametersController
Get parameter value from its name.
getParameterEstimate(int) - 类中的方法 org.hipparchus.stat.regression.RegressionResults
Returns the parameter estimate for the regressor at the given index.
getParameterEstimates() - 类中的方法 org.hipparchus.stat.regression.RegressionResults
Returns a copy of the regression parameters estimates.
getParameterName() - 类中的方法 org.hipparchus.ode.ParameterConfiguration
Get parameter name.
getParameterRelativeTolerance() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
Gets the value of a tuning parameter.
getParameters() - 类中的静态方法 org.hipparchus.analysis.integration.gauss.FieldHermiteParametricTest
Returns the collection of parameters to be passed to the constructor of this class.
getParameters() - 类中的静态方法 org.hipparchus.analysis.integration.gauss.FieldLegendreParametricTest
Returns the collection of parameters to be passed to the constructor of this class.
getParameters() - 类中的静态方法 org.hipparchus.analysis.integration.gauss.HermiteParametricTest
Returns the collection of parameters to be passed to the constructor of this class.
getParameters() - 类中的静态方法 org.hipparchus.analysis.integration.gauss.LegendreHighPrecisionParametricTest
Returns the collection of parameters to be passed to the constructor of this class.
getParameters() - 类中的静态方法 org.hipparchus.analysis.integration.gauss.LegendreParametricTest
Returns the collection of parameters to be passed to the constructor of this class.
getParameters() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the certified values of the paramters.
getParameterSize() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
Get the number of parameters (columns in the Jacobian) in this problem.
getParameterSize() - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem
Get the number of parameters (columns in the Jacobian) in this problem.
getParametersNames() - 类中的方法 org.hipparchus.ode.AbstractParameterizable
Get the names of the supported parameters.
getParametersNames() - 接口中的方法 org.hipparchus.ode.ODEJacobiansProvider
Get the names of the supported parameters.
getParametersNames() - 接口中的方法 org.hipparchus.ode.Parameterizable
Get the names of the supported parameters.
getParametersStandardDeviations() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the certified values of the standard deviations of the parameters.
getParameterStandardDeviation(int) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the certified value of the standard deviation of the i-th parameter.
getParent() - 类中的方法 org.hipparchus.geometry.partitioning.BSPTree
Get the parent node.
getPartialCorrelations(int) - 类中的方法 org.hipparchus.stat.regression.MillerUpdatingRegression
In the original algorithm only the partial correlations of the regressors is returned to the user.
getPartialDerivative(int) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Get the partial derivative with respect to one parameter.
getPartialDerivative(int) - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
Get the partial derivative with respect to one parameter.
getPartialDerivative(int...) - 接口中的方法 org.hipparchus.analysis.differentiation.Derivative
Get a partial derivative.
getPartialDerivative(int...) - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
Get a partial derivative.
getPartialDerivative(int...) - 接口中的方法 org.hipparchus.analysis.differentiation.FieldDerivative
Get a partial derivative.
getPartialDerivative(int...) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
Get a partial derivative.
getPartialDerivative(int...) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Get a partial derivative.
getPartialDerivative(int...) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative
Get a partial derivative.
getPartialDerivative(int...) - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
Get a partial derivative.
getPartialDerivative(int...) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative
Get a partial derivative.
getPartialDerivativeIndex(int...) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Get the index of a partial derivative in the array.
getPartialDerivativeOrders(int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Get the derivation orders for a specific index in the array.
getPartialDerivativeOrdersSum(int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Get the sum of derivation orders for a specific index in the array.
getParts() - 接口中的方法 org.hipparchus.exception.LocalizedException
Get the variable parts of the error message.
getParts() - 异常错误类中的方法 org.hipparchus.exception.MathRuntimeException
Get the variable parts of the error message.
getParts() - 异常错误类中的方法 org.hipparchus.exception.NullArgumentException
Get the variable parts of the error message.
getPartsField() - 类中的方法 org.hipparchus.complex.FieldComplex
Get the Field the real and imaginary parts belong to.
getPct(int) - 类中的方法 org.hipparchus.stat.LongFrequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPct(T) - 类中的方法 org.hipparchus.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPercentile(double) - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns an estimate for the pth percentile of the stored values.
getPercentile(double) - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns an estimate of the given percentile of the values that have been entered.
getPercentileValue() - 接口中的方法 org.hipparchus.stat.descriptive.rank.PSquarePercentile.PSquareMarkers
Returns Percentile value computed thus far.
getPhase(Vector3D) - 类中的方法 org.hipparchus.geometry.spherical.twod.Circle
Get the phase angle of a direction.
getPhi() - 类中的方法 org.hipparchus.geometry.euclidean.threed.SphericalCoordinates
Get the polar (co-latitude) angle.
getPhi() - 类中的方法 org.hipparchus.geometry.spherical.twod.S2Point
Get the polar angle \( \varphi \).
getPi() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.analysis.differentiation.DSFactory.DSField
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.analysis.differentiation.FDSFactory.DerivativeField
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
Get the Archimedes constant π.
getPi() - 接口中的方法 org.hipparchus.CalculusFieldElement
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.complex.Complex
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.complex.FieldComplex
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.dfp.Dfp
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant π.
getPi() - 类中的方法 org.hipparchus.util.Binary64
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.util.FieldTuple
Get the Archimedes constant π.
getPi() - 类中的方法 org.hipparchus.util.Tuple
Get the Archimedes constant π.
getPi(Field<T>) - 类中的静态方法 org.hipparchus.complex.FieldComplex
Get a complex number representing "π + 0.0i".
getPiSplit() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant π split in two pieces.
getPivot() - 类中的方法 org.hipparchus.linear.FieldLUDecomposition
Returns the pivot permutation vector.
getPivot() - 类中的方法 org.hipparchus.linear.LUDecomposition
Returns the pivot permutation vector.
getPivotingStrategy() - 类中的方法 org.hipparchus.stat.descriptive.rank.Percentile
Get the PivotingStrategy used in KthSelector for computation.
getPivotingStrategy() - 类中的方法 org.hipparchus.util.KthSelector
Get the pivoting strategy.
getPlus() - 类中的方法 org.hipparchus.geometry.partitioning.BSPTree
Get the tree on the plus side of the cut hyperplane.
getPlus() - 类中的方法 org.hipparchus.geometry.partitioning.SubHyperplane.SplitSubHyperplane
Get the part of the sub-hyperplane on the plus side of the splitting hyperplane.
getPlus() - 类中的方法 org.hipparchus.geometry.spherical.oned.ArcsSet.Split
Get the part of the arcs set on the plus side of the splitting arc.
getPlusI(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get first canonical vector (coordinates: 1, 0, 0).
getPlusI(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get first canonical vector (coordinates: 1, 0).
getPlusInside() - 类中的方法 org.hipparchus.geometry.partitioning.BoundaryAttribute
Get the part of the node cut sub-hyperplane that belongs to the boundary and has the inside of the region on the plus side of its underlying hyperplane.
getPlusJ(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get second canonical vector (coordinates: 0, 1, 0).
getPlusJ(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get second canonical vector (coordinates: 0, 1).
getPlusK(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get third canonical vector (coordinates: 0, 0, 1).
getPlusOutside() - 类中的方法 org.hipparchus.geometry.partitioning.BoundaryAttribute
Get the part of the node cut sub-hyperplane that belongs to the boundary and has the outside of the region on the plus side of its underlying hyperplane.
getPmf() - 类中的方法 org.hipparchus.distribution.continuous.EnumeratedRealDistribution
Return the probability mass function as a list of (value, probability) pairs.
getPmf() - 类中的方法 org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
Return the probability mass function as a list of (value, probability) pairs.
getPmf() - 类中的方法 org.hipparchus.distribution.EnumeratedDistribution
Return the probability mass function as a list of (value, probability) pairs.
getPoint() - 类中的方法 org.hipparchus.analysis.differentiation.FieldTaylorMap
Get the point at which map is evaluated.
getPoint() - 类中的方法 org.hipparchus.analysis.differentiation.TaylorMap
Get the point at which map is evaluated.
getPoint() - 接口中的方法 org.hipparchus.clustering.Clusterable
Gets the n-dimensional point.
getPoint() - 类中的方法 org.hipparchus.clustering.DoublePoint
Gets the n-dimensional point.
getPoint() - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
Get the abscissa (independent variables) of this evaluation.
getPoint() - 类中的方法 org.hipparchus.optim.PointValuePair
Gets the point.
getPoint() - 类中的方法 org.hipparchus.optim.PointVectorValuePair
Gets the point.
getPoint() - 类中的方法 org.hipparchus.optim.univariate.UnivariatePointValuePair
Get the point.
getPoint(int) - 类中的方法 org.hipparchus.analysis.integration.gauss.FieldGaussIntegrator
Gets the integration point at the given index.
getPoint(int) - 类中的方法 org.hipparchus.analysis.integration.gauss.GaussIntegrator
Gets the integration point at the given index.
getPoint(int) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
Get the simplex point stored at the requested index.
getPointAt(double) - 类中的方法 org.hipparchus.geometry.spherical.twod.Circle
Get a circle point from its phase around the circle.
getPointAt(double) - 类中的方法 org.hipparchus.geometry.spherical.twod.Edge
Get an intermediate point.
getPointAt(Vector1D, double) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Line
Get one point from the plane.
getPointAt(Vector2D, double) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Plane
Get one point from the 3D-space.
getPointRef() - 类中的方法 org.hipparchus.optim.PointValuePair
Gets a reference to the point.
getPointRef() - 类中的方法 org.hipparchus.optim.PointVectorValuePair
Gets a reference to the point.
getPoints() - 类中的方法 org.hipparchus.clustering.Cluster
Get the points contained in the cluster.
getPoints() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
Get the points of the simplex.
getPole() - 类中的方法 org.hipparchus.geometry.spherical.twod.Circle
Get the pole of the circle.
getPolynomials() - 类中的方法 org.hipparchus.analysis.interpolation.HermiteInterpolator
Compute the interpolation polynomials.
getPolynomials() - 类中的方法 org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
Get a copy of the interpolating polynomials array.
getPolynomials() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialSplineFunction
Get a copy of the interpolating polynomials array.
getPopulationSize() - 类中的方法 org.hipparchus.distribution.discrete.HypergeometricDistribution
Access the population size.
getPopulationSize() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer.PopulationSize
Get population size.
getPopulationVariance() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the population variance of the available values.
getPopulationVariance() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns the population variance of the values that have been added.
getPositiveInfinity(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get a vector with all coordinates set to positive infinity.
getPositiveInfinity(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get a vector with all coordinates set to positive infinity.
getPositivePolarForm() - 类中的方法 org.hipparchus.complex.Quaternion
Returns the polar form of the quaternion.
getPredicted() - 类中的方法 org.hipparchus.filtering.kalman.AbstractKalmanFilter
Get the predicted state.
getPredicted() - 接口中的方法 org.hipparchus.filtering.kalman.KalmanFilter
Get the current predicted state.
getPredicted() - 类中的方法 org.hipparchus.filtering.kalman.unscented.UnscentedKalmanFilter
Get the predicted state.
getPredictedMeasurements(RealVector[], T) - 接口中的方法 org.hipparchus.filtering.kalman.unscented.UnscentedProcess
Get the state evolution between two times.
getPreferredEntryValue() - 类中的方法 org.hipparchus.linear.RealVectorAbstractTest
Returns a preferred value of the entries, to be tested specifically.
getPreferredSize() - 类中的方法 org.hipparchus.samples.ClusterAlgorithmComparison.ClusterPlot
 
getPreferredSize() - 类中的方法 org.hipparchus.samples.LowDiscrepancyGeneratorComparison.Plot
getPrefix() - 类中的方法 org.hipparchus.geometry.VectorFormat
Get the format prefix.
getPrefix() - 类中的方法 org.hipparchus.linear.RealMatrixFormat
Get the format prefix.
getPrefix() - 类中的方法 org.hipparchus.linear.RealVectorFormat
Get the format prefix.
getPrevious() - 异常错误类中的方法 org.hipparchus.migration.exception.NonMonotonicSequenceException
已过时。
Get previous value.
getPreviousState() - 类中的方法 org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
Get the state at previous grid point time.
getPreviousState() - 类中的方法 org.hipparchus.ode.sampling.AbstractODEStateInterpolator
Get the state at previous grid point time.
getPreviousState() - 接口中的方法 org.hipparchus.ode.sampling.FieldODEStateInterpolator
Get the state at previous grid point time.
getPreviousState() - 接口中的方法 org.hipparchus.ode.sampling.ODEStateInterpolator
Get the state at previous grid point time.
getPreviousTime() - 接口中的方法 org.hipparchus.migration.ode.sampling.StepInterpolator
已过时。
getPrimary() - 类中的方法 org.hipparchus.ode.ExpandableODE
Get the primary set of differential equations to be integrated.
getPrimary() - 类中的方法 org.hipparchus.ode.FieldExpandableODE
Get the primary set of differential equations to be integrated.
getPrimaryDerivative() - 类中的方法 org.hipparchus.ode.ComplexODEStateAndDerivative
Get derivative of the primary state at time.
getPrimaryDerivative() - 类中的方法 org.hipparchus.ode.FieldODEStateAndDerivative
Get derivative of the primary state at time.
getPrimaryDerivative() - 类中的方法 org.hipparchus.ode.ODEStateAndDerivative
Get derivative of the primary state at time.
getPrimaryState() - 类中的方法 org.hipparchus.ode.ComplexODEState
Get primary state at time.
getPrimaryState() - 类中的方法 org.hipparchus.ode.FieldODEState
Get primary state at time.
getPrimaryState() - 类中的方法 org.hipparchus.ode.ODEState
Get primary state at time.
getPrimaryStateDimension() - 类中的方法 org.hipparchus.ode.ComplexODEState
Get primary state dimension.
getPrimaryStateDimension() - 类中的方法 org.hipparchus.ode.FieldODEState
Get primary state dimension.
getPrimaryStateDimension() - 类中的方法 org.hipparchus.ode.ODEState
Get primary state dimension.
getProbabilityOfSuccess() - 类中的方法 org.hipparchus.distribution.discrete.BinomialDistribution
Access the probability of success for this distribution.
getProbabilityOfSuccess() - 类中的方法 org.hipparchus.distribution.discrete.GeometricDistribution
Access the probability of success for this distribution.
getProbabilityOfSuccess() - 类中的方法 org.hipparchus.distribution.discrete.PascalDistribution
Access the probability of success for this distribution.
getProblem(Collection<WeightedObservedPoint>) - 类中的方法 org.hipparchus.fitting.AbstractCurveFitter
Creates a least squares problem corresponding to the appropriate curve.
getProblem(Collection<WeightedObservedPoint>) - 类中的方法 org.hipparchus.fitting.GaussianCurveFitter
Creates a least squares problem corresponding to the appropriate curve.
getProblem(Collection<WeightedObservedPoint>) - 类中的方法 org.hipparchus.fitting.HarmonicCurveFitter
Creates a least squares problem corresponding to the appropriate curve.
getProblem(Collection<WeightedObservedPoint>) - 类中的方法 org.hipparchus.fitting.PolynomialCurveFitter
Creates a least squares problem corresponding to the appropriate curve.
getProblem(Collection<WeightedObservedPoint>) - 类中的方法 org.hipparchus.fitting.SimpleCurveFitter
Creates a least squares problem corresponding to the appropriate curve.
getProcessNoiseMatrix() - 类中的方法 org.hipparchus.filtering.kalman.extended.NonLinearEvolution
Get process noise.
getProcessNoiseMatrix() - 类中的方法 org.hipparchus.filtering.kalman.linear.LinearEvolution
Get the process noise matrix Qk-1.
getProcessNoiseMatrix() - 类中的方法 org.hipparchus.filtering.kalman.unscented.UnscentedEvolution
Get process noise.
getProjected() - 类中的方法 org.hipparchus.geometry.partitioning.BoundaryProjection
Projected point.
getProperInstance() - 类中的静态方法 org.hipparchus.fraction.BigFractionFormat
Returns the default complex format for the current locale.
getProperInstance() - 类中的静态方法 org.hipparchus.fraction.FractionFormat
Returns the default complex format for the current locale.
getProperInstance(Locale) - 类中的静态方法 org.hipparchus.fraction.BigFractionFormat
Returns the default complex format for the given locale.
getProperInstance(Locale) - 类中的静态方法 org.hipparchus.fraction.FractionFormat
Returns the default complex format for the given locale.
getProperty(Object, String) - 类中的方法 org.hipparchus.stat.data.CertifiedDataAbstractTest
 
getPT() - 类中的方法 org.hipparchus.linear.HessenbergTransformer
Returns the transpose of the matrix P of the transform.
getPT() - 类中的方法 org.hipparchus.linear.SchurTransformer
Returns the transpose of the matrix P of the transform.
getQ() - 类中的方法 org.hipparchus.linear.FieldQRDecomposition
Returns the matrix Q of the decomposition.
getQ() - 类中的方法 org.hipparchus.linear.QRDecomposition
Returns the matrix Q of the decomposition.
getQ() - 类中的方法 org.hipparchus.special.elliptic.jacobi.FieldJacobiTheta
Get the nome.
getQ() - 类中的方法 org.hipparchus.special.elliptic.jacobi.JacobiTheta
Get the nome.
getQ0() - 类中的方法 org.hipparchus.complex.Quaternion
Gets the first component of the quaternion (scalar part).
getQ0() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
Get the scalar coordinate of the quaternion.
getQ0() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
Get the scalar coordinate of the quaternion.
getQ1() - 类中的方法 org.hipparchus.complex.Quaternion
Gets the second component of the quaternion (first component of the vector part).
getQ1() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
Get the first coordinate of the vectorial part of the quaternion.
getQ1() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
Get the first coordinate of the vectorial part of the quaternion.
getQ2() - 类中的方法 org.hipparchus.complex.Quaternion
Gets the third component of the quaternion (second component of the vector part).
getQ2() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
Get the second coordinate of the vectorial part of the quaternion.
getQ2() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
Get the second coordinate of the vectorial part of the quaternion.
getQ3() - 类中的方法 org.hipparchus.complex.Quaternion
Gets the fourth component of the quaternion (third component of the vector part).
getQ3() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldRotation
Get the third coordinate of the vectorial part of the quaternion.
getQ3() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Rotation
Get the third coordinate of the vectorial part of the quaternion.
getQT() - 类中的方法 org.hipparchus.linear.FieldQRDecomposition
Returns the transpose of the matrix Q of the decomposition.
getQT() - 类中的方法 org.hipparchus.linear.QRDecomposition
Returns the transpose of the matrix Q of the decomposition.
getQuadratic() - 类中的静态方法 org.hipparchus.analysis.polynomials.SmoothStepFactory
getQuadratic(Field<T>) - 类中的静态方法 org.hipparchus.analysis.polynomials.SmoothStepFactory
getQuadraticMean() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the quadratic mean of the available values.
getQuadraticMean() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns the quadratic mean, a.k.a.
getQuantile() - 类中的方法 org.hipparchus.stat.descriptive.rank.Percentile
Returns the value of the quantile field (determines what percentile is computed when evaluate() is called with no quantile argument).
getQuantile() - 类中的方法 org.hipparchus.stat.descriptive.rank.PSquarePercentile
Get quantile estimated by this statistic.
getQuantileRank(double) - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentile
Returns the estimated quantile position of value in the dataset.
getQuintic() - 类中的静态方法 org.hipparchus.analysis.polynomials.SmoothStepFactory
getQuintic(Field<T>) - 类中的静态方法 org.hipparchus.analysis.polynomials.SmoothStepFactory
getQuinticEvalCounts() - 类中的方法 org.hipparchus.analysis.solvers.BaseSecantSolverAbstractTest
Returns the expected number of evaluations for the BaseSecantSolverAbstractTest.testQuinticZero() unit test.
getQuinticEvalCounts() - 类中的方法 org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolverTest
Returns the expected number of evaluations for the BaseSecantSolverAbstractTest.testQuinticZero() unit test.
getQuinticEvalCounts() - 类中的方法 org.hipparchus.analysis.solvers.IllinoisSolverTest
Returns the expected number of evaluations for the BaseSecantSolverAbstractTest.testQuinticZero() unit test.
getQuinticEvalCounts() - 类中的方法 org.hipparchus.analysis.solvers.PegasusSolverTest
Returns the expected number of evaluations for the BaseSecantSolverAbstractTest.testQuinticZero() unit test.
getQuinticEvalCounts() - 类中的方法 org.hipparchus.analysis.solvers.RegulaFalsiSolverTest
Returns the expected number of evaluations for the BaseSecantSolverAbstractTest.testQuinticZero() unit test.
getQuinticEvalCounts() - 类中的方法 org.hipparchus.analysis.solvers.SecantSolverTest
Returns the expected number of evaluations for the BaseSecantSolverAbstractTest.testQuinticZero() unit test.
getR() - 类中的方法 org.hipparchus.geometry.euclidean.threed.SphericalCoordinates
Get the radius.
getR() - 类中的方法 org.hipparchus.linear.FieldQRDecomposition
Returns the matrix R of the decomposition.
getR() - 类中的方法 org.hipparchus.linear.QRDecomposition
Returns the matrix R of the decomposition.
getR() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
getRadius() - 类中的方法 org.hipparchus.geometry.enclosing.EnclosingBall
Get the radius of the ball.
getRadius(Vector2D) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.gradient.CircleScalar
 
getRadixDigits() - 类中的方法 org.hipparchus.dfp.Dfp
Get the number of radix digits of the instance.
getRadixDigits() - 类中的方法 org.hipparchus.dfp.DfpField
Get the number of radix digits of the Dfp instances built by this factory.
getRadToDeg() - 类中的方法 org.hipparchus.dfp.DfpField
Get the radians to degrees conversion factor.
getRandomGenerator() - 类中的方法 org.hipparchus.clustering.FuzzyKMeansClusterer
Returns the random generator this instance will use.
getRandomGenerator() - 类中的方法 org.hipparchus.clustering.KMeansPlusPlusClusterer
Returns the random generator this instance will use.
getRank() - 类中的方法 org.hipparchus.linear.RectangularCholeskyDecomposition
Get the rank of the symmetric positive semidefinite matrix.
getRank() - 类中的方法 org.hipparchus.linear.SingularValueDecomposition
Return the effective numerical matrix rank.
getRank() - 类中的方法 org.hipparchus.random.CorrelatedRandomVectorGenerator
Get the rank of the covariance matrix.
getRank(double) - 类中的方法 org.hipparchus.linear.RRQRDecomposition
Return the effective numerical matrix rank.
getRank(double) - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentile
Gets the estimated rank of value, i.e.
getRankCorrelation() - 类中的方法 org.hipparchus.stat.correlation.SpearmansCorrelation
Returns a PearsonsCorrelation instance constructed from the ranked input data.
getRankingThreshold() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
Gets the value of a tuning parameter.
getReal() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.complex.Complex
Access the real part.
getReal() - 类中的方法 org.hipparchus.complex.FieldComplex
Access the real part.
getReal() - 类中的方法 org.hipparchus.dfp.Dfp
Get the real value of the number.
getReal() - 接口中的方法 org.hipparchus.FieldElement
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.fraction.BigFraction
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.fraction.Fraction
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.util.BigReal
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.util.Binary64
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.util.FieldTuple
Get the real value of the number.
getReal() - 类中的方法 org.hipparchus.util.Tuple
Get the real value of the number.
getReal(int) - 类中的方法 org.hipparchus.complex.RootsOfUnity
Get the real part of the k-th n-th root of unity.
getRealFormat() - 类中的方法 org.hipparchus.complex.ComplexFormat
Access the realFormat.
getRealMatrixFormat() - 类中的静态方法 org.hipparchus.linear.RealMatrixFormat
Returns the default real vector format for the current locale.
getRealMatrixFormat(Locale) - 类中的静态方法 org.hipparchus.linear.RealMatrixFormat
Returns the default real vector format for the given locale.
getRealPart() - 类中的方法 org.hipparchus.complex.Complex
Access the real part.
getRealPart() - 类中的方法 org.hipparchus.complex.FieldComplex
Access the real part.
getRealVectorFormat() - 类中的静态方法 org.hipparchus.linear.RealVectorFormat
Returns the default real vector format for the current locale.
getRealVectorFormat(Locale) - 类中的静态方法 org.hipparchus.linear.RealVectorFormat
Returns the default real vector format for the given locale.
getReducedChiSquare(int) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
Get the reduced chi-square.
getReducedChiSquare(int) - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
Get the reduced chi-square.
getReducedFraction(int, int) - 类中的静态方法 org.hipparchus.fraction.BigFraction
Creates a BigFraction instance with the 2 parts of a fraction Y/Z.
getReducedFraction(int, int) - 类中的静态方法 org.hipparchus.fraction.Fraction
Creates a Fraction instance with the 2 parts of a fraction Y/Z.
getRegressionSumSquares() - 类中的方法 org.hipparchus.stat.regression.RegressionResults
Returns the sum of squared deviations of the predicted y values about their mean (which equals the mean of y).
getRegressionSumSquares() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the sum of squared deviations of the predicted y values about their mean (which equals the mean of y).
getRelationship() - 类中的方法 org.hipparchus.optim.linear.LinearConstraint
Gets the relationship between left and right hand sides.
getRelativeAccuracy() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractFieldUnivariateIntegrator
Get the relative accuracy.
getRelativeAccuracy() - 类中的方法 org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
Get the relative accuracy.
getRelativeAccuracy() - 接口中的方法 org.hipparchus.analysis.integration.FieldUnivariateIntegrator
Get the relative accuracy.
getRelativeAccuracy() - 接口中的方法 org.hipparchus.analysis.integration.UnivariateIntegrator
Get the relative accuracy.
getRelativeAccuracy() - 类中的方法 org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
Get the relative accuracy of the solver.
getRelativeAccuracy() - 接口中的方法 org.hipparchus.analysis.solvers.BaseUnivariateSolver
Get the relative accuracy of the solver.
getRelativeAccuracy() - 接口中的方法 org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
Get the relative accuracy of the solver.
getRelativeAccuracy() - 类中的方法 org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
Get the relative accuracy.
getRelativeThreshold() - 类中的方法 org.hipparchus.optim.AbstractConvergenceChecker
Get relative threshold.
getRelativeTolerance(int) - 类中的方法 org.hipparchus.ode.nonstiff.StepsizeHelper
Get the relative tolerance for one component.
getRemainingRegion() - 类中的方法 org.hipparchus.geometry.partitioning.AbstractSubHyperplane
Get the remaining region of the hyperplane.
getResidual() - 类中的方法 org.hipparchus.linear.DefaultIterativeLinearSolverEvent
Returns the residual.
getResidual() - 类中的方法 org.hipparchus.linear.IterativeLinearSolverEvent
Returns the residual.
getResidual() - 类中的方法 org.hipparchus.util.MathUtils.FieldSumAndResidual
Returns the residual error in the sum.
getResidual() - 类中的方法 org.hipparchus.util.MathUtils.SumAndResidual
Returns the residual error in the sum.
getResiduals() - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
Get the weighted residuals.
getResidualSumOfSquares() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the certified value of the residual sum of squares.
getResourceName() - 类中的方法 org.hipparchus.stat.data.CertifiedDataAbstractTest
 
getResourceName() - 类中的方法 org.hipparchus.stat.data.LewTest
 
getResourceName() - 类中的方法 org.hipparchus.stat.data.LotteryTest
 
getResult() - 类中的方法 org.hipparchus.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.moment.GeometricMean
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.moment.Kurtosis
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.moment.Mean
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.moment.SecondMoment
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.moment.Skewness
Returns the value of the statistic based on the values that have been added.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.moment.StandardDeviation
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.moment.Variance
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.rank.Max
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.rank.Min
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.rank.PSquarePercentile
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentile
Returns an estimate of the median.
getResult() - 接口中的方法 org.hipparchus.stat.descriptive.StorelessMultivariateStatistic
Returns the current value of the Statistic.
getResult() - 接口中的方法 org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.summary.Product
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.summary.Sum
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.summary.SumOfLogs
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.summary.SumOfSquares
Returns the current value of the Statistic.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.vector.VectorialCovariance
Get the covariance matrix.
getResult() - 类中的方法 org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic
Returns the current value of the Statistic.
getResult(double) - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentile
Returns an estimate of the given percentile.
getReverse() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Line
Get the reverse of the instance.
getReverse() - 类中的方法 org.hipparchus.geometry.spherical.oned.LimitAngle
Get the reverse of the instance.
getReverse() - 类中的方法 org.hipparchus.geometry.spherical.twod.Circle
Get the reverse of the instance.
getRightAbscissa() - 类中的方法 org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver.Interval
Get the right abscissa.
getRightAbscissa() - 类中的方法 org.hipparchus.analysis.solvers.BracketedUnivariateSolver.Interval
Get the right abscissa.
getRightHandSideVector() - 类中的方法 org.hipparchus.linear.DefaultIterativeLinearSolverEvent
Returns the current right-hand side of the linear system to be solved.
getRightHandSideVector() - 类中的方法 org.hipparchus.linear.IterativeLinearSolverEvent
Returns the current right-hand side of the linear system to be solved.
getRightValue() - 类中的方法 org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver.Interval
getRightValue() - 类中的方法 org.hipparchus.analysis.solvers.BracketedUnivariateSolver.Interval
getRMS() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
Get the normalized cost.
getRMS() - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
Get the normalized cost.
getRootMatrix() - 类中的方法 org.hipparchus.linear.RectangularCholeskyDecomposition
Get the root of the covariance matrix.
getRootMatrix() - 类中的方法 org.hipparchus.random.CorrelatedRandomVectorGenerator
Get the root of the covariance matrix.
getRotationOrder(String) - 枚举类中的静态方法 org.hipparchus.geometry.euclidean.threed.RotationOrder
Get the rotation order corresponding to a string representation.
getRoundingMode() - 类中的方法 org.hipparchus.dfp.DfpField
Get the current rounding mode.
getRoundingMode() - 类中的方法 org.hipparchus.util.BigReal
Gets the rounding mode for division operations The default is RoundingMode.HALF_UP
getRow() - 异常错误类中的方法 org.hipparchus.migration.linear.NonPositiveDefiniteMatrixException
已过时。
Get row index.
getRow() - 异常错误类中的方法 org.hipparchus.migration.linear.NonSymmetricMatrixException
已过时。
Get row index of the entry.
getRow(int) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Get the entries in row number row as an array.
getRow(int) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Get the entries at the given row index.
getRow(int) - 类中的方法 org.hipparchus.linear.Array2DRowFieldMatrix
Get the entries in row number row as an array.
getRow(int) - 类中的方法 org.hipparchus.linear.Array2DRowRealMatrix
Get the entries at the given row index.
getRow(int) - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
Get the entries in row number row as an array.
getRow(int) - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Get the entries at the given row index.
getRow(int) - 接口中的方法 org.hipparchus.linear.FieldMatrix
Get the entries in row number row as an array.
getRow(int) - 接口中的方法 org.hipparchus.linear.RealMatrix
Get the entries at the given row index.
getRowDimension() - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Returns the number of rows in the matrix.
getRowDimension() - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Returns the number of rows of this matrix.
getRowDimension() - 接口中的方法 org.hipparchus.linear.AnyMatrix
Returns the number of rows in the matrix.
getRowDimension() - 类中的方法 org.hipparchus.linear.Array2DRowFieldMatrix
Returns the number of rows in the matrix.
getRowDimension() - 类中的方法 org.hipparchus.linear.Array2DRowRealMatrix
Returns the number of rows of this matrix.
getRowDimension() - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
Returns the number of rows in the matrix.
getRowDimension() - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Returns the number of rows of this matrix.
getRowDimension() - 接口中的方法 org.hipparchus.linear.DecompositionSolver
Returns the number of rows in the matrix.
getRowDimension() - 类中的方法 org.hipparchus.linear.DiagonalMatrix
Returns the number of rows of this matrix.
getRowDimension() - 接口中的方法 org.hipparchus.linear.FieldDecompositionSolver
Returns the number of rows in the matrix.
getRowDimension() - 类中的方法 org.hipparchus.linear.HilbertMatrix
Returns the dimension of the codomain of this operator.
getRowDimension() - 类中的方法 org.hipparchus.linear.InverseHilbertMatrix
Returns the dimension of the codomain of this operator.
getRowDimension() - 类中的方法 org.hipparchus.linear.JacobiPreconditioner
Returns the dimension of the codomain of this operator.
getRowDimension() - 类中的方法 org.hipparchus.linear.OpenMapRealMatrix
Returns the number of rows of this matrix.
getRowDimension() - 接口中的方法 org.hipparchus.linear.RealLinearOperator
Returns the dimension of the codomain of this operator.
getRowDimension() - 类中的方法 org.hipparchus.linear.SparseFieldMatrix
Returns the number of rows in the matrix.
getRowMatrix(int) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Get the entries in row number row as a row matrix.
getRowMatrix(int) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Get the entries at the given row index as a row matrix.
getRowMatrix(int) - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
Get the entries in row number row as a row matrix.
getRowMatrix(int) - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Get the entries at the given row index as a row matrix.
getRowMatrix(int) - 接口中的方法 org.hipparchus.linear.FieldMatrix
Get the entries in row number row as a row matrix.
getRowMatrix(int) - 接口中的方法 org.hipparchus.linear.RealMatrix
Get the entries at the given row index as a row matrix.
getRowPrefix() - 类中的方法 org.hipparchus.linear.RealMatrixFormat
Get the format prefix.
getRowSeparator() - 类中的方法 org.hipparchus.linear.RealMatrixFormat
Get the format separator between rows of the matrix.
getRowSuffix() - 类中的方法 org.hipparchus.linear.RealMatrixFormat
Get the format suffix.
getRowVector(int) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Get the entries in row number row as a vector.
getRowVector(int) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Returns the entries in row number row as a vector.
getRowVector(int) - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
Get the entries in row number row as a vector.
getRowVector(int) - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Returns the entries in row number row as a vector.
getRowVector(int) - 接口中的方法 org.hipparchus.linear.FieldMatrix
Get the entries in row number row as a vector.
getRowVector(int) - 接口中的方法 org.hipparchus.linear.RealMatrix
Returns the entries in row number row as a vector.
getRSquare() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the coefficient of determination, usually denoted r-square.
getRSquared() - 类中的方法 org.hipparchus.stat.regression.RegressionResults
Returns the coefficient of multiple determination, usually denoted r-square.
getRule(int) - 类中的方法 org.hipparchus.analysis.integration.gauss.AbstractRuleFactory
Gets a copy of the quadrature rule with the given number of integration points.
getRule(int) - 类中的方法 org.hipparchus.analysis.integration.gauss.FieldAbstractRuleFactory
Gets a copy of the quadrature rule with the given number of integration points.
getRule(int) - 接口中的方法 org.hipparchus.analysis.integration.gauss.FieldRuleFactory
Gets a copy of the quadrature rule with the given number of integration points.
getRule(int) - 接口中的方法 org.hipparchus.analysis.integration.gauss.RuleFactory
Gets a copy of the quadrature rule with the given number of integration points.
getRuntimeClass() - 类中的方法 org.hipparchus.analysis.differentiation.DSFactory.DSField
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.analysis.differentiation.FDSFactory.DerivativeField
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradientField
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1Field
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2Field
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.analysis.differentiation.GradientField
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1Field
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2Field
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.complex.ComplexField
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.complex.FieldComplexField
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.dfp.DfpField
Returns the runtime class of the FieldElement.
getRuntimeClass() - 接口中的方法 org.hipparchus.Field
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.fraction.BigFractionField
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.fraction.FractionField
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.util.BigRealField
Returns the runtime class of the FieldElement.
getRuntimeClass() - 类中的方法 org.hipparchus.util.Binary64Field
Returns the runtime class of the FieldElement.
getS() - 类中的方法 org.hipparchus.linear.SingularValueDecomposition
Returns the diagonal matrix Σ of the decomposition.
getSafety() - 类中的方法 org.hipparchus.ode.MultistepFieldIntegrator
Get the safety factor for stepsize control.
getSafety() - 类中的方法 org.hipparchus.ode.MultistepIntegrator
Get the safety factor for stepsize control.
getSafety() - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
Get the safety factor for stepsize control.
getSafety() - 类中的方法 org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the safety factor for stepsize control.
getSampleSize() - 类中的方法 org.hipparchus.distribution.discrete.HypergeometricDistribution
Access the sample size.
getSampleSize() - 类中的方法 org.hipparchus.stat.regression.GLSMultipleLinearRegressionTest
 
getSampleSize() - 类中的方法 org.hipparchus.stat.regression.MultipleLinearRegressionAbstractTest
 
getSampleSize() - 类中的方法 org.hipparchus.stat.regression.OLSMultipleLinearRegressionTest
 
getSampleStats() - 类中的方法 org.hipparchus.stat.fitting.EmpiricalDistribution
Returns a StatisticalSummary describing this distribution.
getScalarPart() - 类中的方法 org.hipparchus.complex.Quaternion
Gets the scalar part of the quaternion.
getScale() - 类中的方法 org.hipparchus.distribution.continuous.CauchyDistribution
Access the scale parameter.
getScale() - 类中的方法 org.hipparchus.distribution.continuous.GammaDistribution
Returns the scale parameter of this distribution.
getScale() - 类中的方法 org.hipparchus.distribution.continuous.GumbelDistribution
Access the scale parameter, beta.
getScale() - 类中的方法 org.hipparchus.distribution.continuous.LaplaceDistribution
Access the scale parameter, beta.
getScale() - 类中的方法 org.hipparchus.distribution.continuous.LevyDistribution
Get the scale parameter of the distribution.
getScale() - 类中的方法 org.hipparchus.distribution.continuous.LogisticDistribution
Access the scale parameter, s.
getScale() - 类中的方法 org.hipparchus.distribution.continuous.NakagamiDistribution
Access the scale parameter, omega.
getScale() - 类中的方法 org.hipparchus.distribution.continuous.ParetoDistribution
Returns the scale parameter of this distribution.
getScale() - 类中的方法 org.hipparchus.distribution.continuous.WeibullDistribution
Access the scale parameter, beta.
getScale() - 类中的方法 org.hipparchus.util.BigReal
Sets the scale for division operations.
getSecond() - 类中的方法 org.hipparchus.util.Pair
Get the second element of the pair.
getSecondaryDerivative(int) - 类中的方法 org.hipparchus.ode.ComplexODEStateAndDerivative
Get derivative of the secondary state at time.
getSecondaryDerivative(int) - 类中的方法 org.hipparchus.ode.FieldODEStateAndDerivative
Get derivative of the secondary state at time.
getSecondaryDerivative(int) - 类中的方法 org.hipparchus.ode.ODEStateAndDerivative
Get derivative of the secondary state at time.
getSecondaryState(int) - 类中的方法 org.hipparchus.ode.ComplexODEState
Get secondary state at time.
getSecondaryState(int) - 类中的方法 org.hipparchus.ode.FieldODEState
Get secondary state at time.
getSecondaryState(int) - 类中的方法 org.hipparchus.ode.ODEState
Get secondary state at time.
getSecondaryStateDimension(int) - 类中的方法 org.hipparchus.ode.ComplexODEState
Get secondary state dimension.
getSecondaryStateDimension(int) - 类中的方法 org.hipparchus.ode.FieldODEState
Get secondary state dimension.
getSecondaryStateDimension(int) - 类中的方法 org.hipparchus.ode.ODEState
Get secondary state dimension.
getSecondDerivative() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Get the second derivative.
getSecondDerivative() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
Get the second derivative.
getSecondMoment() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns a statistic related to the Second Central Moment.
getSegments() - 类中的方法 org.hipparchus.geometry.euclidean.threed.SubLine
Get the endpoints of the sub-line.
getSegments() - 类中的方法 org.hipparchus.geometry.euclidean.twod.SubLine
Get the endpoints of the sub-line.
getSeparator() - 类中的方法 org.hipparchus.geometry.VectorFormat
Get the format separator between components.
getSeparator() - 类中的方法 org.hipparchus.linear.RealVectorFormat
Get the format separator between components.
getShape() - 类中的方法 org.hipparchus.distribution.continuous.GammaDistribution
Returns the shape parameter of this distribution.
getShape() - 类中的方法 org.hipparchus.distribution.continuous.LogNormalDistribution
Returns the shape parameter of this distribution.
getShape() - 类中的方法 org.hipparchus.distribution.continuous.NakagamiDistribution
Access the shape parameter, mu.
getShape() - 类中的方法 org.hipparchus.distribution.continuous.ParetoDistribution
Returns the shape parameter of this distribution.
getShape() - 类中的方法 org.hipparchus.distribution.continuous.WeibullDistribution
Access the shape parameter, alpha.
getSide() - 类中的方法 org.hipparchus.geometry.partitioning.SubHyperplane.SplitSubHyperplane
Get the side of the split sub-hyperplane with respect to its splitter.
getSide() - 类中的方法 org.hipparchus.geometry.spherical.oned.ArcsSet.Split
Get the side of the split arc with respect to its splitter.
getSide(AllowedSolution) - 类中的方法 org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver.Interval
Get the abscissa corresponding to the allowed side.
getSide(AllowedSolution) - 类中的方法 org.hipparchus.analysis.solvers.BracketedUnivariateSolver.Interval
Get the abscissa corresponding to the allowed side.
getSigma() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer.Sigma
Get sigma values.
getSigma(double) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
Get an estimate of the standard deviation of the parameters.
getSigma(double) - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
Get an estimate of the standard deviation of the parameters.
getSignificance() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the significance level of the slope (equiv) correlation.
getSingularMatrixCheckTolerance() - 类中的方法 org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
Gets the current setting for the tolerance check used during singular checks before inversion
getSingularValues() - 类中的方法 org.hipparchus.linear.SingularValueDecomposition
Returns the diagonal elements of the matrix Σ of the decomposition.
getSize() - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Get the array size required for holding partial derivatives data.
getSize() - 类中的方法 org.hipparchus.analysis.interpolation.InterpolatingMicrosphere
Get the size of the sphere.
getSize() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Interval
Get the size of the interval.
getSize() - 类中的方法 org.hipparchus.geometry.euclidean.oned.SubOrientedPoint
Get the size of the instance.
getSize() - 类中的方法 org.hipparchus.geometry.partitioning.AbstractRegion
Get the size of the instance.
getSize() - 类中的方法 org.hipparchus.geometry.partitioning.AbstractSubHyperplane
Get the size of the instance.
getSize() - 接口中的方法 org.hipparchus.geometry.partitioning.Region
Get the size of the instance.
getSize() - 接口中的方法 org.hipparchus.geometry.partitioning.SubHyperplane
Get the size of the instance.
getSize() - 类中的方法 org.hipparchus.geometry.spherical.oned.Arc
Get the angular size of the arc.
getSize() - 类中的方法 org.hipparchus.geometry.spherical.oned.SubLimitAngle
Get the size of the instance.
getSize() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
Get simplex size.
getSize() - 类中的方法 org.hipparchus.util.MultidimensionalCounter
Get the total number of elements.
getSizes() - 类中的方法 org.hipparchus.util.MultidimensionalCounter
Get the number of multidimensional counter slots in each dimension.
getSkewness() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the skewness of the available values.
getSlope() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the slope of the estimated regression line.
getSlope() - 类中的方法 org.hipparchus.UnitTestUtils.SimpleRegression
 
getSlopeConfidenceInterval() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the half-width of a 95% confidence interval for the slope estimate.
getSlopeConfidenceInterval(double) - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the half-width of a (100-100*alpha)% confidence interval for the slope estimate.
getSlopeStdErr() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the standard error of the slope estimate, usually denoted s(b1).
getSolution() - 类中的方法 org.hipparchus.linear.DefaultIterativeLinearSolverEvent
Returns the current estimate of the solution to the linear system to be solved.
getSolution() - 类中的方法 org.hipparchus.linear.IterativeLinearSolverEvent
Returns the current estimate of the solution to the linear system to be solved.
getSolution() - 类中的方法 org.hipparchus.optim.linear.SolutionCallback
Retrieve the best solution found so far.
getSolver() - 类中的方法 org.hipparchus.analysis.solvers.BaseSecantSolverAbstractTest
Returns the solver to use to perform the tests.
getSolver() - 类中的方法 org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolverTest
Returns the solver to use to perform the tests.
getSolver() - 类中的方法 org.hipparchus.analysis.solvers.IllinoisSolverTest
Returns the solver to use to perform the tests.
getSolver() - 类中的方法 org.hipparchus.analysis.solvers.PegasusSolverTest
Returns the solver to use to perform the tests.
getSolver() - 类中的方法 org.hipparchus.analysis.solvers.RegulaFalsiSolverTest
Returns the solver to use to perform the tests.
getSolver() - 类中的方法 org.hipparchus.analysis.solvers.SecantSolverTest
Returns the solver to use to perform the tests.
getSolver() - 类中的方法 org.hipparchus.linear.CholeskyDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - 类中的方法 org.hipparchus.linear.EigenDecompositionSymmetric
Gets a solver for finding the \(A \times X = B\) solution in exact linear sense.
getSolver() - 类中的方法 org.hipparchus.linear.FieldLUDecomposition
Get a solver for finding the A × X = B solution in exact linear sense.
getSolver() - 类中的方法 org.hipparchus.linear.FieldQRDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - 类中的方法 org.hipparchus.linear.LUDecomposition
Get a solver for finding the A × X = B solution in exact linear sense.
getSolver() - 类中的方法 org.hipparchus.linear.QRDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - 类中的方法 org.hipparchus.linear.RRQRDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - 类中的方法 org.hipparchus.linear.SingularValueDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - 类中的方法 org.hipparchus.ode.events.AbstractFieldODEDetector
Get the root-finding algorithm to use to detect state events.
getSolver() - 类中的方法 org.hipparchus.ode.events.AbstractODEDetector
Get the root-finding algorithm to use to detect state events.
getSolver() - 类中的方法 org.hipparchus.ode.events.EventSlopeFilterTest.Event
 
getSolver() - 类中的方法 org.hipparchus.ode.events.EventSlopeFilterTest.FieldEvent
 
getSolver() - 接口中的方法 org.hipparchus.ode.events.FieldODEEventDetector
Get the root-finding algorithm to use to detect state events.
getSolver() - 接口中的方法 org.hipparchus.ode.events.ODEEventDetector
Get the root-finding algorithm to use to detect state events.
getSolver() - 类中的方法 org.hipparchus.ode.events.ReappearingEventTest.Event
 
getSolverAbsoluteAccuracy() - 类中的方法 org.hipparchus.distribution.continuous.AbstractRealDistribution
Returns the solver absolute accuracy for inverse cumulative computation.
getSortedValues() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the current set of values in an array of double primitives, sorted in ascending order.
getSourceString() - 枚举类中的方法 org.hipparchus.clustering.LocalizedClusteringFormats
Gets the source (non-localized) string.
getSourceString() - 类中的方法 org.hipparchus.exception.DummyLocalizable
Gets the source (non-localized) string.
getSourceString() - 接口中的方法 org.hipparchus.exception.Localizable
Gets the source (non-localized) string.
getSourceString() - 枚举类中的方法 org.hipparchus.exception.LocalizedCoreFormats
Gets the source (non-localized) string.
getSourceString() - 枚举类中的方法 org.hipparchus.geometry.LocalizedGeometryFormats
Gets the source (non-localized) string.
getSourceString() - 枚举类中的方法 org.hipparchus.migration.exception.util.LocalizedFormats
已过时。
Gets the source (non-localized) string.
getSourceString() - 枚举类中的方法 org.hipparchus.migration.LocalizedMigrationFormats
已过时。
Gets the source (non-localized) string.
getSourceString() - 枚举类中的方法 org.hipparchus.ode.LocalizedODEFormats
Gets the source (non-localized) string.
getSourceString() - 枚举类中的方法 org.hipparchus.optim.LocalizedOptimFormats
Gets the source (non-localized) string.
getSourceString() - 枚举类中的方法 org.hipparchus.stat.LocalizedStatFormats
Gets the source (non-localized) string.
getSourceString() - 枚举类中的方法 org.hipparchus.transform.LocalizedFFTFormats
Gets the source (non-localized) string.
getSpace() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
Get the space to which the point belongs.
getSpace() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
Get the space to which the point belongs.
getSpace() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
Get the space to which the point belongs.
getSpace() - 接口中的方法 org.hipparchus.geometry.Point
Get the space to which the point belongs.
getSpace() - 类中的方法 org.hipparchus.geometry.spherical.oned.S1Point
Get the space to which the point belongs.
getSpace() - 类中的方法 org.hipparchus.geometry.spherical.twod.S2Point
Get the space to which the point belongs.
getSparsity() - 类中的方法 org.hipparchus.linear.OpenMapRealVector
Get percentage of none zero elements as a decimal percent.
getSpecifier() - 接口中的方法 org.hipparchus.exception.LocalizedException
Get the localizable specifier of the error message.
getSpecifier() - 异常错误类中的方法 org.hipparchus.exception.MathRuntimeException
Get the localizable specifier of the error message.
getSpecifier() - 异常错误类中的方法 org.hipparchus.exception.NullArgumentException
Get the localizable specifier of the error message.
getSplitters() - 类中的方法 org.hipparchus.geometry.partitioning.BoundaryAttribute
Get the sub-hyperplanes that were used to split the boundary part.
getSqr2() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant √2.
getSqr2Reciprocal() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant √2 / 2.
getSqr2Split() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant √2 split in two pieces.
getSqr3() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant √3.
getSqr3Reciprocal() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant √3 / 3.
getSquareRoot() - 类中的方法 org.hipparchus.linear.EigenDecompositionSymmetric
Computes the square-root of the matrix.
getStandardDeviation() - 类中的方法 org.hipparchus.distribution.continuous.NormalDistribution
Access the standard deviation.
getStandardDeviation() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the standard deviation of the available values.
getStandardDeviation() - 类中的方法 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the standard deviation of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getStandardDeviation() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the standard deviation of the ith entries of the arrays that correspond to each multivariate sample
getStandardDeviation() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalSummary
Returns the standard deviation of the available values.
getStandardDeviation() - 类中的方法 org.hipparchus.stat.descriptive.StatisticalSummaryValues
 
getStandardDeviation() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns the standard deviation of the values that have been added.
getStandardDeviation() - 类中的方法 org.hipparchus.UnitTestUtils.SimpleStatistics
 
getStandardDeviations() - 类中的方法 org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
Gets the square root of each element on the diagonal of the covariance matrix.
getStart() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Segment
Get the start point of the segment.
getStart() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Segment
Get the start point of the segment.
getStart() - 类中的方法 org.hipparchus.geometry.spherical.twod.Edge
Get start vertex.
getStart() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputOverlapTest
 
getStart() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTest
 
getStart() - 类中的方法 org.hipparchus.ode.sampling.StepNormalizerOutputTestBase
Returns the start time.
getStart() - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
Gets the initial guess.
getStart() - 接口中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem
Gets the initial guess.
getStarterIntegrator() - 类中的方法 org.hipparchus.ode.MultistepFieldIntegrator
Get the starter integrator.
getStarterIntegrator() - 类中的方法 org.hipparchus.ode.MultistepIntegrator
Get the starter integrator.
getStartIndex() - 类中的方法 org.hipparchus.util.ResizableDoubleArray
Returns the "start index" of the internal array.
getStartingPoint(int) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the i-th set of initial values of the parameters.
getStartPoint() - 类中的方法 org.hipparchus.optim.BaseMultivariateOptimizer
Gets the initial guess.
getStartValue() - 类中的方法 org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
Get initial guess.
getStartValue() - 类中的方法 org.hipparchus.optim.univariate.SearchInterval
Gets the start value.
getStartValue() - 类中的方法 org.hipparchus.optim.univariate.UnivariateOptimizer
Get initial guess.
getState() - 类中的方法 org.hipparchus.filtering.kalman.ProcessEstimate
Get the state vector.
getStateTransitionMatrix() - 类中的方法 org.hipparchus.filtering.kalman.extended.NonLinearEvolution
Get state transition matrix between previous and current state.
getStateTransitionMatrix() - 类中的方法 org.hipparchus.filtering.kalman.linear.LinearEvolution
Get the state transition matrix Ak-1.
getStateTransitionMatrix() - 类中的方法 org.hipparchus.filtering.kalman.ProcessEstimate
Get state transition matrix between previous state and estimated (but not yet corrected) state.
getStatisticsDHistory() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
Get history of D matrix.
getStatisticsFitnessHistory() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
Get history of fitness values.
getStatisticsMeanHistory() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
Get history of mean matrix.
getStatisticsSigmaHistory() - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
Get history of sigma values.
getStdErrorOfEstimate(int) - 类中的方法 org.hipparchus.stat.regression.RegressionResults
Returns the standard error of the parameter estimate at index, usually denoted s(bindex).
getStdErrorOfEstimates() - 类中的方法 org.hipparchus.stat.regression.RegressionResults
Returns the standard error of the parameter estimates, usually denoted s(bi).
getStepEndHandlers() - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
Get all the handlers for step ends that have been added to the integrator.
getStepEndHandlers() - 类中的方法 org.hipparchus.ode.AbstractIntegrator
Get all the handlers for step ends that have been added to the integrator.
getStepEndHandlers() - 接口中的方法 org.hipparchus.ode.FieldODEIntegrator
Get all the handlers for step ends that have been added to the integrator.
getStepEndHandlers() - 接口中的方法 org.hipparchus.ode.ODEIntegrator
Get all the handlers for step ends that have been added to the integrator.
getStepHandlers() - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
Get all the step handlers that have been added to the integrator.
getStepHandlers() - 类中的方法 org.hipparchus.ode.AbstractIntegrator
Get all the step handlers that have been added to the integrator.
getStepHandlers() - 接口中的方法 org.hipparchus.ode.FieldODEIntegrator
Get all the step handlers that have been added to the integrator.
getStepHandlers() - 接口中的方法 org.hipparchus.ode.ODEIntegrator
Get all the step handlers that have been added to the integrator.
getStepSize() - 类中的方法 org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
Get the step size.
getStepSize() - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
Get the current step size.
getStepSize() - 类中的方法 org.hipparchus.ode.AbstractIntegrator
Get the current step size.
getStepSizeHelper() - 类中的方法 org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
Get the stepsize helper.
getStepSizeHelper() - 类中的方法 org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
Get the stepsize helper.
getStepStart() - 类中的方法 org.hipparchus.ode.AbstractFieldIntegrator
Get the state at step start time ti.
getStepStart() - 类中的方法 org.hipparchus.ode.AbstractIntegrator
Get the state at step start time ti.
getStepStart() - 接口中的方法 org.hipparchus.ode.FieldODEIntegrator
Get the state at step start time ti.
getStepStart() - 接口中的方法 org.hipparchus.ode.ODEIntegrator
Get the state at step start time ti.
getStopTime() - 类中的方法 org.hipparchus.ode.events.EventOccurrence
Get the new time for a stop action.
getStopTime() - 类中的方法 org.hipparchus.ode.events.FieldEventOccurrence
Get the new time for a stop action.
getStrict() - 异常错误类中的方法 org.hipparchus.migration.exception.NonMonotonicSequenceException
已过时。
Check if sequence should be strictly monotonic.
getSubMatrix(int[], int[]) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Get a submatrix.
getSubMatrix(int[], int[]) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Gets a submatrix.
getSubMatrix(int[], int[]) - 接口中的方法 org.hipparchus.linear.FieldMatrix
Get a submatrix.
getSubMatrix(int[], int[]) - 接口中的方法 org.hipparchus.linear.RealMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Get a submatrix.
getSubMatrix(int, int, int, int) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - 类中的方法 org.hipparchus.linear.Array2DRowFieldMatrix
Get a submatrix.
getSubMatrix(int, int, int, int) - 类中的方法 org.hipparchus.linear.Array2DRowRealMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
Get a submatrix.
getSubMatrix(int, int, int, int) - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - 接口中的方法 org.hipparchus.linear.FieldMatrix
Get a submatrix.
getSubMatrix(int, int, int, int) - 接口中的方法 org.hipparchus.linear.RealMatrix
Gets a submatrix.
getSubSpace() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Euclidean1D
Get the n-1 dimension subspace of this space.
getSubSpace() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Euclidean3D
Get the n-1 dimension subspace of this space.
getSubSpace() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Euclidean2D
Get the n-1 dimension subspace of this space.
getSubSpace() - 接口中的方法 org.hipparchus.geometry.Space
Get the n-1 dimension subspace of this space.
getSubSpace() - 类中的方法 org.hipparchus.geometry.spherical.oned.Sphere1D
Get the n-1 dimension subspace of this space.
getSubSpace() - 类中的方法 org.hipparchus.geometry.spherical.twod.Sphere2D
Get the n-1 dimension subspace of this space.
getSubVector(int, int) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
Get a subvector from consecutive elements.
getSubVector(int, int) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
 
getSubVector(int, int) - 类中的方法 org.hipparchus.linear.ArrayRealVector
Get a subvector from consecutive elements.
getSubVector(int, int) - 接口中的方法 org.hipparchus.linear.FieldVector
Get a subvector from consecutive elements.
getSubVector(int, int) - 类中的方法 org.hipparchus.linear.OpenMapRealVector
Get a subvector from consecutive elements.
getSubVector(int, int) - 类中的方法 org.hipparchus.linear.RealVector
Get a subvector from consecutive elements.
getSubVector(int, int) - 类中的方法 org.hipparchus.linear.RealVectorAbstractTest.RealVectorTestImpl
 
getSubVector(int, int) - 类中的方法 org.hipparchus.linear.SparseFieldVector
Get a subvector from consecutive elements.
getSuffix() - 类中的方法 org.hipparchus.geometry.VectorFormat
Get the format suffix.
getSuffix() - 类中的方法 org.hipparchus.linear.RealMatrixFormat
Get the format suffix.
getSuffix() - 类中的方法 org.hipparchus.linear.RealVectorFormat
Get the format suffix.
getSum() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the sum of the values that have been added to Univariate.
getSum() - 类中的方法 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of the ith entries of the arrays that correspond to each multivariate sample
getSum() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the sum of the ith entries of the arrays that correspond to each multivariate sample
getSum() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalSummary
Returns the sum of the values that have been added to Univariate.
getSum() - 类中的方法 org.hipparchus.stat.descriptive.StatisticalSummaryValues
 
getSum() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns the sum of the values that have been added to Univariate.
getSum() - 类中的方法 org.hipparchus.util.MathUtils.FieldSumAndResidual
Returns the sum.
getSum() - 类中的方法 org.hipparchus.util.MathUtils.SumAndResidual
Returns the sum.
getSumFreq() - 类中的方法 org.hipparchus.stat.Frequency
Returns the sum of all frequencies.
getSumLog() - 类中的方法 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of logs of the ith entries of the arrays that correspond to each multivariate sample
getSumLog() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the sum of logs of the ith entries of the arrays that correspond to each multivariate sample
getSummary() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Return a StatisticalSummaryValues instance reporting current statistics.
getSumOfCrossProducts() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the sum of crossproducts, xi*yi.
getSumOfLogs() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns the sum of the logs of the values that have been added.
getSumOfSquares() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the sum of the squares of the available values.
getSumOfSquares() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns the sum of the squares of the values that have been added.
getSumSq() - 类中的方法 org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of squares of the ith entries of the arrays that correspond to each multivariate sample
getSumSq() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the sum of squares of the ith entries of the arrays that correspond to each multivariate sample
getSumSquaredErrors() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the sum of squared errors (SSE) associated with the regression model.
getSup() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Interval
Get the upper bound of the interval.
getSup() - 类中的方法 org.hipparchus.geometry.euclidean.oned.IntervalsSet
Get the highest value belonging to the instance.
getSup() - 类中的方法 org.hipparchus.geometry.spherical.oned.Arc
Get the upper angular bound of the arc.
getSupport() - 类中的方法 org.hipparchus.geometry.enclosing.EnclosingBall
Get the support points used to define the ball.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.BetaDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.CauchyDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.ChiSquaredDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.ConstantRealDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.EnumeratedRealDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.ExponentialDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.FDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.GammaDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.GumbelDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.LaplaceDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.LevyDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.LogisticDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.LogNormalDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.NakagamiDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.NormalDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.ParetoDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.TDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.TriangularDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.UniformRealDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.continuous.WeibullDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.discrete.BinomialDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.discrete.GeometricDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.discrete.HypergeometricDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.discrete.PascalDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.discrete.PoissonDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.discrete.UniformIntegerDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.distribution.discrete.ZipfDistribution
Access the lower bound of the support.
getSupportLowerBound() - 接口中的方法 org.hipparchus.distribution.IntegerDistribution
Access the lower bound of the support.
getSupportLowerBound() - 接口中的方法 org.hipparchus.distribution.RealDistribution
Access the lower bound of the support.
getSupportLowerBound() - 类中的方法 org.hipparchus.stat.fitting.EmpiricalDistribution
Access the lower bound of the support.
getSupportSize() - 类中的方法 org.hipparchus.geometry.enclosing.EnclosingBall
Get the number of support points used to define the ball.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.BetaDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.CauchyDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.ChiSquaredDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.ConstantRealDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.EnumeratedRealDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.ExponentialDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.FDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.GammaDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.GumbelDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.LaplaceDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.LevyDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.LogisticDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.LogNormalDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.NakagamiDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.NormalDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.ParetoDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.TDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.TriangularDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.UniformRealDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.continuous.WeibullDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.discrete.BinomialDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.discrete.GeometricDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.discrete.HypergeometricDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.discrete.PascalDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.discrete.PoissonDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.discrete.UniformIntegerDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.distribution.discrete.ZipfDistribution
Access the upper bound of the support.
getSupportUpperBound() - 接口中的方法 org.hipparchus.distribution.IntegerDistribution
Access the upper bound of the support.
getSupportUpperBound() - 接口中的方法 org.hipparchus.distribution.RealDistribution
Access the upper bound of the support.
getSupportUpperBound() - 类中的方法 org.hipparchus.stat.fitting.EmpiricalDistribution
Access the upper bound of the support.
getT() - 类中的方法 org.hipparchus.linear.SchurTransformer
Returns the quasi-triangular Schur matrix T of the transform.
getTheoreticalEventsTimes() - 类中的方法 org.hipparchus.ode.TestFieldProblem4
Get the theoretical events times.
getTheoreticalEventsTimes() - 类中的方法 org.hipparchus.ode.TestFieldProblemAbstract
Get the theoretical events times.
getTheoreticalEventsTimes() - 类中的方法 org.hipparchus.ode.TestProblem4
Get the theoretical events times.
getTheoreticalEventsTimes() - 类中的方法 org.hipparchus.ode.TestProblemAbstract
Get the theoretical events times.
getTheta() - 类中的方法 org.hipparchus.geometry.euclidean.threed.SphericalCoordinates
Get the azimuthal angle in x-y plane.
getTheta() - 类中的方法 org.hipparchus.geometry.spherical.twod.S2Point
Get the azimuthal angle \( \theta \) in the x-y plane.
getThreshold() - 异常错误类中的方法 org.hipparchus.migration.linear.NonPositiveDefiniteMatrixException
已过时。
Get absolute positivity threshold.
getThreshold() - 异常错误类中的方法 org.hipparchus.migration.linear.NonSymmetricMatrixException
已过时。
Get relative symmetry threshold.
getTiesStrategy() - 类中的方法 org.hipparchus.stat.ranking.NaturalRanking
Return the TiesStrategy
getTime() - 接口中的方法 org.hipparchus.filtering.kalman.Measurement
Get the process time.
getTime() - 类中的方法 org.hipparchus.filtering.kalman.ProcessEstimate
Get the process time.
getTime() - 类中的方法 org.hipparchus.filtering.kalman.Reference
 
getTime() - 类中的方法 org.hipparchus.filtering.kalman.SimpleMeasurement
 
getTime() - 类中的方法 org.hipparchus.ode.ComplexODEState
Get time.
getTime() - 类中的方法 org.hipparchus.ode.FieldODEState
Get time.
getTime() - 类中的方法 org.hipparchus.ode.ODEState
Get time.
getTolerance() - 类中的方法 org.hipparchus.distribution.continuous.RealDistributionAbstractTest
 
getTolerance() - 类中的方法 org.hipparchus.distribution.discrete.IntegerDistributionAbstractTest
 
getTolerance() - 类中的方法 org.hipparchus.geometry.euclidean.oned.OrientedPoint
Get the tolerance below which points are considered to belong to the hyperplane.
getTolerance() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldLine
Get the tolerance below which points are considered identical.
getTolerance() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Line
Get the tolerance below which points are considered identical.
getTolerance() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Plane
Get the tolerance below which points are considered to belong to the hyperplane.
getTolerance() - 类中的方法 org.hipparchus.geometry.euclidean.twod.hull.MonotoneChain
Get the tolerance below which points are considered identical.
getTolerance() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Line
Get the tolerance below which points are considered to belong to the hyperplane.
getTolerance() - 类中的方法 org.hipparchus.geometry.partitioning.AbstractRegion
Get the tolerance below which points are considered to belong to hyperplanes.
getTolerance() - 接口中的方法 org.hipparchus.geometry.partitioning.Hyperplane
Get the tolerance below which points are considered to belong to the hyperplane.
getTolerance() - 类中的方法 org.hipparchus.geometry.spherical.oned.Arc
Get the tolerance below which angles are considered identical.
getTolerance() - 类中的方法 org.hipparchus.geometry.spherical.oned.LimitAngle
Get the tolerance below which points are considered to belong to the hyperplane.
getTolerance() - 类中的方法 org.hipparchus.geometry.spherical.twod.Circle
Get the tolerance below which points are considered to belong to the hyperplane.
getTolerance() - 类中的方法 org.hipparchus.stat.descriptive.rank.PSquarePercentileTest
 
getTolerance() - 类中的方法 org.hipparchus.stat.descriptive.summary.ProductTest
 
getTolerance() - 类中的方法 org.hipparchus.stat.descriptive.UnivariateStatisticAbstractTest
 
getTolerance(int, double) - 类中的方法 org.hipparchus.ode.nonstiff.StepsizeHelper
Get the tolerance for one component.
getTolerance(int, T) - 类中的方法 org.hipparchus.ode.nonstiff.StepsizeHelper
Get the tolerance for one component.
getTotalDimension() - 类中的方法 org.hipparchus.ode.EquationsMapper
Return the dimension of the complete set of equations.
getTotalDimension() - 类中的方法 org.hipparchus.ode.FieldEquationsMapper
Return the dimension of the complete set of equations.
getTotalSumSquares() - 类中的方法 org.hipparchus.stat.regression.RegressionResults
Returns the sum of squared deviations of the y values about their mean.
getTotalSumSquares() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the sum of squared deviations of the y values about their mean.
getTrace() - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - 接口中的方法 org.hipparchus.linear.FieldMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - 接口中的方法 org.hipparchus.linear.RealMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTransform(double, double, double, double, double, double) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.Line
Get a Transform embedding an affine transform.
getTransform(Rotation) - 类中的静态方法 org.hipparchus.geometry.spherical.twod.Circle
Get a Transform embedding a 3D rotation.
getTree(boolean) - 类中的方法 org.hipparchus.geometry.partitioning.AbstractRegion
Get the underlying BSP tree.
getTree(boolean) - 接口中的方法 org.hipparchus.geometry.partitioning.Region
Get the underlying BSP tree.
getTwo() - 类中的方法 org.hipparchus.dfp.Dfp
Get the constant 2.
getTwo() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant 2.
getU() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Plane
Get the plane first canonical vector.
getU() - 类中的方法 org.hipparchus.linear.FieldLUDecomposition
Returns the matrix U of the decomposition.
getU() - 类中的方法 org.hipparchus.linear.LUDecomposition
Returns the matrix U of the decomposition.
getU() - 类中的方法 org.hipparchus.linear.SingularValueDecomposition
Returns the matrix U of the decomposition.
getUniqueCount() - 类中的方法 org.hipparchus.stat.Frequency
Returns the number of values in the frequency table.
getUnivariateDerivative1Field(Field<T>) - 类中的静态方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1Field
Get the univariate derivative field corresponding to a value field.
getUnivariateDerivative2Field(Field<T>) - 类中的静态方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2Field
Get the univariate derivative field corresponding to a value field.
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.moment.FirstMomentTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.moment.FourthMomentTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.moment.GeometricMeanTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.moment.KurtosisTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.moment.MeanTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.moment.SecondMomentTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.moment.SemiVarianceTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.moment.SkewnessTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.moment.StandardDeviationTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.moment.ThirdMomentTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.moment.VarianceTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.rank.MaxTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.rank.MedianTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.rank.MinTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.rank.PercentileTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.rank.PSquarePercentileTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.rank.RandomPercentileTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.StorelessUnivariateStatisticAbstractTest
Return a new instance of the statistic
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.summary.ProductTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.summary.SumLogTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.summary.SumSqTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.summary.SumTest
 
getUnivariateStatistic() - 类中的方法 org.hipparchus.stat.descriptive.UnivariateStatisticAbstractTest
 
getUnscentedTransformProvider() - 类中的方法 org.hipparchus.filtering.kalman.unscented.UnscentedKalmanFilter
Get the unscented transform provider.
getUpper() - 类中的方法 org.hipparchus.optim.SimpleBounds
Gets the upper bounds.
getUpperBound() - 类中的方法 org.hipparchus.optim.BaseMultivariateOptimizer
Get upper bounds.
getUpperBound() - 类中的方法 org.hipparchus.stat.interval.ConfidenceInterval
Get upper endpoint of the interval.
getUpperBounds() - 类中的方法 org.hipparchus.stat.fitting.EmpiricalDistribution
Returns a fresh copy of the array of upper bounds for the bins.
getUT() - 类中的方法 org.hipparchus.linear.SingularValueDecomposition
Returns the transpose of the matrix U of the decomposition.
getV() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Plane
Get the plane second canonical vector.
getV() - 类中的方法 org.hipparchus.linear.ComplexEigenDecomposition
Getter V.
getV() - 类中的方法 org.hipparchus.linear.EigenDecompositionNonSymmetric
Gets the matrix V of the decomposition.
getV() - 类中的方法 org.hipparchus.linear.EigenDecompositionSymmetric
Gets the matrix V of the decomposition.
getV() - 类中的方法 org.hipparchus.linear.SingularValueDecomposition
Returns the matrix V of the decomposition.
getVals() - 类中的方法 org.hipparchus.special.BesselJ.BesselJResult
Get computed function values.
getValue() - 接口中的方法 org.hipparchus.analysis.differentiation.Derivative
Get the value part of the function.
getValue() - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
Get the value part of the derivative structure.
getValue() - 接口中的方法 org.hipparchus.analysis.differentiation.FieldDerivative
Get the value part of the function.
getValue() - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
Get the value part of the derivative structure.
getValue() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Get the value part of the function.
getValue() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
Get the value part of the univariate derivative.
getValue() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Get the value part of the univariate derivative.
getValue() - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
Get the value part of the function.
getValue() - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
Get the value of the function.
getValue() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
Get the value part of the function.
getValue() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
Get the value part of the function.
getValue() - 接口中的方法 org.hipparchus.filtering.kalman.Measurement
Get the measurement vector.
getValue() - 类中的方法 org.hipparchus.filtering.kalman.SimpleMeasurement
 
getValue() - 类中的方法 org.hipparchus.linear.OpenMapRealVector.OpenMapEntry
Get the value of the entry.
getValue() - 类中的方法 org.hipparchus.linear.RealVector.Entry
Get the value of the entry.
getValue() - 类中的方法 org.hipparchus.optim.linear.LinearConstraint
Gets the value of the constraint (right hand side).
getValue() - 类中的方法 org.hipparchus.optim.PointVectorValuePair
Gets the value of the objective function.
getValue() - 类中的方法 org.hipparchus.optim.univariate.UnivariatePointValuePair
Get the value of the objective function.
getValue() - 类中的方法 org.hipparchus.util.Pair
Get the value.
getValueField() - 类中的方法 org.hipparchus.analysis.differentiation.FDSFactory
Get the Field the value and parameters of the function belongs to.
getValueField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Get the Field the value and parameters of the function belongs to.
getValueField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradientAbstractTest
 
getValueField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradientBinary64Test
 
getValueField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradientDfpTest
 
getValueField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
Get the Field the value and parameters of the function belongs to.
getValueField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1AbstractTest
 
getValueField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1Binary64Test
 
getValueField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1DfpTest
 
getValueField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Get the Field the value and parameters of the function belongs to.
getValueField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2AbstractTest
 
getValueField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2Binary64Test
 
getValueField() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2DfpTest
 
getValueRef() - 类中的方法 org.hipparchus.optim.PointVectorValuePair
Gets a reference to the value of the objective function.
getValues() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the current set of values in an array of double primitives.
getVariance() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the variance of the available values.
getVariance() - 接口中的方法 org.hipparchus.stat.descriptive.StatisticalSummary
Returns the variance of the available values.
getVariance() - 类中的方法 org.hipparchus.stat.descriptive.StatisticalSummaryValues
 
getVariance() - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics
Returns the variance of the available values.
getVariance() - 类中的方法 org.hipparchus.stat.projection.PCA
Get principal component variances.
getVariance() - 类中的方法 org.hipparchus.UnitTestUtils.SimpleStatistics
 
getVarianceDirection() - 类中的方法 org.hipparchus.stat.descriptive.moment.SemiVariance
Returns the varianceDirection property.
getVector() - 类中的方法 org.hipparchus.geometry.spherical.oned.S1Point
Get the corresponding normalized vector in the 2D euclidean space.
getVector() - 类中的方法 org.hipparchus.geometry.spherical.twod.S2Point
Get the corresponding normalized vector in the 3D euclidean space.
getVector1DFormat() - 类中的静态方法 org.hipparchus.geometry.euclidean.oned.Vector1DFormat
Returns the default 1D vector format for the current locale.
getVector1DFormat(Locale) - 类中的静态方法 org.hipparchus.geometry.euclidean.oned.Vector1DFormat
Returns the default 1D vector format for the given locale.
getVector2DFormat() - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.Vector2DFormat
Returns the default 2D vector format for the current locale.
getVector2DFormat(Locale) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.Vector2DFormat
Returns the default 2D vector format for the given locale.
getVector3DFormat() - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.Vector3DFormat
Returns the default 3D vector format for the current locale.
getVector3DFormat(Locale) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.Vector3DFormat
Returns the default 3D vector format for the given locale.
getVectorPart() - 类中的方法 org.hipparchus.complex.Quaternion
Gets the three components of the vector part of the quaternion.
getVertices() - 类中的方法 org.hipparchus.geometry.euclidean.threed.PLYParser
Get the parsed vertices.
getVertices() - 类中的方法 org.hipparchus.geometry.euclidean.threed.PolyhedronsSet.BRep
Get the extracted vertices.
getVertices() - 类中的方法 org.hipparchus.geometry.euclidean.twod.hull.ConvexHull2D
Get the vertices of the convex hull.
getVertices() - 类中的方法 org.hipparchus.geometry.euclidean.twod.PolygonsSet
Get the vertices of the polygon.
getVertices() - 接口中的方法 org.hipparchus.geometry.hull.ConvexHull
Get the vertices of the convex hull.
getVInv() - 类中的方法 org.hipparchus.linear.EigenDecompositionNonSymmetric
Gets the inverse of the matrix V of the decomposition.
getVT() - 类中的方法 org.hipparchus.linear.ComplexEigenDecomposition
Getter VT.
getVT() - 类中的方法 org.hipparchus.linear.EigenDecompositionSymmetric
Gets the transpose of the matrix V of the decomposition.
getVT() - 类中的方法 org.hipparchus.linear.OrderedComplexEigenDecomposition
Getter VT.
getVT() - 类中的方法 org.hipparchus.linear.SingularValueDecomposition
Returns the transpose of the matrix V of the decomposition.
getWc() - 类中的方法 org.hipparchus.util.JulierUnscentedTransform
Get the covariance weights.
getWc() - 类中的方法 org.hipparchus.util.MerweUnscentedTransform
Get the covariance weights.
getWc() - 接口中的方法 org.hipparchus.util.UnscentedTransformProvider
Get the covariance weights.
getWeight() - 类中的方法 org.hipparchus.fitting.WeightedObservedPoint
Gets the weight of the measurement in the fitting process.
getWeight(int) - 类中的方法 org.hipparchus.analysis.integration.gauss.FieldGaussIntegrator
Gets the weight of the integration point at the given index.
getWeight(int) - 类中的方法 org.hipparchus.analysis.integration.gauss.GaussIntegrator
Gets the weight of the integration point at the given index.
getWholeFormat() - 类中的方法 org.hipparchus.fraction.ProperBigFractionFormat
Access the whole format.
getWholeFormat() - 类中的方法 org.hipparchus.fraction.ProperFractionFormat
Access the whole format.
getWilsonScoreInterval(int, double, double) - 类中的静态方法 org.hipparchus.stat.interval.BinomialProportion
Create an Wilson score binomial confidence interval for the true probability of success of an unknown binomial distribution with the given observed number of trials, probability of success and confidence level.
getWindowSize() - 类中的方法 org.hipparchus.stat.descriptive.DescriptiveStatistics
Returns the maximum number of values that can be stored in the dataset, or INFINITE_WINDOW (-1) if there is no limit.
getWm() - 类中的方法 org.hipparchus.util.JulierUnscentedTransform
Get the mean weights.
getWm() - 类中的方法 org.hipparchus.util.MerweUnscentedTransform
Get the mean weights.
getWm() - 接口中的方法 org.hipparchus.util.UnscentedTransformProvider
Get the mean weights.
getWorkArray(double[], int, int) - 类中的方法 org.hipparchus.stat.descriptive.rank.Percentile
Get the work array to operate.
getWrongColumnDimension() - 异常错误类中的方法 org.hipparchus.migration.linear.MatrixDimensionMismatchException
已过时。
Get wrong column dimension.
getWrongDimension(int) - 异常错误类中的方法 org.hipparchus.migration.exception.MultiDimensionMismatchException
已过时。
Get wrong dimension at index.
getWrongDimensions() - 异常错误类中的方法 org.hipparchus.migration.exception.MultiDimensionMismatchException
已过时。
Get array containing the wrong dimensions.
getWrongRowDimension() - 异常错误类中的方法 org.hipparchus.migration.linear.MatrixDimensionMismatchException
已过时。
Get wrong row dimension.
getX() - 类中的方法 org.hipparchus.fitting.WeightedObservedPoint
Gets the abscissa of the point.
getX() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
Get the abscissa of the vector.
getX() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get the abscissa of the vector.
getX() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
Get the abscissa of the vector.
getX() - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get the abscissa of the vector.
getX() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
Get the abscissa of the vector.
getX() - 类中的方法 org.hipparchus.stat.regression.AbstractMultipleLinearRegression
Get the X sample data.
getX(int) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the x-value of the i-th data point.
getXAxis() - 类中的方法 org.hipparchus.geometry.spherical.twod.Circle
Get the X axis of the circle.
getXInf() - 类中的方法 org.hipparchus.analysis.interpolation.BilinearInterpolatingFunction
Get the lowest grid x coordinate.
getXSumSquares() - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the sum of squared deviations of the x values about their mean.
getXSup() - 类中的方法 org.hipparchus.analysis.interpolation.BilinearInterpolatingFunction
Get the highest grid x coordinate.
getY() - 类中的方法 org.hipparchus.fitting.WeightedObservedPoint
Gets the observed value of the function at x.
getY() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get the ordinate of the vector.
getY() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
Get the ordinate of the vector.
getY() - 类中的方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get the ordinate of the vector.
getY() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
Get the ordinate of the vector.
getY() - 类中的方法 org.hipparchus.stat.regression.AbstractMultipleLinearRegression
Get the Y sample data.
getY(int) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.StatisticalReferenceDataset
Returns the y-value of the i-th data point.
getYAxis() - 类中的方法 org.hipparchus.geometry.spherical.twod.Circle
Get the Y axis of the circle.
getYInf() - 类中的方法 org.hipparchus.analysis.interpolation.BilinearInterpolatingFunction
Get the lowest grid y coordinate.
getYSup() - 类中的方法 org.hipparchus.analysis.interpolation.BilinearInterpolatingFunction
Get the highest grid y coordinate.
getZ() - 类中的方法 org.hipparchus.filtering.kalman.Reference
 
getZ() - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get the height of the vector.
getZ() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
Get the height of the vector.
getZero() - 类中的方法 org.hipparchus.analysis.differentiation.DSFactory.DSField
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.analysis.differentiation.FDSFactory.DerivativeField
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradientField
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1Field
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2Field
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.analysis.differentiation.GradientField
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1Field
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2Field
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.complex.ComplexField
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.complex.FieldComplexField
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.dfp.Dfp
Get the constant 0.
getZero() - 类中的方法 org.hipparchus.dfp.DfpField
Get the constant 0.
getZero() - 接口中的方法 org.hipparchus.Field
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.fraction.BigFractionField
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.fraction.FractionField
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1D
Get the null vector of the vectorial space or origin point of the affine space.
getZero() - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3D
Get the null vector of the vectorial space or origin point of the affine space.
getZero() - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2D
Get the null vector of the vectorial space or origin point of the affine space.
getZero() - 接口中的方法 org.hipparchus.geometry.Vector
Get the null vector of the vectorial space or origin point of the affine space.
getZero() - 类中的方法 org.hipparchus.util.BigRealField
Get the additive identity of the field.
getZero() - 类中的方法 org.hipparchus.util.Binary64Field
Get the additive identity of the field.
getZero(Field<T>) - 类中的静态方法 org.hipparchus.complex.FieldComplex
Get a complex number representing "0.0 + 0.0i".
getZero(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.threed.FieldVector3D
Get null vector (coordinates: 0, 0, 0).
getZero(Field<T>) - 类中的静态方法 org.hipparchus.geometry.euclidean.twod.FieldVector2D
Get null vector (coordinates: 0, 0).
GillFieldIntegrator<T> - org.hipparchus.ode.nonstiff中的类
This class implements the Gill fourth order Runge-Kutta integrator for Ordinary Differential Equations .
GillFieldIntegrator(Field<T>, T) - 类的构造器 org.hipparchus.ode.nonstiff.GillFieldIntegrator
Simple constructor.
GillFieldIntegratorTest - org.hipparchus.ode.nonstiff中的类
 
GillFieldIntegratorTest() - 类的构造器 org.hipparchus.ode.nonstiff.GillFieldIntegratorTest
 
GillFieldStateInterpolatorTest - org.hipparchus.ode.nonstiff中的类
 
GillFieldStateInterpolatorTest() - 类的构造器 org.hipparchus.ode.nonstiff.GillFieldStateInterpolatorTest
 
GillIntegrator - org.hipparchus.ode.nonstiff中的类
This class implements the Gill fourth order Runge-Kutta integrator for Ordinary Differential Equations .
GillIntegrator(double) - 类的构造器 org.hipparchus.ode.nonstiff.GillIntegrator
Simple constructor.
GillIntegratorTest - org.hipparchus.ode.nonstiff中的类
 
GillIntegratorTest() - 类的构造器 org.hipparchus.ode.nonstiff.GillIntegratorTest
 
GillStateInterpolatorTest - org.hipparchus.ode.nonstiff中的类
 
GillStateInterpolatorTest() - 类的构造器 org.hipparchus.ode.nonstiff.GillStateInterpolatorTest
 
GLSMultipleLinearRegression - org.hipparchus.stat.regression中的类
The GLS implementation of multiple linear regression.
GLSMultipleLinearRegression() - 类的构造器 org.hipparchus.stat.regression.GLSMultipleLinearRegression
Empty constructor.
GLSMultipleLinearRegressionTest - org.hipparchus.stat.regression中的类
 
GLSMultipleLinearRegressionTest() - 类的构造器 org.hipparchus.stat.regression.GLSMultipleLinearRegressionTest
 
GnuplotComplexPlotter - org.hipparchus.samples.complex中的类
Program plotting complex functions with domain coloring.
GoalType - org.hipparchus.optim.nonlinear.scalar中的枚举类
Goal type for an optimization problem (minimization or maximization of a scalar function.
gradient(double, double...) - 类中的方法 org.hipparchus.analysis.function.Gaussian.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - 类中的方法 org.hipparchus.analysis.function.HarmonicOscillator.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - 类中的方法 org.hipparchus.analysis.function.Logistic.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - 类中的方法 org.hipparchus.analysis.function.Logit.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - 类中的方法 org.hipparchus.analysis.function.Sigmoid.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - 接口中的方法 org.hipparchus.analysis.ParametricUnivariateFunction
Compute the gradient of the function with respect to its parameters.
gradient(double, double...) - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunction.Parametric
Compute the gradient of the function with respect to its parameters.
Gradient - org.hipparchus.analysis.differentiation中的类
Class representing both the value and the differentials of a function.
Gradient(double, double...) - 类的构造器 org.hipparchus.analysis.differentiation.Gradient
Build an instance with values and derivative.
Gradient(DerivativeStructure) - 类的构造器 org.hipparchus.analysis.differentiation.Gradient
Build an instance from a DerivativeStructure.
GradientField - org.hipparchus.analysis.differentiation中的类
Field for Gradient instances.
GradientFunction - org.hipparchus.analysis.differentiation中的类
Class representing the gradient of a multivariate function.
GradientFunction(MultivariateDifferentiableFunction) - 类的构造器 org.hipparchus.analysis.differentiation.GradientFunction
Simple constructor.
GradientFunctionTest - org.hipparchus.analysis.differentiation中的类
Test for class GradientFunction.
GradientFunctionTest() - 类的构造器 org.hipparchus.analysis.differentiation.GradientFunctionTest
 
GradientMultivariateOptimizer - org.hipparchus.optim.nonlinear.scalar中的类
Base class for implementing optimizers for multivariate scalar differentiable functions.
GradientMultivariateOptimizer(ConvergenceChecker<PointValuePair>) - 类的构造器 org.hipparchus.optim.nonlinear.scalar.GradientMultivariateOptimizer
Simple constructor.
GradientTest - org.hipparchus.analysis.differentiation中的类
Test for class UnivariateDerivative.
GradientTest() - 类的构造器 org.hipparchus.analysis.differentiation.GradientTest
 
GraggBulirschStoerIntegrator - org.hipparchus.ode.nonstiff中的类
This class implements a Gragg-Bulirsch-Stoer integrator for Ordinary Differential Equations.
GraggBulirschStoerIntegrator(double, double, double[], double[]) - 类的构造器 org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegrator
Simple constructor.
GraggBulirschStoerIntegrator(double, double, double, double) - 类的构造器 org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegrator
Simple constructor.
GraggBulirschStoerIntegratorTest - org.hipparchus.ode.nonstiff中的类
 
GraggBulirschStoerIntegratorTest() - 类的构造器 org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegratorTest
 
GraggBulirschStoerIntegratorTest.VariableStepHandler - org.hipparchus.ode.nonstiff中的类
 
GraggBulirschStoerStateInterpolatorTest - org.hipparchus.ode.nonstiff中的类
 
GraggBulirschStoerStateInterpolatorTest() - 类的构造器 org.hipparchus.ode.nonstiff.GraggBulirschStoerStateInterpolatorTest
 
GREATER_THAN - 枚举类 中的枚举常量 org.hipparchus.stat.inference.AlternativeHypothesis
Represents a right-sided test.
greaterThan(Dfp) - 类中的方法 org.hipparchus.dfp.Dfp
Check if instance is greater than x.
GridAxis - org.hipparchus.analysis.interpolation中的类
Helper for finding interpolation nodes along one axis of grid data.
GridAxis(double[], int) - 类的构造器 org.hipparchus.analysis.interpolation.GridAxis
Simple constructor.
GridAxisTest - org.hipparchus.analysis.interpolation中的类
 
GridAxisTest() - 类的构造器 org.hipparchus.analysis.interpolation.GridAxisTest
 
gTest(double[], long[]) - 类中的方法 org.hipparchus.stat.inference.GTest
Returns the observed significance level, or p-value, associated with a G-Test for goodness of fit comparing the observed frequency counts to those in the expected array.
gTest(double[], long[]) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
Returns the observed significance level, or p-value, associated with a G-Test for goodness of fit comparing the observed frequency counts to those in the expected array.
gTest(double[], long[], double) - 类中的方法 org.hipparchus.stat.inference.GTest
Performs a G-Test (Log-Likelihood Ratio Test) for goodness of fit evaluating the null hypothesis that the observed counts conform to the frequency distribution described by the expected counts, with significance level alpha.
gTest(double[], long[], double) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
Performs a G-Test (Log-Likelihood Ratio Test) for goodness of fit evaluating the null hypothesis that the observed counts conform to the frequency distribution described by the expected counts, with significance level alpha.
GTest - org.hipparchus.stat.inference中的类
Implements G Test statistics.
GTest() - 类的构造器 org.hipparchus.stat.inference.GTest
Empty constructor.
gTestDataSetsComparison(long[], long[]) - 类中的方法 org.hipparchus.stat.inference.GTest
Returns the observed significance level, or p-value, associated with a G-Value (Log-Likelihood Ratio) for two sample test comparing bin frequency counts in observed1 and observed2.
gTestDataSetsComparison(long[], long[]) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
Returns the observed significance level, or p-value, associated with a G-Value (Log-Likelihood Ratio) for two sample test comparing bin frequency counts in observed1 and observed2.
gTestDataSetsComparison(long[], long[], double) - 类中的方法 org.hipparchus.stat.inference.GTest
Performs a G-Test (Log-Likelihood Ratio Test) comparing two binned data sets.
gTestDataSetsComparison(long[], long[], double) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
Performs a G-Test (Log-Likelihood Ratio Test) comparing two binned data sets.
gTestIntrinsic(double[], long[]) - 类中的方法 org.hipparchus.stat.inference.GTest
Returns the intrinsic (Hardy-Weinberg proportions) p-Value, as described in p64-69 of McDonald, J.H. 2009.
gTestIntrinsic(double[], long[]) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
Returns the intrinsic (Hardy-Weinberg proportions) p-Value, as described in p64-69 of McDonald, J.H. 2009.
GTestTest - org.hipparchus.stat.inference中的类
Test cases for the GTest class.
GTestTest() - 类的构造器 org.hipparchus.stat.inference.GTestTest
 
guess() - 类中的方法 org.hipparchus.fitting.GaussianCurveFitter.ParameterGuesser
Gets an estimation of the parameters.
guess() - 类中的方法 org.hipparchus.fitting.HarmonicCurveFitter.ParameterGuesser
Gets an estimation of the parameters.
GumbelDistribution - org.hipparchus.distribution.continuous中的类
This class implements the Gumbel distribution.
GumbelDistribution(double, double) - 类的构造器 org.hipparchus.distribution.continuous.GumbelDistribution
Build a new instance.
GumbelDistributionTest - org.hipparchus.distribution.continuous中的类
Test cases for GumbelDistribution.
GumbelDistributionTest() - 类的构造器 org.hipparchus.distribution.continuous.GumbelDistributionTest
 
A B C D E F G H I J K L M N O P Q R S T U V W X Y Z 
常量字段值|所有程序包|所有类和接口|序列化表格