索引

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 
常量字段值|所有程序包|所有类和接口|序列化表格

P

paintComponent(Graphics) - 类中的方法 org.hipparchus.samples.ClusterAlgorithmComparison.ClusterPlot
 
paintComponent(Graphics) - 类中的方法 org.hipparchus.samples.LowDiscrepancyGeneratorComparison.Plot
paintConvexHull() - 类中的方法 org.hipparchus.samples.geometry.GeometryExample.Display
Paint a convex hull.
Pair<K,V> - org.hipparchus.util中的类
Generic pair.
Pair(K, V) - 类的构造器 org.hipparchus.util.Pair
Create an entry representing a mapping from the specified key to the specified value.
Pair(Pair<? extends K, ? extends V>) - 类的构造器 org.hipparchus.util.Pair
Create an entry representing the same mapping as the specified entry.
pairedT(double[], double[]) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
Computes a paired, 2-sample t-statistic based on the data in the input arrays.
pairedT(double[], double[]) - 类中的方法 org.hipparchus.stat.inference.TTest
Computes a paired, 2-sample t-statistic based on the data in the input arrays.
pairedTTest(double[], double[]) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
Returns the observed significance level, or p-value, associated with a paired, two-sample, two-tailed t-test based on the data in the input arrays.
pairedTTest(double[], double[]) - 类中的方法 org.hipparchus.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a paired, two-sample, two-tailed t-test based on the data in the input arrays.
pairedTTest(double[], double[], double) - 类中的静态方法 org.hipparchus.stat.inference.InferenceTestUtils
Performs a paired t-test evaluating the null hypothesis that the mean of the paired differences between sample1 and sample2 is 0 in favor of the two-sided alternative that the mean paired difference is not equal to 0, with significance level alpha.
pairedTTest(double[], double[], double) - 类中的方法 org.hipparchus.stat.inference.TTest
Performs a paired t-test evaluating the null hypothesis that the mean of the paired differences between sample1 and sample2 is 0 in favor of the two-sided alternative that the mean paired difference is not equal to 0, with significance level alpha.
PairTest - org.hipparchus.util中的类
Test for Pair.
PairTest() - 类的构造器 org.hipparchus.util.PairTest
 
ParameterConfiguration - org.hipparchus.ode中的类
Simple container pairing a parameter name with a step in order to compute the associated Jacobian matrix by finite difference.
ParameterGuesser(Collection<WeightedObservedPoint>) - 类的构造器 org.hipparchus.fitting.GaussianCurveFitter.ParameterGuesser
Constructs instance with the specified observed points.
ParameterGuesser(Collection<WeightedObservedPoint>) - 类的构造器 org.hipparchus.fitting.HarmonicCurveFitter.ParameterGuesser
Simple constructor.
Parameterizable - org.hipparchus.ode中的接口
This interface enables to process any parameterizable object.
ParameterJacobianProvider - org.hipparchus.migration.ode中的接口
已过时。
as of 1.0, replaced with NamedParameterJacobianProvider
ParametersController - org.hipparchus.ode中的接口
Interface to compute by finite difference Jacobian matrix for some parameter when computing partial derivatives equations.
parameterValidator(ParameterValidator) - 类中的方法 org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
Configure the validator of the model parameters.
ParameterValidator - org.hipparchus.optim.nonlinear.vector.leastsquares中的接口
Interface for validating a set of model parameters.
Parametric() - 类的构造器 org.hipparchus.analysis.function.Gaussian.Parametric
Empty constructor.
Parametric() - 类的构造器 org.hipparchus.analysis.function.HarmonicOscillator.Parametric
Empty constructor.
Parametric() - 类的构造器 org.hipparchus.analysis.function.Logistic.Parametric
Empty constructor.
Parametric() - 类的构造器 org.hipparchus.analysis.function.Logit.Parametric
Empty constructor.
Parametric() - 类的构造器 org.hipparchus.analysis.function.Sigmoid.Parametric
Empty constructor.
Parametric() - 类的构造器 org.hipparchus.analysis.polynomials.PolynomialFunction.Parametric
Empty constructor.
ParametricUnivariateFunction - org.hipparchus.analysis中的接口
An interface representing a real function that depends on one independent variable plus some extra parameters.
ParetoDistribution - org.hipparchus.distribution.continuous中的类
Implementation of the Pareto distribution.
ParetoDistribution() - 类的构造器 org.hipparchus.distribution.continuous.ParetoDistribution
Create a Pareto distribution with a scale of 1 and a shape of 1.
ParetoDistribution(double, double) - 类的构造器 org.hipparchus.distribution.continuous.ParetoDistribution
Create a Pareto distribution using the specified scale and shape.
ParetoDistribution(double, double, double) - 类的构造器 org.hipparchus.distribution.continuous.ParetoDistribution
Creates a Pareto distribution.
ParetoDistributionTest - org.hipparchus.distribution.continuous中的类
Test cases for ParetoDistribution.
ParetoDistributionTest() - 类的构造器 org.hipparchus.distribution.continuous.ParetoDistributionTest
 
