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

A

a - Variable in class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
Members of c[] are called centers of the Newton polynomial.
a - Static variable in class org.apache.commons.math.ode.ClassicalRungeKuttaIntegrator
Internal weights Butcher array.
a - Variable in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Internal weights from Butcher array (without the first empty row).
a - Static variable in class org.apache.commons.math.ode.EulerIntegrator
Internal weights Butcher array.
a - Static variable in class org.apache.commons.math.ode.GillIntegrator
Internal weights Butcher array.
a - Static variable in class org.apache.commons.math.ode.MidpointIntegrator
Internal weights Butcher array.
a - Variable in class org.apache.commons.math.ode.RungeKuttaIntegrator
Internal weights from Butcher array (without the first empty row).
a - Static variable in class org.apache.commons.math.ode.ThreeEighthesIntegrator
Internal weights Butcher array.
a1 - Variable in class org.apache.commons.math.geometry.RotationOrder
Axis of the first rotation.
a2 - Variable in class org.apache.commons.math.geometry.RotationOrder
Axis of the second rotation.
a3 - Variable in class org.apache.commons.math.geometry.RotationOrder
Axis of the third rotation.
a70 - Static variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Last row of the Butcher-array internal weights, element 0.
a72 - Static variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Last row of the Butcher-array internal weights, element 2.
a73 - Static variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Last row of the Butcher-array internal weights, element 3.
a74 - Static variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Last row of the Butcher-array internal weights, element 4.
a75 - Static variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Last row of the Butcher-array internal weights, element 5.
abs() - Method in class org.apache.commons.math.complex.Complex
Return the absolute value of this complex number.
abs() - Method in class org.apache.commons.math.fraction.Fraction
Returns the absolute value of this fraction.
absoluteAccuracy - Variable in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Maximum absolute error.
AbstractContinuousDistribution - Class in org.apache.commons.math.distribution
Base class for continuous distributions.
AbstractContinuousDistribution() - Constructor for class org.apache.commons.math.distribution.AbstractContinuousDistribution
Default constructor.
AbstractDistribution - Class in org.apache.commons.math.distribution
Base class for probability distributions.
AbstractDistribution() - Constructor for class org.apache.commons.math.distribution.AbstractDistribution
Default constructor.
AbstractEstimator - Class in org.apache.commons.math.estimation
Base class for implementing estimators.
AbstractEstimator() - Constructor for class org.apache.commons.math.estimation.AbstractEstimator
Build an abstract estimator for least squares problems.
AbstractIntegerDistribution - Class in org.apache.commons.math.distribution
Base class for integer-valued discrete distributions.
AbstractIntegerDistribution() - Constructor for class org.apache.commons.math.distribution.AbstractIntegerDistribution
Default constructor.
AbstractRandomGenerator - Class in org.apache.commons.math.random
Abstract class implementing the RandomGenerator interface.
AbstractRandomGenerator() - Constructor for class org.apache.commons.math.random.AbstractRandomGenerator
Construct a RandomGenerator.
AbstractStepInterpolator - Class in org.apache.commons.math.ode
This abstract class represents an interpolator over the last step during an ODE integration.
AbstractStepInterpolator() - Constructor for class org.apache.commons.math.ode.AbstractStepInterpolator
Simple constructor.
AbstractStepInterpolator(double[], boolean) - Constructor for class org.apache.commons.math.ode.AbstractStepInterpolator
Simple constructor.
AbstractStepInterpolator(AbstractStepInterpolator) - Constructor for class org.apache.commons.math.ode.AbstractStepInterpolator
Copy constructor.
AbstractStorelessUnivariateStatistic - Class in org.apache.commons.math.stat.descriptive
Abstract implementation of the StorelessUnivariateStatistic interface.
AbstractStorelessUnivariateStatistic() - Constructor for class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
 
AbstractUnivariateStatistic - Class in org.apache.commons.math.stat.descriptive
Abstract base class for all implementations of the UnivariateStatistic interface.
AbstractUnivariateStatistic() - Constructor for class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic
 