parse(String) - 类中的方法 org.hipparchus.complex.ComplexFormat
Parses a string to produce a Complex object.
parse(String) - 类中的方法 org.hipparchus.fraction.BigFractionFormat
Parses a string to produce a BigFraction object.
parse(String) - 类中的方法 org.hipparchus.fraction.FractionFormat
Parses a string to produce a Fraction object.
parse(String) - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1DFormat
Parses a string to produce a Vector object.
parse(String) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3DFormat
Parses a string to produce a Vector3D object.
parse(String) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2DFormat
Parses a string to produce a Vector object.
parse(String) - 类中的方法 org.hipparchus.geometry.VectorFormat
Parses a string to produce a Vector object.
parse(String) - 类中的方法 org.hipparchus.linear.RealMatrixFormat
Parse a string to produce a RealMatrix object.
parse(String) - 类中的方法 org.hipparchus.linear.RealVectorFormat
Parse a string to produce a RealVector object.
parse(String, ParsePosition) - 类中的方法 org.hipparchus.complex.ComplexFormat
Parses a string to produce a Complex object.
parse(String, ParsePosition) - 类中的方法 org.hipparchus.fraction.BigFractionFormat
Parses a string to produce a BigFraction object.
parse(String, ParsePosition) - 类中的方法 org.hipparchus.fraction.FractionFormat
Parses a string to produce a Fraction object.
parse(String, ParsePosition) - 类中的方法 org.hipparchus.fraction.ProperBigFractionFormat
Parses a string to produce a BigFraction object.
parse(String, ParsePosition) - 类中的方法 org.hipparchus.fraction.ProperFractionFormat
Parses a string to produce a Fraction object.
parse(String, ParsePosition) - 类中的方法 org.hipparchus.geometry.euclidean.oned.Vector1DFormat
Parses a string to produce a Vector object.
parse(String, ParsePosition) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Vector3DFormat
Parses a string to produce a Vector3D object.
parse(String, ParsePosition) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Vector2DFormat
Parses a string to produce a Vector object.
parse(String, ParsePosition) - 类中的方法 org.hipparchus.geometry.VectorFormat
Parses a string to produce a Vector object.
parse(String, ParsePosition) - 类中的方法 org.hipparchus.linear.RealMatrixFormat
Parse a string to produce a RealMatrix object.
parse(String, ParsePosition) - 类中的方法 org.hipparchus.linear.RealVectorFormat
Parse a string to produce a RealVector object.
parseAndIgnoreWhitespace(String, ParsePosition) - 类中的静态方法 org.hipparchus.fraction.BigFractionFormat
Parses source until a non-whitespace character is found.
parseAndIgnoreWhitespace(String, ParsePosition) - 类中的静态方法 org.hipparchus.fraction.FractionFormat
Parses source until a non-whitespace character is found.
parseAndIgnoreWhitespace(String, ParsePosition) - 类中的静态方法 org.hipparchus.fraction.ProperBigFractionFormat
Parses source until a non-whitespace character is found.
parseAndIgnoreWhitespace(String, ParsePosition) - 类中的静态方法 org.hipparchus.fraction.ProperFractionFormat
Parses source until a non-whitespace character is found.
parseAndIgnoreWhitespace(String, ParsePosition) - 类中的静态方法 org.hipparchus.util.CompositeFormat
Parses source until a non-whitespace character is found.
parseArcsSet(String) - 类中的静态方法 org.hipparchus.geometry.partitioning.RegionParser
Parse a string representation of an ArcsSet.
parseCoordinates(int, String, ParsePosition) - 类中的方法 org.hipparchus.geometry.VectorFormat
Parses a string to produce an array of coordinates.
parseFixedstring(String, String, ParsePosition) - 类中的静态方法 org.hipparchus.util.CompositeFormat
Parse source for an expected fixed string.
parseIntervalsSet(String) - 类中的静态方法 org.hipparchus.geometry.partitioning.RegionParser
Parse a string representation of an IntervalsSet.
parseNextBigInteger(String, ParsePosition) - 类中的方法 org.hipparchus.fraction.BigFractionFormat
Parses a string to produce a BigInteger.
parseNextCharacter(String, ParsePosition) - 类中的静态方法 org.hipparchus.fraction.BigFractionFormat
Parses source until a non-whitespace character is found.
parseNextCharacter(String, ParsePosition) - 类中的静态方法 org.hipparchus.fraction.FractionFormat
Parses source until a non-whitespace character is found.
parseNextCharacter(String, ParsePosition) - 类中的静态方法 org.hipparchus.fraction.ProperBigFractionFormat
Parses source until a non-whitespace character is found.
parseNextCharacter(String, ParsePosition) - 类中的静态方法 org.hipparchus.fraction.ProperFractionFormat
Parses source until a non-whitespace character is found.
parseNextCharacter(String, ParsePosition) - 类中的静态方法 org.hipparchus.util.CompositeFormat
Parses source until a non-whitespace character is found.
parseNumber(String, NumberFormat, ParsePosition) - 类中的静态方法 org.hipparchus.util.CompositeFormat
Parses source for a number.
parseOptimizationData(OptimizationData...) - 类中的方法 org.hipparchus.optim.BaseMultivariateOptimizer
Scans the list of (required and optional) optimization data that characterize the problem.
parseOptimizationData(OptimizationData...) - 类中的方法 org.hipparchus.optim.BaseOptimizer
Scans the list of (required and optional) optimization data that characterize the problem.
parseOptimizationData(OptimizationData...) - 类中的方法 org.hipparchus.optim.linear.LinearOptimizer
Scans the list of (required and optional) optimization data that characterize the problem.
parseOptimizationData(OptimizationData...) - 类中的方法 org.hipparchus.optim.linear.SimplexSolver
Scans the list of (required and optional) optimization data that characterize the problem.
parseOptimizationData(OptimizationData...) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
Scans the list of (required and optional) optimization data that characterize the problem.
parseOptimizationData(OptimizationData...) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.GradientMultivariateOptimizer
Scans the list of (required and optional) optimization data that characterize the problem.
parseOptimizationData(OptimizationData...) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.MultivariateOptimizer
Scans the list of (required and optional) optimization data that characterize the problem.
parseOptimizationData(OptimizationData...) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
Scans the list of (required and optional) optimization data that characterize the problem.
parseOptimizationData(OptimizationData...) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.noderiv.SimplexOptimizer
Scans the list of (required and optional) optimization data that characterize the problem.
parseOptimizationData(OptimizationData...) - 类中的方法 org.hipparchus.optim.univariate.UnivariateOptimizer
Scans the list of (required and optional) optimization data that characterize the problem.
parsePolygonsSet(String) - 类中的静态方法 org.hipparchus.geometry.partitioning.RegionParser
Parse a string representation of a PolygonsSet.
parsePolyhedronsSet(String) - 类中的静态方法 org.hipparchus.geometry.partitioning.RegionParser
Parse a string representation of a PolyhedronsSet.
parseSphericalPolygonsSet(String) - 类中的静态方法 org.hipparchus.geometry.partitioning.RegionParser
Parse a string representation of a SphericalPolygonsSet.
partialerror(double[], double) - 类中的方法 org.hipparchus.analysis.interpolation.DividedDifferenceInterpolatorTest
Returns the partial error term (z-x[0])(z-x[1])...
partialerror(double[], double) - 类中的方法 org.hipparchus.analysis.interpolation.NevilleInterpolatorTest
Returns the partial error term (z-x[0])(z-x[1])...
partitions(List<T>) - 类中的静态方法 org.hipparchus.util.CombinatoricsUtils
Generate a stream of partitions of a list.
PascalDistribution - org.hipparchus.distribution.discrete中的类
Implementation of the Pascal distribution.
PascalDistribution(int, double) - 类的构造器 org.hipparchus.distribution.discrete.PascalDistribution
Create a Pascal distribution with the given number of successes and probability of success.
PascalDistributionTest - org.hipparchus.distribution.discrete中的类
Test cases for PascalDistribution.
PascalDistributionTest() - 类的构造器 org.hipparchus.distribution.discrete.PascalDistributionTest
 
PCA - org.hipparchus.stat.projection中的类
Principal component analysis (PCA) is a statistical technique for reducing the dimensionality of a dataset.
PCA(int) - 类的构造器 org.hipparchus.stat.projection.PCA
A default PCA will center but not scale.
PCA(int, boolean, boolean) - 类的构造器 org.hipparchus.stat.projection.PCA
Create a PCA with the ability to adjust scaling parameters.
PCATest - org.hipparchus.stat.projection中的类
 
PCATest() - 类的构造器 org.hipparchus.stat.projection.PCATest
 
PearsonsCorrelation - org.hipparchus.stat.correlation中的类
Computes Pearson's product-moment correlation coefficients for pairs of arrays or columns of a matrix.
PearsonsCorrelation() - 类的构造器 org.hipparchus.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation instance without data.
PearsonsCorrelation(double[][]) - 类的构造器 org.hipparchus.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a rectangular array whose columns represent values of variables to be correlated.
PearsonsCorrelation(RealMatrix) - 类的构造器 org.hipparchus.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a RealMatrix whose columns represent variables to be correlated.
PearsonsCorrelation(RealMatrix, int) - 类的构造器 org.hipparchus.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a covariance matrix.
PearsonsCorrelation(Covariance) - 类的构造器 org.hipparchus.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a Covariance.
PearsonsCorrelationTest - org.hipparchus.stat.correlation中的类
 
PearsonsCorrelationTest() - 类的构造器 org.hipparchus.stat.correlation.PearsonsCorrelationTest
 
PEGASUS - 枚举类 中的枚举常量 org.hipparchus.analysis.solvers.BaseSecantSolver.Method
The Pegasus method.
PegasusSolver - org.hipparchus.analysis.solvers中的类
Implements the Pegasus method for root-finding (approximating a zero of a univariate real function).
PegasusSolver() - 类的构造器 org.hipparchus.analysis.solvers.PegasusSolver
Construct a solver with default accuracy (1e-6).
PegasusSolver(double) - 类的构造器 org.hipparchus.analysis.solvers.PegasusSolver
Construct a solver.
PegasusSolver(double, double) - 类的构造器 org.hipparchus.analysis.solvers.PegasusSolver
Construct a solver.
PegasusSolver(double, double, double) - 类的构造器 org.hipparchus.analysis.solvers.PegasusSolver
Construct a solver.
PegasusSolverTest - org.hipparchus.analysis.solvers中的类
Test case for Pegasus solver.
PegasusSolverTest() - 类的构造器 org.hipparchus.analysis.solvers.PegasusSolverTest
 
pelzGood(double, int) - 类中的方法 org.hipparchus.stat.inference.KolmogorovSmirnovTest
Computes the Pelz-Good approximation for \(P(D_n < d)\) as described in [2] in the class javadoc.
percentageValue() - 类中的方法 org.hipparchus.fraction.BigFraction
Gets the fraction percentage as a double.
percentageValue() - 类中的方法 org.hipparchus.fraction.Fraction
Gets the fraction percentage as a double.
percentile(double[], double) - 类中的静态方法 org.hipparchus.stat.StatUtils
Returns an estimate of the pth percentile of the values in the values array.
percentile(double[], int, int, double) - 类中的静态方法 org.hipparchus.stat.StatUtils
Returns an estimate of the pth percentile of the values in the values array, starting with the element in (0-based) position begin in the array and including length values.
Percentile - org.hipparchus.stat.descriptive.rank中的类
Provides percentile computation.
Percentile() - 类的构造器 org.hipparchus.stat.descriptive.rank.Percentile
Constructs a Percentile with the following defaults.
Percentile(double) - 类的构造器 org.hipparchus.stat.descriptive.rank.Percentile
Constructs a Percentile with the specific quantile value and the following default method type: Percentile.EstimationType.LEGACY default NaN strategy: NaNStrategy.REMOVED a Kth Selector : KthSelector
Percentile(double, Percentile.EstimationType, NaNStrategy, KthSelector) - 类的构造器 org.hipparchus.stat.descriptive.rank.Percentile
Constructs a Percentile with the specific quantile value, Percentile.EstimationType, NaNStrategy and KthSelector.
Percentile(Percentile) - 类的构造器 org.hipparchus.stat.descriptive.rank.Percentile
Copy constructor, creates a new Percentile identical to the original
Percentile.EstimationType - org.hipparchus.stat.descriptive.rank中的枚举类
An enum for various estimation strategies of a percentile referred in wikipedia on quantile with the names of enum matching those of types mentioned in wikipedia.
percentile5 - 类中的变量 org.hipparchus.stat.descriptive.rank.PSquarePercentileTest
 
percentile5 - 类中的变量 org.hipparchus.stat.descriptive.UnivariateStatisticAbstractTest
 
percentile95 - 类中的变量 org.hipparchus.stat.descriptive.rank.PSquarePercentileTest
 
percentile95 - 类中的变量 org.hipparchus.stat.descriptive.UnivariateStatisticAbstractTest
 
percentiles(double, RandomGenerator) - 类中的方法 org.hipparchus.stat.descriptive.StreamingStatistics.StreamingStatisticsBuilder
Sets the computePercentiles setting of the factory.
PercentileTest - org.hipparchus.stat.descriptive.rank中的类
Test cases for the Percentile class.
PercentileTest() - 类的构造器 org.hipparchus.stat.descriptive.rank.PercentileTest
 
performHouseholderReflection(int, double[][]) - 类中的方法 org.hipparchus.linear.QRDecomposition
Perform Householder reflection for a minor A(minor, minor) of A.
performHouseholderReflection(int, double[][]) - 类中的方法 org.hipparchus.linear.RRQRDecomposition
Perform Householder reflection for a minor A(minor, minor) of A.
performHouseholderReflection(int, T[][]) - 类中的方法 org.hipparchus.linear.FieldQRDecomposition
Perform Householder reflection for a minor A(minor, minor) of A.
PERMUTATION_EXCEEDS_N - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
PERMUTATION_EXCEEDS_N.
PERMUTATION_EXCEEDS_N - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
已过时。
PERMUTATION_EXCEEDS_N.
PERMUTATION_SIZE - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
PERMUTATION_SIZE.
PERMUTATION_SIZE - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
已过时。
PERMUTATION_SIZE.
permutations(List<T>) - 类中的静态方法 org.hipparchus.util.CombinatoricsUtils
Generate a stream of permutations of a list.
permuteRows(FieldMatrix<Fraction>, int[]) - 类中的方法 org.hipparchus.linear.Array2DRowFieldMatrixTest
Returns the result of applying the given row permutation to the matrix
permuteRows(RealMatrix, int[]) - 类中的方法 org.hipparchus.linear.Array2DRowRealMatrixTest
Returns the result of applying the given row permutation to the matrix
PG_SUM_RELATIVE_ERROR - 类中的静态变量 org.hipparchus.stat.inference.KolmogorovSmirnovTest
Convergence criterion for the sums in #pelzGood(double, double, int)}
Pi(Complex, Complex) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralComplexTest
 
Pi(Complex, Complex, Complex) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralComplexTest
 
Pi(FieldComplex<Binary64>, FieldComplex<Binary64>) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralFieldComplexTest
 
Pi(FieldComplex<Binary64>, FieldComplex<Binary64>, FieldComplex<Binary64>) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralFieldComplexTest
 
Pi(T, T) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralAbstractComplexTest
 
Pi(T, T, T) - 类中的方法 org.hipparchus.special.elliptic.legendre.LegendreEllipticIntegralAbstractComplexTest
 
PI - 类中的静态变量 org.hipparchus.analysis.differentiation.UnivariateDerivative1
The constant value of π as a UnivariateDerivative1.
PI - 类中的静态变量 org.hipparchus.analysis.differentiation.UnivariateDerivative2
The constant value of π as a UnivariateDerivative2.
PI - 类中的静态变量 org.hipparchus.complex.Complex
A complex number representing "π + 0.0i".
PI - 类中的静态变量 org.hipparchus.util.Binary64
The constant value of π as a Binary64.
PI - 类中的静态变量 org.hipparchus.util.FastMath
Archimede's constant PI, ratio of circle circumference to diameter.
PI_SQUARED - 类中的静态变量 org.hipparchus.util.MathUtils
\(\pi^2\)
PiecewiseBicubicSplineInterpolatingFunction - org.hipparchus.analysis.interpolation中的类
Function that implements the bicubic spline interpolation.
PiecewiseBicubicSplineInterpolatingFunction(double[], double[], double[][]) - 类的构造器 org.hipparchus.analysis.interpolation.PiecewiseBicubicSplineInterpolatingFunction
Simple constructor.
PiecewiseBicubicSplineInterpolatingFunctionTest - org.hipparchus.analysis.interpolation中的类
Test case for the piecewise bicubic function.
PiecewiseBicubicSplineInterpolatingFunctionTest() - 类的构造器 org.hipparchus.analysis.interpolation.PiecewiseBicubicSplineInterpolatingFunctionTest
 
PiecewiseBicubicSplineInterpolator - org.hipparchus.analysis.interpolation中的类
Generates a piecewise-bicubic interpolating function.
PiecewiseBicubicSplineInterpolator() - 类的构造器 org.hipparchus.analysis.interpolation.PiecewiseBicubicSplineInterpolator
Empty constructor.
PiecewiseBicubicSplineInterpolatorTest - org.hipparchus.analysis.interpolation中的类
Test case for the piecewise bicubic interpolator.
PiecewiseBicubicSplineInterpolatorTest() - 类的构造器 org.hipparchus.analysis.interpolation.PiecewiseBicubicSplineInterpolatorTest
 
pivotIndex(double[], int, int) - 枚举类中的方法 org.hipparchus.util.PivotingStrategy
Find pivot index of the array so that partition and Kth element selection can be made
PivotingStrategy - org.hipparchus.util中的枚举类
A strategy to pick a pivoting index of an array for doing partitioning.
PivotSelectionRule - org.hipparchus.optim.linear中的枚举类
Pivot selection rule to the use for a Simplex solver.
Plane - org.hipparchus.geometry.euclidean.threed中的类
The class represent planes in a three dimensional space.
Plane(Plane) - 类的构造器 org.hipparchus.geometry.euclidean.threed.Plane
Copy constructor.
Plane(Vector3D, double) - 类的构造器 org.hipparchus.geometry.euclidean.threed.Plane
Build a plane normal to a given direction and containing the origin.
Plane(Vector3D, Vector3D, double) - 类的构造器 org.hipparchus.geometry.euclidean.threed.Plane
Build a plane from a point and a normal.
Plane(Vector3D, Vector3D, Vector3D, double) - 类的构造器 org.hipparchus.geometry.euclidean.threed.Plane
Build a plane from three points.
PlaneTest - org.hipparchus.geometry.euclidean.threed中的类
 