acos() - Method in class org.apache.commons.math.complex.Complex
Compute the inverse cosine of this complex number.
acos(Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.acos()
AdaptiveStepsizeIntegrator - Class in org.apache.commons.math.ode
This abstract class holds the common part of all adaptive stepsize integrators for Ordinary Differential Equations.
AdaptiveStepsizeIntegrator(double, double, double, double) - Constructor for class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Build an integrator with the given stepsize bounds.
AdaptiveStepsizeIntegrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Build an integrator with the given stepsize bounds.
add(Complex) - Method in class org.apache.commons.math.complex.Complex
Return the sum of this complex number and the given complex number.
add(Fraction) - Method in class org.apache.commons.math.fraction.Fraction
Adds the value of this fraction to another, returning the result in reduced form.
add(Vector3D) - Method in class org.apache.commons.math.geometry.Vector3D
Add a vector to the instance.
add(double, Vector3D) - Method in class org.apache.commons.math.geometry.Vector3D
Add a scaled vector to the instance.
add(BigMatrix) - Method in interface org.apache.commons.math.linear.BigMatrix
Compute the sum of this and m.
add(BigMatrix) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Compute the sum of this and m.
add(RealMatrix) - Method in interface org.apache.commons.math.linear.RealMatrix
Compute the sum of this and m.
add(RealMatrix) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Compute the sum of this and m.
add(SwitchingFunction, double, double, int) - Method in class org.apache.commons.math.ode.SwitchingFunctionsHandler
Add a switching function.
addAndCheck(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Add two integers, checking for overflow.
addAndCheck(long, long) - Static method in class org.apache.commons.math.util.MathUtils
Add two long integers, checking for overflow.
addAndCheck(long, long, String) - Static method in class org.apache.commons.math.util.MathUtils
Add two long integers, checking for overflow.
addData(double, double) - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Adds the observation (x,y) to the regression data set.
addData(double[][]) - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Adds the observations represented by the elements in data.
addElement(double) - Method in interface org.apache.commons.math.util.DoubleArray
Adds an element to the end of this expandable array
addElement(double) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Adds an element to the end of this expandable array.
addElementRolling(double) - Method in interface org.apache.commons.math.util.DoubleArray
Adds an element to the end of the array and removes the first element in the array.
addElementRolling(double) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Adds an element to the end of the array and removes the first element in the array.
ADDITIVE_MODE - Static variable in class org.apache.commons.math.util.ResizableDoubleArray
additive expansion mode
addMeasurement(WeightedMeasurement) - Method in class org.apache.commons.math.estimation.SimpleEstimationProblem
Add a new measurement to the set.
addParameter(EstimatedParameter) - Method in class org.apache.commons.math.estimation.SimpleEstimationProblem
Add a parameter to the problem.
addSub(Fraction, boolean) - Method in class org.apache.commons.math.fraction.Fraction
Implement add and subtract using algorithm described in Knuth 4.5.1.
addSwitchingFunction(SwitchingFunction, double, double, int) - Method in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Add a switching function to the integrator.
addSwitchingFunction(SwitchingFunction, double, double, int) - Method in interface org.apache.commons.math.ode.FirstOrderIntegrator
Add a switching function to the integrator.
addSwitchingFunction(SwitchingFunction, double, double, int) - Method in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Add a switching function to the integrator.
addSwitchingFunction(SwitchingFunction, double, double, int) - Method in class org.apache.commons.math.ode.RungeKuttaIntegrator
Add a switching function to the integrator.
addValue(double) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Adds the value to the dataset.
addValue(double[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Add an n-tuple to the data
addValue(double) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Add a value to the data
addValue(double) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
 
addValue(double[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
addValue(double) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
addValue(Object) - Method in class org.apache.commons.math.stat.Frequency
Adds 1 to the frequency count for v.
addValue(int) - Method in class org.apache.commons.math.stat.Frequency
Adds 1 to the frequency count for v.
addValue(Integer) - Method in class org.apache.commons.math.stat.Frequency
Adds 1 to the frequency count for v.
addValue(long) - Method in class org.apache.commons.math.stat.Frequency
Adds 1 to the frequency count for v.
addValue(char) - Method in class org.apache.commons.math.stat.Frequency
Adds 1 to the frequency count for v.
alpha - Variable in class org.apache.commons.math.distribution.GammaDistributionImpl
The shape parameter.
alpha - Variable in class org.apache.commons.math.distribution.WeibullDistributionImpl
The shape parameter.
angle(Vector3D, Vector3D) - Static method in class org.apache.commons.math.geometry.Vector3D
Compute the angular separation between two vectors.
anovaFValue(Collection) - Method in interface org.apache.commons.math.stat.inference.OneWayAnova
Computes the ANOVA F-value for a collection of double[] arrays.
anovaFValue(Collection) - Method in class org.apache.commons.math.stat.inference.OneWayAnovaImpl
Computes the ANOVA F-value for a collection of double[] arrays.
anovaPValue(Collection) - Method in interface org.apache.commons.math.stat.inference.OneWayAnova
Computes the ANOVA P-value for a collection of double[] arrays.
anovaPValue(Collection) - Method in class org.apache.commons.math.stat.inference.OneWayAnovaImpl
Computes the ANOVA P-value for a collection of double[] arrays.
anovaStats(Collection) - Method in class org.apache.commons.math.stat.inference.OneWayAnovaImpl
This method actually does the calculations (except P-value).
anovaTest(Collection, double) - Method in interface org.apache.commons.math.stat.inference.OneWayAnova
Performs an ANOVA test, evaluating the null hypothesis that there is no difference among the means of the data categories.
anovaTest(Collection, double) - Method in class org.apache.commons.math.stat.inference.OneWayAnovaImpl
Performs an ANOVA test, evaluating the null hypothesis that there is no difference among the means of the data categories.
append(ContinuousOutputModel) - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Append another model at the end of the instance.
append(StringBuffer, double[], String, String, String) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Append a text representation of an array to a buffer.
apply(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Apply the given statistic to the data associated with this set of statistics.
apply(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Apply the given statistic to this univariate collection.
applyInverseTo(Vector3D) - Method in class org.apache.commons.math.geometry.Rotation
Apply the inverse of the rotation to a vector.
applyInverseTo(Rotation) - Method in class org.apache.commons.math.geometry.Rotation
Apply the inverse of the instance to another rotation.
applyTo(Vector3D) - Method in class org.apache.commons.math.geometry.Rotation
Apply the rotation to a vector.
applyTo(Rotation) - Method in class org.apache.commons.math.geometry.Rotation
Apply the instance to another rotation.
argument - Variable in exception org.apache.commons.math.FunctionEvaluationException
Argument causing function evaluation failure
ArgumentOutsideDomainException - Exception in org.apache.commons.math
Error thrown when a method is called with an out of bounds argument.
ArgumentOutsideDomainException(double, double, double) - Constructor for exception org.apache.commons.math.ArgumentOutsideDomainException
Constructs an exception with specified formatted detail message.
arguments - Variable in exception org.apache.commons.math.MathException
Arguments used to build the message.
asin() - Method in class org.apache.commons.math.complex.Complex
Compute the inverse sine of this complex number.
asin(Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.asin()
atan() - Method in class org.apache.commons.math.complex.Complex
Compute the inverse tangent of this complex number.
atan(Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.atan()

B

b - Static variable in class org.apache.commons.math.ode.ClassicalRungeKuttaIntegrator
Propagation weights Butcher array.
b - Variable in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
External weights for the high order method from Butcher array.
b - Static variable in class org.apache.commons.math.ode.EulerIntegrator
Propagation weights Butcher array.
b - Static variable in class org.apache.commons.math.ode.GillIntegrator
Propagation weights Butcher array.
b - Static variable in class org.apache.commons.math.ode.MidpointIntegrator
Propagation weights Butcher array.
b - Variable in class org.apache.commons.math.ode.RungeKuttaIntegrator
External weights for the high order method from Butcher array.
b - Static variable in class org.apache.commons.math.ode.ThreeEighthesIntegrator
Propagation weights Butcher array.
b_01 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Propagation weights, element 1.
b_06 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Propagation weights, element 6.
b_07 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Propagation weights, element 7.
b_08 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Propagation weights, element 8.
b_09 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Propagation weights, element 9.
b_10 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Propagation weights, element 10.
b_11 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Propagation weights, element 11.
b_12 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Propagation weights, element 12.
beta - Variable in class org.apache.commons.math.distribution.GammaDistributionImpl
The scale parameter.
beta - Variable in class org.apache.commons.math.distribution.WeibullDistributionImpl
The scale parameter.
beta - Variable in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Coefficients of the Householder transforms vectors.
Beta - Class in org.apache.commons.math.special
This is a utility class that provides computation methods related to the Beta family of functions.
Beta() - Constructor for class org.apache.commons.math.special.Beta
Default constructor.
BigMatrix - Interface in org.apache.commons.math.linear
Interface defining a real-valued matrix with basic algebraic operations, using BigDecimal representations for the entries.
BigMatrixImpl - Class in org.apache.commons.math.linear
Implementation of BigMatrix using a BigDecimal[][] array to store entries and LU decompostion to support linear system solution and inverse.
BigMatrixImpl() - Constructor for class org.apache.commons.math.linear.BigMatrixImpl
Creates a matrix with no data
BigMatrixImpl(int, int) - Constructor for class org.apache.commons.math.linear.BigMatrixImpl
Create a new BigMatrix with the supplied row and column dimensions.
BigMatrixImpl(BigDecimal[][]) - Constructor for class org.apache.commons.math.linear.BigMatrixImpl
Create a new BigMatrix using the data as the underlying data array.
BigMatrixImpl(double[][]) - Constructor for class org.apache.commons.math.linear.BigMatrixImpl
Create a new BigMatrix using the data as the underlying data array.
BigMatrixImpl(String[][]) - Constructor for class org.apache.commons.math.linear.BigMatrixImpl
Create a new BigMatrix using the values represented by the strings in data as the underlying data array.
BigMatrixImpl(BigDecimal[]) - Constructor for class org.apache.commons.math.linear.BigMatrixImpl
Create a new (column) BigMatrix using v as the data for the unique column of the v.length x 1 matrix created.
binCount - Variable in class org.apache.commons.math.random.EmpiricalDistributionImpl
number of bins
binomialCoefficient(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Returns an exact representation of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
binomialCoefficientDouble(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Returns a double representation of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
binomialCoefficientLog(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Returns the natural log of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
BinomialDistribution - Interface in org.apache.commons.math.distribution
The Binomial Distribution.
BinomialDistributionImpl - Class in org.apache.commons.math.distribution
The default implementation of BinomialDistribution.
BinomialDistributionImpl(int, double) - Constructor for class org.apache.commons.math.distribution.BinomialDistributionImpl
Create a binomial distribution with the given number of trials and probability of success.
binStats - Variable in class org.apache.commons.math.random.EmpiricalDistributionImpl
List of SummaryStatistics objects characterizing the bins
BisectionSolver - Class in org.apache.commons.math.analysis
Implements the bisection algorithm for finding zeros of univariate real functions.
BisectionSolver(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.BisectionSolver
Construct a solver for the given function.
bound - Variable in class org.apache.commons.math.estimation.EstimatedParameter
Indicator for bound parameters (ie parameters that should not be estimated)
bracket(UnivariateRealFunction, double, double, double) - Static method in class org.apache.commons.math.analysis.UnivariateRealSolverUtils
This method attempts to find two values a and b satisfying lowerBound <= a < initial < b <= upperBound f(a) * f(b) < 0 If f is continuous on [a,b], this means that a and b bracket a root of f.
bracket(UnivariateRealFunction, double, double, double, int) - Static method in class org.apache.commons.math.analysis.UnivariateRealSolverUtils
This method attempts to find two values a and b satisfying lowerBound <= a < initial < b <= upperBound f(a) * f(b) < 0 If f is continuous on [a,b], this means that a and b bracket a root of f.
BrentSolver - Class in org.apache.commons.math.analysis
Implements the Brent algorithm for finding zeros of real univariate functions.
BrentSolver(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.BrentSolver
Construct a solver for the given function.
buildMessage(String, Object[], Locale) - Static method in exception org.apache.commons.math.MathException
Builds a message string by from a pattern and its arguments.
buildSimplex(double[], double[]) - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Build a simplex from two extreme vertices.
buildSimplex(double[][]) - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Build a simplex from all its points.
buildSimplex(RandomVectorGenerator) - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Build a simplex randomly.

C

c - Variable in class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
Members of c[] are called centers of the Newton polynomial.
c - Static variable in class org.apache.commons.math.ode.ClassicalRungeKuttaIntegrator
Time steps Butcher array.
c - Variable in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Time steps from Butcher array (without the first zero).
c - Static variable in class org.apache.commons.math.ode.EulerIntegrator
Time steps Butcher array.
c - Static variable in class org.apache.commons.math.ode.GillIntegrator
Time steps Butcher array.
c - Static variable in class org.apache.commons.math.ode.MidpointIntegrator
Time steps Butcher array.
c - Variable in class org.apache.commons.math.ode.RungeKuttaIntegrator
Time steps from Butcher array (without the first zero).
c - Static variable in class org.apache.commons.math.ode.ThreeEighthesIntegrator
Time steps Butcher array.
c14 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Time step for stage 14 (interpolation only).
c15 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Time step for stage 15 (interpolation only).
c16 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Time step for stage 16 (interpolation only).
cachedNormalDeviate - Variable in class org.apache.commons.math.random.AbstractRandomGenerator
Cached random normal value.
cachedResources - Static variable in exception org.apache.commons.math.MathException
Cache for resources bundle.
CardanEulerSingularityException - Exception in org.apache.commons.math.geometry
This class represents exceptions thrown while extractiong Cardan or Euler angles from a rotation.
CardanEulerSingularityException(boolean) - Constructor for exception org.apache.commons.math.geometry.CardanEulerSingularityException
Simple constructor.
CauchyDistribution - Interface in org.apache.commons.math.distribution
Cauchy Distribution.
CauchyDistributionImpl - Class in org.apache.commons.math.distribution
Default implementation of CauchyDistribution.
CauchyDistributionImpl() - Constructor for class org.apache.commons.math.distribution.CauchyDistributionImpl
Creates cauchy distribution with the medain equal to zero and scale equal to one.
CauchyDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.CauchyDistributionImpl
Create a cauchy distribution using the given median and scale.
checkArray(long[][]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Checks to make sure that the input long[][] array is rectangular, has at least 2 rows and 2 columns, and has all non-negative entries, throwing IllegalArgumentException if any of these checks fail.
checkContractExpand(float, float) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Checks the expansion factor and the contraction criteria and throws an IllegalArgumentException if the contractionCriteria is less than the expansionCriteria
checkDimension(int) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Throws DimensionMismatchException if dimension != k.
checkEmpty() - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Throws IllegalStateException if n > 0.
checkEmpty() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Throws IllegalStateException if n > 0.
checkEmpty() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Throws IllegalStateException if n > 0.
chiSquare(double[], long[]) - Method in interface org.apache.commons.math.stat.inference.ChiSquareTest
Computes the Chi-Square statistic comparing observed and expected frequency counts.
chiSquare(long[][]) - Method in interface org.apache.commons.math.stat.inference.ChiSquareTest
Computes the Chi-Square statistic associated with a chi-square test of independence based on the input counts array, viewed as a two-way table.
chiSquare(double[], long[]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Computes the Chi-Square statistic comparing observed and expected frequency counts.
chiSquare(long[][]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
 
chiSquare(double[], long[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquare(long[][]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
 
chiSquareDataSetsComparison(long[], long[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareDataSetsComparison(long[], long[]) - Method in interface org.apache.commons.math.stat.inference.UnknownDistributionChiSquareTest
Computes a Chi-Square two sample test statistic comparing bin frequency counts in observed1 and observed2.
ChiSquaredDistribution - Interface in org.apache.commons.math.distribution
The Chi-Squared Distribution.
ChiSquaredDistributionImpl - Class in org.apache.commons.math.distribution
The default implementation of ChiSquaredDistribution
ChiSquaredDistributionImpl(double) - Constructor for class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Create a Chi-Squared distribution with the given degrees of freedom.
ChiSquaredDistributionImpl(double, GammaDistribution) - Constructor for class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Create a Chi-Squared distribution with the given degrees of freedom.
ChiSquareTest - Interface in org.apache.commons.math.stat.inference
An interface for Chi-Square tests.
chiSquareTest(double[], long[]) - Method in interface org.apache.commons.math.stat.inference.ChiSquareTest
Returns the observed significance level, or p-value, associated with a Chi-square goodness of fit test comparing the observed frequency counts to those in the expected array.
chiSquareTest(double[], long[], double) - Method in interface org.apache.commons.math.stat.inference.ChiSquareTest
Performs a Chi-square goodness of fit test evaluating the null hypothesis that the observed counts conform to the frequency distribution described by the expected counts, with significance level alpha.
chiSquareTest(long[][]) - Method in interface org.apache.commons.math.stat.inference.ChiSquareTest
Returns the observed significance level, or p-value, associated with a chi-square test of independence based on the input counts array, viewed as a two-way table.
chiSquareTest(long[][], double) - Method in interface org.apache.commons.math.stat.inference.ChiSquareTest
Performs a chi-square test of independence evaluating the null hypothesis that the classifications represented by the counts in the columns of the input 2-way table are independent of the rows, with significance level alpha.
chiSquareTest(double[], long[]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Returns the observed significance level, or p-value, associated with a Chi-square goodness of fit test comparing the observed frequency counts to those in the expected array.
chiSquareTest(double[], long[], double) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Performs a Chi-square goodness of fit test evaluating the null hypothesis that the observed counts conform to the frequency distribution described by the expected counts, with significance level alpha.
chiSquareTest(long[][]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
 
chiSquareTest(long[][], double) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
 
chiSquareTest - Static variable in class org.apache.commons.math.stat.inference.TestUtils
Singleton ChiSquareTest instance using default implementation.
chiSquareTest(double[], long[], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareTest(double[], long[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareTest(long[][], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareTest(long[][]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareTestDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
 
chiSquareTestDataSetsComparison(long[], long[], double) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
 
chiSquareTestDataSetsComparison(long[], long[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareTestDataSetsComparison(long[], long[], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareTestDataSetsComparison(long[], long[]) - Method in interface org.apache.commons.math.stat.inference.UnknownDistributionChiSquareTest
Returns the observed significance level, or p-value, associated with a Chi-Square two sample test comparing bin frequency counts in observed1 and observed2.
chiSquareTestDataSetsComparison(long[], long[], double) - Method in interface org.apache.commons.math.stat.inference.UnknownDistributionChiSquareTest
Performs a Chi-Square two sample test comparing two binned data sets.
ChiSquareTestImpl - Class in org.apache.commons.math.stat.inference
Implements Chi-Square test statistics defined in the UnknownDistributionChiSquareTest interface.
ChiSquareTestImpl() - Constructor for class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Construct a ChiSquareTestImpl
ChiSquareTestImpl(ChiSquaredDistribution) - Constructor for class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Create a test instance using the given distribution for computing inference statistics.
classes() - Method in class org.apache.commons.math.util.TransformerMap
Returns the Set of Classes used as keys in the map.
ClassicalRungeKuttaIntegrator - Class in org.apache.commons.math.ode
This class implements the classical fourth order Runge-Kutta integrator for Ordinary Differential Equations (it is the most often used Runge-Kutta method).
ClassicalRungeKuttaIntegrator(double) - Constructor for class org.apache.commons.math.ode.ClassicalRungeKuttaIntegrator
Simple constructor.
ClassicalRungeKuttaStepInterpolator - Class in org.apache.commons.math.ode
This class implements a step interpolator for the classical fourth order Runge-Kutta integrator.
ClassicalRungeKuttaStepInterpolator() - Constructor for class org.apache.commons.math.ode.ClassicalRungeKuttaStepInterpolator
Simple constructor.
ClassicalRungeKuttaStepInterpolator(ClassicalRungeKuttaStepInterpolator) - Constructor for class org.apache.commons.math.ode.ClassicalRungeKuttaStepInterpolator
Copy constructor.
clear() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Clears the cache used by the default implementation of AbstractRandomGenerator.nextGaussian().
clear() - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
 
clear() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatisticsImpl
Deprecated. Resets all statistics and storage
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
 
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.FourthMoment
 
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
 
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
 
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.Mean
 
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.SecondMoment
 
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.Skewness
 
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
 
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
 
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
 
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math.stat.descriptive.rank.Max
 
clear() - Method in class org.apache.commons.math.stat.descriptive.rank.Min
 
clear() - Method in interface org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.summary.Product
 
clear() - Method in class org.apache.commons.math.stat.descriptive.summary.Sum
 
clear() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
 
clear() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
 
clear() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatisticsImpl
Deprecated. Resets all statistics and storage.
clear() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
 
clear() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
clear() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
clear() - Method in class org.apache.commons.math.stat.Frequency
Clears the frequency table
clear() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Clears all data from the model.
clear() - Method in interface org.apache.commons.math.util.DoubleArray
Clear the double array
clear() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Clear the array, reset the size to the initialCapacity and the number of elements to zero.
clear() - Method in class org.apache.commons.math.util.TransformerMap
Clears all the Class to Transformer mappings.
clearResult() - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Convenience function for implementations.
clearResult() - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Convenience function for implementations.
closeReplayFile() - Method in class org.apache.commons.math.random.ValueServer
Closes valuesFileURL after use in REPLAY_MODE.
coeff - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
extrapolation coefficients.
coefficients - Variable in class org.apache.commons.math.analysis.PolynomialFunction
The coefficients of the polynomial, ordered by degree -- i.e., coefficients[0] is the constant term and coefficients[n] is the coefficient of x^n where n is the degree of the polynomial.
coefficients - Variable in class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
The coefficients of the polynomial, ordered by degree -- i.e.
coefficients - Variable in class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
The coefficients of the polynomial, ordered by degree -- i.e.
coefficientsComputed - Variable in class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
Whether the polynomial coefficients are available.
coefficientsComputed - Variable in class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
Whether the polynomial coefficients are available.
cols - Variable in class org.apache.commons.math.estimation.AbstractEstimator
Number of columns of the jacobian matrix.
compare(Object, Object) - Method in class org.apache.commons.math.stat.Frequency.NaturalComparator
Compare the two Comparable arguments.
compareTo(Object) - Method in class org.apache.commons.math.fraction.Fraction
Compares this object to another based on size.
Complex - Class in org.apache.commons.math.complex
Representation of a Complex number - a number which has both a real and imaginary part.
Complex(double, double) - Constructor for class org.apache.commons.math.complex.Complex
Create a complex number given the real and imaginary parts.
ComplexFormat - Class in org.apache.commons.math.complex
Formats a Complex number in cartesian format "Re(c) + Im(c)i".
ComplexFormat() - Constructor for class org.apache.commons.math.complex.ComplexFormat
Create an instance with the default imaginary character, 'i', and the default number format for both real and imaginary parts.
ComplexFormat(NumberFormat) - Constructor for class org.apache.commons.math.complex.ComplexFormat
Create an instance with a custom number format for both real and imaginary parts.
ComplexFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math.complex.ComplexFormat
Create an instance with a custom number format for the real part and a custom number format for the imaginary part.
ComplexFormat(String) - Constructor for class org.apache.commons.math.complex.ComplexFormat
Create an instance with a custom imaginary character, and the default number format for both real and imaginary parts.
ComplexFormat(String, NumberFormat) - Constructor for class org.apache.commons.math.complex.ComplexFormat
Create an instance with a custom imaginary character, and a custom number format for both real and imaginary parts.
ComplexFormat(String, NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math.complex.ComplexFormat
Create an instance with a custom imaginary character, a custom number format for the real part, and a custom number format for the imaginary part.
ComplexUtils - Class in org.apache.commons.math.complex
Static implementations of common Complex-valued functions.
ComplexUtils() - Constructor for class org.apache.commons.math.complex.ComplexUtils
Default constructor.
computeBinStats(double, double) - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl.ArrayDataAdapter
Computes binStats
computeBinStats(double, double) - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl.DataAdapter
Compute bin stats.
computeBinStats(double, double) - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl.StreamDataAdapter
Computes binStats
computeCoefficients() - Method in class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
Calculate the coefficients of Lagrange polynomial from the interpolation data.
computeCoefficients() - Method in class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
Calculate the normal polynomial coefficients given the Newton form.
computeCoefficients(int, double) - Method in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Compute the interpolation coefficients for dense output.
computeDerivatives(double, double[], double[]) - Method in class org.apache.commons.math.ode.FirstOrderConverter
Get the current time derivative of the state vector.
computeDerivatives(double, double[], double[]) - Method in interface org.apache.commons.math.ode.FirstOrderDifferentialEquations
Get the current time derivative of the state vector.
computeDistribution() - Method in class org.apache.commons.math.random.ValueServer
Computes the empirical distribution using values from the file in valuesFileURL, using the default number of bins.
computeDistribution(int) - Method in class org.apache.commons.math.random.ValueServer
Computes the empirical distribution using values from the file in valuesFileURL and binCount bins.
computeDividedDifference(double[], double[]) - Static method in class org.apache.commons.math.analysis.DividedDifferenceInterpolator
Returns a copy of the divided difference array.
computeInterpolatedState(double, double) - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Compute the state at the interpolated time.
computeInterpolatedState(double, double) - Method in class org.apache.commons.math.ode.ClassicalRungeKuttaStepInterpolator
Compute the state at the interpolated time.
computeInterpolatedState(double, double) - Method in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Compute the state at the interpolated time.
computeInterpolatedState(double, double) - Method in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Compute the state at the interpolated time.
computeInterpolatedState(double, double) - Method in class org.apache.commons.math.ode.DummyStepInterpolator
Compute the state at the interpolated time.
computeInterpolatedState(double, double) - Method in class org.apache.commons.math.ode.EulerStepInterpolator
Compute the state at the interpolated time.
computeInterpolatedState(double, double) - Method in class org.apache.commons.math.ode.GillStepInterpolator
Compute the state at the interpolated time.
computeInterpolatedState(double, double) - Method in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Compute the state at the interpolated time.
computeInterpolatedState(double, double) - Method in class org.apache.commons.math.ode.HighamHall54StepInterpolator
Compute the state at the interpolated time.
computeInterpolatedState(double, double) - Method in class org.apache.commons.math.ode.MidpointStepInterpolator
Compute the state at the interpolated time.
computeInterpolatedState(double, double) - Method in class org.apache.commons.math.ode.ThreeEighthesStepInterpolator
Compute the state at the interpolated time.
computeOmega(int) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Calculate the n-th roots of unity.
computeSecondDerivatives(double, double[], double[], double[]) - Method in interface org.apache.commons.math.ode.SecondOrderDifferentialEquations
Get the current time derivative of the state vector.
computeStats() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl.ArrayDataAdapter
Computes sampleStats
computeStats() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl.DataAdapter
Compute sample statistics.
computeStats() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl.StreamDataAdapter
Computes sampleStats
conjugate() - Method in class org.apache.commons.math.complex.Complex
Return the conjugate of this complex number.
CONSTANT_MODE - Static variable in class org.apache.commons.math.random.ValueServer
Always return mu
containsClass(Class) - Method in class org.apache.commons.math.util.TransformerMap
Tests if a Class is present in the TransformerMap.
containsTransformer(NumberTransformer) - Method in class org.apache.commons.math.util.TransformerMap
Tests if a NumberTransformer is present in the TransformerMap.
contents - Static variable in class org.apache.commons.math.MessagesResources_fr
Non-translated/translated messages arrays.
CONTINUE - Static variable in interface org.apache.commons.math.ode.SwitchingFunction
Continue indicator.
ContinuedFraction - Class in org.apache.commons.math.util
Provides a generic means to evaluate continued fractions.
ContinuedFraction() - Constructor for class org.apache.commons.math.util.ContinuedFraction
Default constructor.
ContinuousDistribution - Interface in org.apache.commons.math.distribution
Base interface for continuous distributions.
ContinuousOutputModel - Class in org.apache.commons.math.ode
This class stores all information provided by an ODE integrator during the integration process and build a continuous model of the solution from this.
ContinuousOutputModel() - Constructor for class org.apache.commons.math.ode.ContinuousOutputModel
Simple constructor.
contract() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Contracts the storage array to the (size of the element set) + 1 - to avoid a zero length array.
contractionCriteria - Variable in class org.apache.commons.math.util.ResizableDoubleArray
The contraction criteria determines when the internal array will be contracted to fit the number of elements contained in the element array + 1.
converged(PointCostPair[]) - Method in interface org.apache.commons.math.optimization.ConvergenceChecker
Check if the optimization algorithm has converged on the simplex.
convergence - Variable in class org.apache.commons.math.estimation.GaussNewtonEstimator
Threshold for cost convergence.
convergence - Variable in class org.apache.commons.math.ode.SwitchState
Convergence threshold for event localisation.
ConvergenceChecker - Interface in org.apache.commons.math.optimization
This interface specifies how to check if a direct search method has converged.
ConvergenceException - Exception in org.apache.commons.math
Error thrown when a numerical computation can not be performed because the numerical result failed to converge to a finite value.
ConvergenceException() - Constructor for exception org.apache.commons.math.ConvergenceException
Default constructor.
ConvergenceException(String, Object[]) - Constructor for exception org.apache.commons.math.ConvergenceException
Constructs an exception with specified formatted detail message.
ConvergenceException(Throwable) - Constructor for exception org.apache.commons.math.ConvergenceException
Create an exception with a given root cause.
ConvergenceException(String, Object[], Throwable) - Constructor for exception org.apache.commons.math.ConvergenceException
Constructs an exception with specified formatted detail message and root cause.
ConvergenceException(String, Throwable) - Constructor for exception org.apache.commons.math.ConvergenceException
Deprecated. as of 1.2, replaced by ConvergenceException.ConvergenceException(String, Object[], Throwable)
ConvergenceException(String) - Constructor for exception org.apache.commons.math.ConvergenceException
Deprecated. as of 1.2, replaced by ConvergenceException.ConvergenceException(String, Object[])
copy() - Method in interface org.apache.commons.math.linear.BigMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Create a new BigMatrix which is a copy of this.
copy() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Create a new RealMatrix which is a copy of this.
copy() - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Copy the instance.
copy() - Method in interface org.apache.commons.math.ode.StepInterpolator
Copy the instance.
copyIn(BigDecimal[][]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Replaces data with a fresh copy of the input array.
copyIn(double[][]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Replaces data with a fresh copy of the input array.
copyIn(String[][]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Replaces data with BigDecimals represented by the strings in the input array.
copyIn(double[][]) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Replaces data with a fresh copy of the input array.
copyOut() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns a fresh copy of the underlying data array.
copyOut() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns a fresh copy of the underlying data array.
CorrelatedRandomVectorGenerator - Class in org.apache.commons.math.random
A RandomVectorGenerator that generates vectors with with correlated components.
CorrelatedRandomVectorGenerator(double[], RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Simple constructor.
CorrelatedRandomVectorGenerator(RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Simple constructor.
cos() - Method in class org.apache.commons.math.complex.Complex
Compute the cosine of this complex number.
cos(Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.cos()
cosh() - Method in class org.apache.commons.math.complex.Complex
Compute the hyperbolic cosine of this complex number.
cosh(Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.cosh()
cosh(double) - Static method in class org.apache.commons.math.util.MathUtils
Returns the hyperbolic cosine of x.
cost - Variable in class org.apache.commons.math.estimation.AbstractEstimator
Cost value (square root of the sum of the residuals).
cost(double[]) - Method in interface org.apache.commons.math.optimization.CostFunction
Compute the cost associated to the given parameters array.
cost - Variable in class org.apache.commons.math.optimization.PointCostPair
Cost associated to the point.
costEvaluations - Variable in class org.apache.commons.math.estimation.AbstractEstimator
Number of cost evaluations.
CostException - Exception in org.apache.commons.math.optimization
This class represents exceptions thrown by cost functions.
CostException(String, Object[]) - Constructor for exception org.apache.commons.math.optimization.CostException
Constructs a new MathException with specified formatted detail message.
CostException(Throwable) - Constructor for exception org.apache.commons.math.optimization.CostException
Constructs a new MathException with specified nested Throwable root cause.
CostFunction - Interface in org.apache.commons.math.optimization
This interface represents a cost function to be minimized.
costPerStep - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
overall cost of applying step reduction up to iteration k+1, in number of calls.
costPerTimeUnit - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
cost per unit step.
costRelativeTolerance - Variable in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Desired relative error in the sum of squares.
covarianceImpl - Variable in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Covariance statistic implementation - cannot be reset.
createAdaptor(RandomGenerator) - Static method in class org.apache.commons.math.random.RandomAdaptor
Factory method to create a Random using the supplied RandomGenerator.
createBigIdentityMatrix(int) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns dimension x dimension identity matrix.
createBigMatrix(double[][]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns a BigMatrix whose entries are the the values in the the input array.
createBigMatrix(BigDecimal[][]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns a BigMatrix whose entries are the the values in the the input array.
createBigMatrix(String[][]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns a BigMatrix whose entries are the the values in the the input array.
createBinomialDistribution(int, double) - Method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create a binomial distribution with the given number of trials and probability of success.
createBinomialDistribution(int, double) - Method in class org.apache.commons.math.distribution.DistributionFactoryImpl
Deprecated. Create a binomial distribution with the given number of trials and probability of success.
createCauchyDistribution(double, double) - Method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create a new cauchy distribution with the given median and scale.
createChiSquareDistribution(double) - Method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create a new chi-square distribution with the given degrees of freedom.
createChiSquareDistribution(double) - Method in class org.apache.commons.math.distribution.DistributionFactoryImpl
Deprecated. Create a new chi-square distribution with the given degrees of freedom.
createChiSquareTest() - Method in class org.apache.commons.math.stat.inference.TestFactory
Deprecated. Create a ChiSquareTest instance.
createChiSquareTest() - Method in class org.apache.commons.math.stat.inference.TestFactoryImpl
Deprecated. Create a ChiSquareTest instance.
createColumnBigMatrix(double[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a column BigMatrix using the data from the input array.
createColumnBigMatrix(BigDecimal[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a column BigMatrix using the data from the input array.
createColumnBigMatrix(String[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a column BigMatrix using the data from the input array.
createColumnRealMatrix(double[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a column RealMatrix using the data from the input array.
createComplex(double, double) - Method in class org.apache.commons.math.complex.Complex
Create a complex number given the real and imaginary parts.
createExponentialDistribution(double) - Method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create a new exponential distribution with the given degrees of freedom.
createExponentialDistribution(double) - Method in class org.apache.commons.math.distribution.DistributionFactoryImpl
Deprecated. Create a new exponential distribution with the given degrees of freedom.
createFDistribution(double, double) - Method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create a new F-distribution with the given degrees of freedom.
createFDistribution(double, double) - Method in class org.apache.commons.math.distribution.DistributionFactoryImpl
Deprecated. Create a new F-distribution with the given degrees of freedom.
createGammaDistribution(double, double) - Method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create a new gamma distribution with the given shape and scale parameters.
createGammaDistribution(double, double) - Method in class org.apache.commons.math.distribution.DistributionFactoryImpl
Deprecated. Create a new gamma distribution the given shape and scale parameters.
createHypergeometricDistribution(int, int, int) - Method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create a new hypergeometric distribution with the given the population size, the number of successes in the population, and the sample size.
createHypergeometricDistribution(int, int, int) - Method in class org.apache.commons.math.distribution.DistributionFactoryImpl
Deprecated. Create a new hypergeometric distribution with the given the population size, the number of successes in the population, and the sample size.
createNormalDistribution(double, double) - Method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create a new normal distribution with the given mean and standard deviation.
createNormalDistribution() - Method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create a new normal distribution with mean zero and standard deviation one.
createNormalDistribution(double, double) - Method in class org.apache.commons.math.distribution.DistributionFactoryImpl
Deprecated. Create a new normal distribution with the given mean and standard deviation.
createNormalDistribution() - Method in class org.apache.commons.math.distribution.DistributionFactoryImpl
Deprecated. Create a new normal distribution with the mean zero and standard deviation one.
createPascalDistribution(int, double) - Method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create a Pascal distribution with the given number of successes and probability of success.
createPoissonDistribution(double) - Method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create a new Poisson distribution with poisson parameter lambda.
createPoissonDistribution(double) - Method in class org.apache.commons.math.distribution.DistributionFactoryImpl
Deprecated. Create a new Poisson distribution with poisson parameter lambda.
createRealIdentityMatrix(int) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns dimension x dimension identity matrix.
createRealMatrix(double[][]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns a RealMatrix whose entries are the the values in the the input array.
createRowBigMatrix(double[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a row BigMatrix using the data from the input array.
createRowBigMatrix(BigDecimal[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a row BigMatrix using the data from the input array.
createRowBigMatrix(String[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a row BigMatrix using the data from the input array.
createRowRealMatrix(double[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a row RealMatrix using the data from the input array.
createTDistribution(double) - Method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create a new t distribution with the given degrees of freedom.
createTDistribution(double) - Method in class org.apache.commons.math.distribution.DistributionFactoryImpl
Deprecated. Create a new t distribution with the given degrees of freedom.
createTTest() - Method in class org.apache.commons.math.stat.inference.TestFactory
Deprecated. Create a TTest instance.
createTTest() - Method in class org.apache.commons.math.stat.inference.TestFactoryImpl
Deprecated. Create a TTest instance.
createWeibullDistribution(double, double) - Method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create a new Weibull distribution with the given shape and scale parameters.
crossProduct(Vector3D, Vector3D) - Static method in class org.apache.commons.math.geometry.Vector3D
Compute the cross-product of two vectors.
cumulativeProbability(double, double) - Method in class org.apache.commons.math.distribution.AbstractDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 ≤ X ≤ x1).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X ≤ x).
cumulativeProbability(double, double) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 ≤ X ≤ x1).
cumulativeProbability(int) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X ≤ x).
cumulativeProbability(int, int) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 ≤ X ≤ x1).
cumulativeProbability(int) - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
For this distribution, X, this method returns P(X ≤ x).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
For this disbution, X, this method returns P(X < x).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
For this disbution, X, this method returns P(X < x).
cumulativeProbability(double) - Method in interface org.apache.commons.math.distribution.Distribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X ≤ x).
cumulativeProbability(double, double) - Method in interface org.apache.commons.math.distribution.Distribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 ≤ X ≤ x1).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
For this disbution, X, this method returns P(X < x).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.FDistributionImpl
For this distribution, X, this method returns P(X < x).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
For this disbution, X, this method returns P(X < x).
cumulativeProbability(int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
For this disbution, X, this method returns P(X ≤ x).
cumulativeProbability(int) - Method in interface org.apache.commons.math.distribution.IntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X ≤ x).
cumulativeProbability(int, int) - Method in interface org.apache.commons.math.distribution.IntegerDistribution
For this distribution, X, this method returns P(x0 ≤ X ≤ x1).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
For this disbution, X, this method returns P(X < x).
cumulativeProbability(int) - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
For this distribution, X, this method returns P(X ≤ x).
cumulativeProbability(int) - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
The probability distribution function P(X <= x) for a Poisson distribution.
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.TDistributionImpl
For this disbution, X, this method returns P(X < x).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
For this disbution, X, this method returns P(X < x).
currentDegree - Variable in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Degree of the interpolation polynoms.
currentState - Variable in class org.apache.commons.math.ode.AbstractStepInterpolator
current state
currentTime - Variable in class org.apache.commons.math.ode.AbstractStepInterpolator
current time

D

d - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Interpolation weights.
d0 - Static variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Shampine (1986) Dense output, element 0.
d2 - Static variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Shampine (1986) Dense output, element 2.
d3 - Static variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Shampine (1986) Dense output, element 3.
d4 - Static variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Shampine (1986) Dense output, element 4.
d5 - Static variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Shampine (1986) Dense output, element 5.
d6 - Static variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Shampine (1986) Dense output, element 6.
data - Variable in class org.apache.commons.math.linear.BigMatrixImpl
Entries of the matrix
data - Variable in class org.apache.commons.math.linear.RealMatrixImpl
Entries of the matrix
decompose(RealMatrix, double) - Method in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Decompose the original square matrix.
DEFAULT_EPSILON - Static variable in class org.apache.commons.math.special.Beta
Maximum allowed numerical error.
DEFAULT_EPSILON - Static variable in class org.apache.commons.math.special.Gamma
Maximum allowed numerical error.
DEFAULT_EPSILON - Static variable in class org.apache.commons.math.util.ContinuedFraction
Maximum allowed numerical error.
DEFAULT_IMAGINARY_CHARACTER - Static variable in class org.apache.commons.math.complex.ComplexFormat
The default imaginary character.
defaultAbsoluteAccuracy - Variable in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Default maximum absolute error.
defaultFunctionValueAccuracy - Variable in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Default maximum error of function.
defaultMaximalIterationCount - Variable in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
default maximum number of iterations
defaultMaximalIterationCount - Variable in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Default maximum number of iterations.
defaultMinimalIterationCount - Variable in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
default minimum number of iterations
defaultRelativeAccuracy - Variable in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
default maximum relative error
defaultRelativeAccuracy - Variable in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Default maximum relative error.
DefaultTransformer - Class in org.apache.commons.math.util
A Default NumberTransformer for java.lang.Numbers and Numeric Strings.
DefaultTransformer() - Constructor for class org.apache.commons.math.util.DefaultTransformer
 
defaultTransformer - Variable in class org.apache.commons.math.util.TransformerMap
A default Number Transformer for Numbers and numeric Strings.
degree() - Method in class org.apache.commons.math.analysis.PolynomialFunction
Returns the degree of the polynomial
degree() - Method in class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
Returns the degree of the polynomial.
degree() - Method in class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
Returns the degree of the polynomial.
degreesOfFreedom - Variable in class org.apache.commons.math.distribution.TDistributionImpl
The degrees of freedom
denominator - Variable in class org.apache.commons.math.fraction.Fraction
The denominator.
denominatorDegreesOfFreedom - Variable in class org.apache.commons.math.distribution.FDistributionImpl
The numerator degrees of freedom
denominatorFormat - Variable in class org.apache.commons.math.fraction.FractionFormat
The format used for the denominator.
denseOutput - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
dense outpute required.
derivative() - Method in interface org.apache.commons.math.analysis.DifferentiableUnivariateRealFunction
Returns the derivative of the function
derivative - Variable in class org.apache.commons.math.analysis.NewtonSolver
The first derivative of the target function.
derivative() - Method in class org.apache.commons.math.analysis.PolynomialFunction
Returns the derivative as a UnivariateRealFunction
derivative() - Method in class org.apache.commons.math.analysis.PolynomialSplineFunction
Returns the derivative of the polynomial spline function as a UnivariateRealFunction
DerivativeException - Exception in org.apache.commons.math.ode
This exception is made available to users to report the error conditions that are trigegred while computing the differential equations.
DerivativeException(String, String[]) - Constructor for exception org.apache.commons.math.ode.DerivativeException
Simple constructor.
DerivativeException(Throwable) - Constructor for exception org.apache.commons.math.ode.DerivativeException
Build an instance from an underlying cause.
DescriptiveStatistics - Class in org.apache.commons.math.stat.descriptive
Maintains a dataset of values of a single variable and computes descriptive statistics based on stored data.
DescriptiveStatistics() - Constructor for class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Construct a DescriptiveStatistics instance with an infinite window
DescriptiveStatistics(int) - Constructor for class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Construct a DescriptiveStatistics instance with the specified window
DescriptiveStatisticsImpl - Class in org.apache.commons.math.stat.descriptive
Deprecated. to be removed in commons-math 2.0. Use DescriptiveStatistics
DescriptiveStatisticsImpl() - Constructor for class org.apache.commons.math.stat.descriptive.DescriptiveStatisticsImpl
Deprecated. Construct a DescriptiveStatisticsImpl with infinite window
DescriptiveStatisticsImpl(int) - Constructor for class org.apache.commons.math.stat.descriptive.DescriptiveStatisticsImpl
Deprecated. Construct a DescriptiveStatisticsImpl with finite window
determineLMDirection(double[], double[], double[], double[]) - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Solve a*x = b and d*x = 0 in the least squares sense.
determineLMParameter(double[], double, double[], double[], double[], double[]) - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Determine the Levenberg-Marquardt parameter.
dev - Variable in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
Deviation of most recently added value from previous first moment.
df(double, double, double, double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes approximate degrees of freedom for 2-sample t-test.
dfbg - Variable in class org.apache.commons.math.stat.inference.OneWayAnovaImpl.AnovaStats
 
dfwg - Variable in class org.apache.commons.math.stat.inference.OneWayAnovaImpl.AnovaStats
 
diagR - Variable in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Diagonal elements of the R matrix in the Q.R.
DifferentiableUnivariateRealFunction - Interface in org.apache.commons.math.analysis
Extension of UnivariateRealFunction representing a differentiable univariate real function.
differentiate(double[]) - Static method in class org.apache.commons.math.analysis.PolynomialFunction
Returns the coefficients of the derivative of the polynomial with the given coefficients.
DIGEST_MODE - Static variable in class org.apache.commons.math.random.ValueServer
Use empirical distribution
dimension - Variable in class org.apache.commons.math.ode.FirstOrderConverter
second order problem dimension.
dimension1 - Variable in exception org.apache.commons.math.DimensionMismatchException
First dimension.
dimension2 - Variable in exception org.apache.commons.math.DimensionMismatchException
Second dimension.
DimensionMismatchException - Exception in org.apache.commons.math
Error thrown when two dimensions differ.
DimensionMismatchException(int, int) - Constructor for exception org.apache.commons.math.DimensionMismatchException
Construct an exception from the mismatched dimensions
DirectSearchOptimizer - Class in org.apache.commons.math.optimization
This class implements simplex-based direct search optimization algorithms.
DirectSearchOptimizer() - Constructor for class org.apache.commons.math.optimization.DirectSearchOptimizer
Simple constructor.
discardFrontElements(int) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Discards the i initial elements of the array.
DiscreteDistribution - Interface in org.apache.commons.math.distribution
Base interface for discrete distributions.
Distribution - Interface in org.apache.commons.math.distribution
Base interface for probability distributions.
distribution - Variable in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Distribution used to compute inference statistics.
distribution - Variable in class org.apache.commons.math.stat.inference.TTestImpl
Distribution used to compute inference statistics.
distribution - Variable in class org.apache.commons.math.stat.regression.SimpleRegression
the distribution used to compute inference statistics.
DistributionFactory - Class in org.apache.commons.math.distribution
Deprecated. pluggability of distribution instances is now provided through constructors and setters.
DistributionFactory() - Constructor for class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Default constructor.
DistributionFactoryImpl - Class in org.apache.commons.math.distribution
Deprecated. pluggability of distribution instances is now provided through constructors and setters.
DistributionFactoryImpl() - Constructor for class org.apache.commons.math.distribution.DistributionFactoryImpl
Deprecated. Default constructor.
divide(Complex) - Method in class org.apache.commons.math.complex.Complex
Return the quotient of this complex number and the given complex number.
divide(Fraction) - Method in class org.apache.commons.math.fraction.Fraction
Divide the value of this fraction by another.
DividedDifferenceInterpolator - Class in org.apache.commons.math.analysis
Implements the Divided Difference Algorithm for interpolation of real univariate functions.
DividedDifferenceInterpolator() - Constructor for class org.apache.commons.math.analysis.DividedDifferenceInterpolator
 
doCopy() - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Really copy the finalized instance.
doCopy() - Method in class org.apache.commons.math.ode.ClassicalRungeKuttaStepInterpolator
Really copy the finalized instance.
doCopy() - Method in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Really copy the finalized instance.
doCopy() - Method in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Really copy the finalized instance.
doCopy() - Method in class org.apache.commons.math.ode.DummyStepInterpolator
Really copy the finalized instance.
doCopy() - Method in class org.apache.commons.math.ode.EulerStepInterpolator
Really copy the finalized instance.
doCopy() - Method in class org.apache.commons.math.ode.GillStepInterpolator
Really copy the finalized instance.
doCopy() - Method in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Really copy the finalized instance.
doCopy() - Method in class org.apache.commons.math.ode.HighamHall54StepInterpolator
Really copy the finalized instance.
doCopy() - Method in class org.apache.commons.math.ode.MidpointStepInterpolator
Really copy the finalized instance.
doCopy() - Method in class org.apache.commons.math.ode.ThreeEighthesStepInterpolator
Really copy the finalized instance.
doFinalize() - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Really finalize the step.
doFinalize() - Method in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Really finalize the step.
DormandPrince54Integrator - Class in org.apache.commons.math.ode
This class implements the 5(4) Dormand-Prince integrator for Ordinary Differential Equations.
DormandPrince54Integrator(double, double, double, double) - Constructor for class org.apache.commons.math.ode.DormandPrince54Integrator
Simple constructor.
DormandPrince54Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.DormandPrince54Integrator
Simple constructor.
DormandPrince54StepInterpolator - Class in org.apache.commons.math.ode
This class represents an interpolator over the last step during an ODE integration for the 5(4) Dormand-Prince integrator.
DormandPrince54StepInterpolator() - Constructor for class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Simple constructor.
DormandPrince54StepInterpolator(DormandPrince54StepInterpolator) - Constructor for class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Copy constructor.
DormandPrince853Integrator - Class in org.apache.commons.math.ode
This class implements the 8(5,3) Dormand-Prince integrator for Ordinary Differential Equations.
DormandPrince853Integrator(double, double, double, double) - Constructor for class org.apache.commons.math.ode.DormandPrince853Integrator
Simple constructor.
DormandPrince853Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.DormandPrince853Integrator
Simple constructor.
DormandPrince853StepInterpolator - Class in org.apache.commons.math.ode
This class represents an interpolator over the last step during an ODE integration for the 8(5,3) Dormand-Prince integrator.
DormandPrince853StepInterpolator() - Constructor for class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Simple constructor.
DormandPrince853StepInterpolator(DormandPrince853StepInterpolator) - Constructor for class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Copy constructor.
dotProduct(Vector3D, Vector3D) - Static method in class org.apache.commons.math.geometry.Vector3D
Compute the dot-product of two vectors.
DoubleArray - Interface in org.apache.commons.math.util
Provides a standard interface for double arrays.
doubleValue() - Method in class org.apache.commons.math.fraction.Fraction
Gets the fraction as a double.
DummyStepHandler - Class in org.apache.commons.math.ode
This class is a step handler that do nothing.
DummyStepHandler() - Constructor for class org.apache.commons.math.ode.DummyStepHandler
Private constructor.
DummyStepInterpolator - Class in org.apache.commons.math.ode
This class is a step interpolator that does nothing.
DummyStepInterpolator() - Constructor for class org.apache.commons.math.ode.DummyStepInterpolator
Simple constructor.
DummyStepInterpolator(double[], boolean) - Constructor for class org.apache.commons.math.ode.DummyStepInterpolator
Simple constructor.
DummyStepInterpolator(DummyStepInterpolator) - Constructor for class org.apache.commons.math.ode.DummyStepInterpolator
Copy constructor.
DuplicateSampleAbscissaException - Exception in org.apache.commons.math
Exeption thrown when a sample contains several entries at the same abscissa.
DuplicateSampleAbscissaException(double, int, int) - Constructor for exception org.apache.commons.math.DuplicateSampleAbscissaException
Construct an exception indicating the duplicate abscissa.

E

e1 - Static variable in class org.apache.commons.math.ode.DormandPrince54Integrator
Error array, element 1.
e1_01 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
First error weights array, element 1.
e1_06 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
First error weights array, element 6.
e1_07 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
First error weights array, element 7.
e1_08 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
First error weights array, element 8.
e1_09 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
First error weights array, element 9.
e1_10 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
First error weights array, element 10.
e1_11 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
First error weights array, element 11.
e1_12 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
First error weights array, element 12.
e2_01 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
Second error weights array, element 1.
e2_06 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
Second error weights array, element 6.
e2_07 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
Second error weights array, element 7.
e2_08 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
Second error weights array, element 8.
e2_09 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
Second error weights array, element 9.
e2_10 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
Second error weights array, element 10.
e2_11 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
Second error weights array, element 11.
e2_12 - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
Second error weights array, element 12.
e3 - Static variable in class org.apache.commons.math.ode.DormandPrince54Integrator
Error array, element 3.
e4 - Static variable in class org.apache.commons.math.ode.DormandPrince54Integrator
Error array, element 4.
e5 - Static variable in class org.apache.commons.math.ode.DormandPrince54Integrator
Error array, element 5.
e6 - Static variable in class org.apache.commons.math.ode.DormandPrince54Integrator
Error array, element 6.
e7 - Static variable in class org.apache.commons.math.ode.DormandPrince54Integrator
Error array, element 7.
eDA - Variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Stored data values
EmbeddedRungeKuttaIntegrator - Class in org.apache.commons.math.ode
This class implements the common part of all embedded Runge-Kutta integrators for Ordinary Differential Equations.
EmbeddedRungeKuttaIntegrator(boolean, double[], double[][], double[], RungeKuttaStepInterpolator, double, double, double, double) - Constructor for class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Build a Runge-Kutta integrator with the given Butcher array.
EmbeddedRungeKuttaIntegrator(boolean, double[], double[][], double[], RungeKuttaStepInterpolator, double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Build a Runge-Kutta integrator with the given Butcher array.
EmpiricalDistribution - Interface in org.apache.commons.math.random
Represents an empirical probability distribution -- a probability distribution derived from observed data without making any assumptions about the functional form of the population distribution that the data come from.
empiricalDistribution - Variable in class org.apache.commons.math.random.ValueServer
Empirical probability distribution for use with DIGEST_MODE
EmpiricalDistributionImpl - Class in org.apache.commons.math.random
Implements EmpiricalDistribution interface.
EmpiricalDistributionImpl() - Constructor for class org.apache.commons.math.random.EmpiricalDistributionImpl
Creates a new EmpiricalDistribution with the default bin count.
EmpiricalDistributionImpl(int) - Constructor for class org.apache.commons.math.random.EmpiricalDistributionImpl
Creates a new EmpiricalDistribution with the specified bin count.
EmpiricalDistributionImpl.ArrayDataAdapter - Class in org.apache.commons.math.random
DataAdapter for data provided as array of doubles.
EmpiricalDistributionImpl.ArrayDataAdapter(double[]) - Constructor for class org.apache.commons.math.random.EmpiricalDistributionImpl.ArrayDataAdapter
Construct an ArrayDataAdapter from a double[] array
EmpiricalDistributionImpl.DataAdapter - Class in org.apache.commons.math.random
Provides methods for computing sampleStats and beanStats abstracting the source of data.
EmpiricalDistributionImpl.DataAdapter() - Constructor for class org.apache.commons.math.random.EmpiricalDistributionImpl.DataAdapter
 
EmpiricalDistributionImpl.DataAdapterFactory - Class in org.apache.commons.math.random
Factory of DataAdapter objects.
EmpiricalDistributionImpl.DataAdapterFactory() - Constructor for class org.apache.commons.math.random.EmpiricalDistributionImpl.DataAdapterFactory
 
EmpiricalDistributionImpl.StreamDataAdapter - Class in org.apache.commons.math.random
DataAdapter for data provided through some input stream
EmpiricalDistributionImpl.StreamDataAdapter(BufferedReader) - Constructor for class org.apache.commons.math.random.EmpiricalDistributionImpl.StreamDataAdapter
Create a StreamDataAdapter from a BufferedReader
equals(Object) - Method in class org.apache.commons.math.complex.Complex
Test for the equality of two Complex objects.
equals(Object) - Method in class org.apache.commons.math.fraction.Fraction
Test for the equality of two fractions.
equals(Object) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns true iff object is a BigMatrixImpl instance with the same dimensions as this and all corresponding matrix entries are equal.
equals(Object) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns true iff object is a RealMatrixImpl instance with the same dimensions as this and all corresponding matrix entries are equal.
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns true iff object is an AbstractStorelessUnivariateStatistic returning the same values as this for getResult() and getN()
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns true iff object is a SummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
Returns true iff object is a StatisticalSummaryValues instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns true iff object is a SummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
equals(double, double) - Static method in class org.apache.commons.math.util.MathUtils
Returns true iff both arguments are NaN or neither is NaN and they are equal
equals(double[], double[]) - Static method in class org.apache.commons.math.util.MathUtils
Returns true iff both arguments are null or have same dimensions and all their elements are equals
equations - Variable in class org.apache.commons.math.ode.FirstOrderConverter
Underlying second order equations set.
equations - Variable in class org.apache.commons.math.ode.RungeKuttaStepInterpolator
Reference to the differential equations beeing integrated.
Erf - Class in org.apache.commons.math.special
This is a utility class that provides computation methods related to the error functions.
Erf() - Constructor for class org.apache.commons.math.special.Erf
Default constructor.
erf(double) - Static method in class org.apache.commons.math.special.Erf
Returns the error function erf(x).
errfac - Variable in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Error coefficients for the interpolation.
estimate(EstimationProblem) - Method in class org.apache.commons.math.estimation.AbstractEstimator
Solve an estimation problem.
estimate - Variable in class org.apache.commons.math.estimation.EstimatedParameter
Current value of the parameter
estimate(EstimationProblem) - Method in interface org.apache.commons.math.estimation.Estimator
Solve an estimation problem.
estimate(EstimationProblem) - Method in class org.apache.commons.math.estimation.GaussNewtonEstimator
Solve an estimation problem using a least squares criterion.
estimate(EstimationProblem) - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Solve an estimation problem using the Levenberg-Marquardt algorithm.
EstimatedParameter - Class in org.apache.commons.math.estimation
This class represents the estimated parameters of an estimation problem.
EstimatedParameter(String, double) - Constructor for class org.apache.commons.math.estimation.EstimatedParameter
Simple constructor.
EstimatedParameter(String, double, boolean) - Constructor for class org.apache.commons.math.estimation.EstimatedParameter
Simple constructor.
EstimatedParameter(EstimatedParameter) - Constructor for class org.apache.commons.math.estimation.EstimatedParameter
Copy constructor.
estimateError(double[][], double[], double[], double) - Method in class org.apache.commons.math.ode.DormandPrince54Integrator
Compute the error ratio.
estimateError(double[][], double[], double[], double) - Method in class org.apache.commons.math.ode.DormandPrince853Integrator
Compute the error ratio.
estimateError(double[][], double[], double[], double) - Method in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Compute the error ratio.
estimateError(double[]) - Method in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Estimate interpolation error.
estimateError(double[][], double[], double[], double) - Method in class org.apache.commons.math.ode.HighamHall54Integrator
Compute the error ratio.
EstimationException - Exception in org.apache.commons.math.estimation
This class represents exceptions thrown by the estimation solvers.
EstimationException(String, Object[]) - Constructor for exception org.apache.commons.math.estimation.EstimationException
Simple constructor.
EstimationProblem - Interface in org.apache.commons.math.estimation
This interface represents an estimation problem.
Estimator - Interface in org.apache.commons.math.estimation
This interface represents solvers for estimation problems.
EulerIntegrator - Class in org.apache.commons.math.ode
This class implements a simple Euler integrator for Ordinary Differential Equations.
EulerIntegrator(double) - Constructor for class org.apache.commons.math.ode.EulerIntegrator
Simple constructor.
EulerStepInterpolator - Class in org.apache.commons.math.ode
This class implements a linear interpolator for step.
EulerStepInterpolator() - Constructor for class org.apache.commons.math.ode.EulerStepInterpolator
Simple constructor.
EulerStepInterpolator(EulerStepInterpolator) - Constructor for class org.apache.commons.math.ode.EulerStepInterpolator
Copy constructor.
evaluate(double[], double) - Static method in class org.apache.commons.math.analysis.PolynomialFunction
Uses Horner's Method to evaluate the polynomial with the given coefficients at the argument.
evaluate(double[], double[], double) - Static method in class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
Evaluate the Lagrange polynomial using Neville's Algorithm.
evaluate(double[], double[], double) - Static method in class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
Evaluate the Newton polynomial using nested multiplication.
evaluate(double[]) - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation calls AbstractStorelessUnivariateStatistic.clear(), then invokes AbstractStorelessUnivariateStatistic.increment(double) in a loop over the the input array, and then uses AbstractStorelessUnivariateStatistic.getResult() to compute the return value.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation calls AbstractStorelessUnivariateStatistic.clear(), then invokes AbstractStorelessUnivariateStatistic.increment(double) in a loop over the specified portion of the input array, and then uses AbstractStorelessUnivariateStatistic.getResult() to compute the return value.
evaluate(double[]) - Method in class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic
 
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic
 
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Returns the geometric mean of the entries in the specified portion of the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Returns the kurtosis of the entries in the specified portion of the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.Mean
Returns the arithmetic mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.Skewness
Returns the Skewness of the entries in the specifed portion of the input array.
evaluate(double[]) - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the input array, or Double.NaN if the array is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double, int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the specified portion of the input array, using the precomputed mean value.
evaluate(double[], double) - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the input array, using the precomputed mean value.
evaluate(double[]) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the variance of the entries in the input array, or Double.NaN if the array is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double, int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the variance of the entries in the specified portion of the input array, using the precomputed mean value.
evaluate(double[], double) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the variance of the entries in the input array, using the precomputed mean value.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.rank.Max
Returns the maximum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.rank.Min
Returns the minimum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double) - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Returns an estimate of the pth percentile of the values in the values array.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Returns an estimate of the quantileth percentile of the designated values in the values array.
evaluate(double[], int, int, double) - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
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.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.summary.Product
Returns the product of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.summary.Sum
The sum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
Returns the sum of the natural logs of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
Returns the sum of the squares of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[]) - Method in interface org.apache.commons.math.stat.descriptive.UnivariateStatistic
Returns the result of evaluating the statistic over the input array.
evaluate(double[], int, int) - Method in interface org.apache.commons.math.stat.descriptive.UnivariateStatistic
Returns the result of evaluating the statistic over the specified entries in the input array.
evaluate(double) - Method in class org.apache.commons.math.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double, double) - Method in class org.apache.commons.math.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double, int) - Method in class org.apache.commons.math.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double, double, int) - Method in class org.apache.commons.math.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluateCost(double[]) - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Evaluate the cost on one point.
evaluateNewSimplex(PointCostPair[], double) - Method in class org.apache.commons.math.optimization.MultiDirectional
Compute and evaluate a new simplex.
evaluateSimplex() - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Evaluate all the non-evaluated points of the simplex.
evaluateStep(StepInterpolator) - Method in class org.apache.commons.math.ode.SwitchingFunctionsHandler
Evaluate the impact of the proposed step on all handled switching functions.
evaluateStep(StepInterpolator) - Method in class org.apache.commons.math.ode.SwitchState
Evaluate the impact of the proposed step on the switching function.
evaluations - Variable in class org.apache.commons.math.optimization.DirectSearchOptimizer
Number of evaluations already performed.
eventOccurred(double, double[]) - Method in interface org.apache.commons.math.ode.SwitchingFunction
Handle an event and choose what to do next.
exp() - Method in class org.apache.commons.math.complex.Complex
Compute the exponential function of this complex number.
exp(Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.exp()
exp - Variable in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Stepsize control exponent.
expand() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Expands the internal storage array using the expansion factor.
expandTo(int) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Expands the internal storage array to the specified size.
expansionFactor - Variable in class org.apache.commons.math.util.ResizableDoubleArray
The expansion factor of the array.
expansionMode - Variable in class org.apache.commons.math.util.ResizableDoubleArray
Determines whether array expansion by expansionFactor is additive or multiplicative.
EXPONENTIAL_MODE - Static variable in class org.apache.commons.math.random.ValueServer
Exponential random deviates with mean = mu
ExponentialDistribution - Interface in org.apache.commons.math.distribution
The Exponential Distribution.
ExponentialDistributionImpl - Class in org.apache.commons.math.distribution
The default implementation of ExponentialDistribution.
ExponentialDistributionImpl(double) - Constructor for class org.apache.commons.math.distribution.ExponentialDistributionImpl
Create a exponential distribution with the given mean.
extrapolate(int, int, double[][], double[]) - Method in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Extrapolate a vector.

F

f - Variable in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
the integrand function
f - Variable in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
The function to solve.
f - Variable in class org.apache.commons.math.optimization.DirectSearchOptimizer
Cost function.
F - Variable in class org.apache.commons.math.stat.inference.OneWayAnovaImpl.AnovaStats
 
factorial(int) - Static method in class org.apache.commons.math.util.MathUtils
Returns n!.
factorialDouble(int) - Static method in class org.apache.commons.math.util.MathUtils
Returns n!.
factorialLog(int) - Static method in class org.apache.commons.math.util.MathUtils
Returns the natural logarithm of n!.
factory - Static variable in class org.apache.commons.math.analysis.UnivariateRealSolverUtils
Cached solver factory
FastCosineTransformer - Class in org.apache.commons.math.transform
Implements the Fast Cosine Transform for transformation of one-dimensional data sets.
FastCosineTransformer() - Constructor for class org.apache.commons.math.transform.FastCosineTransformer
Construct a default transformer.
FastFourierTransformer - Class in org.apache.commons.math.transform
Implements the Fast Fourier Transform for transformation of one-dimensional data sets.
FastFourierTransformer() - Constructor for class org.apache.commons.math.transform.FastFourierTransformer
Construct a default transformer.
FastSineTransformer - Class in org.apache.commons.math.transform
Implements the Fast Sine Transform for transformation of one-dimensional data sets.
FastSineTransformer() - Constructor for class org.apache.commons.math.transform.FastSineTransformer
Construct a default transformer.
fct(double[]) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Perform the FCT algorithm (including inverse).
FDistribution - Interface in org.apache.commons.math.distribution
F-Distribution.
FDistributionImpl - Class in org.apache.commons.math.distribution
Default implementation of FDistribution.
FDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.FDistributionImpl
Create a F distribution using the given degrees of freedom.
fft(double[], boolean) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Perform the base-4 Cooley-Tukey FFT algorithm (including inverse).
fft(Complex[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Perform the base-4 Cooley-Tukey FFT algorithm (including inverse).
filePointer - Variable in class org.apache.commons.math.random.ValueServer
file pointer for REPLAY_MODE
fill(double[]) - Method in class org.apache.commons.math.random.ValueServer
Fills the input array with values generated using getNext() repeatedly.
fill(int) - Method in class org.apache.commons.math.random.ValueServer
Returns an array of length length with values generated using getNext() repeatedly.
fillBinStats(Object) - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Fills binStats array (second pass through data file).
filterStep(double, boolean) - Method in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Filter the integration step.
finalized - Variable in class org.apache.commons.math.ode.AbstractStepInterpolator
indicate if the step has been finalized or not.
finalizeStep() - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Finalize the step.
finalTime - Variable in class org.apache.commons.math.ode.ContinuousOutputModel
Final integration time.
findBin(double, double, double) - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Returns the index of the bin to which the given value belongs
first - Variable in class org.apache.commons.math.ode.SwitchingFunctionsHandler
First active switching function.
FirstMoment - Class in org.apache.commons.math.stat.descriptive.moment
Computes the first moment (arithmetic mean).
FirstMoment() - Constructor for class org.apache.commons.math.stat.descriptive.moment.FirstMoment
Create a FirstMoment instance
FirstOrderConverter - Class in org.apache.commons.math.ode
This class converts second order differential equations to first order ones.
FirstOrderConverter(SecondOrderDifferentialEquations) - Constructor for class org.apache.commons.math.ode.FirstOrderConverter
Simple constructor.
FirstOrderDifferentialEquations - Interface in org.apache.commons.math.ode
This interface represents a first order differential equations set.
FirstOrderIntegrator - Interface in org.apache.commons.math.ode
This interface represents a first order integrator for differential equations.
FixedStepHandler - Interface in org.apache.commons.math.ode
This interface represents a handler that should be called after each successful fixed step.
floatValue() - Method in class org.apache.commons.math.fraction.Fraction
Gets the fraction as a float.
format(Complex, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.complex.ComplexFormat
Formats a Complex object to produce a string.
format(Object, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.complex.ComplexFormat
Formats a object to produce a string.
format(Fraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.fraction.FractionFormat
Formats a Fraction object to produce a string.
format(Object, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.fraction.FractionFormat
Formats a object to produce a string.
format(Fraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.fraction.ProperFractionFormat
Formats a Fraction object to produce a string.
formatComplex(Complex) - Static method in class org.apache.commons.math.complex.ComplexFormat
This static method calls formatComplex() on a default instance of ComplexFormat.
formatDouble(double, NumberFormat, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.complex.ComplexFormat
Formats a double value to produce a string.
formatFraction(Fraction) - Static method in class org.apache.commons.math.fraction.FractionFormat
This static method calls formatFraction() on a default instance of FractionFormat.
forward - Variable in class org.apache.commons.math.ode.AbstractStepInterpolator
integration direction.
forward - Variable in class org.apache.commons.math.ode.ContinuousOutputModel
Integration direction indicator.
forward - Variable in class org.apache.commons.math.ode.StepNormalizer
Integration direction indicator.
FourthMoment - Class in org.apache.commons.math.stat.descriptive.moment
Computes a statistic related to the Fourth Central Moment.
FourthMoment() - Constructor for class org.apache.commons.math.stat.descriptive.moment.FourthMoment
Create a FourthMoment instance
Fraction - Class in org.apache.commons.math.fraction
Representation of a rational number.
Fraction(double) - Constructor for class org.apache.commons.math.fraction.Fraction
Create a fraction given the double value.
Fraction(double, double, int) - Constructor for class org.apache.commons.math.fraction.Fraction
Create a fraction given the double value and maximum error allowed.
Fraction(double, int) - Constructor for class org.apache.commons.math.fraction.Fraction
Create a fraction given the double value and maximum denominator.
Fraction(double, double, int, int) - Constructor for class org.apache.commons.math.fraction.Fraction
Create a fraction given the double value and either the maximum error allowed or the maximum number of denominator digits.
Fraction(int, int) - Constructor for class org.apache.commons.math.fraction.Fraction
Create a fraction given the numerator and denominator.
FractionConversionException - Exception in org.apache.commons.math.fraction
Error thrown when a double value cannot be converted to a fraction in the allowed number of iterations.
FractionConversionException(double, int) - Constructor for exception org.apache.commons.math.fraction.FractionConversionException
Constructs an exception with specified formatted detail message.
FractionConversionException(double, long, long) - Constructor for exception org.apache.commons.math.fraction.FractionConversionException
Constructs an exception with specified formatted detail message.
FractionFormat - Class in org.apache.commons.math.fraction
Formats a Fraction number in proper format or improper format.
FractionFormat() - Constructor for class org.apache.commons.math.fraction.FractionFormat
Create an improper formatting instance with the default number format for the numerator and denominator.
FractionFormat(NumberFormat) - Constructor for class org.apache.commons.math.fraction.FractionFormat
Create an improper formatting instance with a custom number format for both the numerator and denominator.
FractionFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math.fraction.FractionFormat
Create an improper formatting instance with a custom number format for the numerator and a custom number format for the denominator.
freqTable - Variable in class org.apache.commons.math.stat.Frequency
underlying collection
Frequency - Class in org.apache.commons.math.stat
Maintains a frequency distribution.
Frequency() - Constructor for class org.apache.commons.math.stat.Frequency
Default constructor.
Frequency(Comparator) - Constructor for class org.apache.commons.math.stat.Frequency
Constructor allowing values Comparator to be specified.
Frequency.NaturalComparator - Class in org.apache.commons.math.stat
A Comparator that compares comparable objects using the natural order.
Frequency.NaturalComparator() - Constructor for class org.apache.commons.math.stat.Frequency.NaturalComparator
 
fsal - Variable in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Indicator for fsal methods.
fst(double[]) - Method in class org.apache.commons.math.transform.FastSineTransformer
Perform the FST algorithm (including inverse).
function - Variable in class org.apache.commons.math.ode.SwitchState
Switching function.
FunctionEvaluationException - Exception in org.apache.commons.math
Exception thrown when an error occurs evaluating a function.
FunctionEvaluationException(double) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Construct an exception indicating the argument value that caused the function evaluation to fail.
FunctionEvaluationException(double, String) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Deprecated. as of 1.2, replaced by FunctionEvaluationException.FunctionEvaluationException(double, String, Object[])
FunctionEvaluationException(double, String, Object[]) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Constructs an exception with specified formatted detail message.
FunctionEvaluationException(double, String, Throwable) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Deprecated. as of 1.2, replaced by FunctionEvaluationException.FunctionEvaluationException(double, String, Object[], Throwable)
FunctionEvaluationException(double, Throwable) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Constructs an exception with specified root cause.
FunctionEvaluationException(double, String, Object[], Throwable) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Constructs an exception with specified formatted detail message and root cause.
functions - Variable in class org.apache.commons.math.ode.SwitchingFunctionsHandler
Switching functions.
functionValueAccuracy - Variable in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Maximum error of function.

G

g(double, double[]) - Method in interface org.apache.commons.math.ode.SwitchingFunction
Compute the value of the switching function.
g0 - Variable in class org.apache.commons.math.ode.SwitchState
Value of the switching function at the beginning of the step.
g0Positive - Variable in class org.apache.commons.math.ode.SwitchState
Simulated sign of g0 (we cheat when crossing events).
gamma - Variable in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Internal Gamma distribution.
gamma - Variable in class org.apache.commons.math.optimization.MultiDirectional
Contraction coefficient.
gamma - Variable in class org.apache.commons.math.optimization.NelderMead
Contraction coefficient.
Gamma - Class in org.apache.commons.math.special
This is a utility class that provides computation methods related to the Gamma family of functions.
Gamma() - Constructor for class org.apache.commons.math.special.Gamma
Default constructor.
GammaDistribution - Interface in org.apache.commons.math.distribution
The Gamma Distribution.
GammaDistributionImpl - Class in org.apache.commons.math.distribution
The default implementation of GammaDistribution.
GammaDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.GammaDistributionImpl
Create a new gamma distribution with the given alpha and beta values.
GAUSSIAN_MODE - Static variable in class org.apache.commons.math.random.ValueServer
Gaussian random deviates with mean = mu, std dev = sigma
GaussianRandomGenerator - Class in org.apache.commons.math.random
This class is a gaussian normalized random generator for scalars.
GaussianRandomGenerator(RandomGenerator) - Constructor for class org.apache.commons.math.random.GaussianRandomGenerator
Create a new generator.
GaussNewtonEstimator - Class in org.apache.commons.math.estimation
This class implements a solver for estimation problems.
GaussNewtonEstimator(int, double, double) - Constructor for class org.apache.commons.math.estimation.GaussNewtonEstimator
Simple constructor.
gcd(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Gets the greatest common divisor of the absolute value of two numbers, using the "binary gcd" method which avoids division and modulo operations.
generator - Variable in class org.apache.commons.math.optimization.DirectSearchOptimizer
Random generator for multi-start.
generator - Variable in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Underlying generator.
generator - Variable in class org.apache.commons.math.random.GaussianRandomGenerator
Underlying generator.
generator - Variable in class org.apache.commons.math.random.UncorrelatedRandomVectorGenerator
Underlying scalar generator.
generator - Variable in class org.apache.commons.math.random.UniformRandomGenerator
Underlying generator.
geoMean - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
geoMean of values that have been added
geoMeanImpl - Variable in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Geometric mean statistic implementation - can be reset by setter.
geoMeanImpl - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Geometric mean statistic implementation - can be reset by setter.
GeometricMean - Class in org.apache.commons.math.stat.descriptive.moment
Returns the geometric mean of the available values.
GeometricMean() - Constructor for class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Create a GeometricMean instance
GeometricMean(SumOfLogs) - Constructor for class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Create a GeometricMean instance using the given SumOfLogs instance
geometricMean - Static variable in class org.apache.commons.math.stat.StatUtils
geometric mean
geometricMean(double[]) - Static method in class org.apache.commons.math.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) - Static method in class org.apache.commons.math.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.
geometricMeanImpl - Variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Geometric mean statistic implementation - can be reset by setter.
getA(int, double) - Method in class org.apache.commons.math.util.ContinuedFraction
Access the n-th a coefficient of the continued fraction.
getA1() - Method in class org.apache.commons.math.geometry.RotationOrder
Get the axis of the first rotation.
getA2() - Method in class org.apache.commons.math.geometry.RotationOrder
Get the axis of the second rotation.
getA3() - Method in class org.apache.commons.math.geometry.RotationOrder
Get the axis of the second rotation.
getAbsoluteAccuracy() - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Get the actual absolute accuracy.
getAbsoluteAccuracy() - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Get the actual absolute accuracy.
getAdapter(Object) - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl.DataAdapterFactory
Creates a DataAdapter from a data object
getAllParameters() - Method in interface org.apache.commons.math.estimation.EstimationProblem
Get all the parameters of the problem.
getAllParameters() - Method in class org.apache.commons.math.estimation.SimpleEstimationProblem
Get all the parameters of the problem.
getAlpha() - Method in interface org.apache.commons.math.distribution.GammaDistribution
Access the shape parameter, alpha
getAlpha() - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Access the shape parameter, alpha
getAlpha() - Method in class org.apache.commons.math.geometry.Vector3D
Get the azimuth of the vector.
getAngle() - Method in class org.apache.commons.math.geometry.Rotation
Get the angle of the rotation.
getAngles(RotationOrder) - Method in class org.apache.commons.math.geometry.Rotation
Get the Cardan or Euler angles corresponding to the instance.
getArgument() - Method in exception org.apache.commons.math.FunctionEvaluationException
Returns the function argument that caused this exception.
getArguments() - Method in exception org.apache.commons.math.MathException
Gets the arguments used to build the message of this throwable.
getAvailableLocales() - Static method in class org.apache.commons.math.complex.ComplexFormat
Get the set of locales for which complex formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math.fraction.FractionFormat
Get the set of locales for which complex formats are available.
getAxis() - Method in class org.apache.commons.math.geometry.Rotation
Get the normalized axis of the rotation.
getB(int, double) - Method in class org.apache.commons.math.util.ContinuedFraction
Access the n-th b coefficient of the continued fraction.
getBeta() - Method in interface org.apache.commons.math.distribution.GammaDistribution
Access the scale parameter, beta
getBeta() - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Access the scale parameter, beta
getBinCount() - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Returns the number of bins.
getBinCount() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Returns the number of bins.
getBinStats() - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Returns a list of SummaryStatistics containing statistics describing the values in each of the bins.
getBinStats() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Returns an ArrayList of SummaryStatistics instances containing statistics describing the values in each of the bins.
getCause() - Method in exception org.apache.commons.math.MathException
Gets the cause of this throwable.
getCenters() - Method in class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
Returns a copy of the centers array.
getChiSquare(EstimationProblem) - Method in class org.apache.commons.math.estimation.AbstractEstimator
Get the Chi-Square value.
getChiSquareTest() - Static method in class org.apache.commons.math.stat.inference.TestUtils
Return a (singleton) ChiSquareTest instance.
getCoefficients() - Method in class org.apache.commons.math.analysis.PolynomialFunction
Returns a copy of the coefficients array.
getCoefficients() - Method in class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
Returns a copy of the coefficients array.
getCoefficients() - Method in class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
Returns a copy of the coefficients array.
getColumn(int) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the entries in column number col as an array.
getColumn(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the entries in column number col as an array.
getColumn(int) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the entries in column number col as an array.
getColumn(int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns the entries in column number col as an array.
getColumnAsDoubleArray(int) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the entries in column number col as an array of double values.
getColumnAsDoubleArray(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the entries in column number col as an array of double values.
getColumnDimension() - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the number of columns in the matrix.
getColumnDimension() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math.linear.RealMatrixImpl
 
getColumnMatrix(int) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns the entries in column number column as a column matrix.
getContents() - Method in class org.apache.commons.math.MessagesResources_fr
Get the non-translated/translated messages arrays from this resource bundle.
getContractionCriteria() - Method in class org.apache.commons.math.util.ResizableDoubleArray
The contraction criteria defines when the internal array will contract to store only the number of elements in the element array.
getCost() - Method in class org.apache.commons.math.optimization.PointCostPair
Get the cost.
getCostEvaluations() - Method in class org.apache.commons.math.estimation.AbstractEstimator
Get the number of cost evaluations.
getCount(Object) - Method in class org.apache.commons.math.stat.Frequency
Returns the number of values = v.
getCount(int) - Method in class org.apache.commons.math.stat.Frequency
Returns the number of values = v.
getCount(long) - Method in class org.apache.commons.math.stat.Frequency
Returns the number of values = v.
getCount(char) - Method in class org.apache.commons.math.stat.Frequency
Returns the number of values = v.
getCovariance() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the covariance matrix of the values that have been added.
getCovariance() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns the covariance of the available values.
getCovariance() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getCovariances(EstimationProblem) - Method in class org.apache.commons.math.estimation.AbstractEstimator
Get the covariance matrix of estimated parameters.
getCovariances(EstimationProblem) - Method in interface org.apache.commons.math.estimation.Estimator
Get the covariance matrix of estimated parameters.
getCumFreq(Object) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumFreq(int) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumFreq(long) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumFreq(char) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumPct(Object) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCumPct(int) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCumPct(long) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCumPct(char) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCurrentSignedStepsize() - Method in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Get the current signed value of the integration stepsize.
getCurrentSignedStepsize() - Method in interface org.apache.commons.math.ode.FirstOrderIntegrator
Get the current signed value of the integration stepsize.
getCurrentSignedStepsize() - Method in class org.apache.commons.math.ode.RungeKuttaIntegrator
Get the current signed value of the integration stepsize.
getCurrentStepStart() - Method in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Get the current value of the step start time ti.
getCurrentStepStart() - Method in interface org.apache.commons.math.ode.FirstOrderIntegrator
Get the current value of the step start time ti.
getCurrentStepStart() - Method in class org.apache.commons.math.ode.RungeKuttaIntegrator
Get the current value of the step start time ti.
getCurrentTime() - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Get the current grid point time.
getCurrentTime() - Method in interface org.apache.commons.math.ode.StepInterpolator
Get the current grid point time.
getData() - Method in interface org.apache.commons.math.linear.BigMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns matrix entries as a two-dimensional array.
getData() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns matrix entries as a two-dimensional array.
getDataAsDoubleArray() - Method in interface org.apache.commons.math.linear.BigMatrix
Returns matrix entries as a two-dimensional array.
getDataAsDoubleArray() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns matrix entries as a two-dimensional array.
getDataRef() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns a reference to the underlying data array.
getDefaultNumberFormat() - Static method in class org.apache.commons.math.complex.ComplexFormat
Create a default number format.
getDefaultNumberFormat(Locale) - Static method in class org.apache.commons.math.complex.ComplexFormat
Create a default number format.
getDefaultNumberFormat() - Static method in class org.apache.commons.math.fraction.FractionFormat
Create a default number format.
getDefaultNumberFormat(Locale) - Static method in class org.apache.commons.math.fraction.FractionFormat
Create a default number format.
getDegreesOfFreedom() - Method in interface org.apache.commons.math.distribution.ChiSquaredDistribution
Access the degrees of freedom.
getDegreesOfFreedom() - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Access the degrees of freedom.
getDegreesOfFreedom() - Method in interface org.apache.commons.math.distribution.TDistribution
Access the degrees of freedom.
getDegreesOfFreedom() - Method in class org.apache.commons.math.distribution.TDistributionImpl
Access the degrees of freedom.
getDelta() - Method in class org.apache.commons.math.geometry.Vector3D
Get the elevation of the vector.
getDenominator() - Method in class org.apache.commons.math.fraction.Fraction
Access the denominator.
getDenominatorDegreesOfFreedom() - Method in interface org.apache.commons.math.distribution.FDistribution
Access the denominator degrees of freedom.
getDenominatorDegreesOfFreedom() - Method in class org.apache.commons.math.distribution.FDistributionImpl
Access the denominator degrees of freedom.
getDenominatorFormat() - Method in class org.apache.commons.math.fraction.FractionFormat
Access the denominator format.
getDeterminant() - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the determinant of this matrix.
getDeterminant() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the determinant of this matrix.
getDeterminant() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the determinant of this matrix.
getDeterminant() - Method in class org.apache.commons.math.linear.RealMatrixImpl
 
getDimension() - Method in class org.apache.commons.math.ode.FirstOrderConverter
Get the dimension of the problem.
getDimension() - Method in interface org.apache.commons.math.ode.FirstOrderDifferentialEquations
Get the dimension of the problem.
getDimension() - Method in interface org.apache.commons.math.ode.SecondOrderDifferentialEquations
Get the dimension of the problem.
getDimension() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the dimension of the data
getDimension() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns the dimension of the data
getDimension() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getDimension1() - Method in exception org.apache.commons.math.DimensionMismatchException
Get the first dimension
getDimension2() - Method in exception org.apache.commons.math.DimensionMismatchException
Get the second dimension
getDistributionFactory() - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Deprecated. inject ChiSquaredDistribution instances directly instead of using a factory.
getDistributionFactory() - Method in class org.apache.commons.math.stat.inference.TTestImpl
Deprecated. inject TDistribution directly instead of using a factory.
getDomain(int, int, int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Return the domain for the given hypergeometric distribution parameters.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.AbstractContinuousDistribution
Access the domain value lower bound, based on p, used to bracket a CDF root.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
Access the domain value lower bound, based on p, used to bracket a PDF root.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Access the domain value lower bound, based on p, used to bracket a PDF root.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Access the domain value lower bound, based on p, used to bracket a CDF root.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Access the domain value lower bound, based on p, used to bracket a CDF root.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Access the domain value lower bound, based on p, used to bracket a CDF root.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.FDistributionImpl
Access the domain value lower bound, based on p, used to bracket a CDF root.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Access the domain value lower bound, based on p, used to bracket a CDF root.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Access the domain value lower bound, based on p, used to bracket a PDF root.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Access the domain value lower bound, based on p, used to bracket a CDF root.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Access the domain value lower bound, based on p, used to bracket a PDF root.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Access the domain value lower bound, based on p, used to bracket a CDF root.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.TDistributionImpl
Access the domain value lower bound, based on p, used to bracket a CDF root.
getDomainLowerBound(double) - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Access the domain value lower bound, based on p, used to bracket a CDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.AbstractContinuousDistribution
Access the domain value upper bound, based on p, used to bracket a CDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
Access the domain value upper bound, based on p, used to bracket a PDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Access the domain value upper bound, based on p, used to bracket a PDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Access the domain value upper bound, based on p, used to bracket a CDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Access the domain value upper bound, based on p, used to bracket a CDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Access the domain value upper bound, based on p, used to bracket a CDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.FDistributionImpl
Access the domain value upper bound, based on p, used to bracket a CDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Access the domain value upper bound, based on p, used to bracket a CDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Access the domain value upper bound, based on p, used to bracket a PDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Access the domain value upper bound, based on p, used to bracket a CDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Access the domain value upper bound, based on p, used to bracket a PDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Access the domain value upper bound, based on p, used to bracket a CDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.TDistributionImpl
Access the domain value upper bound, based on p, used to bracket a CDF root.
getDomainUpperBound(double) - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Access the domain value upper bound, based on p, used to bracket a CDF root.
getDuplicateAbscissa() - Method in exception org.apache.commons.math.DuplicateSampleAbscissaException
Get the duplicate abscissa.
getElement(int) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the element at the specified index
getElement(int) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
 
getElement(int) - Method in interface org.apache.commons.math.util.DoubleArray
Returns the element at the specified index.
getElement(int) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns the element at the specified index
getElements() - Method in interface org.apache.commons.math.util.DoubleArray
Returns a double[] array containing the elements of this DoubleArray.
getElements() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns a double array containing the elements of this ResizableArray.
getEmpiricalDistribution() - Method in class org.apache.commons.math.random.ValueServer
Getter for property empiricalDistribution.
getEntry(int, int) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the entry in the specified row and column.
getEntry(int, int) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns the entry in the specified row and column.
getEntryAsDouble(int, int) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the entry in the specified row and column as a double.
getEntryAsDouble(int, int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the entry in the specified row and column as a double.
getEstimate() - Method in class org.apache.commons.math.estimation.EstimatedParameter
Get the current estimate of the parameter
getEventTime() - Method in class org.apache.commons.math.ode.SwitchingFunctionsHandler
Get the occurrence time of the first event triggered in the last evaluated step.
getEventTime() - Method in class org.apache.commons.math.ode.SwitchState
Get the occurrence time of the event triggered in the current step.
getExpansionFactor() - Method in class org.apache.commons.math.util.ResizableDoubleArray
The expansion factor controls the size of a new aray when an array needs to be expanded.
getExpansionMode() - Method in class org.apache.commons.math.util.ResizableDoubleArray
The expansionMode determines whether the internal storage array grows additively (ADDITIVE_MODE) or multiplicatively (MULTIPLICATIVE_MODE) when it is expanded.
getFinalTime() - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Get the final integration time.
getFunctionValueAccuracy() - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Get the actual function value accuracy.
getFunctionValueAccuracy() - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Get the actual function value accuracy.
getGamma() - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Access the Gamma distribution.
getGenerator() - Method in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Get the underlying normalized components generator.
getGeoMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured geometric mean implementation
getGeoMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured geometric mean implementation
getGeoMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getGeoMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getGeometricMean() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the geometric mean of the available values
getGeometricMean() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the geometric mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getGeometricMean() - Method in interface org.apache.commons.math.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() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the geometric mean of the values that have been added.
getGeometricMean() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getGeometricMean() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getGeometricMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured geometric mean implementation.
getIdentity(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. use MatrixUtils.createBigIdentityMatrix(int)
getIdentity(int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. use MatrixUtils.createRealIdentityMatrix(int)
getImaginary() - Method in class org.apache.commons.math.complex.Complex
Access the imaginary part.
getImaginaryCharacter() - Method in class org.apache.commons.math.complex.ComplexFormat
Access the imaginaryCharacter.
getImaginaryFormat() - Method in class org.apache.commons.math.complex.ComplexFormat
Access the imaginaryFormat.
getImproperInstance() - Static method in class org.apache.commons.math.fraction.FractionFormat
Returns the default complex format for the current locale.
getImproperInstance(Locale) - Static method in class org.apache.commons.math.fraction.FractionFormat
Returns the default complex format for the given locale.
getInitialDomain(double) - Method in class org.apache.commons.math.distribution.AbstractContinuousDistribution
Access the initial domain value, based on p, used to bracket a CDF root.
getInitialDomain(double) - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Access the initial domain value, based on p, used to bracket a CDF root.
getInitialDomain(double) - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Access the initial domain value, based on p, used to bracket a CDF root.
getInitialDomain(double) - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Access the initial domain value, based on p, used to bracket a CDF root.
getInitialDomain(double) - Method in class org.apache.commons.math.distribution.FDistributionImpl
Access the initial domain value, based on p, used to bracket a CDF root.
getInitialDomain(double) - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Access the initial domain value, based on p, used to bracket a CDF root.
getInitialDomain(double) - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Access the initial domain value, based on p, used to bracket a CDF root.
getInitialDomain(double) - Method in class org.apache.commons.math.distribution.TDistributionImpl
Access the initial domain value, based on p, used to bracket a CDF root.
getInitialDomain(double) - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Access the initial domain value, based on p, used to bracket a CDF root.
getInitialTime() - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Get the initial integration time.
getInstance() - Static method in class org.apache.commons.math.complex.ComplexFormat
Returns the default complex format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math.complex.ComplexFormat
Returns the default complex format for the given locale.
getInstance() - Static method in class org.apache.commons.math.ode.DummyStepHandler
Get the only instance.
getIntercept() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the intercept of the estimated regression line.
getIntercept(double) - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the intercept of the estimated regression line, given the slope.
getInterceptStdErr() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the standard error of the intercept estimate, usually denoted s(b0).
getInternalLength() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Notice the package scope on this method.
getInterpolatedState() - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Get the state vector of the interpolated point.
getInterpolatedState() - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Get the state vector of the interpolated point.
getInterpolatedState() - Method in interface org.apache.commons.math.ode.StepInterpolator
Get the state vector of the interpolated point.
getInterpolatedTime() - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Get the time of the interpolated point.
getInterpolatedTime() - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Get the time of the interpolated point.
getInterpolatedTime() - Method in interface org.apache.commons.math.ode.StepInterpolator
Get the time of the interpolated point.
getInterpolatingPoints() - Method in class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
Returns a copy of the interpolating points array.
getInterpolatingValues() - Method in class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
Returns a copy of the interpolating values array.
getIterationCount() - Method in interface org.apache.commons.math.analysis.UnivariateRealIntegrator
Get the number of iterations in the last run of the integrator.
getIterationCount() - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Access the last iteration count.
getIterationCount() - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Get the number of iterations in the last run of the solver.
getIterationCount() - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Access the last iteration count.
getJacobianEvaluations() - Method in class org.apache.commons.math.estimation.AbstractEstimator
Get the number of jacobian evaluations.
getKnots() - Method in class org.apache.commons.math.analysis.PolynomialSplineFunction
Returns an array copy of the knot points.
getKurtosis() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the Kurtosis of the available values.
getKurtosisImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured kurtosis implementation.
getLowerDomain(int, int, int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Return the lowest domain value for the given hypergeometric distribution parameters.
getLUMatrix() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the LU decomposition as a BigMatrix.
getLUMatrix() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns the LU decomposition as a RealMatrix.
getMatrix() - Method in class org.apache.commons.math.geometry.Rotation
Get the 3X3 matrix corresponding to the instance
getMax() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the maximum of the available values
getMax() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the maximum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMax() - Method in interface org.apache.commons.math.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() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the maximum of the available values
getMax() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getMax() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the maximum of the values that have been added.
getMax() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getMax() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getMaxGrowth() - Method in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Get the maximal growth factor for stepsize control.
getMaximalIterationCount() - Method in interface org.apache.commons.math.analysis.UnivariateRealIntegrator
Get the upper limit for the number of iterations.
getMaximalIterationCount() - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Get the upper limit for the number of iterations.
getMaximalIterationCount() - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Get the upper limit for the number of iterations.
getMaximalIterationCount() - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Get the upper limit for the number of iterations.
getMaxImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured maximum implementation.
getMaxImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured maximum implementation
getMaxImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured maximum implementation
getMaxImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getMaxImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getMaxIterations() - Method in exception org.apache.commons.math.MaxIterationsExceededException
Get the maximal number of iterations allowed.
getMaxStep() - Method in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Get the maximal step.
getMean() - Method in interface org.apache.commons.math.distribution.ExponentialDistribution
Access the mean.
getMean() - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Access the mean.
getMean() - Method in interface org.apache.commons.math.distribution.NormalDistribution
Access the mean.
getMean() - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Access the mean.
getMean() - Method in interface org.apache.commons.math.distribution.PoissonDistribution
Get the mean for the distribution.
getMean() - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Get the Poisson mean for the distribution.
getMean() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the arithmetic mean of the available values
getMean() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMean() - Method in interface org.apache.commons.math.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() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the arithmetic mean of the available values
getMean() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getMean() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the mean of the values that have been added.
getMean() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getMean() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured mean implementation.
getMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured mean implementation
getMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured mean implementation
getMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getMeanSquareError() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the sum of squared errors divided by the degrees of freedom, usually abbreviated MSE.
getMeasuredValue() - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Get the measured value
getMeasurements() - Method in interface org.apache.commons.math.estimation.EstimationProblem
Get the measurements of an estimation problem.
getMeasurements() - Method in class org.apache.commons.math.estimation.SimpleEstimationProblem
Get the measurements of an estimation problem.
getMedian() - Method in interface org.apache.commons.math.distribution.CauchyDistribution
Access the median.
getMedian() - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Access the median.
getMessage(Locale) - Method in exception org.apache.commons.math.MathException
Gets the message in a specified locale.
getMin() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the minimum of the available values
getMin() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the minimum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMin() - Method in interface org.apache.commons.math.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() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the minimum of the available values
getMin() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getMin() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the minimum of the values that have been added.
getMin() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getMin() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getMinima() - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Get all the minima found during the last call to minimize.
getMinimalIterationCount() - Method in interface org.apache.commons.math.analysis.UnivariateRealIntegrator
Get the lower limit for the number of iterations.
getMinimalIterationCount() - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Get the lower limit for the number of iterations.
getMinImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured minimum implementation.
getMinImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured minimum implementation
getMinImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured minimum implementation
getMinImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getMinImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getMinReduction() - Method in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Get the minimal reduction factor for stepsize control.
getMinStep() - Method in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Get the minimal step.
getMode() - Method in class org.apache.commons.math.random.ValueServer
Getter for property mode.
getMu() - Method in class org.apache.commons.math.random.ValueServer
Getter for property mu.
getN() - Method in class org.apache.commons.math.analysis.PolynomialSplineFunction
Returns the number of spline segments = the number of polynomials = the number of knot points - 1.
getN() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
 
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
 
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
 
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.Mean
 
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.Skewness
 
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
 
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
 
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Get the number of vectors in the sample.
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialMean
Get the number of vectors in the sample.
getN() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math.stat.descriptive.rank.Max
 
getN() - Method in class org.apache.commons.math.stat.descriptive.rank.Min
 
getN() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns the number of available values
getN() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the number of available values
getN() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getN() - Method in interface org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.summary.Product
 
getN() - Method in class org.apache.commons.math.stat.descriptive.summary.Sum
 
getN() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
 
getN() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
 
getN() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
 
getN() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getN() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getN() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the number of observations that have been added to the model.
getName() - Method in class org.apache.commons.math.estimation.EstimatedParameter
get the name of the parameter
getName() - Method in class org.apache.commons.math.ode.ClassicalRungeKuttaIntegrator
Get the name of the method.
getName() - Method in class org.apache.commons.math.ode.DormandPrince54Integrator
Get the name of the method.
getName() - Method in class org.apache.commons.math.ode.DormandPrince853Integrator
Get the name of the method.
getName() - Method in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Get the name of the method.
getName() - Method in class org.apache.commons.math.ode.EulerIntegrator
Get the name of the method.
getName() - Method in interface org.apache.commons.math.ode.FirstOrderIntegrator
Get the name of the method.
getName() - Method in class org.apache.commons.math.ode.GillIntegrator
Get the name of the method.
getName() - Method in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Get the name of the method.
getName() - Method in class org.apache.commons.math.ode.HighamHall54Integrator
Get the name of the method.
getName() - Method in class org.apache.commons.math.ode.MidpointIntegrator
Get the name of the method.
getName() - Method in class org.apache.commons.math.ode.RungeKuttaIntegrator
Get the name of the method.
getName() - Method in interface org.apache.commons.math.ode.SecondOrderIntegrator
Get the name of the method.
getName() - Method in class org.apache.commons.math.ode.ThreeEighthesIntegrator
Get the name of the method.
getNatural(int) - Method in class org.apache.commons.math.random.RandomDataImpl
Returns an array representing n.
getNewtonCoefficients() - Method in class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
Returns a copy of coefficients in Newton form formula.
getNext() - Method in class org.apache.commons.math.random.ValueServer
Returns the next generated value, generated according to the mode value (see MODE constants).
getNextDigest() - Method in class org.apache.commons.math.random.ValueServer
Gets a random value in DIGEST_MODE.
getNextExponential() - Method in class org.apache.commons.math.random.ValueServer
Gets an exponentially distributed random value with mean = mu.
getNextGaussian() - Method in class org.apache.commons.math.random.ValueServer
Gets a Gaussian distributed random value with mean = mu and standard deviation = sigma.
getNextReplay() - Method in class org.apache.commons.math.random.ValueServer
Gets next sequential value from the valuesFileURL.
getNextUniform() - Method in class org.apache.commons.math.random.ValueServer
Gets a uniformly distributed random value with mean = mu.
getNextValue() - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Generates a random value from this distribution.
getNextValue() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Generates a random value from this distribution.
getNorm() - Method in class org.apache.commons.math.geometry.Vector3D
Get the norm for the vector.
getNorm() - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in class org.apache.commons.math.linear.RealMatrixImpl
 
getNumberOfSuccesses() - Method in interface org.apache.commons.math.distribution.HypergeometricDistribution
Access the number of successes.
getNumberOfSuccesses() - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Access the number of successes.
getNumberOfSuccesses() - Method in interface org.apache.commons.math.distribution.PascalDistribution
Access the number of successes for this distribution.
getNumberOfSuccesses() - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Access the number of successes for this distribution.
getNumberOfTrials() - Method in interface org.apache.commons.math.distribution.BinomialDistribution
Access the number of trials for this distribution.
getNumberOfTrials() - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Access the number of trials for this distribution.
getNumElements() - Method in interface org.apache.commons.math.util.DoubleArray
Returns the number of elements currently in the array.
getNumElements() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns the number of elements currently in the array.
getNumerator() - Method in class org.apache.commons.math.fraction.Fraction
Access the numerator.
getNumeratorDegreesOfFreedom() - Method in interface org.apache.commons.math.distribution.FDistribution
Access the numerator degrees of freedom.
getNumeratorDegreesOfFreedom() - Method in class org.apache.commons.math.distribution.FDistributionImpl
Access the numerator degrees of freedom.
getNumeratorFormat() - Method in class org.apache.commons.math.fraction.FractionFormat
Access the numerator format.
getOneWayAnova() - Static method in class org.apache.commons.math.stat.inference.TestUtils
Return a (singleton) OneWayAnova instance.
getOrder() - Method in class org.apache.commons.math.ode.DormandPrince54Integrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math.ode.DormandPrince853Integrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math.ode.HighamHall54Integrator
Get the order of the method.
getPartial(EstimatedParameter) - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Get the partial derivative of the theoretical value according to the parameter.
getPattern() - Method in exception org.apache.commons.math.MathException
Gets the pattern used to build the message of this throwable.
getPct(Object) - Method in class org.apache.commons.math.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPct(int) - Method in class org.apache.commons.math.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPct(long) - Method in class org.apache.commons.math.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPct(char) - Method in class org.apache.commons.math.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPercentile(double) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns an estimate for the pth percentile of the stored values.
getPercentileImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured percentile implementation.
getPermutation() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the permutation associated with the lu decomposition.
getPermutation() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns the permutation associated with the lu decomposition.
getPoint() - Method in class org.apache.commons.math.optimization.PointCostPair
Get the point.
getPolynomialFunction() - Method in class org.apache.commons.math.analysis.LaguerreSolver
Returns a copy of the polynomial function.
getPolynomials() - Method in class org.apache.commons.math.analysis.PolynomialSplineFunction
Returns a copy of the interpolating polynomials array.
getPopulationSize() - Method in interface org.apache.commons.math.distribution.HypergeometricDistribution
Access the population size.
getPopulationSize() - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Access the population size.
getPreviousTime() - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Get the previous grid point time.
getPreviousTime() - Method in interface org.apache.commons.math.ode.StepInterpolator
Get the previous grid point time.
getProbabilityOfSuccess() - Method in interface org.apache.commons.math.distribution.BinomialDistribution
Access the probability of success for this distribution.
getProbabilityOfSuccess() - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Access the probability of success for this distribution.
getProbabilityOfSuccess() - Method in interface org.apache.commons.math.distribution.PascalDistribution
Access the probability of success for this distribution.
getProbabilityOfSuccess() - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Access the probability of success for this distribution.
getProperInstance() - Static method in class org.apache.commons.math.fraction.FractionFormat
Returns the default complex format for the current locale.
getProperInstance(Locale) - Static method in class org.apache.commons.math.fraction.FractionFormat
Returns the default complex format for the given locale.
getQ() - Method in interface org.apache.commons.math.linear.QRDecomposition
Returns the matrix Q of the decomposition.
getQ() - Method in class org.apache.commons.math.linear.QRDecompositionImpl
Returns the matrix Q of the QR-decomposition.
getQ0() - Method in class org.apache.commons.math.geometry.Rotation
Get the scalar coordinate of the quaternion.
getQ1() - Method in class org.apache.commons.math.geometry.Rotation
Get the first coordinate of the vectorial part of the quaternion.
getQ2() - Method in class org.apache.commons.math.geometry.Rotation
Get the second coordinate of the vectorial part of the quaternion.
getQ3() - Method in class org.apache.commons.math.geometry.Rotation
Get the third coordinate of the vectorial part of the quaternion.
getQuantile() - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Returns the value of the quantile field (determines what percentile is computed when evaluate() is called with no quantile argument).
getR() - Method in interface org.apache.commons.math.linear.QRDecomposition
Returns the matrix R of the decomposition.
getR() - Method in class org.apache.commons.math.linear.QRDecompositionImpl
Returns the matrix R of the QR-decomposition.
getR() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns Pearson's product moment correlation coefficient, usually denoted r.
getRan() - Method in class org.apache.commons.math.random.RandomDataImpl
Returns the RandomGenerator used to generate non-secure random data.
getRank() - Method in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Get the rank of the covariance matrix.
getReal() - Method in class org.apache.commons.math.complex.Complex
Access the real part.
getRealFormat() - Method in class org.apache.commons.math.complex.ComplexFormat
Access the realFormat.
getReducedFraction(int, int) - Static method in class org.apache.commons.math.fraction.Fraction
Creates a Fraction instance with the 2 parts of a fraction Y/Z.
getRegressionSumSquares() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the sum of squared deviations of the predicted y values about their mean (which equals the mean of y).
getRegressionSumSquares(double) - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Computes SSR from b1.
getRelativeAccuracy() - Method in interface org.apache.commons.math.analysis.UnivariateRealIntegrator
Get the actual relative accuracy.
getRelativeAccuracy() - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Get the actual relative accuracy.
getRelativeAccuracy() - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Get the actual relative accuracy.
getRelativeAccuracy() - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Get the actual relative accuracy.
getResidual() - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Get the residual for this measurement The residual is the measured value minus the theoretical value.
getResult() - Method in interface org.apache.commons.math.analysis.UnivariateRealIntegrator
Get the result of the last run of the integrator.
getResult() - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Access the last computed integral.
getResult() - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Get the result of the last run of the solver.
getResult() - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Access the last computed root.
getResult() - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.FourthMoment
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.Mean
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.SecondMoment
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.Skewness
Returns the value of the statistic based on the values that have been added.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Get the covariance matrix.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialMean
Get the mean vector.
getResult() - Method in class org.apache.commons.math.stat.descriptive.rank.Max
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.rank.Min
 
getResult() - Method in interface org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.summary.Product
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.summary.Sum
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
 
getResult() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
 
getResults(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array of the results of a statistic.
getRMS(EstimationProblem) - Method in class org.apache.commons.math.estimation.AbstractEstimator
Get the Root Mean Square value.
getRMS(EstimationProblem) - Method in interface org.apache.commons.math.estimation.Estimator
Get the Root Mean Square value.
getRootMatrix() - Method in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Get the root of the covariance matrix.
getRoundingMode() - Method in interface org.apache.commons.math.linear.BigMatrix
Gets the rounding mode
getRoundingMode() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Gets the rounding mode for division operations The default is BigDecimal.ROUND_HALF_UP
getRow(int) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the entries in row number row as an array.
getRow(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the entries in row number row as an array.
getRow(int) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the entries in row number row as an array.
getRow(int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns the entries in row number row as an array.
getRowAsDoubleArray(int) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the entries in row number row as an array of double values.
getRowAsDoubleArray(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the entries in row number row as an array of double values.
getRowDimension() - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the number of rows in the matrix.
getRowDimension() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math.linear.RealMatrixImpl
 
getRowMatrix(int) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the entries in row number row as a row matrix.
getRowMatrix(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the entries in row number row as a row matrix.
getRowMatrix(int) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the entries in row number row as a row matrix.
getRowMatrix(int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns the entries in row number row as a row matrix.
getRSquare() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the coefficient of determination, usually denoted r-square.
getSafety() - Method in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Get the safety factor for stepsize control.
getSampleSize() - Method in interface org.apache.commons.math.distribution.HypergeometricDistribution
Access the sample size.
getSampleSize() - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Access the sample size.
getSampleStats() - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Returns a StatisticalSummary describing this distribution.
getSampleStats() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Returns a StatisticalSummary describing this distribution.
getScale() - Method in interface org.apache.commons.math.distribution.CauchyDistribution
Access the scale parameter.
getScale() - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Access the scale parameter.
getScale() - Method in interface org.apache.commons.math.distribution.WeibullDistribution
Access the scale parameter.
getScale() - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Access the scale parameter.
getScale() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Sets the scale for division operations.
getSecRan() - Method in class org.apache.commons.math.random.RandomDataImpl
Returns the SecureRandom used to generate secure random data.
getShape() - Method in interface org.apache.commons.math.distribution.WeibullDistribution
Access the shape parameter.
getShape() - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Access the shape parameter.
getSigma() - Method in class org.apache.commons.math.random.ValueServer
Getter for property sigma.
getSignificance() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the significance level of the slope (equiv) correlation.
getSkewness() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the skewness of the available values.
getSkewnessImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured skewness implementation.
getSlope() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the slope of the estimated regression line.
getSlopeConfidenceInterval() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the half-width of a 95% confidence interval for the slope estimate.
getSlopeConfidenceInterval(double) - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the half-width of a (100-100*alpha)% confidence interval for the slope estimate.
getSlopeStdErr() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the standard error of the slope estimate, usually denoted s(b1).
getSortedValues() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the current set of values in an array of double primitives, sorted in ascending order.
getStandardDeviation() - Method in interface org.apache.commons.math.distribution.NormalDistribution
Access the standard deviation.
getStandardDeviation() - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Access the standard deviation.
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math.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() - Method in interface org.apache.commons.math.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() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the standard deviation of the values that have been added.
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getStepHandler() - Method in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Get the step handler for this integrator.
getStepHandler() - Method in interface org.apache.commons.math.ode.FirstOrderIntegrator
Get the step handler for this integrator.
getStepHandler() - Method in class org.apache.commons.math.ode.RungeKuttaIntegrator
Get the step handler for this integrator.
getStepHandler() - Method in interface org.apache.commons.math.ode.SecondOrderIntegrator
Get the step handler for this integrator.
getSubMatrix(int, int, int, int) - Method in interface org.apache.commons.math.linear.BigMatrix
Gets a submatrix.
getSubMatrix(int[], int[]) - Method in interface org.apache.commons.math.linear.BigMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Gets a submatrix.
getSubMatrix(int[], int[]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in interface org.apache.commons.math.linear.RealMatrix
Gets a submatrix.
getSubMatrix(int[], int[]) - Method in interface org.apache.commons.math.linear.RealMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Gets a submatrix.
getSubMatrix(int[], int[]) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Gets a submatrix.
getSum() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the sum of the values that have been added to Univariate.
getSum() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSum() - Method in interface org.apache.commons.math.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() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the sum of the values that have been added to Univariate.
getSum() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getSum() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the sum of the values that have been added
getSum() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getSum() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getSumFreq() - Method in class org.apache.commons.math.stat.Frequency
Returns the sum of all frequencies.
getSumImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured sum implementation.
getSumImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured Sum implementation
getSumImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured Sum implementation
getSumImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getSumImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getSumLog() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of logs of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumLog() - Method in interface org.apache.commons.math.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
getSumLog() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getSumLogImpl() - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getSumLogImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getSummary() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Return a StatisticalSummaryValues instance reporting current statistics.
getSummary() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getSumOfLogs() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the sum of the logs of the values that have been added.
getSumsq() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the sum of the squares of the available values.
getSumSq() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of squares of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumSq() - Method in interface org.apache.commons.math.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
getSumsq() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the sum of the squares of the values that have been added.
getSumSq() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getSumsq() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getSumsqImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured sum of squares implementation.
getSumsqImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured sum of squares implementation
getSumsqImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured sum of squares implementation
getSumsqImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
getSumsqImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getSumSquaredErrors() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the sum of squared errors (SSE) associated with the regression model.
getTheoreticalValue() - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Get the theoretical value expected for this measurement
getTotalSumSquares() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the sum of squared deviations of the y values about their mean.
getTrace() - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in class org.apache.commons.math.linear.RealMatrixImpl
 
getTransformer(Class) - Method in class org.apache.commons.math.util.TransformerMap
Returns the Transformer that is mapped to a class if mapping is not present, this returns null.
getTTest() - Static method in class org.apache.commons.math.stat.inference.TestUtils
Return a (singleton) TTest instance.
getUnboundParameters() - Method in interface org.apache.commons.math.estimation.EstimationProblem
Get the unbound parameters of the problem.
getUnboundParameters() - Method in class org.apache.commons.math.estimation.SimpleEstimationProblem
Get the unbound parameters of the problem.
getUnknownDistributionChiSquareTest() - Static method in class org.apache.commons.math.stat.inference.TestUtils
Return a (singleton) UnknownDistributionChiSquareTest instance.
getUpperBounds() - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Returns the array of upper bounds for the bins.
getUpperBounds() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Returns (a fresh copy of) the array of upper bounds for the bins.
getUpperDomain(int, int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Return the highest domain value for the given hypergeometric distribution parameters.
getValues() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the current set of values in an array of double primitives.
getValues() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
 
getValues() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns the internal storage array.
getValuesFileURL() - Method in class org.apache.commons.math.random.ValueServer
Getter for valuesFileURL
getVariance() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the variance of the available values.
getVariance() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the variance of the available values.
getVariance() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getVariance() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the variance of the values that have been added.
getVariance() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getVarianceImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured variance implementation.
getVarianceImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured variance implementation
getVarianceImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
getWeight() - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Get the weight of the measurement in the least squares problem
getWholeFormat() - Method in class org.apache.commons.math.fraction.ProperFractionFormat
Access the whole format.
getWindowSize() - Method in class org.apache.commons.math.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.
getWindowSize() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Access the window size.
getX() - Method in class org.apache.commons.math.geometry.Vector3D
Get the abscissa of the vector.
getY() - Method in class org.apache.commons.math.geometry.Vector3D
Get the ordinate of the vector.
getZ() - Method in class org.apache.commons.math.geometry.Vector3D
Get the height of the vector.
GillIntegrator - Class in org.apache.commons.math.ode
This class implements the Gill fourth order Runge-Kutta integrator for Ordinary Differential Equations .
GillIntegrator(double) - Constructor for class org.apache.commons.math.ode.GillIntegrator
Simple constructor.
GillStepInterpolator - Class in org.apache.commons.math.ode
This class implements a step interpolator for the Gill fourth order Runge-Kutta integrator.
GillStepInterpolator() - Constructor for class org.apache.commons.math.ode.GillStepInterpolator
Simple constructor.
GillStepInterpolator(GillStepInterpolator) - Constructor for class org.apache.commons.math.ode.GillStepInterpolator
Copy constructor.
GraggBulirschStoerIntegrator - Class in org.apache.commons.math.ode
This class implements a Gragg-Bulirsch-Stoer integrator for Ordinary Differential Equations.
GraggBulirschStoerIntegrator(double, double, double, double) - Constructor for class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Simple constructor.
GraggBulirschStoerIntegrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Simple constructor.
GraggBulirschStoerStepInterpolator - Class in org.apache.commons.math.ode
This class implements an interpolator for the Gragg-Bulirsch-Stoer integrator.
GraggBulirschStoerStepInterpolator() - Constructor for class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Simple constructor.
GraggBulirschStoerStepInterpolator(double[], double[], double[], double[], double[][], boolean) - Constructor for class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Simple constructor.
GraggBulirschStoerStepInterpolator(GraggBulirschStoerStepInterpolator) - Constructor for class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Copy constructor.
guessParametersErrors(EstimationProblem) - Method in class org.apache.commons.math.estimation.AbstractEstimator
Guess the errors in estimated parameters.
guessParametersErrors(EstimationProblem) - Method in interface org.apache.commons.math.estimation.Estimator
Guess the errors in estimated parameters.

H

h - Variable in class org.apache.commons.math.ode.AbstractStepInterpolator
current time step
h - Variable in class org.apache.commons.math.ode.StepNormalizer
Fixed time step.
HALF_LOG_2_PI - Static variable in class org.apache.commons.math.special.Gamma
Avoid repeated computation of log of 2 PI in logGamma
handler - Variable in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Step handler.
handler - Variable in class org.apache.commons.math.ode.RungeKuttaIntegrator
Step handler.
handler - Variable in class org.apache.commons.math.ode.StepNormalizer
Underlying step handler.
handleStep(StepInterpolator, boolean) - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Handle the last accepted step.
handleStep(StepInterpolator, boolean) - Method in class org.apache.commons.math.ode.DummyStepHandler
Handle the last accepted step.
handleStep(double, double[], boolean) - Method in interface org.apache.commons.math.ode.FixedStepHandler
Handle the last accepted step
handleStep(StepInterpolator, boolean) - Method in interface org.apache.commons.math.ode.StepHandler
Handle the last accepted step
handleStep(StepInterpolator, boolean) - Method in class org.apache.commons.math.ode.StepNormalizer
Handle the last accepted step
hash(double) - Static method in class org.apache.commons.math.util.MathUtils
Returns an integer hash code representing the given double value.
hash(double[]) - Static method in class org.apache.commons.math.util.MathUtils
Returns an integer hash code representing the given double array value.
hashCode() - Method in class org.apache.commons.math.complex.Complex
Get a hashCode for the complex number.
hashCode() - Method in class org.apache.commons.math.fraction.Fraction
Gets a hashCode for the fraction.
hashCode() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Computes a hashcode for the matrix.
hashCode() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Computes a hashcode for the matrix.
hashCode() - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns hash code based on getResult() and getN()
hashCode() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
hashCode() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
HighamHall54Integrator - Class in org.apache.commons.math.ode
This class implements the 5(4) Higham and Hall integrator for Ordinary Differential Equations.
HighamHall54Integrator(double, double, double, double) - Constructor for class org.apache.commons.math.ode.HighamHall54Integrator
Simple constructor.
HighamHall54Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.HighamHall54Integrator
Simple constructor.
HighamHall54StepInterpolator - Class in org.apache.commons.math.ode
This class represents an interpolator over the last step during an ODE integration for the 5(4) Higham and Hall integrator.
HighamHall54StepInterpolator() - Constructor for class org.apache.commons.math.ode.HighamHall54StepInterpolator
Simple constructor.
HighamHall54StepInterpolator(HighamHall54StepInterpolator) - Constructor for class org.apache.commons.math.ode.HighamHall54StepInterpolator
Copy constructor.
homoscedasticT(double[], double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
homoscedasticT(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
homoscedasticT(double[], double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a 2-sample t statistic, under the hypothesis of equal subpopulation variances.
homoscedasticT(StatisticalSummary, StatisticalSummary) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a 2-sample t statistic, comparing the means of the datasets described by two StatisticalSummary instances, under the assumption of equal subpopulation variances.
homoscedasticT(double[], double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a 2-sample t statistic, under the hypothesis of equal subpopulation variances.
homoscedasticT(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a 2-sample t statistic, comparing the means of the datasets described by two StatisticalSummary instances, under the assumption of equal subpopulation variances.
homoscedasticT(double, double, double, double, double, double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes t test statistic for 2-sample t-test under the hypothesis of equal subpopulation variances.
homoscedasticTTest(double[], double[], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
homoscedasticTTest(double[], double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
homoscedasticTTest(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
homoscedasticTTest(double[], double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays, under the assumption that the two samples are drawn from subpopulations with equal variances.
homoscedasticTTest(double[], double[], double) - Method in interface org.apache.commons.math.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that sample1 and sample2 are drawn from populations with the same mean, with significance level alpha, assuming that the subpopulation variances are equal.
homoscedasticTTest(StatisticalSummary, StatisticalSummary) - Method in interface org.apache.commons.math.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances, under the hypothesis of equal subpopulation variances.
homoscedasticTTest(double[], double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays, under the assumption that the two samples are drawn from subpopulations with equal variances.
homoscedasticTTest(double[], double[], double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Performs a two-sided t-test evaluating the null hypothesis that sample1 and sample2 are drawn from populations with the same mean, with significance level alpha, assuming that the subpopulation variances are equal.
homoscedasticTTest(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances, under the hypothesis of equal subpopulation variances.
homoscedasticTTest(double, double, double, double, double, double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes p-value for 2-sided, 2-sample t-test, under the assumption of equal subpopulation variances.
HypergeometricDistribution - Interface in org.apache.commons.math.distribution
The Hypergeometric Distribution.
HypergeometricDistributionImpl - Class in org.apache.commons.math.distribution
The default implementation of HypergeometricDistribution.
HypergeometricDistributionImpl(int, int, int) - Constructor for class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Construct a new hypergeometric distribution with the given the population size, the number of successes in the population, and the sample size.

I

I - Static variable in class org.apache.commons.math.complex.Complex
The square root of -1.
ignored - Variable in class org.apache.commons.math.estimation.WeightedMeasurement
Ignore measurement indicator.
imaginary - Variable in class org.apache.commons.math.complex.Complex
Deprecated. to be made final and private in 2.0
imaginaryCharacter - Variable in class org.apache.commons.math.complex.ComplexFormat
The notation used to signify the imaginary part of the complex number.
imaginaryFormat - Variable in class org.apache.commons.math.complex.ComplexFormat
The format used for the imaginary part.
incMoment - Variable in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Determines whether or not this statistic can be incremented or cleared.
incMoment - Variable in class org.apache.commons.math.stat.descriptive.moment.Mean
Determines whether or not this statistic can be incremented or cleared.
incMoment - Variable in class org.apache.commons.math.stat.descriptive.moment.Skewness
Determines whether or not this statistic can be incremented or cleared.
incMoment - Variable in class org.apache.commons.math.stat.descriptive.moment.Variance
Boolean test to determine if this Variance should also increment the second moment, this evaluates to false when this Variance is constructed with an external SecondMoment as a parameter.
increasing - Variable in class org.apache.commons.math.ode.SwitchState
Variation direction around pending event.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.FourthMoment
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.Mean
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.SecondMoment
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.Skewness
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double[]) - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Add a new vector to the sample.
increment(double[]) - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialMean
Add a new vector to the sample.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.rank.Max
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.rank.Min
 
increment(double) - Method in interface org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.summary.Product
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.summary.Sum
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
 
increment(double) - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
 
incrementAll(double[]) - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation just calls AbstractStorelessUnivariateStatistic.increment(double) in a loop over the input array.
incrementAll(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation just calls AbstractStorelessUnivariateStatistic.increment(double) in a loop over the specified portion of the input array.
incrementAll(double[]) - Method in interface org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
Updates the internal state of the statistic to reflect addition of all values in the values array.
incrementAll(double[], int, int) - Method in interface org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
Updates the internal state of the statistic to reflect addition of the values in the designated portion of the values array.
incrementJacobianEvaluationsCounter() - Method in class org.apache.commons.math.estimation.AbstractEstimator
Increment the jacobian evaluations counter.
index - Variable in class org.apache.commons.math.ode.ContinuousOutputModel
Current interpolator index.
indicator(byte) - Static method in class org.apache.commons.math.util.MathUtils
For a byte value x, this method returns (byte)(+1) if x >= 0 and (byte)(-1) if x < 0.
indicator(double) - Static method in class org.apache.commons.math.util.MathUtils
For a double precision value x, this method returns +1.0 if x >= 0 and -1.0 if x < 0.
indicator(float) - Static method in class org.apache.commons.math.util.MathUtils
For a float value x, this method returns +1.0F if x >= 0 and -1.0F if x < 0.
indicator(int) - Static method in class org.apache.commons.math.util.MathUtils
For an int value x, this method returns +1 if x >= 0 and -1 if x < 0.
indicator(long) - Static method in class org.apache.commons.math.util.MathUtils
For a long value x, this method returns +1L if x >= 0 and -1L if x < 0.
indicator(short) - Static method in class org.apache.commons.math.util.MathUtils
For a short value x, this method returns (short)(+1) if x >= 0 and (short)(-1) if x < 0.
INF - Static variable in class org.apache.commons.math.complex.Complex
A complex number representing "+INF + INFi"
INFINITE_WINDOW - Static variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Represents an infinite window size.
initialCapacity - Variable in class org.apache.commons.math.util.ResizableDoubleArray
The initial capacity of the array.
initializeArrays() - Method in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Initialize the integrator internal arrays.
initialized - Variable in class org.apache.commons.math.ode.SwitchingFunctionsHandler
Initialization indicator.
initializeEstimate(EstimationProblem) - Method in class org.apache.commons.math.estimation.AbstractEstimator
Initialization of the common parts of the estimation.
initializeStep(FirstOrderDifferentialEquations, boolean, int, double[], double, double[], double[], double[], double[]) - Method in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Initialize the integration step.
initialStep - Variable in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
User supplied initial step.
initialStepBoundFactor - Variable in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Positive input variable used in determining the initial step bound.
initialTime - Variable in class org.apache.commons.math.ode.ContinuousOutputModel
Initial integration time.
innerCumulativeProbability(int, int, int, int, int, int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
For this disbution, X, this method returns P(x0 ≤ X ≤ x1).
inputArray - Variable in class org.apache.commons.math.random.EmpiricalDistributionImpl.ArrayDataAdapter
Array of input data values
inputStream - Variable in class org.apache.commons.math.random.EmpiricalDistributionImpl.StreamDataAdapter
Input stream providng access to the data
instance - Static variable in class org.apache.commons.math.ode.DummyStepHandler
The only instance.
IntegerDistribution - Interface in org.apache.commons.math.distribution
Interface for discrete distributions of integer-valued random variables.
integrate(double, double) - Method in class org.apache.commons.math.analysis.RombergIntegrator
Integrate the function in the given interval.
integrate(double, double) - Method in class org.apache.commons.math.analysis.SimpsonIntegrator
Integrate the function in the given interval.
integrate(double, double) - Method in class org.apache.commons.math.analysis.TrapezoidIntegrator
Integrate the function in the given interval.
integrate(double, double) - Method in interface org.apache.commons.math.analysis.UnivariateRealIntegrator
Integrate the function in the given interval.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Integrate the differential equations up to the given time.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Integrate the differential equations up to the given time.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in interface org.apache.commons.math.ode.FirstOrderIntegrator
Integrate the differential equations up to the given time.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Integrate the differential equations up to the given time.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math.ode.RungeKuttaIntegrator
Integrate the differential equations up to the given time.
integrate(SecondOrderDifferentialEquations, double, double[], double[], double, double[], double[]) - Method in interface org.apache.commons.math.ode.SecondOrderIntegrator
Integrate the differential equations up to the given time
IntegratorException - Exception in org.apache.commons.math.ode
This exception is made available to users to report the error conditions that are triggered during integration
IntegratorException(String, Object[]) - Constructor for exception org.apache.commons.math.ode.IntegratorException
Simple constructor.
IntegratorException(Throwable) - Constructor for exception org.apache.commons.math.ode.IntegratorException
Create an exception with a given root cause.
internalArray - Variable in class org.apache.commons.math.util.ResizableDoubleArray
The internal storage array.
interpolate(double[], double[]) - Method in class org.apache.commons.math.analysis.DividedDifferenceInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[]) - Method in class org.apache.commons.math.analysis.NevilleInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[]) - Method in class org.apache.commons.math.analysis.SplineInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[]) - Method in interface org.apache.commons.math.analysis.UnivariateRealInterpolator
Computes an interpolating function for the data set.
interpolatedState - Variable in class org.apache.commons.math.ode.AbstractStepInterpolator
interpolated state
interpolatedTime - Variable in class org.apache.commons.math.ode.AbstractStepInterpolator
interpolated time
intValue() - Method in class org.apache.commons.math.fraction.Fraction
Gets the fraction as an int.
InvalidMatrixException - Exception in org.apache.commons.math.linear
Thrown when a system attempts an operation on a matrix, and that matrix does not satisfy the preconditions for the aforementioned operation.
InvalidMatrixException() - Constructor for exception org.apache.commons.math.linear.InvalidMatrixException
Default constructor.
InvalidMatrixException(String) - Constructor for exception org.apache.commons.math.linear.InvalidMatrixException
Construct an exception with the given message.
inverse() - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the inverse of this matrix.
inverse() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the inverse matrix if this matrix is invertible.
inverse() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the inverse of this matrix.
inverse() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns the inverse matrix if this matrix is invertible.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.AbstractContinuousDistribution
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns the largest x, such that P(X ≤ x) ≤ p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
For this distribution, X, this method returns the largest x, such that P(X ≤ x) ≤ p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in interface org.apache.commons.math.distribution.ContinuousDistribution
For this disbution, X, this method returns x such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.FDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in interface org.apache.commons.math.distribution.IntegerDistribution
For this distribution, X, this method returns the largest x such that P(X ≤ x) <= p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
For this distribution, X, this method returns the largest x, such that P(X ≤ x) ≤ p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.TDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inversetransform(double[]) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Inversely transform the given real data set.
inversetransform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Inversely transform the given real function, sampled on the given interval.
inversetransform(double[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Inversely transform the given real data set.
inversetransform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Inversely transform the given real function, sampled on the given interval.
inversetransform(Complex[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Inversely transform the given complex data set.
inversetransform(double[]) - Method in class org.apache.commons.math.transform.FastSineTransformer
Inversely transform the given real data set.
inversetransform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastSineTransformer
Inversely transform the given real function, sampled on the given interval.
inversetransform2(double[]) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Inversely transform the given real data set.
inversetransform2(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Inversely transform the given real function, sampled on the given interval.
inversetransform2(double[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Inversely transform the given real data set.
inversetransform2(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Inversely transform the given real function, sampled on the given interval.
inversetransform2(Complex[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Inversely transform the given complex data set.
inversetransform2(double[]) - Method in class org.apache.commons.math.transform.FastSineTransformer
Inversely transform the given real data set.
inversetransform2(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastSineTransformer
Inversely transform the given real function, sampled on the given interval.
isBiasCorrected() - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
 
isBiasCorrected - Variable in class org.apache.commons.math.stat.descriptive.moment.Variance
Determines whether or not bias correction is applied when computing the value of the statisic.
isBiasCorrected() - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
 
isBiasCorrected - Variable in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Indicator for bias correction.
isBound() - Method in class org.apache.commons.math.estimation.EstimatedParameter
Check if the parameter is bound
isBracketing(double, double, UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Returns true iff the function takes opposite signs at the endpoints.
isEmpty() - Method in class org.apache.commons.math.ode.SwitchingFunctionsHandler
Check if the handler does not have any condition.
isForward() - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Check if the natural integration direction is forward.
isForward() - Method in interface org.apache.commons.math.ode.StepInterpolator
Check if the natural integration direction is forward.
isIgnored() - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Check if this measurement should be ignored
isInfinite() - Method in class org.apache.commons.math.complex.Complex
Returns true if either the real or imaginary part of this complex number takes an infinite value (either Double.POSITIVE_INFINITY or Double.NEGATIVE_INFINITY) and neither part is NaN.
isLoaded() - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Property indicating whether or not the distribution has been loaded.
isLoaded() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Property indicating whether or not the distribution has been loaded.
isNaN() - Method in class org.apache.commons.math.complex.Complex
Returns true if either or both parts of this complex number is NaN; false otherwise
isNonNegative(long[]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Returns true iff all entries of the input array are >= 0.
isNonNegative(long[][]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Returns true iff all entries of (all subarrays of) the input array are >= 0.
isPositive(double[]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Returns true iff all entries of the input array are > 0.
isPowerOf2(long) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Returns true if the argument is power of 2.
isRectangular(long[][]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Returns true iff input array is rectangular.
isRootOK(double, double, Complex) - Method in class org.apache.commons.math.analysis.LaguerreSolver
Returns true iff the given complex root is actually a real zero in the given interval, within the solver tolerance level.
isSequence(double, double, double) - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Returns true if the arguments form a (strictly) increasing sequence
isSequence(double, double, double) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Returns true if the arguments form a (strictly) increasing sequence
isSingular() - Method in interface org.apache.commons.math.linear.BigMatrix
Is this a singular matrix?
isSingular() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Is this a singular matrix?
isSingular() - Method in interface org.apache.commons.math.linear.RealMatrix
Is this a singular matrix?
isSingular() - Method in class org.apache.commons.math.linear.RealMatrixImpl
 
isSquare() - Method in interface org.apache.commons.math.linear.BigMatrix
Is this a square matrix?
isSquare() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Is this a square matrix?
isSquare() - Method in interface org.apache.commons.math.linear.RealMatrix
Is this a square matrix?
isSquare() - Method in class org.apache.commons.math.linear.RealMatrixImpl
 
isStrictlyIncreasing(double[]) - Static method in class org.apache.commons.math.analysis.PolynomialSplineFunction
Determines if the given array is ordered in a strictly increasing fashion.
isValidCoordinate(int, int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Tests a given coordinate as being valid or invalid
isValidCoordinate(int, int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Tests a given coordinate as being valid or invalid
iterateSimplex() - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Compute the next simplex of the algorithm.
iterateSimplex() - Method in class org.apache.commons.math.optimization.MultiDirectional
Compute the next simplex of the algorithm.
iterateSimplex() - Method in class org.apache.commons.math.optimization.NelderMead
Compute the next simplex of the algorithm.
iterationCount - Variable in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
the last iteration count
iterationCount - Variable in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
The last iteration count.

J

jacNorm - Variable in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Norms of the columns of the jacobian matrix.
jacobian - Variable in class org.apache.commons.math.estimation.AbstractEstimator
Jacobian matrix.
jacobianEvaluations - Variable in class org.apache.commons.math.estimation.AbstractEstimator
Number of jacobian evaluations.
JDK_SUPPORTS_NESTED - Static variable in exception org.apache.commons.math.MathException
Does JDK support nested exceptions?
JDKRandomGenerator - Class in org.apache.commons.math.random
Extension of java.util.Random to implement RandomGenerator.
JDKRandomGenerator() - Constructor for class org.apache.commons.math.random.JDKRandomGenerator
 

K

k - Variable in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Dimension of the data.
k14_01 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 14, element 1.
k14_06 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 14, element 6.
k14_07 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 14, element 7.
k14_08 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 14, element 8.
k14_09 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 14, element 9.
k14_10 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 14, element 10.
k14_11 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 14, element 11.
k14_12 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 14, element 12.
k14_13 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 14, element 13.
k15_01 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 15, element 1.
k15_06 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 15, element 6.
k15_07 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 15, element 7.
k15_08 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 15, element 8.
k15_09 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 15, element 9.
k15_10 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 15, element 10.
k15_11 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 15, element 11.
k15_12 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 15, element 12.
k15_13 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 15, element 13.
k15_14 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 15, element 14.
k16_01 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 16, element 1.
k16_06 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 16, element 6.
k16_07 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 16, element 7.
k16_08 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 16, element 8.
k16_09 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 16, element 9.
k16_10 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 16, element 10.
k16_11 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 16, element 11.
k16_12 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 16, element 12.
k16_13 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 16, element 13.
k16_14 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 16, element 14.
k16_15 - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Internal weights for stage 16, element 15.
khi - Variable in class org.apache.commons.math.optimization.MultiDirectional
Expansion coefficient.
khi - Variable in class org.apache.commons.math.optimization.NelderMead
Expansion coefficient.
knots - Variable in class org.apache.commons.math.analysis.PolynomialSplineFunction
Spline segment interval delimiters (knots).
Kurtosis - Class in org.apache.commons.math.stat.descriptive.moment
Computes the Kurtosis of the available values.
Kurtosis() - Constructor for class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Construct a Kurtosis
Kurtosis(FourthMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Construct a Kurtosis from an external moment
kurtosisImpl - Variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Kurtosis statistic implementation - can be reset by setter.

L

LaguerreSolver - Class in org.apache.commons.math.analysis
Implements the Laguerre's Method for root finding of real coefficient polynomials.
LaguerreSolver(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.LaguerreSolver
Construct a solver for the given function.
lanczos - Static variable in class org.apache.commons.math.special.Gamma
Lanczos coefficients
lastState - Variable in class org.apache.commons.math.ode.StepNormalizer
Last State vector.
lastTime - Variable in class org.apache.commons.math.ode.StepNormalizer
Last step time.
lcm(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Returns the least common multiple between two integer values.
LevenbergMarquardtEstimator - Class in org.apache.commons.math.estimation
This class solves a least squares problem.
LevenbergMarquardtEstimator() - Constructor for class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Build an estimator for least squares problems.
lmDir - Variable in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Parameters evolution direction associated with lmPar.
lmPar - Variable in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Levenberg-Marquardt parameter.
load(double[]) - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Computes the empirical distribution from the provided array of numbers.
load(File) - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Computes the empirical distribution from the input file.
load(URL) - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Computes the empirical distribution using data read from a URL.
load(double[]) - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Computes the empirical distribution from the provided array of numbers.
load(URL) - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Computes the empirical distribution using data read from a URL.
load(File) - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Computes the empirical distribution from the input file.
loaded - Variable in class org.apache.commons.math.random.EmpiricalDistributionImpl
is the distribution loaded?
locatePoint(double, StepInterpolator) - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Compare a step interval and a double.
log() - Method in class org.apache.commons.math.complex.Complex
Compute the natural logarithm of this complex number.
log(Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.log()
log(double, double) - Static method in class org.apache.commons.math.util.MathUtils
Returns the logarithm for base b of x.
logBeta(double, double) - Static method in class org.apache.commons.math.special.Beta
Returns the natural logarithm of the beta function B(a, b).
logBeta(double, double, double, int) - Static method in class org.apache.commons.math.special.Beta
Returns the natural logarithm of the beta function B(a, b).
logGamma(double) - Static method in class org.apache.commons.math.special.Gamma
Returns the natural logarithm of the gamma function Γ(x).
longValue() - Method in class org.apache.commons.math.fraction.Fraction
Gets the fraction as a long.
lu - Variable in class org.apache.commons.math.linear.BigMatrixImpl
Entries of cached LU decomposition.
lu - Variable in class org.apache.commons.math.linear.RealMatrixImpl
Entries of cached LU decomposition.
luDecompose() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Computes a new LU decompostion for this matrix, storing the result for use by other methods.
luDecompose() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Computes a new LU decomposition for this matrix, storing the result for use by other methods.

M

m - Variable in class org.apache.commons.math.linear.QRDecompositionImpl
The row dimension of the given matrix.
m1 - Variable in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
First moment of values that have been added
m2 - Variable in class org.apache.commons.math.stat.descriptive.moment.SecondMoment
second moment of values that have been added
m3 - Variable in class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
third moment of values that have been added
m4 - Variable in class org.apache.commons.math.stat.descriptive.moment.FourthMoment
fourth moment of values that have been added
map - Variable in class org.apache.commons.math.util.TransformerMap
The internal Map.
MathConfigurationException - Exception in org.apache.commons.math
Signals a configuration problem with any of the factory methods.
MathConfigurationException() - Constructor for exception org.apache.commons.math.MathConfigurationException
Default constructor.
MathConfigurationException(String) - Constructor for exception org.apache.commons.math.MathConfigurationException
Deprecated. as of 1.2, replaced by MathConfigurationException.MathConfigurationException(String, Object[])
MathConfigurationException(String, Object[]) - Constructor for exception org.apache.commons.math.MathConfigurationException
Constructs an exception with specified formatted detail message.
MathConfigurationException(String, Throwable) - Constructor for exception org.apache.commons.math.MathConfigurationException
Deprecated. as of 1.2, replaced by MathConfigurationException.MathConfigurationException(String, Object[], Throwable)
MathConfigurationException(Throwable) - Constructor for exception org.apache.commons.math.MathConfigurationException
Create an exception with a given root cause.
MathConfigurationException(String, Object[], Throwable) - Constructor for exception org.apache.commons.math.MathConfigurationException
Constructs an exception with specified formatted detail message and root cause.
MathException - Exception in org.apache.commons.math
Base class for commons-math checked exceptions.
MathException() - Constructor for exception org.apache.commons.math.MathException
Constructs a new MathException with no detail message.
MathException(String) - Constructor for exception org.apache.commons.math.MathException
Deprecated. as of 1.2, replaced by MathException.MathException(String, Object[])
MathException(String, Object[]) - Constructor for exception org.apache.commons.math.MathException
Constructs a new MathException with specified formatted detail message.
MathException(Throwable) - Constructor for exception org.apache.commons.math.MathException
Constructs a new MathException with specified nested Throwable root cause.
MathException(String, Throwable) - Constructor for exception org.apache.commons.math.MathException
Deprecated. as of 1.2, replaced by MathException.MathException(String, Object[], Throwable)
MathException(String, Object[], Throwable) - Constructor for exception org.apache.commons.math.MathException
Constructs a new MathException with specified formatted detail message and nested Throwable root cause.
MathUtils - Class in org.apache.commons.math.util
Some useful additions to the built-in functions in Math.
MathUtils() - Constructor for class org.apache.commons.math.util.MathUtils
Private Constructor
MatrixIndexException - Exception in org.apache.commons.math.linear
Thrown when an operation addresses a matrix coordinate (row,col) which is outside of the dimensions of a matrix.
MatrixIndexException() - Constructor for exception org.apache.commons.math.linear.MatrixIndexException
Deprecated. as of 1.2 replaced by #MatrixIndexException(String)
MatrixIndexException(String) - Constructor for exception org.apache.commons.math.linear.MatrixIndexException
Construct an exception with the given message and root cause.
MatrixUtils - Class in org.apache.commons.math.linear
A collection of static methods that operate on or return matrices.
MatrixUtils() - Constructor for class org.apache.commons.math.linear.MatrixUtils
Default constructor.
Max - Class in org.apache.commons.math.stat.descriptive.rank
Returns the maximum of the available values.
Max() - Constructor for class org.apache.commons.math.stat.descriptive.rank.Max
Create a Max instance
max - Variable in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
The maximum value
max - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
max of values that have been added
max - Static variable in class org.apache.commons.math.stat.StatUtils
max
max(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the maximum of the entries in the input array, or Double.NaN if the array is empty.
max(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the maximum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
maxCheckInterval - Variable in class org.apache.commons.math.ode.SwitchState
Maximal time interval between switching function checks.
maxChecks - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
maximal number of checks for each iteration.
maxCostEval - Variable in class org.apache.commons.math.estimation.AbstractEstimator
Maximal allowed number of cost evaluations.
maxGrowth - Variable in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Maximal growth factor for stepsize control.
maximalIterationCount - Variable in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
maximum number of iterations
maximalIterationCount - Variable in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Maximum number of iterations.
maxImpl - Variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Maximum statistic implementation - can be reset by setter.
maxImpl - Variable in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Maximum statistic implementation - can be reset by setter.
maxImpl - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Maximum statistic implementation - can be reset by setter.
maxIter - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
maximal number of iterations for which checks are performed.
maxIterationCount - Variable in class org.apache.commons.math.ode.SwitchState
Upper limit in the iteration count for event localisation.
maxIterations - Variable in exception org.apache.commons.math.MaxIterationsExceededException
Maximal number of iterations allowed.
MaxIterationsExceededException - Exception in org.apache.commons.math
Error thrown when a numerical computation exceeds its allowed number of iterations.
MaxIterationsExceededException(int) - Constructor for exception org.apache.commons.math.MaxIterationsExceededException
Constructs an exception with specified formatted detail message.
MaxIterationsExceededException(int, String, Object[]) - Constructor for exception org.apache.commons.math.MaxIterationsExceededException
Constructs an exception with specified formatted detail message.
maxOrder - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
maximal order.
maxStep - Variable in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Maximal step.
mean - Variable in class org.apache.commons.math.distribution.ExponentialDistributionImpl
The mean of this distribution.
mean - Variable in class org.apache.commons.math.distribution.NormalDistributionImpl
The mean of this distribution.
mean - Variable in class org.apache.commons.math.distribution.PoissonDistributionImpl
Holds the Poisson mean for the distribution.
mean - Variable in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Mean vector.
mean - Variable in class org.apache.commons.math.random.UncorrelatedRandomVectorGenerator
Mean vector.
Mean - Class in org.apache.commons.math.stat.descriptive.moment
Computes the arithmetic mean of a set of values.
Mean() - Constructor for class org.apache.commons.math.stat.descriptive.moment.Mean
Constructs a Mean.
Mean(FirstMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Mean
Constructs a Mean with an External Moment.
mean - Variable in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
The sample mean
mean - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
mean of values that have been added
mean - Static variable in class org.apache.commons.math.stat.StatUtils
mean
mean(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the arithmetic mean of the entries in the input array, or Double.NaN if the array is empty.
mean(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the arithmetic mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
meanDifference(double[], double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the mean of the (signed) differences between corresponding elements of the input arrays -- i.e., sum(sample1[i] - sample2[i]) / sample1.length.
meanImpl - Variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Mean statistic implementation - can be reset by setter.
meanImpl - Variable in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Mean statistic implementation - can be reset by setter.
meanImpl - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Mean statistic implementation - can be reset by setter.
means - Variable in class org.apache.commons.math.stat.descriptive.moment.VectorialMean
Means for each component.
measuredValue - Variable in class org.apache.commons.math.estimation.WeightedMeasurement
Value of the measurements.
measurements - Variable in class org.apache.commons.math.estimation.AbstractEstimator
Array of measurements.
measurements - Variable in class org.apache.commons.math.estimation.SimpleEstimationProblem
Measurements.
median - Variable in class org.apache.commons.math.distribution.CauchyDistributionImpl
The median of this distribution.
Median - Class in org.apache.commons.math.stat.descriptive.rank
Returns the median of the available values.
Median() - Constructor for class org.apache.commons.math.stat.descriptive.rank.Median
Default constructor.
MessagesResources_fr - Class in org.apache.commons.math
French localization message resources for the commons-math library.
MessagesResources_fr() - Constructor for class org.apache.commons.math.MessagesResources_fr
Simple constructor.
methodName - Static variable in class org.apache.commons.math.ode.ClassicalRungeKuttaIntegrator
Integrator method name.
methodName - Static variable in class org.apache.commons.math.ode.DormandPrince54Integrator
Integrator method name.
methodName - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
Integrator method name.
methodName - Static variable in class org.apache.commons.math.ode.EulerIntegrator
Integrator method name.
methodName - Static variable in class org.apache.commons.math.ode.GillIntegrator
Integrator method name.
methodName - Static variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Integrator method name.
methodName - Static variable in class org.apache.commons.math.ode.HighamHall54Integrator
Integrator method name.
methodName - Static variable in class org.apache.commons.math.ode.MidpointIntegrator
Integrator method name.
methodName - Static variable in class org.apache.commons.math.ode.ThreeEighthesIntegrator
Integrator method name.
midpoint(double, double) - Static method in class org.apache.commons.math.analysis.UnivariateRealSolverUtils
Compute the midpoint of two values.
MidpointIntegrator - Class in org.apache.commons.math.ode
This class implements a second order Runge-Kutta integrator for Ordinary Differential Equations.
MidpointIntegrator(double) - Constructor for class org.apache.commons.math.ode.MidpointIntegrator
Simple constructor.
MidpointStepInterpolator - Class in org.apache.commons.math.ode
This class implements a step interpolator for second order Runge-Kutta integrator.
MidpointStepInterpolator() - Constructor for class org.apache.commons.math.ode.MidpointStepInterpolator
Simple constructor.
MidpointStepInterpolator(MidpointStepInterpolator) - Constructor for class org.apache.commons.math.ode.MidpointStepInterpolator
Copy constructor.
Min - Class in org.apache.commons.math.stat.descriptive.rank
Returns the minimum of the available values.
Min() - Constructor for class org.apache.commons.math.stat.descriptive.rank.Min
Create a Min instance
min - Variable in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
The minimum value
min - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
min of values that have been added
min - Static variable in class org.apache.commons.math.stat.StatUtils
min
min(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the minimum of the entries in the input array, or Double.NaN if the array is empty.
min(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the minimum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
minima - Variable in class org.apache.commons.math.optimization.DirectSearchOptimizer
Found minima.
minimalIterationCount - Variable in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
minimum number of iterations
minimize(CostFunction, int, ConvergenceChecker, double[], double[]) - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Minimizes a cost function.
minimize(CostFunction, int, ConvergenceChecker, double[], double[], int, long) - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Minimizes a cost function.
minimize(CostFunction, int, ConvergenceChecker, double[][]) - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Minimizes a cost function.
minimize(CostFunction, int, ConvergenceChecker, double[][], int, long) - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Minimizes a cost function.
minimize(CostFunction, int, ConvergenceChecker, RandomVectorGenerator) - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Minimizes a cost function.
minimize(CostFunction, int, ConvergenceChecker, RandomVectorGenerator, int) - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Minimizes a cost function.
minimize(CostFunction, int, ConvergenceChecker) - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Minimizes a cost function.
minImpl - Variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Minimum statistic implementation - can be reset by setter.
minImpl - Variable in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Minimum statistic implementation - can be reset by setter.
minImpl - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Minimum statistic implementation - can be reset by setter.
minReduction - Variable in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Minimal reduction factor for stepsize control.
minStep - Variable in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Minimal step.
minusI - Static variable in class org.apache.commons.math.geometry.Vector3D
Opposite of the first canonical vector (coordinates: -1, 0, 0).
minusJ - Static variable in class org.apache.commons.math.geometry.Vector3D
Opposite of the second canonical vector (coordinates: 0, -1, 0).
minusK - Static variable in class org.apache.commons.math.geometry.Vector3D
Opposite of the third canonical vector (coordinates: 0, 0, -1).
mode - Variable in class org.apache.commons.math.random.ValueServer
mode determines how values are generated
moment - Variable in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Fourth Moment on which this statistic is based
moment - Variable in class org.apache.commons.math.stat.descriptive.moment.Mean
First moment on which this statistic is based.
moment - Variable in class org.apache.commons.math.stat.descriptive.moment.Skewness
Third moment on which this statistic is based
moment - Variable in class org.apache.commons.math.stat.descriptive.moment.Variance
SecondMoment is used in incremental calculation of Variance
mu - Variable in class org.apache.commons.math.random.ValueServer
Mean for use with non-data-driven modes
mudif - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
interpolation order control parameter.
mulAndCheck(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Multiply two integers, checking for overflow.
mulAndCheck(long, long) - Static method in class org.apache.commons.math.util.MathUtils
Multiply two long integers, checking for overflow.
MullerSolver - Class in org.apache.commons.math.analysis
Implements the Muller's Method for root finding of real univariate functions.
MullerSolver(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.MullerSolver
Construct a solver for the given function.
MultiDirectional - Class in org.apache.commons.math.optimization
This class implements the multi-directional direct search method.
MultiDirectional() - Constructor for class org.apache.commons.math.optimization.MultiDirectional
Build a multi-directional optimizer with default coefficients.
MultiDirectional(double, double) - Constructor for class org.apache.commons.math.optimization.MultiDirectional
Build a multi-directional optimizer with specified coefficients.
MULTIPLICATIVE_MODE - Static variable in class org.apache.commons.math.util.ResizableDoubleArray
multiplicative expansion mode
multiply(Complex) - Method in class org.apache.commons.math.complex.Complex
Return the product of this complex number and the given complex number.
multiply(Fraction) - Method in class org.apache.commons.math.fraction.Fraction
Multiplies the value of this fraction by another, returning the result in reduced form.
multiply(BigMatrix) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the result of postmultiplying this by m.
multiply(BigMatrix) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the result of postmultiplying this by m.
multiply(RealMatrix) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the result of postmultiplying this by m.
multiply(RealMatrix) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns the result of postmultiplying this by m.
MultivariateSummaryStatistics - Class in org.apache.commons.math.stat.descriptive
Computes summary statistics for a stream of n-tuples added using the addValue method.
MultivariateSummaryStatistics(int, boolean) - Constructor for class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Construct a MultivariateSummaryStatistics instance

N

n - Variable in class org.apache.commons.math.analysis.PolynomialSplineFunction
Number of spline segments = number of polynomials = number of partition points - 1
n - Variable in class org.apache.commons.math.linear.QRDecompositionImpl
The column dimension of the given matrix.
n - Variable in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
Count of values that have been added
n - Variable in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Number of vectors in the sample.
n - Variable in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Count of values that have been added
n - Variable in class org.apache.commons.math.stat.descriptive.rank.Max
Number of values that have been added
n - Variable in class org.apache.commons.math.stat.descriptive.rank.Min
Number of values that have been added
n - Variable in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
The number of observations in the sample
n - Variable in class org.apache.commons.math.stat.descriptive.summary.Product
The number of values that have been added
n - Variable in class org.apache.commons.math.stat.descriptive.summary.Sum
 
n - Variable in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
Number of values that have been added
n - Variable in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
 
n - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
count of values that have been added
n - Variable in class org.apache.commons.math.stat.regression.SimpleRegression
number of observations
name - Variable in class org.apache.commons.math.estimation.EstimatedParameter
Name of the parameter
name - Variable in class org.apache.commons.math.geometry.RotationOrder
Name of the rotations order.
NaN - Static variable in class org.apache.commons.math.complex.Complex
A complex number representing "NaN + NaNi"
NB - Static variable in class org.apache.commons.math.util.MathUtils
-1.0 cast as a byte.
nDev - Variable in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
Deviation of most recently added value from previous first moment, normalized by previous sample size.
nDevSq - Variable in class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
Square of deviation of most recently added value from previous first moment, normalized by previous sample size.
negate() - Method in class org.apache.commons.math.complex.Complex
Return the additive inverse of this complex number.
negate() - Method in class org.apache.commons.math.fraction.Fraction
Return the additive inverse of this fraction.
negate() - Method in class org.apache.commons.math.geometry.Vector3D
Get the opposite of the instance.
NelderMead - Class in org.apache.commons.math.optimization
This class implements the Nelder-Mead direct search method.
NelderMead() - Constructor for class org.apache.commons.math.optimization.NelderMead
Build a Nelder-Mead optimizer with default coefficients.
NelderMead(double, double, double, double) - Constructor for class org.apache.commons.math.optimization.NelderMead
Build a Nelder-Mead optimizer with specified coefficients.
NevilleInterpolator - Class in org.apache.commons.math.analysis
Implements the Neville's Algorithm for interpolation of real univariate functions.
NevilleInterpolator() - Constructor for class org.apache.commons.math.analysis.NevilleInterpolator
 
newBisectionSolver(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverFactory
Create a new UnivariateRealSolver for the given function.
newBisectionSolver(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverFactoryImpl
Create a new UnivariateRealSolver for the given function.
newBrentSolver(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverFactory
Create a new UnivariateRealSolver for the given function.
newBrentSolver(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverFactoryImpl
Create a new UnivariateRealSolver for the given function.
newDefaultSolver(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverFactory
Create a new UnivariateRealSolver for the given function.
newDefaultSolver(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverFactoryImpl
Create a new UnivariateRealSolver for the given function.
newInstance() - Static method in class org.apache.commons.math.analysis.UnivariateRealSolverFactory
Create a new factory.
newInstance() - Static method in class org.apache.commons.math.distribution.DistributionFactory
Deprecated. Create an instance of a DistributionFactory
newInstance(Class) - Static method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Deprecated. to be removed in commons-math 2.0
newInstance() - Static method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Deprecated. to be removed in commons-math 2.0
newInstance(Class) - Static method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Deprecated. to be removed in commons-math 2.0
newInstance() - Static method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Deprecated. to be removed in commons-math 2.0
newInstance() - Static method in class org.apache.commons.math.stat.inference.TestFactory
Deprecated. Create an instance of a TestFactory
newNewtonSolver(DifferentiableUnivariateRealFunction) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverFactory
Create a new UnivariateRealSolver for the given function.
newNewtonSolver(DifferentiableUnivariateRealFunction) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverFactoryImpl
Create a new UnivariateRealSolver for the given function.
newSecantSolver(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverFactory
Create a new UnivariateRealSolver for the given function.
newSecantSolver(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverFactoryImpl
Create a new UnivariateRealSolver for the given function.
NewtonSolver - Class in org.apache.commons.math.analysis
Implements Newton's Method for finding zeros of real univariate functions.
NewtonSolver(DifferentiableUnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.NewtonSolver
Construct a solver for the given function.
nextAction - Variable in class org.apache.commons.math.ode.SwitchState
Next action indicator.
nextAfter(double, double) - Static method in class org.apache.commons.math.util.MathUtils
Get the next machine representable number after a number, moving in the direction of another number.
nextBoolean() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBoolean() - Method in class org.apache.commons.math.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBoolean() - Method in interface org.apache.commons.math.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBytes(byte[]) - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Generates random bytes and places them into a user-supplied byte array.
nextBytes(byte[]) - Method in class org.apache.commons.math.random.RandomAdaptor
Generates random bytes and places them into a user-supplied byte array.
nextBytes(byte[]) - Method in interface org.apache.commons.math.random.RandomGenerator
Generates random bytes and places them into a user-supplied byte array.
nextDouble() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in class org.apache.commons.math.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in interface org.apache.commons.math.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextExponential(double) - Method in interface org.apache.commons.math.random.RandomData
Generates a random value from the exponential distribution with expected value = mean.
nextExponential(double) - Method in class org.apache.commons.math.random.RandomDataImpl
Returns a random value from an Exponential distribution with the given mean.
nextFloat() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloat() - Method in class org.apache.commons.math.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloat() - Method in interface org.apache.commons.math.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextGaussian() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGaussian() - Method in class org.apache.commons.math.random.RandomAdaptor
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGaussian(double, double) - Method in interface org.apache.commons.math.random.RandomData
Generates a random value from the Normal (or Gaussian) distribution with the given mean and standard deviation.
nextGaussian(double, double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generate a random value from a Normal (a.k.a.
nextGaussian() - Method in interface org.apache.commons.math.random.RandomGenerator
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextHexString(int) - Method in interface org.apache.commons.math.random.RandomData
Generates a random string of hex characters of length len.
nextHexString(int) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random string of hex characters of length len.
nextInt() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt() - Method in class org.apache.commons.math.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in class org.apache.commons.math.random.RandomAdaptor
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt(int, int) - Method in interface org.apache.commons.math.random.RandomData
Generates a uniformly distributed random integer between lower and upper (endpoints included).
nextInt(int, int) - Method in class org.apache.commons.math.random.RandomDataImpl
Generate a random int value uniformly distributed between lower and upper, inclusive.
nextInt() - Method in interface org.apache.commons.math.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in interface org.apache.commons.math.random.RandomGenerator
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextLong() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLong() - Method in class org.apache.commons.math.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLong(long, long) - Method in interface org.apache.commons.math.random.RandomData
Generates a uniformly distributed random long integer between lower and upper (endpoints included).
nextLong(long, long) - Method in class org.apache.commons.math.random.RandomDataImpl
Generate a random long value uniformly distributed between lower and upper, inclusive.
nextLong() - Method in interface org.apache.commons.math.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextNormalizedDouble() - Method in class org.apache.commons.math.random.GaussianRandomGenerator
Generate a random scalar with null mean and unit standard deviation.
nextNormalizedDouble() - Method in interface org.apache.commons.math.random.NormalizedRandomGenerator
Generate a random scalar with null mean and unit standard deviation.
nextNormalizedDouble() - Method in class org.apache.commons.math.random.UniformRandomGenerator
Generate a random scalar with null mean and unit standard deviation.
nextPermutation(int, int) - Method in interface org.apache.commons.math.random.RandomData
Generates an integer array of length k whose entries are selected randomly, without repetition, from the integers 0 through n-1 (inclusive).
nextPermutation(int, int) - Method in class org.apache.commons.math.random.RandomDataImpl
Uses a 2-cycle permutation shuffle to generate a random permutation.
nextPoisson(double) - Method in interface org.apache.commons.math.random.RandomData
Generates a random value from the Poisson distribution with the given mean.
nextPoisson(double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random value from the Poisson distribution with the given mean.
nextSample(Collection, int) - Method in interface org.apache.commons.math.random.RandomData
Returns an array of k objects selected randomly from the Collection c.
nextSample(Collection, int) - Method in class org.apache.commons.math.random.RandomDataImpl
Uses a 2-cycle permutation shuffle to generate a random permutation.
nextSecureHexString(int) - Method in interface org.apache.commons.math.random.RandomData
Generates a random string of hex characters from a secure random sequence.
nextSecureHexString(int) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random string of hex characters from a secure random sequence.
nextSecureInt(int, int) - Method in interface org.apache.commons.math.random.RandomData
Generates a uniformly distributed random integer between lower and upper (endpoints included) from a secure random sequence.
nextSecureInt(int, int) - Method in class org.apache.commons.math.random.RandomDataImpl
Generate a random int value uniformly distributed between lower and upper, inclusive.
nextSecureLong(long, long) - Method in interface org.apache.commons.math.random.RandomData
Generates a random long integer between lower and upper (endpoints included).
nextSecureLong(long, long) - Method in class org.apache.commons.math.random.RandomDataImpl
Generate a random long value uniformly distributed between lower and upper, inclusive.
nextUniform(double, double) - Method in interface org.apache.commons.math.random.RandomData
Generates a uniformly distributed random value from the open interval (lower,upper) (i.e., endpoints excluded).
nextUniform(double, double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a uniformly distributed random value from the open interval (lower,upper) (i.e., endpoints excluded).
nextVector() - Method in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Generate a correlated random vector.
nextVector() - Method in interface org.apache.commons.math.random.RandomVectorGenerator
Generate a random vector.
nextVector() - Method in class org.apache.commons.math.random.UncorrelatedRandomVectorGenerator
Generate an uncorrelated random vector.
normal - Variable in class org.apache.commons.math.distribution.PoissonDistributionImpl
Distribution used to compute normal approximation.
normalApproximateProbability(int) - Method in interface org.apache.commons.math.distribution.PoissonDistribution
Calculates the Poisson distribution function using a normal approximation.
normalApproximateProbability(int) - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Calculates the Poisson distribution function using a normal approximation.
NormalDistribution - Interface in org.apache.commons.math.distribution
Normal (Gauss) Distribution.
NormalDistributionImpl - Class in org.apache.commons.math.distribution
Default implementation of NormalDistribution.
NormalDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.NormalDistributionImpl
Create a normal distribution using the given mean and standard deviation.
NormalDistributionImpl() - Constructor for class org.apache.commons.math.distribution.NormalDistributionImpl
Creates normal distribution with the mean equal to zero and standard deviation equal to one.
normalize() - Method in class org.apache.commons.math.geometry.Vector3D
Get a normalized vector aligned with the instance.
normalizeAngle(double, double) - Static method in class org.apache.commons.math.util.MathUtils
Normalize an angle in a 2&pi wide interval around a center value.
normalized - Variable in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Storage for the normalized vector.
NormalizedRandomGenerator - Interface in org.apache.commons.math.random
This interface represent a normalized random generator for scalars.
NotARotationMatrixException - Exception in org.apache.commons.math.geometry
This class represents exceptions thrown while building rotations from matrices.
NotARotationMatrixException(String, Object[]) - Constructor for exception org.apache.commons.math.geometry.NotARotationMatrixException
Simple constructor.
NotPositiveDefiniteMatrixException - Exception in org.apache.commons.math.random
This class represents exceptions thrown by the correlated random vector generator.
NotPositiveDefiniteMatrixException() - Constructor for exception org.apache.commons.math.random.NotPositiveDefiniteMatrixException
Simple constructor.
NS - Static variable in class org.apache.commons.math.util.MathUtils
-1.0 cast as a short.
numberOfSuccesses - Variable in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
The number of successes in the population.
numberOfSuccesses - Variable in class org.apache.commons.math.distribution.PascalDistributionImpl
The number of successes
numberOfTrials - Variable in class org.apache.commons.math.distribution.BinomialDistributionImpl
The number of trials.
NumberTransformer - Interface in org.apache.commons.math.util
Subclasses implementing this interface can transform Objects to doubles.
numElements - Variable in class org.apache.commons.math.util.ResizableDoubleArray
The number of addressable elements in the array.
numerator - Variable in class org.apache.commons.math.fraction.Fraction
The numerator.
numeratorDegreesOfFreedom - Variable in class org.apache.commons.math.distribution.FDistributionImpl
The numerator degrees of freedom
numeratorFormat - Variable in class org.apache.commons.math.fraction.FractionFormat
The format used for the numerator.

O

omega - Variable in class org.apache.commons.math.transform.FastFourierTransformer
array of the roots of unity
omegaCount - Variable in class org.apache.commons.math.transform.FastFourierTransformer
|omegaCount| is the length of lasted computed omega[].
ONE - Static variable in class org.apache.commons.math.complex.Complex
A complex number representing "1.0 + 0.0i"
ONE - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "1 / 1".
ONE - Static variable in class org.apache.commons.math.linear.BigMatrixImpl
BigDecimal 1
OneWayAnova - Interface in org.apache.commons.math.stat.inference
An interface for one-way ANOVA (analysis of variance).
oneWayAnova - Static variable in class org.apache.commons.math.stat.inference.TestUtils
Singleton OneWayAnova instance using default implementation.
oneWayAnovaFValue(Collection) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
OneWayAnovaImpl - Class in org.apache.commons.math.stat.inference
Implements one-way ANOVA statistics defined in the OneWayAnovaImpl interface.
OneWayAnovaImpl() - Constructor for class org.apache.commons.math.stat.inference.OneWayAnovaImpl
Default constructor.
OneWayAnovaImpl.AnovaStats - Class in org.apache.commons.math.stat.inference
Convenience class to pass dfbg,dfwg,F values around within AnovaImpl.
OneWayAnovaImpl.AnovaStats(int, int, double) - Constructor for class org.apache.commons.math.stat.inference.OneWayAnovaImpl.AnovaStats
Constructor
oneWayAnovaPValue(Collection) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
oneWayAnovaTest(Collection, double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
operate(BigDecimal[]) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the result of multiplying this by the vector v.
operate(BigDecimal[]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math.linear.RealMatrixImpl
 
optimalStep - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
optimal steps for each order.
orderControl1 - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
first order control factor.
orderControl2 - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
second order control factor.
org.apache.commons.math - package org.apache.commons.math
Common classes used throughout the commons-math library.
org.apache.commons.math.analysis - package org.apache.commons.math.analysis
Implementations of common numerical analysis procedures, including root finding and function interpolation.
org.apache.commons.math.complex - package org.apache.commons.math.complex
Complex number type and implementations of complex transcendental functions.
org.apache.commons.math.distribution - package org.apache.commons.math.distribution
Implementations of common discrete and continuous distributions.
org.apache.commons.math.estimation - package org.apache.commons.math.estimation
This package provides classes to solve estimation problems.
org.apache.commons.math.fraction - package org.apache.commons.math.fraction
Fraction number type and fraction number formatting.
org.apache.commons.math.geometry - package org.apache.commons.math.geometry
This package provides basic 3D geometry components.
org.apache.commons.math.linear - package org.apache.commons.math.linear
Linear algebra support.
org.apache.commons.math.ode - package org.apache.commons.math.ode
This package provides classes to solve Ordinary Differential Equations problems.
org.apache.commons.math.optimization - package org.apache.commons.math.optimization
This package provides parametric optimization algorithms.
org.apache.commons.math.random - package org.apache.commons.math.random
Random number and random data generators.
org.apache.commons.math.special - package org.apache.commons.math.special
Implementations of special functions such as Beta and Gamma.
org.apache.commons.math.stat - package org.apache.commons.math.stat
Data storage, manipulation and summary routines.
org.apache.commons.math.stat.descriptive - package org.apache.commons.math.stat.descriptive
Generic univariate summary statistic objects.
org.apache.commons.math.stat.descriptive.moment - package org.apache.commons.math.stat.descriptive.moment
Summary statistics based on moments.
org.apache.commons.math.stat.descriptive.rank - package org.apache.commons.math.stat.descriptive.rank
Summary statistics based on ranks.
org.apache.commons.math.stat.descriptive.summary - package org.apache.commons.math.stat.descriptive.summary
Other summary statistics.
org.apache.commons.math.stat.inference - package org.apache.commons.math.stat.inference
Classes providing hypothesis testing and confidence interval construction.
org.apache.commons.math.stat.regression - package org.apache.commons.math.stat.regression
Statistical routines involving multivariate data.
org.apache.commons.math.transform - package org.apache.commons.math.transform
Implementations of transform methods, including Fast Fourier transforms.
org.apache.commons.math.util - package org.apache.commons.math.util
Convenience routines and common data structures used throughout the commons-math library.
orthogonal() - Method in class org.apache.commons.math.geometry.Vector3D
Get a vector orthogonal to the instance.
orthogonalizeMatrix(double[][], double) - Method in class org.apache.commons.math.geometry.Rotation
Perfect orthogonality on a 3X3 matrix.
orthoTolerance - Variable in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Desired max cosine on the orthogonality between the function vector and the columns of the jacobian.

P

p - Variable in class org.apache.commons.math.analysis.LaguerreSolver
polynomial function to solve
pairedT(double[], double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
pairedT(double[], double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a paired, 2-sample t-statistic based on the data in the input arrays.
pairedT(double[], double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a paired, 2-sample t-statistic based on the data in the input arrays.
pairedTTest(double[], double[], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
pairedTTest(double[], double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
pairedTTest(double[], double[]) - Method in interface org.apache.commons.math.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) - Method in interface org.apache.commons.math.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.
pairedTTest(double[], double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
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) - Method in class org.apache.commons.math.stat.inference.TTestImpl
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.
parameters - Variable in class org.apache.commons.math.estimation.AbstractEstimator
Array of parameters.
parameters - Variable in class org.apache.commons.math.estimation.SimpleEstimationProblem
Estimated parameters.
parity - Variable in class org.apache.commons.math.linear.BigMatrixImpl
Parity of the permutation associated with the LU decomposition
parity - Variable in class org.apache.commons.math.linear.RealMatrixImpl
Parity of the permutation associated with the LU decomposition
parRelativeTolerance - Variable in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Desired relative error in the approximate solution parameters.
parse(String) - Method in class org.apache.commons.math.complex.ComplexFormat
Parses a string to produce a Complex object.
parse(String, ParsePosition) - Method in class org.apache.commons.math.complex.ComplexFormat
Parses a string to produce a Complex object.
parse(String) - Method in class org.apache.commons.math.fraction.FractionFormat
Parses a string to produce a Fraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math.fraction.FractionFormat
Parses a string to produce a Fraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math.fraction.ProperFractionFormat
Parses a string to produce a Fraction object.
parseAndIgnoreWhitespace(String, ParsePosition) - Method in class org.apache.commons.math.complex.ComplexFormat
Parses source until a non-whitespace character is found.
parseAndIgnoreWhitespace(String, ParsePosition) - Static method in class org.apache.commons.math.fraction.FractionFormat
Parses source until a non-whitespace character is found.
parseNextCharacter(String, ParsePosition) - Method in class org.apache.commons.math.complex.ComplexFormat
Parses source until a non-whitespace character is found.
parseNextCharacter(String, ParsePosition) - Static method in class org.apache.commons.math.fraction.FractionFormat
Parses source until a non-whitespace character is found.
parseNumber(String, double, ParsePosition) - Method in class org.apache.commons.math.complex.ComplexFormat
Parses source for a special double values.
parseNumber(String, NumberFormat, ParsePosition) - Method in class org.apache.commons.math.complex.ComplexFormat
Parses source for a number.
parseObject(String, ParsePosition) - Method in class org.apache.commons.math.complex.ComplexFormat
Parses a string to produce a object.
parseObject(String, ParsePosition) - Method in class org.apache.commons.math.fraction.FractionFormat
Parses a string to produce a object.
PascalDistribution - Interface in org.apache.commons.math.distribution
The Pascal distribution.
PascalDistributionImpl - Class in org.apache.commons.math.distribution
The default implementation of PascalDistribution.
PascalDistributionImpl(int, double) - Constructor for class org.apache.commons.math.distribution.PascalDistributionImpl
Create a binomial distribution with the given number of trials and probability of success.
pattern - Variable in exception org.apache.commons.math.MathException
Pattern used to build the message.
PB - Static variable in class org.apache.commons.math.util.MathUtils
1.0 cast as a byte.
pendingEvent - Variable in class org.apache.commons.math.ode.SwitchState
Indicator of event expected during the step.
pendingEventTime - Variable in class org.apache.commons.math.ode.SwitchState
Occurrence time of the pending event.
Percentile - Class in org.apache.commons.math.stat.descriptive.rank
Provides percentile computation.
Percentile() - Constructor for class org.apache.commons.math.stat.descriptive.rank.Percentile
Constructs a Percentile with a default quantile value of 50.0.
Percentile(double) - Constructor for class org.apache.commons.math.stat.descriptive.rank.Percentile
Constructs a Percentile with the specific quantile value.
percentile - Static variable in class org.apache.commons.math.stat.StatUtils
percentile
percentile(double[], double) - Static method in class org.apache.commons.math.stat.StatUtils
Returns an estimate of the pth percentile of the values in the values array.
percentile(double[], int, int, double) - Static method in class org.apache.commons.math.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.
percentileImpl - Variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Percentile statistic implementation - can be reset by setter.
performTest - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
stability check enabling parameter.
permutation - Variable in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Columns permutation array.
permutation - Variable in class org.apache.commons.math.linear.BigMatrixImpl
Permutation associated with LU decomposition
permutation - Variable in class org.apache.commons.math.linear.RealMatrixImpl
Permutation associated with LU decomposition
plusI - Static variable in class org.apache.commons.math.geometry.Vector3D
First canonical vector (coordinates: 1, 0, 0).
plusJ - Static variable in class org.apache.commons.math.geometry.Vector3D
Second canonical vector (coordinates: 0, 1, 0).
plusK - Static variable in class org.apache.commons.math.geometry.Vector3D
Third canonical vector (coordinates: 0, 0, 1).
point - Variable in class org.apache.commons.math.optimization.PointCostPair
Point coordinates.
PointCostPair - Class in org.apache.commons.math.optimization
This class holds a point and its associated cost.
PointCostPair(double[], double) - Constructor for class org.apache.commons.math.optimization.PointCostPair
Build a point/cost pair.
pointCostPairComparator - Static variable in class org.apache.commons.math.optimization.DirectSearchOptimizer
Comparator for PointCostPair objects.
PoissonDistribution - Interface in org.apache.commons.math.distribution
Interface representing the Poisson Distribution.
PoissonDistributionImpl - Class in org.apache.commons.math.distribution
Implementation for the PoissonDistribution.
PoissonDistributionImpl(double) - Constructor for class org.apache.commons.math.distribution.PoissonDistributionImpl
Create a new Poisson distribution with the given the mean.
PoissonDistributionImpl(double, NormalDistribution) - Constructor for class org.apache.commons.math.distribution.PoissonDistributionImpl
Create a new Poisson distribution with the given the mean.
polar2Complex(double, double) - Static method in class org.apache.commons.math.complex.ComplexUtils
Creates a complex number from the given polar representation.
polynomialDerivative() - Method in class org.apache.commons.math.analysis.PolynomialFunction
Returns the derivative as a PolynomialRealFunction
PolynomialFunction - Class in org.apache.commons.math.analysis
Immutable representation of a real polynomial function with real coefficients.
PolynomialFunction(double[]) - Constructor for class org.apache.commons.math.analysis.PolynomialFunction
Construct a polynomial with the given coefficients.
PolynomialFunctionLagrangeForm - Class in org.apache.commons.math.analysis
Implements the representation of a real polynomial function in Lagrange Form.
PolynomialFunctionLagrangeForm(double[], double[]) - Constructor for class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
Construct a Lagrange polynomial with the given abscissas and function values.
PolynomialFunctionNewtonForm - Class in org.apache.commons.math.analysis
Implements the representation of a real polynomial function in Newton Form.
PolynomialFunctionNewtonForm(double[], double[]) - Constructor for class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
Construct a Newton polynomial with the given a[] and c[].
polynomials - Variable in class org.apache.commons.math.analysis.PolynomialSplineFunction
The polynomial functions that make up the spline.
polynomialSplineDerivative() - Method in class org.apache.commons.math.analysis.PolynomialSplineFunction
Returns the derivative of the polynomial spline function as a PolynomialSplineFunction
PolynomialSplineFunction - Class in org.apache.commons.math.analysis
Represents a polynomial spline function.
PolynomialSplineFunction(double[], PolynomialFunction[]) - Constructor for class org.apache.commons.math.analysis.PolynomialSplineFunction
Construct a polynomial spline function with the given segment delimiters and interpolating polynomials.
polynoms - Variable in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Interpolation polynoms.
populationSize - Variable in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
The population size.
pow(Complex) - Method in class org.apache.commons.math.complex.Complex
Returns of value of this complex number raised to the power of x.
pow(Complex, Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.pow(x)
predict(double) - Method in class org.apache.commons.math.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.
preMultiply(BigMatrix) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the result premultiplying this by m.
preMultiply(BigDecimal[]) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(BigMatrix) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the result premultiplying this by m.
preMultiply(BigDecimal[]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealMatrix) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the result premultiplying this by m.
preMultiply(double[]) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealMatrix) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns the result premultiplying this by m.
preMultiply(double[]) - Method in class org.apache.commons.math.linear.RealMatrixImpl
 
previousEventTime - Variable in class org.apache.commons.math.ode.SwitchState
Occurrence time of the previous event.
previousTime - Variable in class org.apache.commons.math.ode.AbstractStepInterpolator
previous time
printStackTrace() - Method in exception org.apache.commons.math.MathException
Prints the stack trace of this exception to the standard error stream.
printStackTrace(PrintStream) - Method in exception org.apache.commons.math.MathException
Prints the stack trace of this exception to the specified stream.
printStackTrace(PrintWriter) - Method in exception org.apache.commons.math.MathException
Prints the stack trace of this exception to the specified writer.
probability(double) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
For this disbution, X, this method returns P(X = x).
probability(double) - Method in interface org.apache.commons.math.distribution.DiscreteDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
For this disbution, X, this method returns P(X = x).
probability(int, int, int, int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
For the disbution, X, defined by the given hypergeometric distribution parameters, this method returns P(X = x).
probability(int) - Method in interface org.apache.commons.math.distribution.IntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
For this distribution, X, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
The probability mass function P(X = x) for a Poisson distribution.
probabilityOfSuccess - Variable in class org.apache.commons.math.distribution.BinomialDistributionImpl
The probability of success.
probabilityOfSuccess - Variable in class org.apache.commons.math.distribution.PascalDistributionImpl
The probability of success
prod - Static variable in class org.apache.commons.math.stat.StatUtils
prod
Product - Class in org.apache.commons.math.stat.descriptive.summary
Returns the product of the available values.
Product() - Constructor for class org.apache.commons.math.stat.descriptive.summary.Product
Create a Product instance
product(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the product of the entries in the input array, or Double.NaN if the array is empty.
product(double[], int, int) - Static method in class org.apache.commons.math.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.
productsSums - Variable in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Sums of products for each component.
ProperFractionFormat - Class in org.apache.commons.math.fraction
Formats a Fraction number in proper format.
ProperFractionFormat() - Constructor for class org.apache.commons.math.fraction.ProperFractionFormat
Create a proper formatting instance with the default number format for the whole, numerator, and denominator.
ProperFractionFormat(NumberFormat) - Constructor for class org.apache.commons.math.fraction.ProperFractionFormat
Create a proper formatting instance with a custom number format for the whole, numerator, and denominator.
ProperFractionFormat(NumberFormat, NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math.fraction.ProperFractionFormat
Create a proper formatting instance with a custom number format for each of the whole, numerator, and denominator.
prototype - Variable in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Prototype of the step interpolator.
prototype - Variable in class org.apache.commons.math.ode.RungeKuttaIntegrator
Prototype of the step interpolator.
PS - Static variable in class org.apache.commons.math.util.MathUtils
1.0 cast as a short.
putTransformer(Class, NumberTransformer) - Method in class org.apache.commons.math.util.TransformerMap
Sets a Class to Transformer Mapping in the Map.

Q

q0 - Variable in class org.apache.commons.math.geometry.Rotation
Scalar coordinate of the quaternion.
q1 - Variable in class org.apache.commons.math.geometry.Rotation
First coordinate of the vectorial part of the quaternion.
q2 - Variable in class org.apache.commons.math.geometry.Rotation
Second coordinate of the vectorial part of the quaternion.
q3 - Variable in class org.apache.commons.math.geometry.Rotation
Third coordinate of the vectorial part of the quaternion.
qr - Variable in class org.apache.commons.math.linear.QRDecompositionImpl
A packed representation of the QR decomposition.
qrDecomposition() - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Decompose a matrix A as A.P = Q.R using Householder transforms.
QRDecomposition - Interface in org.apache.commons.math.linear
An interface to classes that implement a algorithm to calculate the QR-decomposition of a real matrix.
QRDecompositionImpl - Class in org.apache.commons.math.linear
Calculates the QR-decomposition of a matrix.
QRDecompositionImpl(RealMatrix) - Constructor for class org.apache.commons.math.linear.QRDecompositionImpl
Calculates the QR decomposition of the given matrix.
qTy(double[]) - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Compute the product Qt.y for some Q.R.
quantile - Variable in class org.apache.commons.math.stat.descriptive.rank.Percentile
Determines what percentile is computed when evaluate() is activated with no quantile argument

R

rand - Variable in class org.apache.commons.math.random.RandomDataImpl
underlying random number generator
RandomAdaptor - Class in org.apache.commons.math.random
Extension of java.util.Random wrapping a RandomGenerator.
RandomAdaptor() - Constructor for class org.apache.commons.math.random.RandomAdaptor
Prevent instantiation without a generator argument
RandomAdaptor(RandomGenerator) - Constructor for class org.apache.commons.math.random.RandomAdaptor
Construct a RandomAdaptor wrapping the supplied RandomGenerator.
randomData - Variable in class org.apache.commons.math.random.EmpiricalDistributionImpl
RandomData instance to use in repeated calls to getNext()
RandomData - Interface in org.apache.commons.math.random
Random data generation utilities.
randomData - Variable in class org.apache.commons.math.random.ValueServer
RandomDataImpl to use for random data generation
RandomDataImpl - Class in org.apache.commons.math.random
Implements the RandomData interface using a RandomGenerator instance to generate non-secure data and a SecureRandom instance to provide data for the nextSecureXxx methods.
RandomDataImpl() - Constructor for class org.apache.commons.math.random.RandomDataImpl
Construct a RandomDataImpl.
RandomDataImpl(RandomGenerator) - Constructor for class org.apache.commons.math.random.RandomDataImpl
Construct a RandomDataImpl using the supplied RandomGenerator as the source of (non-secure) random data.
randomGenerator - Variable in class org.apache.commons.math.random.RandomAdaptor
Wrapped randomGenerator instance
RandomGenerator - Interface in org.apache.commons.math.random
Interface extracted from java.util.Random.
RandomVectorGenerator - Interface in org.apache.commons.math.random
This interface represents a random generator for whole vectors.
rank - Variable in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Rank of the jacobian matrix.
rank - Variable in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Rank of the covariance matrix.
rDiag - Variable in class org.apache.commons.math.linear.QRDecompositionImpl
The diagonal elements of R.
readBaseExternal(ObjectInput) - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Read the base state of the instance.
readExternal(ObjectInput) - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Read the instance from an input channel.
readExternal(ObjectInput) - Method in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Read the state of the instance.
readExternal(ObjectInput) - Method in class org.apache.commons.math.ode.DummyStepInterpolator
Read the instance from an input channel.
readExternal(ObjectInput) - Method in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Read the state of the instance.
readExternal(ObjectInput) - Method in class org.apache.commons.math.ode.RungeKuttaStepInterpolator
Read the state of the instance.
readObject(ObjectInputStream) - Method in class org.apache.commons.math.analysis.NewtonSolver
Custom deserialization to initialize transient deriviate field.
real - Variable in class org.apache.commons.math.complex.Complex
Deprecated. to be made final and private in 2.0
realFormat - Variable in class org.apache.commons.math.complex.ComplexFormat
The format used for the real part.
RealMatrix - Interface in org.apache.commons.math.linear
Interface defining a real-valued matrix with basic algebraic operations.
RealMatrixImpl - Class in org.apache.commons.math.linear
Implementation of RealMatrix using a double[][] array to store entries and LU decomposition to support linear system solution and inverse.
RealMatrixImpl() - Constructor for class org.apache.commons.math.linear.RealMatrixImpl
Creates a matrix with no data
RealMatrixImpl(int, int) - Constructor for class org.apache.commons.math.linear.RealMatrixImpl
Create a new RealMatrix with the supplied row and column dimensions.
RealMatrixImpl(double[][]) - Constructor for class org.apache.commons.math.linear.RealMatrixImpl
Create a new RealMatrix using the input array as the underlying data array.
RealMatrixImpl(double[]) - Constructor for class org.apache.commons.math.linear.RealMatrixImpl
Create a new (column) RealMatrix using v as the data for the unique column of the v.length x 1 matrix created.
reciprocal() - Method in class org.apache.commons.math.fraction.Fraction
Return the multiplicative inverse of this fraction.
regularizedBeta(double, double, double) - Static method in class org.apache.commons.math.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedBeta(double, double, double, double) - Static method in class org.apache.commons.math.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedBeta(double, double, double, int) - Static method in class org.apache.commons.math.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedBeta(double, double, double, double, int) - Static method in class org.apache.commons.math.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedGammaP(double, double) - Static method in class org.apache.commons.math.special.Gamma
Returns the regularized gamma function P(a, x).
regularizedGammaP(double, double, double, int) - Static method in class org.apache.commons.math.special.Gamma
Returns the regularized gamma function P(a, x).
regularizedGammaQ(double, double) - Static method in class org.apache.commons.math.special.Gamma
Returns the regularized gamma function Q(a, x) = 1 - P(a, x).
regularizedGammaQ(double, double, double, int) - Static method in class org.apache.commons.math.special.Gamma
Returns the regularized gamma function Q(a, x) = 1 - P(a, x).
reinitialize(double[], boolean) - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Reinitialize the instance
reinitialize(FirstOrderDifferentialEquations, double[], double[][], boolean) - Method in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Reinitialize the instance
reinitialize(FirstOrderDifferentialEquations, double[], double[][], boolean) - Method in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Reinitialize the instance Some embedded Runge-Kutta integrators need fewer functions evaluations than their counterpart step interpolators.
reinitialize(FirstOrderDifferentialEquations, double[], double[][], boolean) - Method in class org.apache.commons.math.ode.RungeKuttaStepInterpolator
Reinitialize the instance
reinitializeBegin(double, double[]) - Method in class org.apache.commons.math.ode.SwitchState
Reinitialize the beginning of the step.
relativeAccuracy - Variable in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
maximum relative error
relativeAccuracy - Variable in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Maximum relative error.
removeTransformer(Class) - Method in class org.apache.commons.math.util.TransformerMap
Removes a Class to Transformer Mapping in the Map.
replaceWorstPoint(PointCostPair) - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Replace the worst point of the simplex by a new point.
REPLAY_MODE - Static variable in class org.apache.commons.math.random.ValueServer
Replay data from valuesFilePath
requiresDenseOutput() - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Determines whether this handler needs dense output.
requiresDenseOutput() - Method in class org.apache.commons.math.ode.DummyStepHandler
Determines whether this handler needs dense output.
requiresDenseOutput() - Method in interface org.apache.commons.math.ode.StepHandler
Determines whether this handler needs dense output.
requiresDenseOutput() - Method in class org.apache.commons.math.ode.StepNormalizer
Determines whether this handler needs dense output.
rescale(double[], double[], double[]) - Method in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Update scaling array.
reSeed(long) - Method in class org.apache.commons.math.random.RandomDataImpl
Reseeds the random number generator with the supplied seed.
reSeed() - Method in class org.apache.commons.math.random.RandomDataImpl
Reseeds the random number generator with the current time in milliseconds.
reSeedSecure() - Method in class org.apache.commons.math.random.RandomDataImpl
Reseeds the secure random number generator with the current time in milliseconds.
reSeedSecure(long) - Method in class org.apache.commons.math.random.RandomDataImpl
Reseeds the secure random number generator with the supplied seed.
reset() - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Reset the step handler.
reset() - Method in class org.apache.commons.math.ode.DummyStepHandler
Reset the step handler.
reset() - Method in interface org.apache.commons.math.ode.StepHandler
Reset the step handler.
reset() - Method in class org.apache.commons.math.ode.StepNormalizer
Reset the step handler.
reset(double, double[]) - Method in class org.apache.commons.math.ode.SwitchingFunctionsHandler
Let the switching functions reset the state if they want.
reset(double, double[]) - Method in class org.apache.commons.math.ode.SwitchState
Let the switching function reset the state if it wants.
RESET_DERIVATIVES - Static variable in interface org.apache.commons.math.ode.SwitchingFunction
Reset derivatives indicator.
RESET_STATE - Static variable in interface org.apache.commons.math.ode.SwitchingFunction
Reset state indicator.
resetAbsoluteAccuracy() - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Reset the absolute accuracy to the default.
resetAbsoluteAccuracy() - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Reset the absolute accuracy to the default.
resetFunctionValueAccuracy() - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Reset the actual function accuracy to the default.
resetFunctionValueAccuracy() - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Reset the actual function accuracy to the default.
resetInternalState() - Method in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Reset internal state to dummy values.
resetInternalState() - Method in class org.apache.commons.math.ode.RungeKuttaIntegrator
Reset internal state to dummy values.
resetMaximalIterationCount() - Method in interface org.apache.commons.math.analysis.UnivariateRealIntegrator
Reset the upper limit for the number of iterations to the default.
resetMaximalIterationCount() - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Reset the upper limit for the number of iterations to the default.
resetMaximalIterationCount() - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Reset the upper limit for the number of iterations to the default.
resetMaximalIterationCount() - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Reset the upper limit for the number of iterations to the default.
resetMinimalIterationCount() - Method in interface org.apache.commons.math.analysis.UnivariateRealIntegrator
Reset the lower limit for the number of iterations to the default.
resetMinimalIterationCount() - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Reset the lower limit for the number of iterations to the default.
resetRelativeAccuracy() - Method in interface org.apache.commons.math.analysis.UnivariateRealIntegrator
Reset the relative accuracy to the default.
resetRelativeAccuracy() - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Reset the relative accuracy to the default.
resetRelativeAccuracy() - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Reset the relative accuracy to the default.
resetRelativeAccuracy() - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Reset the relative accuracy to the default.
resetReplayFile() - Method in class org.apache.commons.math.random.ValueServer
Resets REPLAY_MODE file pointer to the beginning of the valuesFileURL.
resetState(double, double[]) - Method in interface org.apache.commons.math.ode.SwitchingFunction
Reset the state prior to continue the integration.
resetTables(int) - Method in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Reallocate the internal tables.
residuals - Variable in class org.apache.commons.math.estimation.AbstractEstimator
Residuals array.
ResizableDoubleArray - Class in org.apache.commons.math.util
A variable length DoubleArray implementation that automatically handles expanding and contracting its internal storage array as elements are added and removed.
ResizableDoubleArray() - Constructor for class org.apache.commons.math.util.ResizableDoubleArray
Create a ResizableArray with default properties.
ResizableDoubleArray(int) - Constructor for class org.apache.commons.math.util.ResizableDoubleArray
Create a ResizableArray with the specified initial capacity.
ResizableDoubleArray(int, float) - Constructor for class org.apache.commons.math.util.ResizableDoubleArray
Create a ResizableArray with the specified initial capacity and expansion factor.
ResizableDoubleArray(int, float, float) - Constructor for class org.apache.commons.math.util.ResizableDoubleArray
Create a ResizableArray with the specified initialCapacity, expansionFactor, and contractionCriteria.
ResizableDoubleArray(int, float, float, int) - Constructor for class org.apache.commons.math.util.ResizableDoubleArray
Create a ResizableArray with the specified properties.
result - Variable in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
the last computed integral
result - Variable in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
The last computed root.
resultComputed - Variable in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
indicates whether an integral has been computed
resultComputed - Variable in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Indicates where a root has been computed.
revert() - Method in class org.apache.commons.math.geometry.Rotation
Revert a rotation.
rho - Variable in class org.apache.commons.math.optimization.NelderMead
Reflection coefficient.
RiddersSolver - Class in org.apache.commons.math.analysis
Implements the Ridders' Method for root finding of real univariate functions.
RiddersSolver(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.RiddersSolver
Construct a solver for the given function.
RombergIntegrator - Class in org.apache.commons.math.analysis
Implements the Romberg Algorithm for integration of real univariate functions.
RombergIntegrator(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.RombergIntegrator
Construct an integrator for the given function.
root - Variable in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Permutated Cholesky root of the covariance matrix.
rootCause - Variable in exception org.apache.commons.math.MathException
Root cause of the exception
Rotation - Class in org.apache.commons.math.geometry
This class implements rotations in a three-dimensional space.
Rotation() - Constructor for class org.apache.commons.math.geometry.Rotation
Build the identity rotation.
Rotation(double, double, double, double, boolean) - Constructor for class org.apache.commons.math.geometry.Rotation
Build a rotation from the quaternion coordinates.
Rotation(Vector3D, double) - Constructor for class org.apache.commons.math.geometry.Rotation
Build a rotation from an axis and an angle.
Rotation(double[][], double) - Constructor for class org.apache.commons.math.geometry.Rotation
Build a rotation from a 3X3 matrix.
Rotation(Vector3D, Vector3D, Vector3D, Vector3D) - Constructor for class org.apache.commons.math.geometry.Rotation
Build the rotation that transforms a pair of vector into another pair.
Rotation(Vector3D, Vector3D) - Constructor for class org.apache.commons.math.geometry.Rotation
Build one of the rotations that transform one vector into another one.
Rotation(RotationOrder, double, double, double) - Constructor for class org.apache.commons.math.geometry.Rotation
Build a rotation from three Cardan or Euler elementary rotations.
RotationOrder - Class in org.apache.commons.math.geometry
This class is a utility representing a rotation order specification for Cardan or Euler angles specification.
RotationOrder(String, Vector3D, Vector3D, Vector3D) - Constructor for class org.apache.commons.math.geometry.RotationOrder
Private constructor.
round(double, int) - Static method in class org.apache.commons.math.util.MathUtils
Round the given value to the specified number of decimal places.
round(double, int, int) - Static method in class org.apache.commons.math.util.MathUtils
Round the given value to the specified number of decimal places.
round(float, int) - Static method in class org.apache.commons.math.util.MathUtils
Round the given value to the specified number of decimal places.
round(float, int, int) - Static method in class org.apache.commons.math.util.MathUtils
Round the given value to the specified number of decimal places.
roundingMode - Variable in class org.apache.commons.math.linear.BigMatrixImpl
Rounding mode for divisions
roundUnscaled(double, double, int) - Static method in class org.apache.commons.math.util.MathUtils
Round the given non-negative, value to the "nearest" integer.
rows - Variable in class org.apache.commons.math.estimation.AbstractEstimator
Number of rows of the jacobian matrix.
RungeKuttaIntegrator - Class in org.apache.commons.math.ode
This class implements the common part of all fixed step Runge-Kutta integrators for Ordinary Differential Equations.
RungeKuttaIntegrator(double[], double[][], double[], RungeKuttaStepInterpolator, double) - Constructor for class org.apache.commons.math.ode.RungeKuttaIntegrator
Simple constructor.
RungeKuttaStepInterpolator - Class in org.apache.commons.math.ode
This class represents an interpolator over the last step during an ODE integration for Runge-Kutta and embedded Runge-Kutta integrators.
RungeKuttaStepInterpolator() - Constructor for class org.apache.commons.math.ode.RungeKuttaStepInterpolator
Simple constructor.
RungeKuttaStepInterpolator(RungeKuttaStepInterpolator) - Constructor for class org.apache.commons.math.ode.RungeKuttaStepInterpolator
Copy constructor.

S

s - Variable in class org.apache.commons.math.analysis.TrapezoidIntegrator
intermediate result
safety - Variable in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Safety factor for stepsize control.
sample(UnivariateRealFunction, double, double, int) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Sample the given univariate real function on the given interval.
sampleSize - Variable in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
The sample size.
sampleStats - Variable in class org.apache.commons.math.random.EmpiricalDistributionImpl
Sample statistics
sanityChecks(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Perform some sanity checks on the integration parameters.
sanityChecks(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math.ode.RungeKuttaIntegrator
Perform some sanity checks on the integration parameters.
scalAbsoluteTolerance - Variable in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Allowed absolute scalar error.
scalarAdd(BigDecimal) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the result of adding d to each entry of this.
scalarAdd(BigDecimal) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the result of adding d to each entry of this.
scalarAdd(double) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the result of adding d to each entry of this.
scalarAdd(double) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns the result of adding d to each entry of this.
scalarMultiply(double) - Method in class org.apache.commons.math.geometry.Vector3D
Multiply the instance by a scalar
scalarMultiply(BigDecimal) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the result multiplying each entry of this by d.
scalarMultiply(BigDecimal) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the result multiplying each entry of this by d
scalarMultiply(double) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the result multiplying each entry of this by d.
scalarMultiply(double) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns the result multiplying each entry of this by d
scale - Variable in class org.apache.commons.math.distribution.CauchyDistributionImpl
The scale of this distribution.
scale - Variable in class org.apache.commons.math.linear.BigMatrixImpl
BigDecimal scale
scaleArray(double[], double) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Multiply every component in the given real array by the given real number.
scaleArray(Complex[], double) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Multiply every component in the given complex array by the given real number.
scalRelativeTolerance - Variable in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Allowed relative scalar error.
SecantSolver - Class in org.apache.commons.math.analysis
Implements a modified version of the secant method for approximating a zero of a real univariate function.
SecantSolver(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.SecantSolver
Construct a solver for the given function.
SecondMoment - Class in org.apache.commons.math.stat.descriptive.moment
Computes a statistic related to the Second Central Moment.
SecondMoment() - Constructor for class org.apache.commons.math.stat.descriptive.moment.SecondMoment
Create a SecondMoment instance
secondMoment - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
SecondMoment is used to compute the mean and variance
SecondOrderDifferentialEquations - Interface in org.apache.commons.math.ode
This interface represents a second order differential equations set.
SecondOrderIntegrator - Interface in org.apache.commons.math.ode
This interface represents a second order integrator for differential equations.
secRand - Variable in class org.apache.commons.math.random.RandomDataImpl
underlying secure random number generator
sequence - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
step size sequence.
serialVersionUID - Static variable in class org.apache.commons.math.analysis.BisectionSolver
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.BrentSolver
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.DividedDifferenceInterpolator
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.LaguerreSolver
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.MullerSolver
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.NevilleInterpolator
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.NewtonSolver
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.PolynomialFunction
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.PolynomialSplineFunction
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.RiddersSolver
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.RombergIntegrator
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.SecantSolver
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.SimpsonIntegrator
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.TrapezoidIntegrator
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.ArgumentOutsideDomainException
Serializable version identifier.
serialVersionUID - Static variable in class org.apache.commons.math.complex.Complex
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.complex.ComplexFormat
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.ConvergenceException
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.DimensionMismatchException
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.AbstractContinuousDistribution
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.AbstractDistribution
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.AbstractIntegerDistribution
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.BinomialDistributionImpl
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.CauchyDistributionImpl
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.FDistributionImpl
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.GammaDistributionImpl
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.NormalDistributionImpl
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.PascalDistributionImpl
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.PoissonDistributionImpl
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.TDistributionImpl
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.distribution.WeibullDistributionImpl
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.DuplicateSampleAbscissaException
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.estimation.EstimatedParameter
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.estimation.EstimationException
Serializable version identifier.
serialVersionUID - Static variable in class org.apache.commons.math.estimation.GaussNewtonEstimator
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.fraction.Fraction
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.fraction.FractionConversionException
Serializable version identifier.
serialVersionUID - Static variable in class org.apache.commons.math.fraction.FractionFormat
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.fraction.ProperFractionFormat
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.FunctionEvaluationException
Serializable version identifier.
serialVersionUID - Static variable in exception org.apache.commons.math.geometry.CardanEulerSingularityException
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.geometry.NotARotationMatrixException
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.geometry.Rotation
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.geometry.Vector3D
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.linear.BigMatrixImpl
Serialization id
serialVersionUID - Static variable in exception org.apache.commons.math.linear.InvalidMatrixException
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.linear.MatrixIndexException
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.linear.RealMatrixImpl
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.MathConfigurationException
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.MathException
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.MaxIterationsExceededException
Serializable version identifier.
serialVersionUID - Static variable in class org.apache.commons.math.ode.ClassicalRungeKuttaStepInterpolator
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.ode.ContinuousOutputModel
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.ode.DerivativeException
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.ode.DummyStepHandler
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.ode.DummyStepInterpolator
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.ode.EulerStepInterpolator
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.ode.GillStepInterpolator
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.ode.HighamHall54StepInterpolator
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.ode.IntegratorException
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.ode.MidpointStepInterpolator
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.ode.SwitchState
Serializable version identifier.
serialVersionUID - Static variable in class org.apache.commons.math.ode.ThreeEighthesStepInterpolator
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.optimization.CostException
Serializable version identifier.
serialVersionUID - Static variable in class org.apache.commons.math.random.EmpiricalDistributionImpl
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.random.JDKRandomGenerator
Serializable version identifier
serialVersionUID - Static variable in exception org.apache.commons.math.random.NotPositiveDefiniteMatrixException
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.random.RandomAdaptor
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.random.RandomDataImpl
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.special.Beta
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.special.Erf
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.special.Gamma
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
Serialization UID
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic
Serialization UID
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Serialization UID
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatisticsImpl
Deprecated. Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.moment.FourthMoment
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.moment.Mean
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.moment.SecondMoment
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.moment.Skewness
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.moment.Variance
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.moment.VectorialMean
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Serialization UID
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.rank.Max
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.rank.Median
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.rank.Min
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.rank.Percentile
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
Serialization id
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.summary.Product
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.summary.Sum
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Serialization UID
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.SummaryStatisticsImpl
Deprecated. Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Serialization UID
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Serialization UID
serialVersionUID - Static variable in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Serialization UID
serialVersionUID - Static variable in class org.apache.commons.math.stat.Frequency.NaturalComparator
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.Frequency
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.stat.regression.SimpleRegression
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.transform.FastCosineTransformer
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.transform.FastFourierTransformer
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.transform.FastSineTransformer
serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.util.ContinuedFraction
Serialization UID
serialVersionUID - Static variable in class org.apache.commons.math.util.DefaultTransformer
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.util.ResizableDoubleArray
Serializable version identifier
serialVersionUID - Static variable in class org.apache.commons.math.util.TransformerMap
Serializable version identifier
setAbsoluteAccuracy(double) - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Set the absolute accuracy.
setAbsoluteAccuracy(double) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Set the absolute accuracy.
setAlpha(double) - Method in interface org.apache.commons.math.distribution.GammaDistribution
Modify the shape parameter, alpha.
setAlpha(double) - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Modify the shape parameter, alpha.
setBeta(double) - Method in interface org.apache.commons.math.distribution.GammaDistribution
Modify the scale parameter, beta.
setBeta(double) - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Modify the scale parameter, beta.
setBiasCorrected(boolean) - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
 
setBiasCorrected(boolean) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
 
setBound(boolean) - Method in class org.apache.commons.math.estimation.EstimatedParameter
Set the bound flag of the parameter
setChiSquareTest(TTest) - Static method in class org.apache.commons.math.stat.inference.TestUtils
Set the (singleton) TTest instance.
setChiSquareTest(ChiSquareTest) - Static method in class org.apache.commons.math.stat.inference.TestUtils
Set the (singleton) ChiSquareTest instance.
setContractionCriteria(float) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Sets the contraction criteria for this ExpandContractDoubleArray.
setCostRelativeTolerance(double) - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Set the desired relative error in the sum of squares.
setDegreesOfFreedom(double) - Method in interface org.apache.commons.math.distribution.ChiSquaredDistribution
Modify the degrees of freedom.
setDegreesOfFreedom(double) - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Modify the degrees of freedom.
setDegreesOfFreedom(double) - Method in interface org.apache.commons.math.distribution.TDistribution
Modify the degrees of freedom.
setDegreesOfFreedom(double) - Method in class org.apache.commons.math.distribution.TDistributionImpl
Modify the degrees of freedom.
setDenominatorDegreesOfFreedom(double) - Method in interface org.apache.commons.math.distribution.FDistribution
Modify the denominator degrees of freedom.
setDenominatorDegreesOfFreedom(double) - Method in class org.apache.commons.math.distribution.FDistributionImpl
Modify the denominator degrees of freedom.
setDenominatorFormat(NumberFormat) - Method in class org.apache.commons.math.fraction.FractionFormat
Modify the denominator format.
setDistribution(ChiSquaredDistribution) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Modify the distribution used to compute inference statistics.
setDistribution(TDistribution) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Modify the distribution used to compute inference statistics.
setDistribution(TDistribution) - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Modify the distribution used to compute inference statistics.
setElement(int, double) - Method in interface org.apache.commons.math.util.DoubleArray
Sets the element at the specified index.
setElement(int, double) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Sets the element at the specified index.
setEstimate(double) - Method in class org.apache.commons.math.estimation.EstimatedParameter
Set a new estimated value for the parameter.
setExpansionFactor(float) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Sets the expansionFactor.
setExpansionMode(int) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Sets the expansionMode.
setFunctionValueAccuracy(double) - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Set the function value accuracy.
setFunctionValueAccuracy(double) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Set the function value accuracy.
setGamma(GammaDistribution) - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Modify the underlying gamma distribution.
setGeoMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the geometric mean.
setGeoMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the geometric mean.
setGeoMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
setGeoMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
setGeometricMeanImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the gemoetric mean.
setIgnored(boolean) - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Set the ignore flag to the specified value Setting the ignore flag to true allow to reject wrong measurements, which sometimes can be detected only rather late.
setImaginaryCharacter(String) - Method in class org.apache.commons.math.complex.ComplexFormat
Modify the imaginaryCharacter.
setImaginaryFormat(NumberFormat) - Method in class org.apache.commons.math.complex.ComplexFormat
Modify the imaginaryFormat.
setImpl(StorelessUnivariateStatistic[], StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets statistics implementations.
setInitialCapacity(int) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Sets the initial capacity.
setInitialStepBoundFactor(double) - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Set the positive input variable used in determining the initial step bound.
setInitialStepSize(double) - Method in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Set the initial step size.
setInterpolatedTime(double) - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Set the time of the interpolated point.
setInterpolatedTime(double) - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Set the time of the interpolated point.
setInterpolatedTime(double) - Method in interface org.apache.commons.math.ode.StepInterpolator
Set the time of the interpolated point.
setInterpolationControl(boolean, int) - Method in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Set the interpolation order control parameter.
setKurtosisImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the kurtosis.
setMaxCostEval(int) - Method in class org.apache.commons.math.estimation.AbstractEstimator
Set the maximal number of cost evaluations allowed.
setMaxGrowth(double) - Method in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Set the maximal growth factor for stepsize control.
setMaximalIterationCount(int) - Method in interface org.apache.commons.math.analysis.UnivariateRealIntegrator
Set the upper limit for the number of iterations.
setMaximalIterationCount(int) - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Set the upper limit for the number of iterations.
setMaximalIterationCount(int) - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Set the upper limit for the number of iterations.
setMaximalIterationCount(int) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Set the upper limit for the number of iterations.
setMaxImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
setMaxImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
setMean(double) - Method in interface org.apache.commons.math.distribution.ExponentialDistribution
Modify the mean.
setMean(double) - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Modify the mean.
setMean(double) - Method in interface org.apache.commons.math.distribution.NormalDistribution
Modify the mean.
setMean(double) - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Modify the mean.
setMean(double) - Method in interface org.apache.commons.math.distribution.PoissonDistribution
Set the mean for the distribution.
setMean(double) - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Set the Poisson mean for the distribution.
setMeanImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
setMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
setMedian(double) - Method in interface org.apache.commons.math.distribution.CauchyDistribution
Modify the median.
setMedian(double) - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Modify the median.
setMinimalIterationCount(int) - Method in interface org.apache.commons.math.analysis.UnivariateRealIntegrator
Set the lower limit for the number of iterations.
setMinimalIterationCount(int) - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Set the lower limit for the number of iterations.
setMinImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
setMinImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
setMinReduction(double) - Method in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Set the minimal reduction factor for stepsize control.
setMode(int) - Method in class org.apache.commons.math.random.ValueServer
Setter for property mode.
setMu(double) - Method in class org.apache.commons.math.random.ValueServer
Setter for property mu.
setMultiStart(int, RandomVectorGenerator) - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Set up multi-start mode.
setNormal(NormalDistribution) - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Modify the normal distribution used to compute normal approximations.
setNumberOfSuccesses(int) - Method in interface org.apache.commons.math.distribution.HypergeometricDistribution
Modify the number of successes.
setNumberOfSuccesses(int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Modify the number of successes.
setNumberOfSuccesses(int) - Method in interface org.apache.commons.math.distribution.PascalDistribution
Change the number of successes for this distribution.
setNumberOfSuccesses(int) - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Change the number of successes for this distribution.
setNumberOfTrials(int) - Method in interface org.apache.commons.math.distribution.BinomialDistribution
Change the number of trials for this distribution.
setNumberOfTrials(int) - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Change the number of trials for this distribution.
setNumElements(int) - Method in class org.apache.commons.math.util.ResizableDoubleArray
This function allows you to control the number of elements contained in this array, and can be used to "throw out" the last n values in an array.
setNumeratorDegreesOfFreedom(double) - Method in interface org.apache.commons.math.distribution.FDistribution
Modify the numerator degrees of freedom.
setNumeratorDegreesOfFreedom(double) - Method in class org.apache.commons.math.distribution.FDistributionImpl
Modify the numerator degrees of freedom.
setNumeratorFormat(NumberFormat) - Method in class org.apache.commons.math.fraction.FractionFormat
Modify the numerator format.
setOneWayAnova(OneWayAnova) - Static method in class org.apache.commons.math.stat.inference.TestUtils
Set the (singleton) OneWayAnova instance
setOrderControl(int, double, double) - Method in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Set the order control parameters.
setOrthoTolerance(double) - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Set the desired max cosine on the orthogonality.
setParRelativeTolerance(double) - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Set the desired relative error in the approximate solution parameters.
setPercentileImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation to be used by DescriptiveStatistics.getPercentile(double).
setPopulationSize(int) - Method in interface org.apache.commons.math.distribution.HypergeometricDistribution
Modify the population size.
setPopulationSize(int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Modify the population size.
setProbabilityOfSuccess(double) - Method in interface org.apache.commons.math.distribution.BinomialDistribution
Change the probability of success for this distribution.
setProbabilityOfSuccess(double) - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Change the probability of success for this distribution.
setProbabilityOfSuccess(double) - Method in interface org.apache.commons.math.distribution.PascalDistribution
Change the probability of success for this distribution.
setProbabilityOfSuccess(double) - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Change the probability of success for this distribution.
setQuantile(double) - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Sets the value of the quantile field (determines what percentile is computed when evaluate() is called with no quantile argument).
setRealFormat(NumberFormat) - Method in class org.apache.commons.math.complex.ComplexFormat
Modify the realFormat.
setRelativeAccuracy(double) - Method in interface org.apache.commons.math.analysis.UnivariateRealIntegrator
Set the relative accuracy.
setRelativeAccuracy(double) - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Set the relative accuracy.
setRelativeAccuracy(double) - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Set the relative accuracy.
setRelativeAccuracy(double) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Set the relative accuracy.
setResult(double, int) - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Convenience function for implementations.
setResult(double, int) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Convenience function for implementations.
setRoundingMode(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Sets the rounding mode for decimal divisions.
setSafety(double) - Method in class org.apache.commons.math.ode.EmbeddedRungeKuttaIntegrator
Set the safety factor for stepsize control.
setSampleSize(int) - Method in interface org.apache.commons.math.distribution.HypergeometricDistribution
Modify the sample size.
setSampleSize(int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Modify the sample size.
setScale(double) - Method in interface org.apache.commons.math.distribution.CauchyDistribution
Modify the scale parameter.
setScale(double) - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Modify the scale parameter.
setScale(double) - Method in interface org.apache.commons.math.distribution.WeibullDistribution
Modify the scale parameter.
setScale(double) - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Modify the scale parameter.
setScale(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Sets the scale for division operations.
setSecureAlgorithm(String, String) - Method in class org.apache.commons.math.random.RandomDataImpl
Sets the PRNG algorithm for the underlying SecureRandom instance using the Security Provider API.
setSeed(long) - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Sets the seed of the underyling random number generator using a long seed.
setSeed(long) - Method in class org.apache.commons.math.random.RandomAdaptor
Sets the seed of the underyling random number generator using a long seed.
setSeed(long) - Method in interface org.apache.commons.math.random.RandomGenerator
Sets the seed of the underyling random number generator using a long seed.
setShape(double) - Method in interface org.apache.commons.math.distribution.WeibullDistribution
Modify the shape parameter.
setShape(double) - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Modify the shape parameter.
setSigma(double) - Method in class org.apache.commons.math.random.ValueServer
Setter for property sigma.
setSingleStart() - Method in class org.apache.commons.math.optimization.DirectSearchOptimizer
Set up single-start mode.
setSkewnessImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the skewness.
setStabilityCheck(boolean, int, int, double) - Method in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Set the stability check controls.
setStandardDeviation(double) - Method in interface org.apache.commons.math.distribution.NormalDistribution
Modify the standard deviation.
setStandardDeviation(double) - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Modify the standard deviation.
setStepHandler(StepHandler) - Method in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Set the step handler for this integrator.
setStepHandler(StepHandler) - Method in interface org.apache.commons.math.ode.FirstOrderIntegrator
Set the step handler for this integrator.
setStepHandler(StepHandler) - Method in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Set the step handler for this integrator.
setStepHandler(StepHandler) - Method in class org.apache.commons.math.ode.RungeKuttaIntegrator
Set the step handler for this integrator.
setStepHandler(StepHandler) - Method in interface org.apache.commons.math.ode.SecondOrderIntegrator
Set the step handler for this integrator.
setStepsizeControl(double, double, double, double) - Method in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Set the step size control factors.
setSubMatrix(BigDecimal[][], int, int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSumImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the sum.
setSumImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the Sum.
setSumImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the Sum.
setSumImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
setSumImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
setSumsqImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
setSumsqImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
setUnknownDistributionChiSquareTest(UnknownDistributionChiSquareTest) - Static method in class org.apache.commons.math.stat.inference.TestUtils
Set the (singleton) UnknownDistributionChiSquareTest instance.
setup(UnivariateRealFunction) - Static method in class org.apache.commons.math.analysis.UnivariateRealSolverUtils
Checks to see if f is null, throwing IllegalArgumentException if so.
setValuesFileURL(String) - Method in class org.apache.commons.math.random.ValueServer
Sets the valuesFileURL using a string URL representation
setValuesFileURL(URL) - Method in class org.apache.commons.math.random.ValueServer
Sets the valuesFileURL
setVarianceImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the variance.
setVarianceImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the variance.
setVarianceImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
setWholeFormat(NumberFormat) - Method in class org.apache.commons.math.fraction.ProperFractionFormat
Modify the whole format.
setWindowSize(int) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
WindowSize controls the number of values which contribute to the reported statistics.
setWindowSize(int) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
 
shift() - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Shift one step forward.
shouldContract() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns true if the internal storage array has too many unused storage positions.
shuffle(int[], int) - Method in class org.apache.commons.math.random.RandomDataImpl
Uses a 2-cycle permutation shuffle to randomly re-order the last elements of list.
sigma - Variable in class org.apache.commons.math.optimization.NelderMead
Shrinkage coefficient.
sigma - Variable in class org.apache.commons.math.random.ValueServer
Standard deviation for use with GAUSSIAN_MODE
sign(byte) - Static method in class org.apache.commons.math.util.MathUtils
Returns the sign for byte value x.
sign(double) - Static method in class org.apache.commons.math.util.MathUtils
Returns the sign for double precision x.
sign(float) - Static method in class org.apache.commons.math.util.MathUtils
Returns the sign for float value x.
sign(int) - Static method in class org.apache.commons.math.util.MathUtils
Returns the sign for int value x.
sign(long) - Static method in class org.apache.commons.math.util.MathUtils
Returns the sign for long value x.
sign(short) - Static method in class org.apache.commons.math.util.MathUtils
Returns the sign for short value x.
SimpleEstimationProblem - Class in org.apache.commons.math.estimation
Simple implementation of the EstimationProblem interface for boilerplate data handling.
SimpleEstimationProblem() - Constructor for class org.apache.commons.math.estimation.SimpleEstimationProblem
Build an empty instance without parameters nor measurements.
SimpleRegression - Class in org.apache.commons.math.stat.regression
Estimates an ordinary least squares regression model with one independent variable.
SimpleRegression() - Constructor for class org.apache.commons.math.stat.regression.SimpleRegression
Create an empty SimpleRegression instance
SimpleRegression(TDistribution) - Constructor for class org.apache.commons.math.stat.regression.SimpleRegression
Create an empty SimpleRegression using the given distribution object to compute inference statistics.
simplex - Variable in class org.apache.commons.math.optimization.DirectSearchOptimizer
Simplex.
SimpsonIntegrator - Class in org.apache.commons.math.analysis
Implements the Simpson's Rule for integration of real univariate functions.
SimpsonIntegrator(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.SimpsonIntegrator
Construct an integrator for the given function.
sin() - Method in class org.apache.commons.math.complex.Complex
Compute the sine of this complex number.
sin(Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.sin()
sinh() - Method in class org.apache.commons.math.complex.Complex
Compute the hyperbolic sine of this complex number.
sinh(Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.sinh()
sinh(double) - Static method in class org.apache.commons.math.util.MathUtils
Returns the hyperbolic sine of x.
Skewness - Class in org.apache.commons.math.stat.descriptive.moment
Computes the skewness of the available values.
Skewness() - Constructor for class org.apache.commons.math.stat.descriptive.moment.Skewness
Constructs a Skewness
Skewness(ThirdMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Skewness
Constructs a Skewness with an external moment
skewnessImpl - Variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Skewness statistic implementation - can be reset by setter.
solve(double, double, double) - Method in class org.apache.commons.math.analysis.BisectionSolver
Find a zero in the given interval.
solve(double, double) - Method in class org.apache.commons.math.analysis.BisectionSolver
Find a zero root in the given interval.
solve(double, double, double) - Method in class org.apache.commons.math.analysis.BrentSolver
Find a zero in the given interval with an initial guess.
solve(double, double) - Method in class org.apache.commons.math.analysis.BrentSolver
Find a zero in the given interval.
solve(double, double, double, double, double, double) - Method in class org.apache.commons.math.analysis.BrentSolver
Find a zero starting search according to the three provided points.
solve(double, double, double) - Method in class org.apache.commons.math.analysis.LaguerreSolver
Find a real root in the given interval with initial value.
solve(double, double) - Method in class org.apache.commons.math.analysis.LaguerreSolver
Find a real root in the given interval.
solve(Complex[], Complex) - Method in class org.apache.commons.math.analysis.LaguerreSolver
Find a complex root for the polynomial with the given coefficients, starting from the given initial value.
solve(double, double, double) - Method in class org.apache.commons.math.analysis.MullerSolver
Find a real root in the given interval with initial value.
solve(double, double) - Method in class org.apache.commons.math.analysis.MullerSolver
Find a real root in the given interval.
solve(double, double) - Method in class org.apache.commons.math.analysis.NewtonSolver
Find a zero near the midpoint of min and max.
solve(double, double, double) - Method in class org.apache.commons.math.analysis.NewtonSolver
Find a zero near the value startValue.
solve(double, double, double) - Method in class org.apache.commons.math.analysis.RiddersSolver
Find a root in the given interval with initial value.
solve(double, double) - Method in class org.apache.commons.math.analysis.RiddersSolver
Find a root in the given interval.
solve(double, double, double) - Method in class org.apache.commons.math.analysis.SecantSolver
Find a zero in the given interval.
solve(double, double) - Method in class org.apache.commons.math.analysis.SecantSolver
Find a zero in the given interval.
solve(double, double) - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Solve for a zero root in the given interval.
solve(double, double, double) - Method in interface org.apache.commons.math.analysis.UnivariateRealSolver
Solve for a zero in the given interval, start at startValue.
solve(UnivariateRealFunction, double, double) - Static method in class org.apache.commons.math.analysis.UnivariateRealSolverUtils
Convenience method to find a zero of a univariate real function.
solve(UnivariateRealFunction, double, double, double) - Static method in class org.apache.commons.math.analysis.UnivariateRealSolverUtils
Convenience method to find a zero of a univariate real function.
solve(BigDecimal[]) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the solution vector for a linear system with coefficient matrix = this and constant vector = b.
solve(BigMatrix) - Method in interface org.apache.commons.math.linear.BigMatrix
Returns a matrix of (column) solution vectors for linear systems with coefficient matrix = this and constant vectors = columns of b.
solve(BigDecimal[]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns a matrix of (column) solution vectors for linear systems with coefficient matrix = this and constant vectors = columns of b.
solve(double[]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns a matrix of (column) solution vectors for linear systems with coefficient matrix = this and constant vectors = columns of b.
solve(BigMatrix) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns a matrix of (column) solution vectors for linear systems with coefficient matrix = this and constant vectors = columns of b.
solve(double[]) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the solution vector for a linear system with coefficient matrix = this and constant vector = b.
solve(RealMatrix) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns a matrix of (column) solution vectors for linear systems with coefficient matrix = this and constant vectors = columns of b.
solve(double[]) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns a matrix of (column) solution vectors for linear systems with coefficient matrix = this and constant vectors = columns of b.
solve(RealMatrix) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns a matrix of (column) solution vectors for linear systems with coefficient matrix = this and constant vectors = columns of b.
solve2(double, double) - Method in class org.apache.commons.math.analysis.MullerSolver
Find a real root in the given interval.
solveAll(double[], double) - Method in class org.apache.commons.math.analysis.LaguerreSolver
Find all complex roots for the polynomial with the given coefficients, starting from the given initial value.
solveAll(Complex[], Complex) - Method in class org.apache.commons.math.analysis.LaguerreSolver
Find all complex roots for the polynomial with the given coefficients, starting from the given initial value.
solvedCols - Variable in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Number of solved variables.
SplineInterpolator - Class in org.apache.commons.math.analysis
Computes a natural (also known as "free", "unclamped") cubic spline interpolation for the data set.
SplineInterpolator() - Constructor for class org.apache.commons.math.analysis.SplineInterpolator
 
sqrt() - Method in class org.apache.commons.math.complex.Complex
Compute the square root of this complex number.
sqrt(Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.sqrt()
sqrt1z() - Method in class org.apache.commons.math.complex.Complex
Compute the square root of 1 - this2 for this complex number.
sqrt1z(Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.sqrt1z()
SQRT3 - Static variable in class org.apache.commons.math.random.UniformRandomGenerator
Square root of three.
stabilityReduction - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
stepsize reduction factor in case of stability check failure.
stage(double, double, int) - Method in class org.apache.commons.math.analysis.TrapezoidIntegrator
Compute the n-th stage integral of trapezoid rule.
standardDeviation - Variable in class org.apache.commons.math.distribution.NormalDistributionImpl
The standard deviation of this distribution.
standardDeviation - Variable in class org.apache.commons.math.random.UncorrelatedRandomVectorGenerator
Standard deviation vector.
StandardDeviation - Class in org.apache.commons.math.stat.descriptive.moment
Computes the sample standard deviation.
StandardDeviation() - Constructor for class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Constructs a StandardDeviation.
StandardDeviation(SecondMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Constructs a StandardDeviation from an external second moment.
StandardDeviation(boolean) - Constructor for class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Contructs a StandardDeviation with the specified value for the isBiasCorrected property.
StandardDeviation(boolean, SecondMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Contructs a StandardDeviation with the specified value for the isBiasCorrected property and the supplied external moment.
start() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns the starting index of the internal array.
startIndex - Variable in class org.apache.commons.math.util.ResizableDoubleArray
The position of the first addressable element in the internal storage array.
starts - Variable in class org.apache.commons.math.optimization.DirectSearchOptimizer
Number of starts to go.
staticA - Static variable in class org.apache.commons.math.ode.DormandPrince54Integrator
Internal weights Butcher array.
staticA - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
Internal weights Butcher array.
staticA - Static variable in class org.apache.commons.math.ode.HighamHall54Integrator
Internal weights Butcher array.
staticB - Static variable in class org.apache.commons.math.ode.DormandPrince54Integrator
Propagation weights Butcher array.
staticB - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
Propagation weights Butcher array.
staticB - Static variable in class org.apache.commons.math.ode.HighamHall54Integrator
Propagation weights Butcher array.
staticC - Static variable in class org.apache.commons.math.ode.DormandPrince54Integrator
Time steps Butcher array.
staticC - Static variable in class org.apache.commons.math.ode.DormandPrince853Integrator
Time steps Butcher array.
staticC - Static variable in class org.apache.commons.math.ode.HighamHall54Integrator
Time steps Butcher array.
staticE - Static variable in class org.apache.commons.math.ode.HighamHall54Integrator
Error weights Butcher array.
StatisticalMultivariateSummary - Interface in org.apache.commons.math.stat.descriptive
Reporting interface for basic multivariate statistics.
StatisticalSummary - Interface in org.apache.commons.math.stat.descriptive
Reporting interface for basic univariate statistics.
StatisticalSummaryValues - Class in org.apache.commons.math.stat.descriptive
Value object representing the results of a univariate statistical summary.
StatisticalSummaryValues(double, double, long, double, double, double) - Constructor for class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
Constructor
StatUtils - Class in org.apache.commons.math.stat
StatUtils provides static methods for computing statistics based on data stored in double[] arrays.
StatUtils() - Constructor for class org.apache.commons.math.stat.StatUtils
Private Constructor
steadyStateThreshold - Variable in class org.apache.commons.math.estimation.GaussNewtonEstimator
Threshold for cost steady state detection.
step - Variable in class org.apache.commons.math.ode.RungeKuttaIntegrator
Integration step.
stepAccepted(double, double[]) - Method in class org.apache.commons.math.ode.SwitchingFunctionsHandler
Inform the switching functions that the step has been accepted by the integrator.
stepAccepted(double, double[]) - Method in class org.apache.commons.math.ode.SwitchState
Acknowledge the fact the step has been accepted by the integrator.
stepControl1 - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
first stepsize control factor.
stepControl2 - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
second stepsize control factor.
stepControl3 - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
third stepsize control factor.
stepControl4 - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
fourth stepsize control factor.
StepHandler - Interface in org.apache.commons.math.ode
This interface represents a handler that should be called after each successful step.
StepInterpolator - Interface in org.apache.commons.math.ode
This interface represents an interpolator over the last step during an ODE integration.
StepNormalizer - Class in org.apache.commons.math.ode
This class wraps an object implementing FixedStepHandler into a StepHandler.
StepNormalizer(double, FixedStepHandler) - Constructor for class org.apache.commons.math.ode.StepNormalizer
Simple constructor.
steps - Variable in class org.apache.commons.math.ode.ContinuousOutputModel
Steps table.
stepSize - Variable in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Current stepsize.
stepSize - Variable in class org.apache.commons.math.ode.RungeKuttaIntegrator
Current stepsize.
stepStart - Variable in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Current step start time.
stepStart - Variable in class org.apache.commons.math.ode.RungeKuttaIntegrator
Current step start time.
STOP - Static variable in interface org.apache.commons.math.ode.SwitchingFunction
Stop indicator.
stop() - Method in class org.apache.commons.math.ode.SwitchingFunctionsHandler
Check if the integration should be stopped at the end of the current step.
stop() - Method in class org.apache.commons.math.ode.SwitchState
Check if the integration should be stopped at the end of the current step.
StorelessUnivariateStatistic - Interface in org.apache.commons.math.stat.descriptive
Extends the definition of UnivariateStatistic with StorelessUnivariateStatistic.increment(double) and StorelessUnivariateStatistic.incrementAll(double[]) methods for adding values and updating internal state.
storeTime(double) - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Store the current step time.
storeTime(double) - Method in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Store the current step time.
storeTime(double) - Method in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Store the current step time.
subAndCheck(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Subtract two integers, checking for overflow.
subAndCheck(long, long) - Static method in class org.apache.commons.math.util.MathUtils
Subtract two long integers, checking for overflow.
subtract(Complex) - Method in class org.apache.commons.math.complex.Complex
Return the difference between this complex number and the given complex number.
subtract(Fraction) - Method in class org.apache.commons.math.fraction.Fraction
Subtracts the value of another fraction from the value of this one, returning the result in reduced form.
subtract(Vector3D) - Method in class org.apache.commons.math.geometry.Vector3D
Subtract a vector from the instance.
subtract(double, Vector3D) - Method in class org.apache.commons.math.geometry.Vector3D
Subtract a scaled vector from the instance.
subtract(BigMatrix) - Method in interface org.apache.commons.math.linear.BigMatrix
Compute this minus m.
subtract(BigMatrix) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Compute this minus m.
subtract(RealMatrix) - Method in interface org.apache.commons.math.linear.RealMatrix
Compute this minus m.
subtract(RealMatrix) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Compute this minus m.
sum - Variable in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
The sum of the sample values
Sum - Class in org.apache.commons.math.stat.descriptive.summary
Returns the sum of the available values.
Sum() - Constructor for class org.apache.commons.math.stat.descriptive.summary.Sum
Create a Sum instance
sum - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
sum of values that have been added
sum - Static variable in class org.apache.commons.math.stat.StatUtils
sum
sum(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the values in the input array, or Double.NaN if the array is empty.
sum(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
sumDifference(double[], double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the (signed) differences between corresponding elements of the input arrays -- i.e., sum(sample1[i] - sample2[i]).
sumImpl - Variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sum statistic implementation - can be reset by setter.
sumImpl - Variable in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sum statistic implementation - can be reset by setter.
sumImpl - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sum statistic implementation - can be reset by setter.
sumLog - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
sumLog of values that have been added
sumLog - Static variable in class org.apache.commons.math.stat.StatUtils
sumLog
sumLog(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the natural logs of the entries in the input array, or Double.NaN if the array is empty.
sumLog(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the natural logs of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
sumLogImpl - Variable in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sum of log statistic implementation - can be reset by setter.
sumLogImpl - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sum of log statistic implementation - can be reset by setter.
SummaryStatistics - Class in org.apache.commons.math.stat.descriptive
Computes summary statistics for a stream of data values added using the addValue method.
SummaryStatistics() - Constructor for class org.apache.commons.math.stat.descriptive.SummaryStatistics
Construct a SummaryStatistics instance
SummaryStatisticsImpl - Class in org.apache.commons.math.stat.descriptive
Deprecated. to be removed in commons math 2.0. Use SummaryStatistics.
SummaryStatisticsImpl() - Constructor for class org.apache.commons.math.stat.descriptive.SummaryStatisticsImpl
Deprecated. Construct a SummaryStatistics
sumOfLogs - Variable in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Wrapped SumOfLogs instance
SumOfLogs - Class in org.apache.commons.math.stat.descriptive.summary
Returns the sum of the natural logs for this collection of values.
SumOfLogs() - Constructor for class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
Create a SumOfLogs instance
SumOfSquares - Class in org.apache.commons.math.stat.descriptive.summary
Returns the sum of the squares of the available values.
SumOfSquares() - Constructor for class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
Create a SumOfSquares instance
sums - Variable in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Sums for each component.
sumsq - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
sum of the square of each value that has been added
sumSq - Static variable in class org.apache.commons.math.stat.StatUtils
sumSq
sumSq(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the squares of the entries in the input array, or Double.NaN if the array is empty.
sumSq(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the squares of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
sumsqImpl - Variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sum of squares statistic implementation - can be reset by setter.
sumSqImpl - Variable in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sum of squares statistic implementation - can be reset by setter.
sumsqImpl - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sum of squares statistic implementation - can be reset by setter.
sumX - Variable in class org.apache.commons.math.stat.regression.SimpleRegression
sum of x values
sumXX - Variable in class org.apache.commons.math.stat.regression.SimpleRegression
total variation in x (sum of squared deviations from xbar)
sumXY - Variable in class org.apache.commons.math.stat.regression.SimpleRegression
sum of products
sumY - Variable in class org.apache.commons.math.stat.regression.SimpleRegression
sum of y values
sumYY - Variable in class org.apache.commons.math.stat.regression.SimpleRegression
total variation in y (sum of squared deviations from ybar)
switchesHandler - Variable in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Switching functions handler.
switchesHandler - Variable in class org.apache.commons.math.ode.RungeKuttaIntegrator
Switching functions handler.
SwitchingFunction - Interface in org.apache.commons.math.ode
This interface represents a switching function.
SwitchingFunctionsHandler - Class in org.apache.commons.math.ode
This class handles several switching functions during integration.
SwitchingFunctionsHandler() - Constructor for class org.apache.commons.math.ode.SwitchingFunctionsHandler
Simple constructor.
SwitchState - Class in org.apache.commons.math.ode
This class handles the state for one switching function during integration steps.
SwitchState(SwitchingFunction, double, double, int) - Constructor for class org.apache.commons.math.ode.SwitchState
Simple constructor.
SynchronizedDescriptiveStatistics - Class in org.apache.commons.math.stat.descriptive
Implementation of DescriptiveStatistics that is safe to use in a multithreaded environment.
SynchronizedDescriptiveStatistics() - Constructor for class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Construct an instance with infinite window
SynchronizedDescriptiveStatistics(int) - Constructor for class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Construct an instance with finite window
SynchronizedMultivariateSummaryStatistics - Class in org.apache.commons.math.stat.descriptive
Implementation of MultivariateSummaryStatistics that is safe to use in a multithreaded environment.
SynchronizedMultivariateSummaryStatistics(int, boolean) - Constructor for class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Construct a SynchronizedMultivariateSummaryStatistics instance
SynchronizedSummaryStatistics - Class in org.apache.commons.math.stat.descriptive
Implementation of SummaryStatistics that is safe to use in a multithreaded environment.
SynchronizedSummaryStatistics() - Constructor for class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Construct a SynchronizedSummaryStatistics instance

T

t(double, double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
t(double, StatisticalSummary) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
t(double[], double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
t(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
t(double, double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a t statistic given observed values and a comparison constant.
t(double, StatisticalSummary) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a t statistic to use in comparing the mean of the dataset described by sampleStats to mu.
t(double[], double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a 2-sample t statistic, without the hypothesis of equal subpopulation variances.
t(StatisticalSummary, StatisticalSummary) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a 2-sample t statistic , comparing the means of the datasets described by two StatisticalSummary instances, without the assumption of equal subpopulation variances.
t(double, double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a t statistic given observed values and a comparison constant.
t(double, StatisticalSummary) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a t statistic to use in comparing the mean of the dataset described by sampleStats to mu.
t(double[], double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a 2-sample t statistic, without the hypothesis of equal subpopulation variances.
t(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a 2-sample t statistic , comparing the means of the datasets described by two StatisticalSummary instances, without the assumption of equal subpopulation variances.
t(double, double, double, double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes t test statistic for 1-sample t-test.
t(double, double, double, double, double, double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes t test statistic for 2-sample t-test.
t0 - Variable in class org.apache.commons.math.ode.SwitchState
Time at the beginning of the step.
tan() - Method in class org.apache.commons.math.complex.Complex
Compute the tangent of this complex number.
tan(Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.tan()
tanh() - Method in class org.apache.commons.math.complex.Complex
Compute the hyperbolic tangent of this complex number.
tanh(Complex) - Static method in class org.apache.commons.math.complex.ComplexUtils
Deprecated. use Complex.tanh()
TDistribution - Interface in org.apache.commons.math.distribution
Student's t-Distribution.
TDistributionImpl - Class in org.apache.commons.math.distribution
Default implementation of TDistribution.
TDistributionImpl(double) - Constructor for class org.apache.commons.math.distribution.TDistributionImpl
Create a t distribution using the given degrees of freedom.
test(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic
This method is used by evaluate(double[], int, int) methods to verify that the input parameters designate a subarray of positive length.
TestFactory - Class in org.apache.commons.math.stat.inference
Deprecated. as of 1.2, pluggability of test instances is now provided through constructors and setters.
TestFactory() - Constructor for class org.apache.commons.math.stat.inference.TestFactory
Deprecated. Default constructor.
TestFactoryImpl - Class in org.apache.commons.math.stat.inference
Deprecated. as of 1.2, pluggability of test instances is now provided through constructors and setters.
TestFactoryImpl() - Constructor for class org.apache.commons.math.stat.inference.TestFactoryImpl
Deprecated. Default constructor.
TestUtils - Class in org.apache.commons.math.stat.inference
A collection of static methods to create inference test instances or to perform inference tests.
TestUtils() - Constructor for class org.apache.commons.math.stat.inference.TestUtils
Prevent instantiation.
ThirdMoment - Class in org.apache.commons.math.stat.descriptive.moment
Computes a statistic related to the Third Central Moment.
ThirdMoment() - Constructor for class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
Create a FourthMoment instance
ThreeEighthesIntegrator - Class in org.apache.commons.math.ode
This class implements the 3/8 fourth order Runge-Kutta integrator for Ordinary Differential Equations.
ThreeEighthesIntegrator(double) - Constructor for class org.apache.commons.math.ode.ThreeEighthesIntegrator
Simple constructor.
ThreeEighthesStepInterpolator - Class in org.apache.commons.math.ode
This class implements a step interpolator for the 3/8 fourth order Runge-Kutta integrator.
ThreeEighthesStepInterpolator() - Constructor for class org.apache.commons.math.ode.ThreeEighthesStepInterpolator
Simple constructor.
ThreeEighthesStepInterpolator(ThreeEighthesStepInterpolator) - Constructor for class org.apache.commons.math.ode.ThreeEighthesStepInterpolator
Copy constructor.
tMq - Static variable in class org.apache.commons.math.ode.GillStepInterpolator
First Gill coefficient.
TOO_SMALL - Static variable in class org.apache.commons.math.linear.BigMatrixImpl
Bound to determine effective singularity in LU decomposition
TOO_SMALL - Static variable in class org.apache.commons.math.linear.RealMatrixImpl
Bound to determine effective singularity in LU decomposition
toString() - Method in class org.apache.commons.math.geometry.RotationOrder
Get a string representation of the instance.
toString() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Get a string representation for this matrix.
toString() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Get a string representation for this matrix.
toString() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Generates a text report displaying univariate statistics from values that have been added.
toString() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Generates a text report displaying univariate statistics from values that have been added.
toString() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
 
toString() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
 
toString() - Method in class org.apache.commons.math.stat.Frequency
Return a string representation of this frequency distribution.
tPq - Static variable in class org.apache.commons.math.ode.GillStepInterpolator
Second Gill coefficient.
transform(double[]) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Transform the given real data set.
transform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Transform the given real function, sampled on the given interval.
transform(double[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Transform the given real data set.
transform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Transform the given real function, sampled on the given interval.
transform(Complex[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Transform the given complex data set.
transform(double[]) - Method in class org.apache.commons.math.transform.FastSineTransformer
Transform the given real data set.
transform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastSineTransformer
Transform the given real function, sampled on the given interval.
transform(Object) - Method in class org.apache.commons.math.util.DefaultTransformer
 
transform(Object) - Method in interface org.apache.commons.math.util.NumberTransformer
Implementing this interface provides a facility to transform from Object to Double.
transform(Object) - Method in class org.apache.commons.math.util.TransformerMap
Attempts to transform the Object against the map of NumberTransformers.
transform2(double[]) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Transform the given real data set.
transform2(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Transform the given real function, sampled on the given interval.
transform2(double[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Transform the given real data set.
transform2(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Transform the given real function, sampled on the given interval.
transform2(Complex[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Transform the given complex data set.
transform2(double[]) - Method in class org.apache.commons.math.transform.FastSineTransformer
Transform the given real data set.
transform2(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastSineTransformer
Transform the given real function, sampled on the given interval.
TransformerMap - Class in org.apache.commons.math.util
This TansformerMap automates the transformation of mixed object types.
TransformerMap() - Constructor for class org.apache.commons.math.util.TransformerMap
 
transformers() - Method in class org.apache.commons.math.util.TransformerMap
Returns the Set of NumberTransformers used as values in the map.
translate(String, Locale) - Static method in exception org.apache.commons.math.MathException
Translate a string to a given locale.
transpose() - Method in interface org.apache.commons.math.linear.BigMatrix
Returns the transpose of this matrix.
transpose() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Returns the transpose matrix.
transpose() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the transpose of this matrix.
transpose() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Returns the transpose matrix.
TrapezoidIntegrator - Class in org.apache.commons.math.analysis
Implements the Trapezoidal Rule for integration of real univariate functions.
TrapezoidIntegrator(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.TrapezoidIntegrator
Construct an integrator for the given function.
tryStep(FirstOrderDifferentialEquations, double, double[], double, int, double[], double[][], double[], double[], double[]) - Method in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
Perform integration over one step using substeps of a modified midpoint method.
tTest - Static variable in class org.apache.commons.math.stat.inference.TestUtils
Singleton TTest instance using default implementation.
tTest(double, double[], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(double, double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(double, StatisticalSummary, double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(double, StatisticalSummary) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(double[], double[], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(double[], double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(StatisticalSummary, StatisticalSummary, double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
TTest - Interface in org.apache.commons.math.stat.inference
An interface for Student's t-tests.
tTest(double, double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the input array with the constant mu.
tTest(double, double[], double) - Method in interface org.apache.commons.math.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which sample is drawn equals mu.
tTest(double, StatisticalSummary) - Method in interface org.apache.commons.math.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the dataset described by sampleStats with the constant mu.
tTest(double, StatisticalSummary, double) - Method in interface org.apache.commons.math.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which the dataset described by stats is drawn equals mu.
tTest(double[], double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays.
tTest(double[], double[], double) - Method in interface org.apache.commons.math.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that sample1 and sample2 are drawn from populations with the same mean, with significance level alpha.
tTest(StatisticalSummary, StatisticalSummary) - Method in interface org.apache.commons.math.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances.
tTest(StatisticalSummary, StatisticalSummary, double) - Method in interface org.apache.commons.math.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that sampleStats1 and sampleStats2 describe datasets drawn from populations with the same mean, with significance level alpha.
tTest(double, double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the input array with the constant mu.
tTest(double, double[], double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which sample is drawn equals mu.
tTest(double, StatisticalSummary) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the dataset described by sampleStats with the constant mu.
tTest(double, StatisticalSummary, double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which the dataset described by stats is drawn equals mu.
tTest(double[], double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays.
tTest(double[], double[], double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Performs a two-sided t-test evaluating the null hypothesis that sample1 and sample2 are drawn from populations with the same mean, with significance level alpha.
tTest(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances.
tTest(StatisticalSummary, StatisticalSummary, double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Performs a two-sided t-test evaluating the null hypothesis that sampleStats1 and sampleStats2 describe datasets drawn from populations with the same mean, with significance level alpha.
tTest(double, double, double, double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes p-value for 2-sided, 1-sample t-test.
tTest(double, double, double, double, double, double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes p-value for 2-sided, 2-sample t-test.
TTestImpl - Class in org.apache.commons.math.stat.inference
Implements t-test statistics defined in the TTest interface.
TTestImpl() - Constructor for class org.apache.commons.math.stat.inference.TTestImpl
Default constructor.
TTestImpl(TDistribution) - Constructor for class org.apache.commons.math.stat.inference.TTestImpl
Create a test instance using the given distribution for computing inference statistics.
TWO_PI - Static variable in class org.apache.commons.math.util.MathUtils
2 π.

U

UncorrelatedRandomVectorGenerator - Class in org.apache.commons.math.random
A RandomVectorGenerator that generates vectors with uncorrelated components.
UncorrelatedRandomVectorGenerator(double[], double[], NormalizedRandomGenerator) - Constructor for class org.apache.commons.math.random.UncorrelatedRandomVectorGenerator
Simple constructor.
UncorrelatedRandomVectorGenerator(int, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math.random.UncorrelatedRandomVectorGenerator
Simple constructor.
UNIFORM_MODE - Static variable in class org.apache.commons.math.random.ValueServer
Uniform random deviates with mean = mu
UniformRandomGenerator - Class in org.apache.commons.math.random
This class implements a normalized uniform random generator.
UniformRandomGenerator(RandomGenerator) - Constructor for class org.apache.commons.math.random.UniformRandomGenerator
Create a new generator.
UnivariateRealFunction - Interface in org.apache.commons.math.analysis
An interface representing a univariate real function.
UnivariateRealIntegrator - Interface in org.apache.commons.math.analysis
Interface for univariate real integration algorithms.
UnivariateRealIntegratorImpl - Class in org.apache.commons.math.analysis
Provide a default implementation for several generic functions.
UnivariateRealIntegratorImpl(UnivariateRealFunction, int) - Constructor for class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Construct an integrator with given iteration count and accuracy.
UnivariateRealInterpolator - Interface in org.apache.commons.math.analysis
Interface representing a univariate real interpolating function.
UnivariateRealSolver - Interface in org.apache.commons.math.analysis
Interface for (univariate real) rootfinding algorithms.
UnivariateRealSolverFactory - Class in org.apache.commons.math.analysis
Abstract factory class used to create UnivariateRealSolver instances.
UnivariateRealSolverFactory() - Constructor for class org.apache.commons.math.analysis.UnivariateRealSolverFactory
Default constructor.
UnivariateRealSolverFactoryImpl - Class in org.apache.commons.math.analysis
A concrete UnivariateRealSolverFactory.
UnivariateRealSolverFactoryImpl() - Constructor for class org.apache.commons.math.analysis.UnivariateRealSolverFactoryImpl
Default constructor.
UnivariateRealSolverImpl - Class in org.apache.commons.math.analysis
Provide a default implementation for several functions useful to generic solvers.
UnivariateRealSolverImpl(UnivariateRealFunction, int, double) - Constructor for class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Construct a solver with given iteration count and accuracy.
UnivariateRealSolverUtils - Class in org.apache.commons.math.analysis
Utility routines for UnivariateRealSolver objects.
UnivariateRealSolverUtils() - Constructor for class org.apache.commons.math.analysis.UnivariateRealSolverUtils
Default constructor.
UnivariateStatistic - Interface in org.apache.commons.math.stat.descriptive
Base evaluation interface implemented by all statistics.
unknownDistributionChiSquareTest - Static variable in class org.apache.commons.math.stat.inference.TestUtils
Singleton ChiSquareTest instance using default implementation.
UnknownDistributionChiSquareTest - Interface in org.apache.commons.math.stat.inference
An interface for Chi-Square tests for unknown distributions.
updateJacobian() - Method in class org.apache.commons.math.estimation.AbstractEstimator
Update the jacobian matrix.
updateResidualsAndCost() - Method in class org.apache.commons.math.estimation.AbstractEstimator
Update the residuals array and cost function value.
upperBounds - Variable in class org.apache.commons.math.random.EmpiricalDistributionImpl
upper bounds of subintervals in (0,1) "belonging" to the bins
upperCumulativeProbability(int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
For this disbution, X, this method returns P(X ≥ x).
useInterpolationError - Variable in class org.apache.commons.math.ode.GraggBulirschStoerIntegrator
use interpolation error in stepsize control.

V

v - Variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Vectors for interpolation.
v1 - Variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
First vector for interpolation.
v2 - Variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Second vector for interpolation.
v3 - Variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Third vector for interpolation.
v4 - Variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Fourth vector for interpolation.
value(double) - Method in class org.apache.commons.math.analysis.PolynomialFunction
Compute the value of the function for the given argument.
value(double) - Method in class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
Calculate the function value at the given point.
value(double) - Method in class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
Calculate the function value at the given point.
value(double) - Method in class org.apache.commons.math.analysis.PolynomialSplineFunction
Compute the value for the function.
value(double) - Method in interface org.apache.commons.math.analysis.UnivariateRealFunction
Compute the value for the function.
value - Variable in class org.apache.commons.math.stat.descriptive.rank.Max
Current value of the statistic
value - Variable in class org.apache.commons.math.stat.descriptive.rank.Min
Current value of the statistic
value - Variable in class org.apache.commons.math.stat.descriptive.summary.Product
The current Running Product.
value - Variable in class org.apache.commons.math.stat.descriptive.summary.Sum
The currently running sum.
value - Variable in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
The currently running value
value - Variable in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
The currently running sumSq
ValueServer - Class in org.apache.commons.math.random
Generates values for use in simulation applications.
ValueServer() - Constructor for class org.apache.commons.math.random.ValueServer
Creates new ValueServer
ValueServer(RandomData) - Constructor for class org.apache.commons.math.random.ValueServer
Construct a ValueServer instance using a RandomData as its source of random data.
valuesFileURL - Variable in class org.apache.commons.math.random.ValueServer
URI to raw data values
valuesIterator() - Method in class org.apache.commons.math.stat.Frequency
Returns an Iterator over the set of values that have been added.
variance - Variable in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Wrapped Variance instance
Variance - Class in org.apache.commons.math.stat.descriptive.moment
Computes the variance of the available values.
Variance() - Constructor for class org.apache.commons.math.stat.descriptive.moment.Variance
Constructs a Variance with default (true) isBiasCorrected property.
Variance(SecondMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Variance
Constructs a Variance based on an external second moment.
Variance(boolean) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Variance
Constructs a Variance with the specified isBiasCorrected property
Variance(boolean, SecondMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Variance
Constructs a Variance with the specified isBiasCorrected property and the supplied external second moment.
variance - Variable in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
The sample variance
variance - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
variance of values that have been added
variance - Static variable in class org.apache.commons.math.stat.StatUtils
variance
variance(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the variance of the entries in the input array, or Double.NaN if the array is empty.
variance(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
variance(double[], double, int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the variance of the entries in the specified portion of the input array, using the precomputed mean value.
variance(double[], double) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the variance of the entries in the input array, using the precomputed mean value.
varianceDifference(double[], double[], double) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the variance of the (signed) differences between corresponding elements of the input arrays -- i.e., var(sample1[i] - sample2[i]).
varianceImpl - Variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Variance statistic implementation - can be reset by setter.
varianceImpl - Variable in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Variance statistic implementation - can be reset by setter.
vecAbsoluteTolerance - Variable in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Allowed absolute vectorial error.
vecRelativeTolerance - Variable in class org.apache.commons.math.ode.AdaptiveStepsizeIntegrator
Allowed relative vectorial error.
Vector3D - Class in org.apache.commons.math.geometry
This class implements vectors in a three-dimensional space.
Vector3D() - Constructor for class org.apache.commons.math.geometry.Vector3D
Simple constructor.
Vector3D(double, double, double) - Constructor for class org.apache.commons.math.geometry.Vector3D
Simple constructor.
Vector3D(double, double) - Constructor for class org.apache.commons.math.geometry.Vector3D
Simple constructor.
Vector3D(double, Vector3D) - Constructor for class org.apache.commons.math.geometry.Vector3D
Multiplicative constructor Build a vector from another one and a scale factor.
Vector3D(double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math.geometry.Vector3D
Linear constructor Build a vector from two other ones and corresponding scale factors.
Vector3D(double, Vector3D, double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math.geometry.Vector3D
Linear constructor Build a vector from three other ones and corresponding scale factors.
Vector3D(double, Vector3D, double, Vector3D, double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math.geometry.Vector3D
Linear constructor Build a vector from four other ones and corresponding scale factors.
VectorialCovariance - Class in org.apache.commons.math.stat.descriptive.moment
Returns the covariance matrix of the available vectors.
VectorialCovariance(int, boolean) - Constructor for class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Constructs a VectorialMean.
VectorialMean - Class in org.apache.commons.math.stat.descriptive.moment
Returns the arithmetic mean of the available vectors.
VectorialMean(int) - Constructor for class org.apache.commons.math.stat.descriptive.moment.VectorialMean
Constructs a VectorialMean.
vectorsInitialized - Variable in class org.apache.commons.math.ode.DormandPrince54StepInterpolator
Initialization indicator for the interpolation vectors.
vectorsInitialized - Variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Initialization indicator for the interpolation vectors.
verifyBracketing(double, double, UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Verifies that the endpoints specify an interval and the function takes opposite signs at the enpoints, throws IllegalArgumentException if not
verifyDataSet(double[]) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Verifies that the data set has length of power of 2.
verifyDataSet(Object[]) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Verifies that the data set has length of power of 2.
verifyInputArray(double[], double[]) - Static method in class org.apache.commons.math.analysis.PolynomialFunctionNewtonForm
Verifies that the input arrays are valid.
verifyInterpolationArray(double[], double[]) - Static method in class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
Verifies that the interpolation arrays are valid.
verifyInterval(double, double) - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Verifies that the endpoints specify an interval.
verifyInterval(double, double) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Verifies that the endpoints specify an interval, throws IllegalArgumentException if not
verifyInterval(double, double) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Verifies that the endpoints specify an interval.
verifyIterationCount() - Method in class org.apache.commons.math.analysis.RombergIntegrator
Verifies that the iteration limits are valid and within the range.
verifyIterationCount() - Method in class org.apache.commons.math.analysis.SimpsonIntegrator
Verifies that the iteration limits are valid and within the range.
verifyIterationCount() - Method in class org.apache.commons.math.analysis.TrapezoidIntegrator
Verifies that the iteration limits are valid and within the range.
verifyIterationCount() - Method in class org.apache.commons.math.analysis.UnivariateRealIntegratorImpl
Verifies that the upper and lower limits of iterations are valid.
verifySequence(double, double, double) - Method in class org.apache.commons.math.analysis.UnivariateRealSolverImpl
Verifies that lower < initial < upper throws IllegalArgumentException if not

W

WeibullDistribution - Interface in org.apache.commons.math.distribution
Weibull Distribution.
WeibullDistributionImpl - Class in org.apache.commons.math.distribution
Default implementation of WeibullDistribution.
WeibullDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.WeibullDistributionImpl
Creates weibull distribution with the given shape and scale and a location equal to zero.
weight - Variable in class org.apache.commons.math.estimation.WeightedMeasurement
Measurement weight.
WeightedMeasurement - Class in org.apache.commons.math.estimation
This class represents measurements in estimation problems.
WeightedMeasurement(double, double) - Constructor for class org.apache.commons.math.estimation.WeightedMeasurement
Simple constructor.
WeightedMeasurement(double, double, boolean) - Constructor for class org.apache.commons.math.estimation.WeightedMeasurement
Simple constructor.
wholeFormat - Variable in class org.apache.commons.math.fraction.ProperFractionFormat
The format used for the whole number.
windowSize - Variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
hold the window size
writeBaseExternal(ObjectOutput) - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Save the base state of the instance.
writeExternal(ObjectOutput) - Method in class org.apache.commons.math.ode.AbstractStepInterpolator
Write the instance to an output channel.
writeExternal(ObjectOutput) - Method in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Save the state of the instance.
writeExternal(ObjectOutput) - Method in class org.apache.commons.math.ode.DummyStepInterpolator
Write the instance to an output channel.
writeExternal(ObjectOutput) - Method in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Save the state of the instance.
writeExternal(ObjectOutput) - Method in class org.apache.commons.math.ode.RungeKuttaStepInterpolator
Save the state of the instance.

X

x - Variable in class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
Interpolating points (abscissas) and the function values at these points.
x - Variable in class org.apache.commons.math.geometry.Vector3D
Abscissa.
xbar - Variable in class org.apache.commons.math.stat.regression.SimpleRegression
mean of accumulated x values, used in updating formulas
XYX - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Euler angles.
XYZ - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Cardan angles.
XZX - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Euler angles.
XZY - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Cardan angles.

Y

y - Variable in class org.apache.commons.math.analysis.PolynomialFunctionLagrangeForm
Interpolating points (abscissas) and the function values at these points.
y - Variable in class org.apache.commons.math.geometry.Vector3D
Ordinate.
y0Dot - Variable in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Slope at the beginning of the step.
y1 - Variable in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
State at the end of the step.
y1Dot - Variable in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Slope at the end of the step.
ybar - Variable in class org.apache.commons.math.stat.regression.SimpleRegression
mean of accumulated y values, used in updating formulas
yDotK - Variable in class org.apache.commons.math.ode.RungeKuttaStepInterpolator
Slopes at the intermediate points
yDotKLast - Variable in class org.apache.commons.math.ode.DormandPrince853StepInterpolator
Last evaluations.
yMidDots - Variable in class org.apache.commons.math.ode.GraggBulirschStoerStepInterpolator
Derivatives at the middle of the step.
YXY - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Euler angles.
YXZ - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Cardan angles.
YZX - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Cardan angles.
YZY - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Euler angles.

Z

z - Variable in class org.apache.commons.math.geometry.Vector3D
Height.
z - Variable in class org.apache.commons.math.ode.FirstOrderConverter
state vector.
ZB - Static variable in class org.apache.commons.math.util.MathUtils
0.0 cast as a byte.
zDDot - Variable in class org.apache.commons.math.ode.FirstOrderConverter
second time derivative of the state vector.
zDot - Variable in class org.apache.commons.math.ode.FirstOrderConverter
first time derivative of the state vector.
ZERO - Static variable in class org.apache.commons.math.complex.Complex
A complex number representing "0.0 + 0.0i"
ZERO - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "0 / 1".
zero - Static variable in class org.apache.commons.math.geometry.Vector3D
Null vector (coordinates: 0, 0, 0).
ZERO - Static variable in class org.apache.commons.math.linear.BigMatrixImpl
BigDecimal 0
ZS - Static variable in class org.apache.commons.math.util.MathUtils
0.0 cast as a short.
ZXY - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Cardan angles.
ZXZ - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Euler angles.
ZYX - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Cardan angles.
ZYZ - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Euler angles.

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