PlaneTest() - 类的构造器 org.hipparchus.geometry.euclidean.threed.PlaneTest
 
plot() - 类中的方法 org.hipparchus.samples.complex.GnuplotComplexPlotter
Plot the function.
Plot(List<Vector2D>) - 类的构造器 org.hipparchus.samples.LowDiscrepancyGeneratorComparison.Plot
Simple constructor.
PLUS - 枚举类 中的枚举常量 org.hipparchus.geometry.partitioning.Side
Code for the plus side of the hyperplane.
PLUS_I - 类中的静态变量 org.hipparchus.geometry.euclidean.threed.Vector3D
First canonical vector (coordinates: 1, 0, 0).
PLUS_I - 类中的静态变量 org.hipparchus.geometry.euclidean.twod.Vector2D
First canonical vector (coordinates: 1, 0).
PLUS_I - 类中的静态变量 org.hipparchus.geometry.spherical.twod.S2Point
+I (coordinates: \( \theta = 0, \varphi = \pi/2 \)).
PLUS_J - 类中的静态变量 org.hipparchus.geometry.euclidean.threed.Vector3D
Second canonical vector (coordinates: 0, 1, 0).
PLUS_J - 类中的静态变量 org.hipparchus.geometry.euclidean.twod.Vector2D
Second canonical vector (coordinates: 0, 1).
PLUS_J - 类中的静态变量 org.hipparchus.geometry.spherical.twod.S2Point
+J (coordinates: \( \theta = \pi/2, \varphi = \pi/2 \))).
PLUS_K - 类中的静态变量 org.hipparchus.geometry.euclidean.threed.Vector3D
Third canonical vector (coordinates: 0, 0, 1).
PLUS_K - 类中的静态变量 org.hipparchus.geometry.spherical.twod.S2Point
+K (coordinates: \( \theta = any angle, \varphi = 0 \)).
PLUS_MINUS_SUB - 枚举类 中的枚举常量 org.hipparchus.geometry.partitioning.BSPTreeVisitor.Order
Indicator for visit order plus sub-tree, then minus sub-tree, and last cut sub-hyperplane.
PLUS_SUB_MINUS - 枚举类 中的枚举常量 org.hipparchus.geometry.partitioning.BSPTreeVisitor.Order
Indicator for visit order plus sub-tree, then cut sub-hyperplane, and last minus sub-tree.
PLUS_X - 类中的静态变量 org.hipparchus.util.Binary64Test
 
PLUS_X - 类中的静态变量 org.hipparchus.util.FieldTupleTest
 
PLUS_X - 类中的静态变量 org.hipparchus.util.TupleTest
 
PLUS_Y - 类中的静态变量 org.hipparchus.util.Binary64Test
 
PLUS_Y - 类中的静态变量 org.hipparchus.util.FieldTupleTest
 
PLUS_Y - 类中的静态变量 org.hipparchus.util.TupleTest
 
PLUS_ZERO - 类中的静态变量 org.hipparchus.util.Binary64Test
 
PLUS_ZERO - 类中的静态变量 org.hipparchus.util.FieldTupleTest
 
PLUS_ZERO - 类中的静态变量 org.hipparchus.util.TupleTest
 
PLYParser - org.hipparchus.geometry.euclidean.threed中的类
This class is a small and incomplete parser for PLY files.
PLYParser(InputStream) - 类的构造器 org.hipparchus.geometry.euclidean.threed.PLYParser
Simple constructor.
Point<S> - org.hipparchus.geometry中的接口
This interface represents a generic geometrical point.
pointAt(double) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldLine
Get one point from the line.
pointAt(double) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Line
Get one point from the line.
pointAt(T) - 类中的方法 org.hipparchus.geometry.euclidean.threed.FieldLine
Get one point from the line.
PointValuePair - org.hipparchus.optim中的类
This class holds a point and the value of an objective function at that point.
PointValuePair(double[], double) - 类的构造器 org.hipparchus.optim.PointValuePair
Builds a point/objective function value pair.
PointValuePair(double[], double, boolean) - 类的构造器 org.hipparchus.optim.PointValuePair
Builds a point/objective function value pair.
PointValuePairTest - org.hipparchus.optim中的类
 
PointValuePairTest() - 类的构造器 org.hipparchus.optim.PointValuePairTest
 
PointVectorValuePair - org.hipparchus.optim中的类
This class holds a point and the vectorial value of an objective function at that point.
PointVectorValuePair(double[], double[]) - 类的构造器 org.hipparchus.optim.PointVectorValuePair
Builds a point/objective function value pair.
PointVectorValuePair(double[], double[], boolean) - 类的构造器 org.hipparchus.optim.PointVectorValuePair
Build a point/objective function value pair.
PointVectorValuePairTest - org.hipparchus.optim中的类
 
PointVectorValuePairTest() - 类的构造器 org.hipparchus.optim.PointVectorValuePairTest
 
PoissonDistribution - org.hipparchus.distribution.discrete中的类
Implementation of the Poisson distribution.
PoissonDistribution(double) - 类的构造器 org.hipparchus.distribution.discrete.PoissonDistribution
Creates a new Poisson distribution with specified mean.
PoissonDistribution(double, double) - 类的构造器 org.hipparchus.distribution.discrete.PoissonDistribution
Creates a new Poisson distribution with the specified mean and convergence criterion.
PoissonDistribution(double, double, int) - 类的构造器 org.hipparchus.distribution.discrete.PoissonDistribution
Creates a new Poisson distribution with specified mean, convergence criterion and maximum number of iterations.
PoissonDistribution(double, int) - 类的构造器 org.hipparchus.distribution.discrete.PoissonDistribution
Creates a new Poisson distribution with the specified mean and maximum number of iterations.
PoissonDistributionTest - org.hipparchus.distribution.discrete中的类
PoissonDistributionTest
PoissonDistributionTest() - 类的构造器 org.hipparchus.distribution.discrete.PoissonDistributionTest
Constructor.
POLAK_RIBIERE - 枚举类 中的枚举常量 org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.Formula
Polak-Ribière formula.
polar2Complex(double, double) - 类中的静态方法 org.hipparchus.complex.ComplexUtils
Creates a complex number from the given polar representation.
polar2Complex(T, T) - 类中的静态方法 org.hipparchus.complex.ComplexUtils
Creates a complex number from the given polar representation.
PolygonsSet - org.hipparchus.geometry.euclidean.twod中的类
This class represents a 2D region: a set of polygons.
PolygonsSet(double) - 类的构造器 org.hipparchus.geometry.euclidean.twod.PolygonsSet
Build a polygons set representing the whole plane.
PolygonsSet(double, double, double, double, double) - 类的构造器 org.hipparchus.geometry.euclidean.twod.PolygonsSet
Build a parallellepipedic box.
PolygonsSet(double, Vector2D...) - 类的构造器 org.hipparchus.geometry.euclidean.twod.PolygonsSet
Build a polygon from a simple list of vertices.
PolygonsSet(Collection<SubHyperplane<Euclidean2D>>, double) - 类的构造器 org.hipparchus.geometry.euclidean.twod.PolygonsSet
Build a polygons set from a Boundary REPresentation (B-rep).
PolygonsSet(BSPTree<Euclidean2D>, double) - 类的构造器 org.hipparchus.geometry.euclidean.twod.PolygonsSet
Build a polygons set from a BSP tree.
PolygonsSetTest - org.hipparchus.geometry.euclidean.twod中的类
 
PolygonsSetTest() - 类的构造器 org.hipparchus.geometry.euclidean.twod.PolygonsSetTest
 
PolyhedronsSet - org.hipparchus.geometry.euclidean.threed中的类
This class represents a 3D region: a set of polyhedrons.
PolyhedronsSet(double) - 类的构造器 org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
Build a polyhedrons set representing the whole real line.
PolyhedronsSet(double, double, double, double, double, double, double) - 类的构造器 org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
Build a parallellepipedic box.
PolyhedronsSet(Collection<SubHyperplane<Euclidean3D>>, double) - 类的构造器 org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
Build a polyhedrons set from a Boundary REPresentation (B-rep) specified by sub-hyperplanes.
PolyhedronsSet(List<Vector3D>, List<int[]>, double) - 类的构造器 org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
Build a polyhedrons set from a Boundary REPresentation (B-rep) specified by connected vertices.
PolyhedronsSet(PolyhedronsSet.BRep, double) - 类的构造器 org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
Build a polyhedrons set from a Boundary REPresentation (B-rep) specified by connected vertices.
PolyhedronsSet(BSPTree<Euclidean3D>, double) - 类的构造器 org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
Build a polyhedrons set from a BSP tree.
PolyhedronsSet.BRep - org.hipparchus.geometry.euclidean.threed中的类
Container for Boundary REPresentation (B-Rep).
PolyhedronsSetTest - org.hipparchus.geometry.euclidean.threed中的类
 
PolyhedronsSetTest() - 类的构造器 org.hipparchus.geometry.euclidean.threed.PolyhedronsSetTest
 
polynomial() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegratorTest
 
polynomial() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsBashforthIntegratorTest
 
polynomial() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsFieldIntegratorAbstractTest
 
polynomial() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsIntegratorAbstractTest
 
polynomial() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegratorTest
 
polynomial() - 类中的方法 org.hipparchus.ode.nonstiff.AdamsMoultonIntegratorTest
 
POLYNOMIAL - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
POLYNOMIAL.
POLYNOMIAL - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
已过时。
POLYNOMIAL.
POLYNOMIAL_INTERPOLANTS_MISMATCH_SEGMENTS - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
已过时。
POLYNOMIAL_INTERPOLANTS_MISMATCH_SEGMENTS.
POLYNOMIAL_INTERPOLANTS_MISMATCH_SEGMENTS - 枚举类 中的枚举常量 org.hipparchus.migration.LocalizedMigrationFormats
已过时。
POLYNOMIAL_INTERPOLANTS_MISMATCH_SEGMENTS.
PolynomialCurveFitter - org.hipparchus.fitting中的类
Fits points to a polynomial function.
PolynomialCurveFitterTest - org.hipparchus.fitting中的类
Test for class PolynomialCurveFitter.
PolynomialCurveFitterTest() - 类的构造器 org.hipparchus.fitting.PolynomialCurveFitterTest
 
polynomialDerivative() - 类中的方法 org.hipparchus.analysis.polynomials.FieldPolynomialFunction
Returns the derivative as a FieldPolynomialFunction.
polynomialDerivative() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialFunction
Returns the derivative as a PolynomialFunction.
PolynomialFunction - org.hipparchus.analysis.polynomials中的类
Immutable representation of a real polynomial function with real coefficients.
PolynomialFunction(double[]) - 类的构造器 org.hipparchus.analysis.polynomials.PolynomialFunction
Construct a polynomial with the given coefficients.
PolynomialFunction.Parametric - org.hipparchus.analysis.polynomials中的类
Dedicated parametric polynomial class.
PolynomialFunctionLagrangeForm - org.hipparchus.analysis.polynomials中的类
Implements the representation of a real polynomial function in Lagrange Form.
PolynomialFunctionLagrangeForm(double[], double[]) - 类的构造器 org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
Construct a Lagrange polynomial with the given abscissas and function values.
PolynomialFunctionLagrangeFormTest - org.hipparchus.analysis.polynomials中的类
Test case for Lagrange form of polynomial function.
PolynomialFunctionLagrangeFormTest() - 类的构造器 org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeFormTest
 
PolynomialFunctionNewtonForm - org.hipparchus.analysis.polynomials中的类
Implements the representation of a real polynomial function in Newton Form.
PolynomialFunctionNewtonForm(double[], double[]) - 类的构造器 org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
Construct a Newton polynomial with the given a[] and c[].
PolynomialFunctionNewtonFormTest - org.hipparchus.analysis.polynomials中的类
Test case for Newton form of polynomial function.
PolynomialFunctionNewtonFormTest() - 类的构造器 org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonFormTest
 
PolynomialFunctionTest - org.hipparchus.analysis.polynomials中的类
Tests the PolynomialFunction implementation of a UnivariateFunction.
PolynomialFunctionTest() - 类的构造器 org.hipparchus.analysis.polynomials.PolynomialFunctionTest
 
polynomials - 类中的变量 org.hipparchus.analysis.polynomials.PolynomialSplineFunctionTest
Quadratic polynomials used in tests: x^2 + x [-1, 0) x^2 + x + 2 [0, 1) x^2 + x + 4 [1, 2) Defined so that evaluation using PolynomialSplineFunction evaluation algorithm agrees at knot point boundaries.
PolynomialSolver - org.hipparchus.analysis.solvers中的接口
Interface for (polynomial) root-finding algorithms.
polynomialSplineDerivative() - 类中的方法 org.hipparchus.analysis.polynomials.FieldPolynomialSplineFunction
Get the derivative of the polynomial spline function.
polynomialSplineDerivative() - 类中的方法 org.hipparchus.analysis.polynomials.PolynomialSplineFunction
Get the derivative of the polynomial spline function.
PolynomialSplineFunction - org.hipparchus.analysis.polynomials中的类
Represents a polynomial spline function.
PolynomialSplineFunction(double[], PolynomialFunction[]) - 类的构造器 org.hipparchus.analysis.polynomials.PolynomialSplineFunction
Construct a polynomial spline function with the given segment delimiters and interpolating polynomials.
PolynomialSplineFunctionTest - org.hipparchus.analysis.polynomials中的类
Tests the PolynomialSplineFunction implementation.
PolynomialSplineFunctionTest() - 类的构造器 org.hipparchus.analysis.polynomials.PolynomialSplineFunctionTest
 
PolynomialsUtils - org.hipparchus.analysis.polynomials中的类
A collection of static methods that operate on or return polynomials.
PolynomialsUtilsTest - org.hipparchus.analysis.polynomials中的类
Tests the PolynomialsUtils class.
PolynomialsUtilsTest() - 类的构造器 org.hipparchus.analysis.polynomials.PolynomialsUtilsTest
 
POPULATION_SIZE - 枚举类 中的枚举常量 org.hipparchus.exception.LocalizedCoreFormats
POPULATION_SIZE.
POPULATION_SIZE - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
已过时。
POPULATION_SIZE.
PopulationSize(int) - 类的构造器 org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer.PopulationSize
Simple constructor.
populationStandardDeviation(double[]) - 类中的方法 org.hipparchus.stat.descriptive.moment.StandardDeviationTest
Definitional formula for population standard deviation
populationVariance(double[]) - 类中的方法 org.hipparchus.stat.descriptive.moment.VarianceTest
Definitional formula for population variance
populationVariance(double...) - 类中的静态方法 org.hipparchus.stat.StatUtils
Returns the population variance of the entries in the input array, or Double.NaN if the array is empty.
populationVariance(double[], double) - 类中的静态方法 org.hipparchus.stat.StatUtils
Returns the population variance of the entries in the input array, using the precomputed mean value.
populationVariance(double[], double, int, int) - 类中的静态方法 org.hipparchus.stat.StatUtils
Returns the population variance of the entries in the specified portion of the input array, using the precomputed mean value.
populationVariance(double[], int, int) - 类中的静态方法 org.hipparchus.stat.StatUtils
Returns the population variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
POSITIVE_INFINITY - 类中的静态变量 org.hipparchus.geometry.euclidean.oned.Vector1D
A vector with all coordinates set to positive infinity.
POSITIVE_INFINITY - 类中的静态变量 org.hipparchus.geometry.euclidean.threed.Vector3D
A vector with all coordinates set to positive infinity.
POSITIVE_INFINITY - 类中的静态变量 org.hipparchus.geometry.euclidean.twod.Vector2D
A vector with all coordinates set to positive infinity.
POSITIVE_INFINITY - 类中的静态变量 org.hipparchus.util.Binary64
The constant value of Double.POSITIVE_INFINITY as a Binary64.
positiveOrNull() - 类中的方法 org.hipparchus.dfp.Dfp
Check if instance is greater than or equal to 0.
POSITIVITY_THRESHOLD - 类中的静态变量 org.hipparchus.linear.SemiDefinitePositiveCholeskyDecomposition
Default threshold below which elements are not considered positive.
pow(double) - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
Power operation.
pow(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
Power operation.
pow(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Power operation.
pow(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
Power operation.
pow(double) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Power operation.
pow(double) - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
Power operation.
pow(double) - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
Power operation.
pow(double) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
Power operation.
pow(double) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
Power operation.
pow(double) - 接口中的方法 org.hipparchus.CalculusFieldElement
Power operation.
pow(double) - 类中的方法 org.hipparchus.complex.Complex
Returns of value of this complex number raised to the power of x.
pow(double) - 类中的方法 org.hipparchus.complex.FieldComplex
Returns of value of this complex number raised to the power of x.
pow(double) - 类中的方法 org.hipparchus.dfp.Dfp
Power operation.
pow(double) - 类中的方法 org.hipparchus.fraction.BigFraction
Returns a double whose value is thisexponent, returning the result in reduced form.
pow(double) - 类中的方法 org.hipparchus.util.Binary64
Power operation.
pow(double) - 类中的方法 org.hipparchus.util.FieldTuple
Power operation.
pow(double) - 类中的方法 org.hipparchus.util.Tuple
Power operation.
pow(double[], int, double[], int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Compute power of a derivative structure.
pow(double[], int, double, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Compute power of a derivative structure.
pow(double[], int, int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Compute integer power of a derivative structure.
pow(double, double) - 类中的静态方法 org.hipparchus.util.FastMath
Power function.
pow(double, double[], int, double[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Compute power of a double to a derivative structure.
pow(double, int) - 类中的静态方法 org.hipparchus.util.FastMath
Raise a double to an int power.
pow(double, long) - 类中的静态方法 org.hipparchus.util.FastMath
Raise a double to a long power.
pow(double, DerivativeStructure) - 类中的静态方法 org.hipparchus.analysis.differentiation.DerivativeStructure
Compute ax where a is a double and x a DerivativeStructure
pow(double, FieldDerivativeStructure<T>) - 类中的静态方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
Compute ax where a is a double and x a FieldDerivativeStructure
pow(double, FieldGradient<T>) - 类中的静态方法 org.hipparchus.analysis.differentiation.FieldGradient
Compute ax where a is a double and x a FieldGradient
pow(double, FieldUnivariateDerivative1<T>) - 类中的静态方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
Compute ax where a is a double and x a FieldUnivariateDerivative1
pow(double, FieldUnivariateDerivative2<T>) - 类中的静态方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Compute ax where a is a double and x a FieldUnivariateDerivative2
pow(double, Gradient) - 类中的静态方法 org.hipparchus.analysis.differentiation.Gradient
Compute ax where a is a double and x a Gradient
pow(double, SparseGradient) - 类中的静态方法 org.hipparchus.analysis.differentiation.SparseGradient
Compute ax where a is a double and x a SparseGradient
pow(double, UnivariateDerivative1) - 类中的静态方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
Compute ax where a is a double and x a UnivariateDerivative1
pow(double, UnivariateDerivative2) - 类中的静态方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
Compute ax where a is a double and x a UnivariateDerivative2
pow(double, T[], int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Compute power of a double to a derivative structure.
pow(int) - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
Integer power operation.
pow(int) - 接口中的方法 org.hipparchus.CalculusFieldElement
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.complex.Complex
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.complex.FieldComplex
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.dfp.Dfp
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.fraction.BigFraction
Returns a BigFraction whose value is (this<sup>exponent</sup>), returning the result in reduced form.
pow(int) - 类中的方法 org.hipparchus.util.Binary64
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.util.FieldTuple
Integer power operation.
pow(int) - 类中的方法 org.hipparchus.util.Tuple
Integer power operation.
pow(int, int) - 类中的静态方法 org.hipparchus.util.ArithmeticUtils
Raise an int to an int power.
pow(long) - 类中的方法 org.hipparchus.fraction.BigFraction
Returns a BigFraction whose value is thisexponent, returning the result in reduced form.
pow(long, int) - 类中的静态方法 org.hipparchus.util.ArithmeticUtils
Raise a long to an int power.
pow(BigInteger) - 类中的方法 org.hipparchus.fraction.BigFraction
Returns a BigFraction whose value is thisexponent, returning the result in reduced form.
pow(BigInteger, int) - 类中的静态方法 org.hipparchus.util.ArithmeticUtils
Raise a BigInteger to an int power.
pow(BigInteger, long) - 类中的静态方法 org.hipparchus.util.ArithmeticUtils
Raise a BigInteger to a long power.
pow(BigInteger, BigInteger) - 类中的静态方法 org.hipparchus.util.ArithmeticUtils
Raise a BigInteger to a BigInteger power.
pow(DerivativeStructure) - 类中的方法 org.hipparchus.analysis.differentiation.DerivativeStructure
Power operation.
pow(FieldDerivativeStructure<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldDerivativeStructure
Power operation.
pow(FieldGradient<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldGradient
Power operation.
pow(FieldUnivariateDerivative1<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative1
Power operation.
pow(FieldUnivariateDerivative2<T>) - 类中的方法 org.hipparchus.analysis.differentiation.FieldUnivariateDerivative2
Power operation.
pow(Gradient) - 类中的方法 org.hipparchus.analysis.differentiation.Gradient
Power operation.
pow(SparseGradient) - 类中的方法 org.hipparchus.analysis.differentiation.SparseGradient
Power operation.
pow(UnivariateDerivative1) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative1
Power operation.
pow(UnivariateDerivative2) - 类中的方法 org.hipparchus.analysis.differentiation.UnivariateDerivative2
Power operation.
pow(Complex) - 类中的方法 org.hipparchus.complex.Complex
Returns of value of this complex number raised to the power of x.
pow(FieldComplex<T>) - 类中的方法 org.hipparchus.complex.FieldComplex
Returns of value of this complex number raised to the power of x.
pow(Dfp) - 类中的方法 org.hipparchus.dfp.Dfp
Power operation.
pow(Dfp, int) - 类中的静态方法 org.hipparchus.dfp.DfpMath
Raises base to the power a by successive squaring.
pow(Dfp, Dfp) - 类中的静态方法 org.hipparchus.dfp.DfpMath
Computes x to the y power.
pow(Binary64) - 类中的方法 org.hipparchus.util.Binary64
Power operation.
pow(FieldTuple<T>) - 类中的方法 org.hipparchus.util.FieldTuple
Power operation.
pow(Tuple) - 类中的方法 org.hipparchus.util.Tuple
Power operation.
pow(T) - 接口中的方法 org.hipparchus.CalculusFieldElement
Power operation.
pow(T) - 类中的方法 org.hipparchus.complex.FieldComplex
Returns of value of this complex number raised to the power of x.
pow(T[], int, double, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Compute power of a derivative structure.
pow(T[], int, int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Compute integer power of a derivative structure.
pow(T[], int, T[], int, T[], int) - 类中的方法 org.hipparchus.analysis.differentiation.DSCompiler
Compute power of a derivative structure.
pow(T, double) - 类中的静态方法 org.hipparchus.util.FastMath
Power function.
pow(T, int) - 类中的静态方法 org.hipparchus.util.FastMath
Raise a double to an int power.
pow(T, T) - 类中的静态方法 org.hipparchus.util.FastMath
Power function.
Pow - org.hipparchus.analysis.function中的类
Power function.
Pow() - 类的构造器 org.hipparchus.analysis.function.Pow
Empty constructor.
PowellOptimizer - org.hipparchus.optim.nonlinear.scalar.noderiv中的类
Powell's algorithm.
PowellOptimizer(double, double) - 类的构造器 org.hipparchus.optim.nonlinear.scalar.noderiv.PowellOptimizer
The parameters control the default convergence checking procedure.
PowellOptimizer(double, double, double, double) - 类的构造器 org.hipparchus.optim.nonlinear.scalar.noderiv.PowellOptimizer
Builds an instance with the default convergence checking procedure.
PowellOptimizer(double, double, double, double, ConvergenceChecker<PointValuePair>) - 类的构造器 org.hipparchus.optim.nonlinear.scalar.noderiv.PowellOptimizer
This constructor allows to specify a user-defined convergence checker, in addition to the parameters that control the default convergence checking procedure and the line search tolerances.
PowellOptimizer(double, double, ConvergenceChecker<PointValuePair>) - 类的构造器 org.hipparchus.optim.nonlinear.scalar.noderiv.PowellOptimizer
This constructor allows to specify a user-defined convergence checker, in addition to the parameters that control the default convergence checking procedure.
PowellOptimizerTest - org.hipparchus.optim.nonlinear.scalar.noderiv中的类
Test for PowellOptimizer.
PowellOptimizerTest() - 类的构造器 org.hipparchus.optim.nonlinear.scalar.noderiv.PowellOptimizerTest
 
power(int) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Returns the result multiplying this with itself p times.
power(int) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Returns the result of multiplying this with itself p times.
power(int) - 接口中的方法 org.hipparchus.linear.FieldMatrix
Returns the result multiplying this with itself p times.
power(int) - 接口中的方法 org.hipparchus.linear.RealMatrix
Returns the result of multiplying this with itself p times.
Power - org.hipparchus.analysis.function中的类
Power function.
Power(double) - 类的构造器 org.hipparchus.analysis.function.Power
Simple constructor.
POWER_NEGATIVE_PARAMETERS - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
已过时。
POWER_NEGATIVE_PARAMETERS.
POWER_NEGATIVE_PARAMETERS - 枚举类 中的枚举常量 org.hipparchus.migration.LocalizedMigrationFormats
已过时。
POWER_NEGATIVE_PARAMETERS.
power10(int) - 类中的方法 org.hipparchus.dfp.Dfp
Return the specified power of 10.
power10K(int) - 类中的方法 org.hipparchus.dfp.Dfp
Get the specified power of 10000.
powerTolerance - 类中的变量 org.hipparchus.linear.Array2DRowRealMatrixTest
 
Precision - org.hipparchus.util中的类
Utilities for comparing numbers.
PrecisionTest - org.hipparchus.util中的类
Test cases for the Precision class.
PrecisionTest() - 类的构造器 org.hipparchus.util.PrecisionTest
 
precondition(double[], double[]) - 类中的方法 org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.IdentityPreconditioner
Precondition a search direction.
precondition(double[], double[]) - 接口中的方法 org.hipparchus.optim.nonlinear.scalar.gradient.Preconditioner
Precondition a search direction.
PreconditionedIterativeLinearSolver - org.hipparchus.linear中的类
This abstract class defines preconditioned iterative solvers.
PreconditionedIterativeLinearSolver(int) - 类的构造器 org.hipparchus.linear.PreconditionedIterativeLinearSolver
Creates a new instance of this class, with default iteration manager.
PreconditionedIterativeLinearSolver(IterationManager) - 类的构造器 org.hipparchus.linear.PreconditionedIterativeLinearSolver
Creates a new instance of this class, with custom iteration manager.
Preconditioner - org.hipparchus.optim.nonlinear.scalar.gradient中的接口
This interface represents a preconditioner for differentiable scalar objective function optimizers.
predict(double) - 类中的方法 org.hipparchus.stat.regression.SimpleRegression
Returns the "predicted" y value associated with the supplied x value, based on the data that has been added to the model when this method is activated.
predict(double, RealVector, RealMatrix, RealMatrix) - 类中的方法 org.hipparchus.filtering.kalman.AbstractKalmanFilter
Perform prediction step.
predictionAndCorrectionSteps(T, RealVector[]) - 类中的方法 org.hipparchus.filtering.kalman.unscented.UnscentedKalmanFilter
This method perform the prediction and correction steps of the Unscented Kalman Filter.
preMultiply(double[]) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(double[]) - 类中的方法 org.hipparchus.linear.Array2DRowRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(double[]) - 类中的方法 org.hipparchus.linear.BlockRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(double[]) - 类中的方法 org.hipparchus.linear.DiagonalMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(double[]) - 接口中的方法 org.hipparchus.linear.RealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(FieldMatrix<T>) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Premultiply this matrix by m.
preMultiply(FieldMatrix<T>) - 接口中的方法 org.hipparchus.linear.FieldMatrix
Premultiply this matrix by m.
preMultiply(FieldVector<T>) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(FieldVector<T>) - 接口中的方法 org.hipparchus.linear.FieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealMatrix) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Returns the result of premultiplying this by m.
preMultiply(RealMatrix) - 接口中的方法 org.hipparchus.linear.RealMatrix
Returns the result of premultiplying this by m.
preMultiply(RealVector) - 类中的方法 org.hipparchus.linear.AbstractRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealVector) - 类中的方法 org.hipparchus.linear.DiagonalMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealVector) - 接口中的方法 org.hipparchus.linear.RealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(T[]) - 类中的方法 org.hipparchus.linear.AbstractFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(T[]) - 类中的方法 org.hipparchus.linear.Array2DRowFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(T[]) - 类中的方法 org.hipparchus.linear.BlockFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(T[]) - 接口中的方法 org.hipparchus.linear.FieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultTest - 类中的变量 org.hipparchus.linear.Array2DRowFieldMatrixTest
 
preMultTest - 类中的变量 org.hipparchus.linear.Array2DRowRealMatrixTest
 
preMultTest - 类中的变量 org.hipparchus.linear.BlockFieldMatrixTest
 
preMultTest - 类中的变量 org.hipparchus.linear.BlockRealMatrixTest
 
preMultTest - 类中的变量 org.hipparchus.linear.SparseFieldMatrixTest
 
preMultTest - 类中的变量 org.hipparchus.linear.SparseRealMatrixTest
 
probability(double) - 类中的方法 org.hipparchus.distribution.continuous.EnumeratedRealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(double, double) - 类中的方法 org.hipparchus.distribution.continuous.AbstractRealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
probability(double, double) - 类中的方法 org.hipparchus.distribution.continuous.LogNormalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
probability(double, double) - 类中的方法 org.hipparchus.distribution.continuous.NormalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
probability(double, double) - 接口中的方法 org.hipparchus.distribution.RealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
probability(int) - 类中的方法 org.hipparchus.distribution.discrete.BinomialDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - 类中的方法 org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - 类中的方法 org.hipparchus.distribution.discrete.GeometricDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - 类中的方法 org.hipparchus.distribution.discrete.HypergeometricDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - 类中的方法 org.hipparchus.distribution.discrete.PascalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - 类中的方法 org.hipparchus.distribution.discrete.PoissonDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - 类中的方法 org.hipparchus.distribution.discrete.UniformIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - 类中的方法 org.hipparchus.distribution.discrete.ZipfDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - 接口中的方法 org.hipparchus.distribution.IntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int, int) - 类中的方法 org.hipparchus.distribution.discrete.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
probability(int, int) - 接口中的方法 org.hipparchus.distribution.IntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
probability(T) - 类中的方法 org.hipparchus.distribution.EnumeratedDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
PROBABILITY_OF_ZERO - 类中的静态变量 org.hipparchus.linear.UnmodifiableOpenMapRealVectorTest
To ensure sufficient sparsity.
processDataPoint(double) - 接口中的方法 org.hipparchus.stat.descriptive.rank.PSquarePercentile.PSquareMarkers
Process a data point by moving the marker heights based on estimator.
ProcessEstimate - org.hipparchus.filtering.kalman中的类
Holder for process state and covariance.
ProcessEstimate(double, RealVector, RealMatrix) - 类的构造器 org.hipparchus.filtering.kalman.ProcessEstimate
Simple constructor.
ProcessEstimate(double, RealVector, RealMatrix, RealMatrix, RealMatrix, RealMatrix, RealMatrix) - 类的构造器 org.hipparchus.filtering.kalman.ProcessEstimate
Simple constructor.
product - 类中的变量 org.hipparchus.stat.descriptive.UnivariateStatisticAbstractTest
 
product(double...) - 类中的静态方法 org.hipparchus.stat.StatUtils
Returns the product of the entries in the input array, or Double.NaN if the array is empty.
product(double[], int, int) - 类中的静态方法 org.hipparchus.stat.StatUtils
Returns the product of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
Product - org.hipparchus.stat.descriptive.summary中的类
Returns the product of the available values.
Product() - 类的构造器 org.hipparchus.stat.descriptive.summary.Product
Create a Product instance.
Product(Product) - 类的构造器 org.hipparchus.stat.descriptive.summary.Product
Copy constructor, creates a new Product identical to the original.
ProductTest - org.hipparchus.stat.descriptive.summary中的类
Test cases for the Product class.
ProductTest() - 类的构造器 org.hipparchus.stat.descriptive.summary.ProductTest
 
project(Point<Euclidean1D>) - 类中的方法 org.hipparchus.geometry.euclidean.oned.OrientedPoint
Project a point to the hyperplane.
project(Point<Euclidean3D>) - 类中的方法 org.hipparchus.geometry.euclidean.threed.Plane
Project a point to the hyperplane.
project(Point<Euclidean2D>) - 类中的方法 org.hipparchus.geometry.euclidean.twod.Line
Project a point to the hyperplane.
project(Point<Sphere1D>) - 类中的方法 org.hipparchus.geometry.spherical.oned.LimitAngle
Project a point to the hyperplane.
project(Point<Sphere2D>) - 类中的方法 org.hipparchus.geometry.spherical.twod.Circle
Project a point to the hyperplane.
project(Point<S>) - 接口中的方法 org.hipparchus.geometry.partitioning.Hyperplane
Project a point to the hyperplane.
projection(ArrayFieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
Find the orthogonal projection of this vector onto another vector.
projection(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVector
Find the orthogonal projection of this vector onto another vector.
projection(FieldVector<T>) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
 
projection(FieldVector<T>) - 接口中的方法 org.hipparchus.linear.FieldVector
Find the orthogonal projection of this vector onto another vector.
projection(FieldVector<T>) - 类中的方法 org.hipparchus.linear.SparseFieldVector
Find the orthogonal projection of this vector onto another vector.
projection(RealVector) - 类中的方法 org.hipparchus.linear.RealVector
Find the orthogonal projection of this vector onto another vector.
projection(T[]) - 类中的方法 org.hipparchus.linear.ArrayFieldVectorTest.FieldVectorTestImpl
 
projectToBoundary(Point<Euclidean1D>) - 类中的方法 org.hipparchus.geometry.euclidean.oned.IntervalsSet
Project a point on the boundary of the region.
projectToBoundary(Point<Sphere1D>) - 类中的方法 org.hipparchus.geometry.spherical.oned.ArcsSet
Project a point on the boundary of the region.
projectToBoundary(Point<S>) - 类中的方法 org.hipparchus.geometry.partitioning.AbstractRegion
Project a point on the boundary of the region.
projectToBoundary(Point<S>) - 接口中的方法 org.hipparchus.geometry.partitioning.Region
Project a point on the boundary of the region.
PROPAGATION_DIRECTION_MISMATCH - 枚举类 中的枚举常量 org.hipparchus.migration.exception.util.LocalizedFormats
已过时。
PROPAGATION_DIRECTION_MISMATCH.
PROPAGATION_DIRECTION_MISMATCH - 枚举类 中的枚举常量 org.hipparchus.ode.LocalizedODEFormats
PROPAGATION_DIRECTION_MISMATCH.
ProperBigFractionFormat - org.hipparchus.fraction中的类
Formats a BigFraction number in proper format.
ProperBigFractionFormat() - 类的构造器 org.hipparchus.fraction.ProperBigFractionFormat
Create a proper formatting instance with the default number format for the whole, numerator, and denominator.
ProperBigFractionFormat(NumberFormat) - 类的构造器 org.hipparchus.fraction.ProperBigFractionFormat
Create a proper formatting instance with a custom number format for the whole, numerator, and denominator.
ProperBigFractionFormat(NumberFormat, NumberFormat, NumberFormat) - 类的构造器 org.hipparchus.fraction.ProperBigFractionFormat
Create a proper formatting instance with a custom number format for each of the whole, numerator, and denominator.
ProperFractionFormat - org.hipparchus.fraction中的类
Formats a Fraction number in proper format.
ProperFractionFormat() - 类的构造器 org.hipparchus.fraction.ProperFractionFormat
Create a proper formatting instance with the default number format for the whole, numerator, and denominator.
ProperFractionFormat(NumberFormat) - 类的构造器 org.hipparchus.fraction.ProperFractionFormat
Create a proper formatting instance with a custom number format for the whole, numerator, and denominator.
ProperFractionFormat(NumberFormat, NumberFormat, NumberFormat) - 类的构造器 org.hipparchus.fraction.ProperFractionFormat
Create a proper formatting instance with a custom number format for each of the whole, numerator, and denominator.
providesResidual() - 类中的方法 org.hipparchus.linear.DefaultIterativeLinearSolverEvent
Returns true if IterativeLinearSolverEvent.getResidual() is supported.
providesResidual() - 类中的方法 org.hipparchus.linear.IterativeLinearSolverEvent
Returns true if IterativeLinearSolverEvent.getResidual() is supported.
pruneAroundConvexCell(Object, Object, Object) - 类中的方法 org.hipparchus.geometry.partitioning.BSPTree
Prune a tree around a cell.
PSquarePercentile - org.hipparchus.stat.descriptive.rank中的类
A StorelessUnivariateStatistic estimating percentiles using the P2 Algorithm as explained by Raj Jain and Imrich Chlamtac in P2 Algorithm for Dynamic Calculation of Quantiles and Histogram Without Storing Observations.
PSquarePercentile(double) - 类的构造器 org.hipparchus.stat.descriptive.rank.PSquarePercentile
Constructs a PSquarePercentile with the specific percentile value.
PSquarePercentile(PSquarePercentile) - 类的构造器 org.hipparchus.stat.descriptive.rank.PSquarePercentile
Copy constructor, creates a new PSquarePercentile identical to the original.
PSquarePercentile.PSquareMarkers - org.hipparchus.stat.descriptive.rank中的接口
An interface that encapsulates abstractions of the P-square algorithm markers as is explained in the original works.
PSquarePercentileTest - org.hipparchus.stat.descriptive.rank中的类
Test cases for the PSquarePercentile class which naturally extends StorelessUnivariateStatisticAbstractTest.
PSquarePercentileTest() - 类的构造器 org.hipparchus.stat.descriptive.rank.PSquarePercentileTest
 
put(int, double) - 类中的方法 org.hipparchus.util.OpenIntToDoubleHashMap
Put a value associated with a key in the map.
put(int, T) - 类中的方法 org.hipparchus.util.OpenIntToFieldHashMap
Put a value associated with a key in the map.
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 
常量字段值|所有程序包|所有类和接口|序列化表格