A B C D E F G H I J K L M N O P Q R S T V W Z 
All Classes All Packages

A

abs() - Method in class org.apache.commons.numbers.complex.Complex
Returns the absolute value of this complex number.
abs() - Method in class org.apache.commons.numbers.fraction.BigFraction
Returns the absolute value of this fraction.
abs() - Method in class org.apache.commons.numbers.fraction.Fraction
Returns the absolute value of this fraction.
AbstractField<T extends NativeOperators<T>> - Class in org.apache.commons.numbers.field
Boiler-plate code for concrete implementations of Field.
AbstractField() - Constructor for class org.apache.commons.numbers.field.AbstractField
 
accept(double) - Method in class org.apache.commons.numbers.core.Sum
Adds a single term to this sum.
acos() - Method in class org.apache.commons.numbers.complex.Complex
Returns the inverse cosine of this complex number.
acosh() - Method in class org.apache.commons.numbers.complex.Complex
Returns the inverse hyperbolic cosine of this complex number.
add(double) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is (this + addend), with addend interpreted as a real number.
add(double) - Method in class org.apache.commons.numbers.core.Sum
Adds a single term to this sum.
add(double...) - Method in class org.apache.commons.numbers.core.Sum
Adds values from the given array to the sum.
add(int) - Method in class org.apache.commons.numbers.fraction.BigFraction
Adds the specified value to this fraction, returning the result in reduced form.
add(int) - Method in class org.apache.commons.numbers.fraction.Fraction
Adds the specified value to this fraction, returning the result in reduced form.
add(long) - Method in class org.apache.commons.numbers.fraction.BigFraction
Adds the specified value to this fraction, returning the result in reduced form.
add(BigInteger) - Method in class org.apache.commons.numbers.fraction.BigFraction
Adds the specified value to this fraction, returning the result in reduced form.
add(Complex) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is (this + addend).
add(Sum) - Method in class org.apache.commons.numbers.core.Sum
Adds another sum to this sum.
add(FP64) - Method in class org.apache.commons.numbers.field.FP64
Binary addition.
add(BigFraction) - Method in class org.apache.commons.numbers.fraction.BigFraction
Adds the specified value to this fraction, returning the result in reduced form.
add(Fraction) - Method in class org.apache.commons.numbers.fraction.Fraction
Adds the specified value to this fraction, returning the result in reduced form.
add(Quaternion) - Method in class org.apache.commons.numbers.quaternion.Quaternion
Computes the sum of the instance and another quaternion.
add(Quaternion, Quaternion) - Static method in class org.apache.commons.numbers.quaternion.Quaternion
Computes the sum of two quaternions.
add(T) - Method in interface org.apache.commons.numbers.core.Addition
Binary addition.
add(T, T) - Method in class org.apache.commons.numbers.field.AbstractField
add(T, T) - Method in interface org.apache.commons.numbers.field.Field
 
addImaginary(double) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is (this + addend), with addend interpreted as an imaginary number.
Addition<T> - Interface in org.apache.commons.numbers.core
Addition.
addProduct(double, double) - Method in class org.apache.commons.numbers.core.Sum
Adds the high-accuracy product \( a b \) to this sum.
addProducts(double[], double[]) - Method in class org.apache.commons.numbers.core.Sum
Adds \( \sum_i a_i b_i \) to this sum.
Angle - Class in org.apache.commons.numbers.angle
Represents the angle concept.
Angle.Deg - Class in org.apache.commons.numbers.angle
Unit: degrees.
Angle.Rad - Class in org.apache.commons.numbers.angle
Unit: radians.
Angle.Turn - Class in org.apache.commons.numbers.angle
Unit: turns.
apply(double) - Method in class org.apache.commons.numbers.quaternion.Slerp
Performs the interpolation.
apply(double[], double[]...) - Method in enum org.apache.commons.numbers.arrays.SortInPlace
Sorts in place.
applyAsDouble(double) - Method in class org.apache.commons.numbers.angle.Reduce
arg() - Method in class org.apache.commons.numbers.complex.Complex
Returns the argument of this complex number.
ArithmeticUtils - Class in org.apache.commons.numbers.core
Some useful, arithmetics related, additions to the built-in functions in Math.
ASCENDING - org.apache.commons.numbers.arrays.SortInPlace
Sort in ascending order.
asin() - Method in class org.apache.commons.numbers.complex.Complex
Returns the inverse sine of this complex number.
asinh() - Method in class org.apache.commons.numbers.complex.Complex
Returns the inverse hyperbolic sine of this complex number.
atan() - Method in class org.apache.commons.numbers.complex.Complex
Returns the inverse tangent of this complex number.
atanh() - Method in class org.apache.commons.numbers.complex.Complex
Returns the inverse hyperbolic tangent of this complex number.

B

Beta - Class in org.apache.commons.numbers.gamma
bigDecimalValue() - Method in class org.apache.commons.numbers.fraction.BigFraction
Returns the BigDecimal representation of this fraction.
bigDecimalValue(int, RoundingMode) - Method in class org.apache.commons.numbers.fraction.BigFraction
Returns the BigDecimal representation of this fraction.
bigDecimalValue(RoundingMode) - Method in class org.apache.commons.numbers.fraction.BigFraction
Returns the BigDecimal representation of this fraction.
BigFraction - Class in org.apache.commons.numbers.fraction
Representation of a rational number using arbitrary precision.
BigFractionField - Class in org.apache.commons.numbers.field
BinomialCoefficient - Class in org.apache.commons.numbers.combinatorics
Representation of the binomial coefficient.
BinomialCoefficientDouble - Class in org.apache.commons.numbers.combinatorics
Representation of the binomial coefficient, as a double.
BrentSolver - Class in org.apache.commons.numbers.rootfinder
This class implements the Brent algorithm for finding zeros of real univariate functions.
BrentSolver(double, double, double) - Constructor for class org.apache.commons.numbers.rootfinder.BrentSolver
Construct a solver.
byteValue() - Method in class org.apache.commons.numbers.field.FP64

C

Combinations - Class in org.apache.commons.numbers.combinatorics
Utility to create combinations (n, k) of k elements in a set of n elements.
comparator() - Method in class org.apache.commons.numbers.combinatorics.Combinations
Creates a comparator.
compare(double, double) - Method in interface org.apache.commons.numbers.core.Precision.DoubleEquivalence
Compares two values.
compareTo(double, double, double) - Static method in class org.apache.commons.numbers.core.Precision
Compares two numbers given some amount of allowed error.
compareTo(double, double, int) - Static method in class org.apache.commons.numbers.core.Precision
Compares two numbers given some amount of allowed error.
compareTo(FP64) - Method in class org.apache.commons.numbers.field.FP64
compareTo(BigFraction) - Method in class org.apache.commons.numbers.fraction.BigFraction
Compares this object with the specified object for order using the signed magnitude.
compareTo(Fraction) - Method in class org.apache.commons.numbers.fraction.Fraction
Compares this object with the specified object for order using the signed magnitude.
complement(double, double, double) - Static method in class org.apache.commons.numbers.gamma.IncompleteBeta
Computes the complement of the incomplete beta function B(x, a, b).
complement(double, double, double) - Static method in class org.apache.commons.numbers.gamma.RegularizedBeta
Computes the complement of the regularized beta function I(x, a, b).
complement(double, double, double, double, int) - Static method in class org.apache.commons.numbers.gamma.IncompleteBeta
Computes the complement of the incomplete beta function B(x, a, b).
complement(double, double, double, double, int) - Static method in class org.apache.commons.numbers.gamma.RegularizedBeta
Computes the complement of the regularized beta function I(x, a, b).
Complex - Class in org.apache.commons.numbers.complex
Cartesian representation of a complex number.
conj() - Method in class org.apache.commons.numbers.complex.Complex
Returns the conjugate \( \overline{z} \) of this complex number \( z \).
conjugate() - Method in class org.apache.commons.numbers.quaternion.Quaternion
Returns the conjugate of this quaternion number.
ContinuedFraction - Class in org.apache.commons.numbers.fraction
Provides a generic means to evaluate continued fractions.
ContinuedFraction() - Constructor for class org.apache.commons.numbers.fraction.ContinuedFraction
 
cos() - Method in class org.apache.commons.numbers.complex.Complex
Returns the cosine of this complex number.
CosAngle - Class in org.apache.commons.numbers.angle
Computes the cosine of the angle between two vectors.
cosh() - Method in class org.apache.commons.numbers.complex.Complex
Returns the hyperbolic cosine of this complex number.
create() - Static method in class org.apache.commons.numbers.combinatorics.FactorialDouble
Deprecated.
Since 1.1 this functionality has been replaced with Factorial.doubleValue(int).

This class no longer supports a cache. This method returns a reference to a single instance.

create() - Static method in class org.apache.commons.numbers.combinatorics.LogFactorial
Creates an instance with no precomputed values.
create() - Static method in class org.apache.commons.numbers.core.Sum
Creates a new instance with an initial value of zero.

D

delta(double, double) - Static method in class org.apache.commons.numbers.gamma.GammaRatio
Computes the ratio of gamma functions of a value and an offset value.
derivative(double, double) - Static method in class org.apache.commons.numbers.gamma.RegularizedGamma.P
Computes the derivative of the lower regularized gamma function \( P(a, x) \).
derivative(double, double) - Static method in class org.apache.commons.numbers.gamma.RegularizedGamma.Q
Computes the derivative of the upper regularized gamma function \( Q(a, x) \).
derivative(double, double, double) - Static method in class org.apache.commons.numbers.gamma.RegularizedBeta
Computes the derivative of the regularized beta function I(x, a, b).
DESCENDING - org.apache.commons.numbers.arrays.SortInPlace
Sort in descending order.
Digamma - Class in org.apache.commons.numbers.gamma
divide(double) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is (this / divisor), with divisor interpreted as a real number.
divide(double) - Method in class org.apache.commons.numbers.quaternion.Quaternion
Divides the instance by a scalar.
divide(int) - Method in class org.apache.commons.numbers.fraction.BigFraction
Divide this fraction by the passed value, returning the result in reduced form.
divide(int) - Method in class org.apache.commons.numbers.fraction.Fraction
Divide this fraction by the passed value, returning the result in reduced form.
divide(long) - Method in class org.apache.commons.numbers.fraction.BigFraction
Divide this fraction by the passed value, returning the result in reduced form.
divide(BigInteger) - Method in class org.apache.commons.numbers.fraction.BigFraction
Divide this fraction by the passed value, returning the result in reduced form.
divide(Complex) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is (this / divisor).
divide(FP64) - Method in class org.apache.commons.numbers.field.FP64
Binary division.
divide(BigFraction) - Method in class org.apache.commons.numbers.fraction.BigFraction
Divide this fraction by the passed value, returning the result in reduced form.
divide(Fraction) - Method in class org.apache.commons.numbers.fraction.Fraction
Divide this fraction by the passed value, returning the result in reduced form.
divide(T) - Method in interface org.apache.commons.numbers.core.NativeOperators
Binary division.
divide(T, T) - Method in class org.apache.commons.numbers.field.AbstractField
divide(T, T) - Method in interface org.apache.commons.numbers.field.Field
 
divideImaginary(double) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is (this / divisor), with divisor interpreted as an imaginary number.
divideUnsigned(int, int) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Returns the unsigned quotient of dividing the first argument by the second where each argument and the result is interpreted as an unsigned value.
divideUnsigned(long, long) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Returns the unsigned quotient of dividing the first argument by the second where each argument and the result is interpreted as an unsigned value.
dot(Quaternion) - Method in class org.apache.commons.numbers.quaternion.Quaternion
Computes the dot-product of the instance by a quaternion.
dot(Quaternion, Quaternion) - Static method in class org.apache.commons.numbers.quaternion.Quaternion
Computes the dot-product of two quaternions.
doubleEquivalenceOfEpsilon(double) - Static method in class org.apache.commons.numbers.core.Precision
Creates a Precision.DoubleEquivalence instance that uses the given epsilon value for determining equality.
doubleValue() - Method in class org.apache.commons.numbers.field.FP64
doubleValue() - Method in class org.apache.commons.numbers.fraction.BigFraction
Returns the double value closest to this fraction.
doubleValue() - Method in class org.apache.commons.numbers.fraction.Fraction
Returns the double value closest to this fraction.
doubleValue(int) - Static method in class org.apache.commons.numbers.combinatorics.Factorial
Computes the factorial of n.

E

EPSILON - Static variable in class org.apache.commons.numbers.core.Precision
Largest double-precision floating-point number such that 1 + EPSILON is numerically equal to 1.
eq(double, double) - Method in interface org.apache.commons.numbers.core.Precision.DoubleEquivalence
Indicates whether given values are considered equal to each other.
equals(double, double) - Static method in class org.apache.commons.numbers.core.Precision
Returns true iff they are equal as defined by equals(x, y, 1).
equals(double, double, double) - Static method in class org.apache.commons.numbers.core.Precision
Returns true if there is no double value strictly between the arguments or the difference between them is within the range of allowed error (inclusive).
equals(double, double, int) - Static method in class org.apache.commons.numbers.core.Precision
Returns true if the arguments are equal or within the range of allowed error (inclusive).
equals(float, float) - Static method in class org.apache.commons.numbers.core.Precision
Returns true iff they are equal as defined by equals(x, y, 1).
equals(float, float, float) - Static method in class org.apache.commons.numbers.core.Precision
Returns true if there is no float value strictly between the arguments or the difference between them is within the range of allowed error (inclusive).
equals(float, float, int) - Static method in class org.apache.commons.numbers.core.Precision
Returns true if the arguments are equal or within the range of allowed error (inclusive).
equals(Object) - Method in class org.apache.commons.numbers.angle.Angle
Test for equality with another object.
equals(Object) - Method in class org.apache.commons.numbers.complex.Complex
Test for equality with another object.
equals(Object) - Method in class org.apache.commons.numbers.field.FP64
equals(Object) - Method in class org.apache.commons.numbers.fraction.BigFraction
Test for equality with another object.
equals(Object) - Method in class org.apache.commons.numbers.fraction.Fraction
Test for equality with another object.
equals(Object) - Method in class org.apache.commons.numbers.quaternion.Quaternion
equals(Quaternion, double) - Method in class org.apache.commons.numbers.quaternion.Quaternion
Checks whether this instance is equal to another quaternion within a given tolerance.
equalsIncludingNaN(double, double) - Static method in class org.apache.commons.numbers.core.Precision
Returns true if the arguments are both NaN or they are equal as defined by equals(x, y, 1).
equalsIncludingNaN(double, double, double) - Static method in class org.apache.commons.numbers.core.Precision
Returns true if the arguments are both NaN, there are no double value strictly between the arguments or the difference between them is within the range of allowed error (inclusive).
equalsIncludingNaN(double, double, int) - Static method in class org.apache.commons.numbers.core.Precision
Returns true if both arguments are NaN or if they are equal as defined by equals(x, y, maxUlps).
equalsIncludingNaN(float, float) - Static method in class org.apache.commons.numbers.core.Precision
Returns true if both arguments are NaN or they are equal as defined by equals(x, y, 1).
equalsIncludingNaN(float, float, float) - Static method in class org.apache.commons.numbers.core.Precision
Returns true if the arguments are both NaN, there are no float value strictly between the arguments or the difference between them is within the range of allowed error (inclusive).
equalsIncludingNaN(float, float, int) - Static method in class org.apache.commons.numbers.core.Precision
Returns true if both arguments are NaN or if they are equal as defined by equals(x, y, maxUlps).
equalsWithRelativeTolerance(double, double, double) - Static method in class org.apache.commons.numbers.core.Precision
Returns true if there is no double value strictly between the arguments or the relative difference between them is less than or equal to the given tolerance.
eqZero(double) - Method in interface org.apache.commons.numbers.core.Precision.DoubleEquivalence
Indicates whether the given value is considered equal to zero.
Erf - Class in org.apache.commons.numbers.gamma
Erfc - Class in org.apache.commons.numbers.gamma
Erfcx - Class in org.apache.commons.numbers.gamma
Scaled complementary error function.
ErfDifference - Class in org.apache.commons.numbers.gamma
Computes the difference between error function values.
EUCLIDEAN - org.apache.commons.numbers.core.Norm
Alias for Norm.L2.
evaluate(double, double) - Method in class org.apache.commons.numbers.fraction.ContinuedFraction
Evaluates the continued fraction.
evaluate(double, double, int) - Method in class org.apache.commons.numbers.fraction.ContinuedFraction
Evaluates the continued fraction.
exp() - Method in class org.apache.commons.numbers.complex.Complex
Returns the exponential function of this complex number.

F

Factorial - Class in org.apache.commons.numbers.combinatorics
FactorialDouble - Class in org.apache.commons.numbers.combinatorics
Deprecated.
Since 1.1 this functionality has been replaced with Factorial.doubleValue(int). Factorial of a number.
Field<T> - Interface in org.apache.commons.numbers.field
Interface representing a field.
findRoot(DoubleUnaryOperator, double, double) - Method in class org.apache.commons.numbers.rootfinder.BrentSolver
Search the function's zero within the given interval.
findRoot(DoubleUnaryOperator, double, double, double) - Method in class org.apache.commons.numbers.rootfinder.BrentSolver
Search the function's zero within the given interval, starting from the given estimate.
floatValue() - Method in class org.apache.commons.numbers.field.FP64
floatValue() - Method in class org.apache.commons.numbers.fraction.BigFraction
Returns the float value closest to this fraction.
floatValue() - Method in class org.apache.commons.numbers.fraction.Fraction
Returns the float value closest to this fraction.
FP64 - Class in org.apache.commons.numbers.field
Wraps a double value in order to be used as a field element.
FP64Field - Class in org.apache.commons.numbers.field
Double field.
Fraction - Class in org.apache.commons.numbers.fraction
Representation of a rational number.
FractionField - Class in org.apache.commons.numbers.field
Fraction field.
from(double) - Static method in class org.apache.commons.numbers.fraction.BigFraction
Create a fraction given the double value.
from(double) - Static method in class org.apache.commons.numbers.fraction.Fraction
Create a fraction given the double value.
from(double, double, int) - Static method in class org.apache.commons.numbers.fraction.BigFraction
Create a fraction given the double value and maximum error allowed.
from(double, double, int) - Static method in class org.apache.commons.numbers.fraction.Fraction
Create a fraction given the double value and maximum error allowed.
from(double, int) - Static method in class org.apache.commons.numbers.fraction.BigFraction
Create a fraction given the double value and maximum denominator.
from(double, int) - Static method in class org.apache.commons.numbers.fraction.Fraction
Create a fraction given the double value and maximum denominator.

G

g() - Static method in class org.apache.commons.numbers.gamma.LanczosApproximation
 
Gamma - Class in org.apache.commons.numbers.gamma
Gamma function \( \Gamma(x) \).
GammaRatio - Class in org.apache.commons.numbers.gamma
Ratio of Gamma functions.
gcd(int, int) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Computes the greatest common divisor of the absolute value of two numbers, using a modified version of the "binary gcd" method.
gcd(long, long) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Gets the greatest common divisor of the absolute value of two numbers, using the "binary gcd" method which avoids division and modulo operations.
GeneralizedContinuedFraction - Class in org.apache.commons.numbers.fraction
Provides a means to evaluate generalized continued fractions.
GeneralizedContinuedFraction.Coefficient - Class in org.apache.commons.numbers.fraction
Defines the n-th "a" and "b" coefficients of the continued fraction.
get() - Static method in class org.apache.commons.numbers.field.BigFractionField
 
get() - Static method in class org.apache.commons.numbers.field.FP64Field
 
get() - Static method in class org.apache.commons.numbers.field.FractionField
 
getA() - Method in class org.apache.commons.numbers.fraction.GeneralizedContinuedFraction.Coefficient
Returns the n-th "a" coefficient of the continued fraction.
getA(int, double) - Method in class org.apache.commons.numbers.fraction.ContinuedFraction
Defines the n-th "a" coefficient of the continued fraction.
getAsDouble() - Method in class org.apache.commons.numbers.angle.Angle
 
getAsDouble() - Method in class org.apache.commons.numbers.core.Sum
Gets the sum value.
getB() - Method in class org.apache.commons.numbers.fraction.GeneralizedContinuedFraction.Coefficient
Returns the n-th "b" coefficient of the continued fraction.
getB(int, double) - Method in class org.apache.commons.numbers.fraction.ContinuedFraction
Defines the n-th "b" coefficient of the continued fraction.
getDenominator() - Method in class org.apache.commons.numbers.fraction.BigFraction
Access the denominator as a BigInteger.
getDenominator() - Method in class org.apache.commons.numbers.fraction.Fraction
Access the denominator as an int.
getDenominatorAsInt() - Method in class org.apache.commons.numbers.fraction.BigFraction
Access the denominator as an int.
getDenominatorAsLong() - Method in class org.apache.commons.numbers.fraction.BigFraction
Access the denominator as a long.
getDimension() - Method in class org.apache.commons.numbers.arrays.MultidimensionalCounter
Gets the number of dimensions of the multidimensional counter.
getImaginary() - Method in class org.apache.commons.numbers.complex.Complex
Gets the imaginary part \( b \) of this complex number \( (a + i b) \).
getK() - Method in class org.apache.commons.numbers.combinatorics.Combinations
Gets the number of elements in each combination.
getN() - Method in class org.apache.commons.numbers.combinatorics.Combinations
Gets the size of the set from which combinations are drawn.
getNumerator() - Method in class org.apache.commons.numbers.fraction.BigFraction
Access the numerator as a BigInteger.
getNumerator() - Method in class org.apache.commons.numbers.fraction.Fraction
Access the numerator as an int.
getNumeratorAsInt() - Method in class org.apache.commons.numbers.fraction.BigFraction
Access the numerator as an int.
getNumeratorAsLong() - Method in class org.apache.commons.numbers.fraction.BigFraction
Access the numerator as a long.
getReal() - Method in class org.apache.commons.numbers.complex.Complex
Gets the real part \( a \) of this complex number \( (a + i b) \).
getScalarPart() - Method in class org.apache.commons.numbers.quaternion.Quaternion
Gets the scalar part of the quaternion.
getSize() - Method in class org.apache.commons.numbers.arrays.MultidimensionalCounter
Gets the total number of elements.
getSizes() - Method in class org.apache.commons.numbers.arrays.MultidimensionalCounter
Gets the number of multidimensional counter slots in each dimension.
getVectorPart() - Method in class org.apache.commons.numbers.quaternion.Quaternion
Gets the three components of the vector part of the quaternion.
getW() - Method in class org.apache.commons.numbers.quaternion.Quaternion
Gets the first component of the quaternion (scalar part).
getX() - Method in class org.apache.commons.numbers.quaternion.Quaternion
Gets the second component of the quaternion (first component of the vector part).
getY() - Method in class org.apache.commons.numbers.quaternion.Quaternion
Gets the third component of the quaternion (second component of the vector part).
getZ() - Method in class org.apache.commons.numbers.quaternion.Quaternion
Gets the fourth component of the quaternion (third component of the vector part).
gt(double, double) - Method in interface org.apache.commons.numbers.core.Precision.DoubleEquivalence
Indicates whether the first argument is strictly greater than the second.
gte(double, double) - Method in interface org.apache.commons.numbers.core.Precision.DoubleEquivalence
Indicates whether the first argument is greater than or considered equal to the second.

H

hashCode() - Method in class org.apache.commons.numbers.angle.Angle
hashCode() - Method in class org.apache.commons.numbers.complex.Complex
Gets a hash code for the complex number.
hashCode() - Method in class org.apache.commons.numbers.field.FP64
hashCode() - Method in class org.apache.commons.numbers.fraction.BigFraction
 
hashCode() - Method in class org.apache.commons.numbers.fraction.Fraction
 
hashCode() - Method in class org.apache.commons.numbers.quaternion.Quaternion

I

I - Static variable in class org.apache.commons.numbers.complex.Complex
A complex number representing \( i \), the square root of \( -1 \).
I - Static variable in class org.apache.commons.numbers.quaternion.Quaternion
i.
imag() - Method in class org.apache.commons.numbers.complex.Complex
Gets the imaginary part \( b \) of this complex number \( (a + i b) \).
IncompleteBeta - Class in org.apache.commons.numbers.gamma
IncompleteGamma - Class in org.apache.commons.numbers.gamma
IncompleteGamma.Lower - Class in org.apache.commons.numbers.gamma
IncompleteGamma.Upper - Class in org.apache.commons.numbers.gamma
intValue() - Method in class org.apache.commons.numbers.field.FP64
intValue() - Method in class org.apache.commons.numbers.fraction.BigFraction
Returns the whole number part of the fraction.
intValue() - Method in class org.apache.commons.numbers.fraction.Fraction
Returns the whole number part of the fraction.
inverse() - Method in class org.apache.commons.numbers.quaternion.Quaternion
Returns the inverse of this instance.
InverseErf - Class in org.apache.commons.numbers.gamma
Inverse of the error function.
InverseErfc - Class in org.apache.commons.numbers.gamma
isFinite() - Method in class org.apache.commons.numbers.complex.Complex
Returns true if both real and imaginary component of the complex number are finite.
isInfinite() - Method in class org.apache.commons.numbers.complex.Complex
Returns true if either real or imaginary component of the complex number is infinite.
isNaN() - Method in class org.apache.commons.numbers.complex.Complex
Returns true if either the real or imaginary component of the complex number is NaN and the complex number is not infinite.
isPowerOfTwo(long) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Returns true if the argument is a power of two.
isPrime(int) - Static method in class org.apache.commons.numbers.primes.Primes
Primality test: tells if the argument is a (provable) prime or not.
isPure(double) - Method in class org.apache.commons.numbers.quaternion.Quaternion
Checks whether the instance is a pure quaternion within a given tolerance.
isUnit(double) - Method in class org.apache.commons.numbers.quaternion.Quaternion
Checks whether the instance is a unit quaternion within a given tolerance.
iterator() - Method in class org.apache.commons.numbers.combinatorics.Combinations
Creates an iterator whose range is the k-element subsets of {0, ..., n - 1} represented as int[] arrays.

J

J - Static variable in class org.apache.commons.numbers.quaternion.Quaternion
j.

K

K - Static variable in class org.apache.commons.numbers.quaternion.Quaternion
k.

L

L1 - org.apache.commons.numbers.core.Norm
Manhattan norm (sum of the absolute values of the arguments).
L2 - org.apache.commons.numbers.core.Norm
LanczosApproximation - Class in org.apache.commons.numbers.gamma
Lanczos approximation to the Gamma function.
lcm(int, int) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Returns the least common multiple of the absolute value of two numbers, using the formula lcm(a,b) = (a / gcd(a,b)) * b.
lcm(long, long) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Returns the least common multiple of the absolute value of two numbers, using the formula lcm(a,b) = (a / gcd(a,b)) * b.
LINF - org.apache.commons.numbers.core.Norm
Maximum norm (maximum of the absolute values of the arguments).
log() - Method in class org.apache.commons.numbers.complex.Complex
Returns the natural logarithm of this complex number.
log10() - Method in class org.apache.commons.numbers.complex.Complex
Returns the base 10 common logarithm of this complex number.
LogBeta - Class in org.apache.commons.numbers.gamma
Computes \( log_e B(p, q) \).
LogBinomialCoefficient - Class in org.apache.commons.numbers.combinatorics
Natural logarithm of the binomial coefficient.
LogFactorial - Class in org.apache.commons.numbers.combinatorics
Class for computing the natural logarithm of the factorial of a number.
LogGamma - Class in org.apache.commons.numbers.gamma
Natural logarithm of the absolute value of \( \Gamma(x) \).
longValue() - Method in class org.apache.commons.numbers.field.FP64
longValue() - Method in class org.apache.commons.numbers.fraction.BigFraction
Returns the whole number part of the fraction.
longValue() - Method in class org.apache.commons.numbers.fraction.Fraction
Returns the whole number part of the fraction.
lt(double, double) - Method in interface org.apache.commons.numbers.core.Precision.DoubleEquivalence
Indicates whether the first argument is strictly smaller than the second.
lte(double, double) - Method in interface org.apache.commons.numbers.core.Precision.DoubleEquivalence
Indicates whether the first argument is smaller or considered equal to the second.

M

MANHATTAN - org.apache.commons.numbers.core.Norm
Alias for Norm.L1.
MAXIMUM - org.apache.commons.numbers.core.Norm
Alias for Norm.LINF.
MultidimensionalCounter - Class in org.apache.commons.numbers.arrays
Converter between unidimensional storage structure and multidimensional conceptual structure.
Multiplication<T> - Interface in org.apache.commons.numbers.core
Multiplication.
multiply(double) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is this * factor, with factor interpreted as a real number.
multiply(double) - Method in class org.apache.commons.numbers.quaternion.Quaternion
Multiplies the instance by a scalar.
multiply(int) - Method in interface org.apache.commons.numbers.core.NativeOperators
Repeated addition.
multiply(int) - Method in class org.apache.commons.numbers.field.FP64
Repeated addition.
multiply(int) - Method in class org.apache.commons.numbers.fraction.BigFraction
Multiply this fraction by the passed value, returning the result in reduced form.
multiply(int) - Method in class org.apache.commons.numbers.fraction.Fraction
Multiply this fraction by the passed value, returning the result in reduced form.
multiply(int, T) - Method in class org.apache.commons.numbers.field.AbstractField
multiply(int, T) - Method in interface org.apache.commons.numbers.field.Field
 
multiply(long) - Method in class org.apache.commons.numbers.fraction.BigFraction
Multiply this fraction by the passed value, returning the result in reduced form.
multiply(BigInteger) - Method in class org.apache.commons.numbers.fraction.BigFraction
Multiply this fraction by the passed value, returning the result in reduced form.
multiply(Complex) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is this * factor.
multiply(FP64) - Method in class org.apache.commons.numbers.field.FP64
Binary multiplication.
multiply(BigFraction) - Method in class org.apache.commons.numbers.fraction.BigFraction
Multiply this fraction by the passed value, returning the result in reduced form.
multiply(Fraction) - Method in class org.apache.commons.numbers.fraction.Fraction
Multiply this fraction by the passed value, returning the result in reduced form.
multiply(Quaternion) - Method in class org.apache.commons.numbers.quaternion.Quaternion
Returns the Hamilton product of the instance by a quaternion.
multiply(Quaternion, Quaternion) - Static method in class org.apache.commons.numbers.quaternion.Quaternion
Returns the Hamilton product of two quaternions.
multiply(T) - Method in interface org.apache.commons.numbers.core.Multiplication
Binary multiplication.
multiply(T, T) - Method in class org.apache.commons.numbers.field.AbstractField
multiply(T, T) - Method in interface org.apache.commons.numbers.field.Field
 
multiplyImaginary(double) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is this * factor, with factor interpreted as an imaginary number.

N

NativeOperators<T> - Interface in org.apache.commons.numbers.core
Operators that can be implemented in a more performant way using the language constructs.
negate() - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is the negation of both the real and imaginary parts of complex number \( z \).
negate() - Method in interface org.apache.commons.numbers.core.Addition
Additive inverse.
negate() - Method in class org.apache.commons.numbers.field.FP64
Additive inverse.
negate() - Method in class org.apache.commons.numbers.fraction.BigFraction
 
negate() - Method in class org.apache.commons.numbers.fraction.Fraction
 
negate() - Method in class org.apache.commons.numbers.quaternion.Quaternion
Returns the opposite of this instance.
negate(T) - Method in class org.apache.commons.numbers.field.AbstractField
negate(T) - Method in interface org.apache.commons.numbers.field.Field
 
nextPrime(int) - Static method in class org.apache.commons.numbers.primes.Primes
Return the smallest prime greater than or equal to n.
norm() - Method in class org.apache.commons.numbers.complex.Complex
Returns the squared norm value of this complex number.
norm() - Method in class org.apache.commons.numbers.quaternion.Quaternion
Computes the norm of the quaternion.
Norm - Enum in org.apache.commons.numbers.core
Norm functions.
normalize() - Method in class org.apache.commons.numbers.quaternion.Quaternion
Computes the normalized quaternion (the versor of the instance).
normalizer(double) - Static method in class org.apache.commons.numbers.angle.Angle.Deg
Creates an operator for normalizing/reducing an angle.
normalizer(double) - Static method in class org.apache.commons.numbers.angle.Angle.Rad
Creates an operator for normalizing/reducing an angle.
normalizer(double) - Static method in class org.apache.commons.numbers.angle.Angle.Turn
Creates an operator for normalizing/reducing an angle.
normSq() - Method in class org.apache.commons.numbers.quaternion.Quaternion
Computes the square of the norm of the quaternion.
nthRoot(int) - Method in class org.apache.commons.numbers.complex.Complex
Returns the n-th roots of this complex number.

O

of(double) - Static method in class org.apache.commons.numbers.angle.Angle.Deg
 
of(double) - Static method in class org.apache.commons.numbers.angle.Angle.Rad
 
of(double) - Static method in class org.apache.commons.numbers.angle.Angle.Turn
 
of(double) - Static method in class org.apache.commons.numbers.core.Sum
Creates an instance initialized to the given value.
of(double) - Static method in class org.apache.commons.numbers.field.FP64
Factory.
of(double[]) - Method in enum org.apache.commons.numbers.core.Norm
Computes the norm.
of(double...) - Static method in class org.apache.commons.numbers.core.Sum
Creates an instance containing the sum of the given values.
of(double[]) - Static method in class org.apache.commons.numbers.quaternion.Quaternion
Builds a pure quaternion from a vector (assuming that the scalar part is zero).
of(double, double) - Method in enum org.apache.commons.numbers.core.Norm
Computes the norm.
of(double, double) - Static method in class org.apache.commons.numbers.fraction.GeneralizedContinuedFraction.Coefficient
Create a new coefficient.
of(double, double[]) - Static method in class org.apache.commons.numbers.quaternion.Quaternion
Builds a quaternion from scalar and vector parts.
of(double, double, double) - Method in enum org.apache.commons.numbers.core.Norm
Computes the norm.
of(double, double, double, double) - Static method in class org.apache.commons.numbers.quaternion.Quaternion
Builds a quaternion from its components.
of(int) - Static method in class org.apache.commons.numbers.fraction.BigFraction
Create a fraction given the numerator.
of(int) - Static method in class org.apache.commons.numbers.fraction.Fraction
Create a fraction given the numerator.
of(int...) - Static method in class org.apache.commons.numbers.arrays.MultidimensionalCounter
Creates a counter.
of(int, int) - Static method in class org.apache.commons.numbers.combinatorics.Combinations
 
of(int, int) - Static method in class org.apache.commons.numbers.fraction.BigFraction
Create a fraction given the numerator and denominator.
of(int, int) - Static method in class org.apache.commons.numbers.fraction.Fraction
Create a fraction given the numerator and denominator.
of(long) - Static method in class org.apache.commons.numbers.fraction.BigFraction
Create a fraction given the numerator.
of(long, long) - Static method in class org.apache.commons.numbers.fraction.BigFraction
Create a fraction given the numerator and denominator.
of(BigInteger) - Static method in class org.apache.commons.numbers.fraction.BigFraction
Create a fraction given the numerator.
of(BigInteger, BigInteger) - Static method in class org.apache.commons.numbers.fraction.BigFraction
Create a fraction given the numerator and denominator.
ofCartesian(double, double) - Static method in class org.apache.commons.numbers.complex.Complex
Create a complex number given the real and imaginary parts.
ofCis(double) - Static method in class org.apache.commons.numbers.complex.Complex
Create a complex cis number.
ofPolar(double, double) - Static method in class org.apache.commons.numbers.complex.Complex
Creates a complex number from its polar representation using modulus rho (\( \rho \)) and phase angle theta (\( \theta \)).
ofProducts(double[], double[]) - Static method in class org.apache.commons.numbers.core.Sum
Creates a new instance containing \( \sum_i a_i b_i \).
one() - Method in interface org.apache.commons.numbers.core.Multiplication
Identity element.
one() - Method in class org.apache.commons.numbers.field.BigFractionField
one() - Method in interface org.apache.commons.numbers.field.Field
 
one() - Method in class org.apache.commons.numbers.field.FP64
Identity element.
one() - Method in class org.apache.commons.numbers.field.FP64Field
one() - Method in class org.apache.commons.numbers.field.FractionField
one() - Method in class org.apache.commons.numbers.fraction.BigFraction
 
one() - Method in class org.apache.commons.numbers.fraction.Fraction
 
ONE - Static variable in class org.apache.commons.numbers.complex.Complex
A complex number representing one.
ONE - Static variable in class org.apache.commons.numbers.fraction.BigFraction
A fraction representing "1".
ONE - Static variable in class org.apache.commons.numbers.fraction.Fraction
A fraction representing "1".
ONE - Static variable in class org.apache.commons.numbers.quaternion.Quaternion
Identity quaternion.
org.apache.commons.numbers.angle - package org.apache.commons.numbers.angle
Angle-related utilities.
org.apache.commons.numbers.arrays - package org.apache.commons.numbers.arrays
Array utilities.
org.apache.commons.numbers.combinatorics - package org.apache.commons.numbers.combinatorics
Combinatorics.
org.apache.commons.numbers.complex - package org.apache.commons.numbers.complex
Complex numbers.
org.apache.commons.numbers.core - package org.apache.commons.numbers.core
Basic utilities.
org.apache.commons.numbers.field - package org.apache.commons.numbers.field
Field-related utilities.
org.apache.commons.numbers.fraction - package org.apache.commons.numbers.fraction
Fraction number type and fraction number formatting.
org.apache.commons.numbers.gamma - package org.apache.commons.numbers.gamma
Γ (Gamma) and Β (Beta) family of functions.
org.apache.commons.numbers.primes - package org.apache.commons.numbers.primes
Methods related to prime numbers like primality test, factor decomposition.
org.apache.commons.numbers.quaternion - package org.apache.commons.numbers.quaternion
Quaternion number type.
org.apache.commons.numbers.rootfinder - package org.apache.commons.numbers.rootfinder
Root finding utilities.

P

parse(String) - Static method in class org.apache.commons.numbers.complex.Complex
Returns a Complex instance representing the specified string s.
parse(String) - Static method in class org.apache.commons.numbers.fraction.BigFraction
Returns a BigFraction instance representing the specified string s.
parse(String) - Static method in class org.apache.commons.numbers.fraction.Fraction
Returns a Fraction instance representing the specified string s.
parse(String) - Static method in class org.apache.commons.numbers.quaternion.Quaternion
Parses a string that would be produced by Quaternion.toString() and instantiates the corresponding object.
PI - Static variable in class org.apache.commons.numbers.angle.Angle.Rad
π.
PI_OVER_TWO - Static variable in class org.apache.commons.numbers.angle.Angle
π/2.
positivePolarForm() - Method in class org.apache.commons.numbers.quaternion.Quaternion
Returns the polar form of the quaternion.
pow(double) - Method in class org.apache.commons.numbers.complex.Complex
Returns the complex power of this complex number raised to the power of x, with x interpreted as a real number.
pow(int) - Method in interface org.apache.commons.numbers.core.NativeOperators
Repeated multiplication.
pow(int) - Method in class org.apache.commons.numbers.field.FP64
Repeated multiplication.
pow(int) - Method in class org.apache.commons.numbers.fraction.BigFraction
Returns a BigFraction whose value is thisexponent, returning the result in reduced form.
pow(int) - Method in class org.apache.commons.numbers.fraction.Fraction
Returns a Fraction whose value is thisexponent, returning the result in reduced form.
pow(int, int) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Raise an int to an int power.
pow(long, int) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Raise a long to an int power.
pow(BigInteger, int) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Raise a BigInteger to an int power.
pow(BigInteger, long) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Raise a BigInteger to a long power.
pow(BigInteger, BigInteger) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Raise a BigInteger to a BigInteger power.
pow(Complex) - Method in class org.apache.commons.numbers.complex.Complex
Returns the complex power of this complex number raised to the power of x.
Precision - Class in org.apache.commons.numbers.core
Utilities for comparing numbers.
Precision.DoubleEquivalence - Interface in org.apache.commons.numbers.core
Interface containing comparison operations for doubles that allow values to be considered equal even if they are not exactly equal.
primeFactors(int) - Static method in class org.apache.commons.numbers.primes.Primes
Prime factors decomposition.
Primes - Class in org.apache.commons.numbers.primes
Methods related to prime numbers in the range of int.
proj() - Method in class org.apache.commons.numbers.complex.Complex
Returns the projection of this complex number onto the Riemann sphere.

Q

Quaternion - Class in org.apache.commons.numbers.quaternion
This class implements quaternions (Hamilton's hypercomplex numbers).

R

real() - Method in class org.apache.commons.numbers.complex.Complex
Gets the real part \( a \) of this complex number \( (a + i b) \).
reciprocal() - Method in interface org.apache.commons.numbers.core.Multiplication
Multiplicative inverse.
reciprocal() - Method in class org.apache.commons.numbers.field.FP64
Multiplicative inverse.
reciprocal() - Method in class org.apache.commons.numbers.fraction.BigFraction
Multiplicative inverse.
reciprocal() - Method in class org.apache.commons.numbers.fraction.Fraction
Multiplicative inverse.
reciprocal(T) - Method in class org.apache.commons.numbers.field.AbstractField
reciprocal(T) - Method in interface org.apache.commons.numbers.field.Field
 
Reduce - Class in org.apache.commons.numbers.angle
Reduces |a - offset| to the primary interval [0, |period|).
Reduce(double, double) - Constructor for class org.apache.commons.numbers.angle.Reduce
 
RegularizedBeta - Class in org.apache.commons.numbers.gamma
RegularizedGamma - Class in org.apache.commons.numbers.gamma
RegularizedGamma.P - Class in org.apache.commons.numbers.gamma
RegularizedGamma.Q - Class in org.apache.commons.numbers.gamma
remainderUnsigned(int, int) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Returns the unsigned remainder from dividing the first argument by the second where each argument and the result is interpreted as an unsigned value.
remainderUnsigned(long, long) - Static method in class org.apache.commons.numbers.core.ArithmeticUtils
Returns the unsigned remainder from dividing the first argument by the second where each argument and the result is interpreted as an unsigned value.
representableDelta(double, double) - Static method in class org.apache.commons.numbers.core.Precision
Computes a number close to delta with the property that (x + delta - x) is exactly machine-representable.
round(double, int) - Static method in class org.apache.commons.numbers.core.Precision
Rounds the given value to the specified number of decimal places.
round(double, int, RoundingMode) - Static method in class org.apache.commons.numbers.core.Precision
Rounds the given value to the specified number of decimal places.

S

SAFE_MIN - Static variable in class org.apache.commons.numbers.core.Precision
Safe minimum, such that 1 / SAFE_MIN does not overflow.
signum() - Method in class org.apache.commons.numbers.fraction.BigFraction
Retrieves the sign of this fraction.
signum() - Method in class org.apache.commons.numbers.fraction.Fraction
Retrieves the sign of this fraction.
signum(double) - Method in interface org.apache.commons.numbers.core.Precision.DoubleEquivalence
Returns the sign of the argument.
sin() - Method in class org.apache.commons.numbers.complex.Complex
Returns the sine of this complex number.
sinh() - Method in class org.apache.commons.numbers.complex.Complex
Returns the hyperbolic sine of this complex number.
Slerp - Class in org.apache.commons.numbers.quaternion
Perform spherical linear interpolation (Slerp).
Slerp(Quaternion, Quaternion) - Constructor for class org.apache.commons.numbers.quaternion.Slerp
 
SortInPlace - Enum in org.apache.commons.numbers.arrays
Sort an array and perform the same reordering of entries on other arrays.
sqrt() - Method in class org.apache.commons.numbers.complex.Complex
Returns the square root of this complex number.
subtract(double) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is (this - subtrahend), with subtrahend interpreted as a real number.
subtract(int) - Method in class org.apache.commons.numbers.fraction.BigFraction
Subtracts the specified value from this fraction, returning the result in reduced form.
subtract(int) - Method in class org.apache.commons.numbers.fraction.Fraction
Subtracts the specified value from this fraction, returning the result in reduced form.
subtract(long) - Method in class org.apache.commons.numbers.fraction.BigFraction
Subtracts the specified value from this fraction, returning the result in reduced form.
subtract(BigInteger) - Method in class org.apache.commons.numbers.fraction.BigFraction
Subtracts the specified value from this fraction, returning the result in reduced form.
subtract(Complex) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is (this - subtrahend).
subtract(FP64) - Method in class org.apache.commons.numbers.field.FP64
Binary subtraction.
subtract(BigFraction) - Method in class org.apache.commons.numbers.fraction.BigFraction
Subtracts the specified value from this fraction, returning the result in reduced form.
subtract(Fraction) - Method in class org.apache.commons.numbers.fraction.Fraction
Subtracts the specified value from this fraction, returning the result in reduced form.
subtract(Quaternion) - Method in class org.apache.commons.numbers.quaternion.Quaternion
Subtracts a quaternion from the instance.
subtract(Quaternion, Quaternion) - Static method in class org.apache.commons.numbers.quaternion.Quaternion
Subtracts two quaternions.
subtract(T) - Method in interface org.apache.commons.numbers.core.NativeOperators
Binary subtraction.
subtract(T, T) - Method in class org.apache.commons.numbers.field.AbstractField
subtract(T, T) - Method in interface org.apache.commons.numbers.field.Field
 
subtractFrom(double) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is (minuend - this), with minuend interpreted as a real number.
subtractFromImaginary(double) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is (this - subtrahend), with minuend interpreted as an imaginary number.
subtractImaginary(double) - Method in class org.apache.commons.numbers.complex.Complex
Returns a Complex whose value is (this - subtrahend), with subtrahend interpreted as an imaginary number.
Sum - Class in org.apache.commons.numbers.core
Class providing accurate floating-point sums and linear combinations.

T

tan() - Method in class org.apache.commons.numbers.complex.Complex
Returns the tangent of this complex number.
tanh() - Method in class org.apache.commons.numbers.complex.Complex
Returns the hyperbolic tangent of this complex number.
toDeg() - Method in class org.apache.commons.numbers.angle.Angle.Deg
toDeg() - Method in class org.apache.commons.numbers.angle.Angle.Rad
toDeg() - Method in class org.apache.commons.numbers.angle.Angle
 
toDeg() - Method in class org.apache.commons.numbers.angle.Angle.Turn
toMulti(int) - Method in class org.apache.commons.numbers.arrays.MultidimensionalCounter
Converts to a multidimensional counter.
toRad() - Method in class org.apache.commons.numbers.angle.Angle.Deg
toRad() - Method in class org.apache.commons.numbers.angle.Angle.Rad
toRad() - Method in class org.apache.commons.numbers.angle.Angle
 
toRad() - Method in class org.apache.commons.numbers.angle.Angle.Turn
toString() - Method in class org.apache.commons.numbers.arrays.MultidimensionalCounter
toString() - Method in class org.apache.commons.numbers.complex.Complex
Returns a string representation of the complex number.
toString() - Method in class org.apache.commons.numbers.field.FP64
toString() - Method in class org.apache.commons.numbers.fraction.BigFraction
Returns the String representing this fraction.
toString() - Method in class org.apache.commons.numbers.fraction.Fraction
Returns the String representing this fraction.
toString() - Method in class org.apache.commons.numbers.quaternion.Quaternion
toTurn() - Method in class org.apache.commons.numbers.angle.Angle.Deg
toTurn() - Method in class org.apache.commons.numbers.angle.Angle.Rad
toTurn() - Method in class org.apache.commons.numbers.angle.Angle
 
toTurn() - Method in class org.apache.commons.numbers.angle.Angle.Turn
toUni(int...) - Method in class org.apache.commons.numbers.arrays.MultidimensionalCounter
Converts to a unidimensional counter.
Trigamma - Class in org.apache.commons.numbers.gamma
TWO_PI - Static variable in class org.apache.commons.numbers.angle.Angle.Rad
2π.
TWO_PI - Static variable in class org.apache.commons.numbers.angle.Angle
2π.

V

value(double) - Static method in class org.apache.commons.numbers.gamma.Digamma
Computes the digamma function.
value(double) - Static method in class org.apache.commons.numbers.gamma.Erf
Returns the error function.
value(double) - Static method in class org.apache.commons.numbers.gamma.Erfc
Returns the complementary error function.
value(double) - Static method in class org.apache.commons.numbers.gamma.Erfcx
Returns the scaled complementary error function.
value(double) - Static method in class org.apache.commons.numbers.gamma.Gamma
Computes the value of \( \Gamma(x) \).
value(double) - Static method in class org.apache.commons.numbers.gamma.InverseErf
Returns the inverse error function.
value(double) - Static method in class org.apache.commons.numbers.gamma.InverseErfc
Returns the inverse complementary error function.
value(double) - Static method in class org.apache.commons.numbers.gamma.LanczosApproximation
Computes the Lanczos approximation.
value(double) - Static method in class org.apache.commons.numbers.gamma.LogGamma
Computes the function \( \ln \lvert \Gamma(x) \rvert \), the natural logarithm of the absolute value of \( \Gamma(x) \).
value(double) - Static method in class org.apache.commons.numbers.gamma.Trigamma
Computes the trigamma function.
value(double[], double[]) - Static method in class org.apache.commons.numbers.angle.CosAngle
Computes the cosine of the angle between v1 and v2.
value(double, double) - Static method in class org.apache.commons.numbers.gamma.Beta
Computes the value of the beta function B(a, b).
value(double, double) - Static method in class org.apache.commons.numbers.gamma.ErfDifference
The implementation uses either Erf or Erfc, depending on which provides the most precise result.
value(double, double) - Static method in class org.apache.commons.numbers.gamma.GammaRatio
Computes the ratio of gamma functions of two values.
value(double, double) - Static method in class org.apache.commons.numbers.gamma.IncompleteGamma.Lower
Computes the lower incomplete gamma function \( \gamma(a, x) \).
value(double, double) - Static method in class org.apache.commons.numbers.gamma.IncompleteGamma.Upper
Computes the upper incomplete gamma function \( \Gamma(a, x) \).
value(double, double) - Static method in class org.apache.commons.numbers.gamma.LogBeta
Returns the value of \( \log B(p, q) \) for \( 0 \leq x \leq 1 \) and \( p, q > 0 \).
value(double, double) - Static method in class org.apache.commons.numbers.gamma.RegularizedGamma.P
Computes the lower regularized gamma function \( P(a, x) \).
value(double, double) - Static method in class org.apache.commons.numbers.gamma.RegularizedGamma.Q
Computes the upper regularized gamma function \( Q(a, x) \).
value(double, double, double) - Static method in class org.apache.commons.numbers.gamma.IncompleteBeta
Computes the value of the incomplete beta function B(x, a, b).
value(double, double, double) - Static method in class org.apache.commons.numbers.gamma.RegularizedBeta
Computes the value of the regularized beta function I(x, a, b).
value(double, double, double, double, int) - Static method in class org.apache.commons.numbers.gamma.IncompleteBeta
Computes the value of the incomplete beta function B(x, a, b).
value(double, double, double, double, int) - Static method in class org.apache.commons.numbers.gamma.RegularizedBeta
Computes the value of the regularized beta function I(x, a, b).
value(double, double, double, int) - Static method in class org.apache.commons.numbers.gamma.IncompleteGamma.Lower
Computes the lower incomplete gamma function \( \gamma(a, x) \).
value(double, double, double, int) - Static method in class org.apache.commons.numbers.gamma.IncompleteGamma.Upper
Computes the upper incomplete gamma function \( \Gamma(a, x) \).
value(double, double, double, int) - Static method in class org.apache.commons.numbers.gamma.RegularizedGamma.P
Computes the lower regularized gamma function \( P(a, x) \).
value(double, double, double, int) - Static method in class org.apache.commons.numbers.gamma.RegularizedGamma.Q
Computes the upper regularized gamma function \( Q(a, x) \).
value(double, int[]) - Static method in class org.apache.commons.numbers.gamma.LogGamma
Computes the function \( \ln \lvert \Gamma(x) \rvert \), the natural logarithm of the absolute value of \( \Gamma(x) \).
value(double, Supplier<GeneralizedContinuedFraction.Coefficient>) - Static method in class org.apache.commons.numbers.fraction.GeneralizedContinuedFraction
Evaluates the continued fraction.
value(double, Supplier<GeneralizedContinuedFraction.Coefficient>, double) - Static method in class org.apache.commons.numbers.fraction.GeneralizedContinuedFraction
Evaluates the continued fraction.
value(double, Supplier<GeneralizedContinuedFraction.Coefficient>, double, int) - Static method in class org.apache.commons.numbers.fraction.GeneralizedContinuedFraction
Evaluates the continued fraction.
value(int) - Static method in class org.apache.commons.numbers.combinatorics.Factorial
Computes the factorial of n.
value(int) - Method in class org.apache.commons.numbers.combinatorics.FactorialDouble
Deprecated.
Since 1.1 this functionality has been replaced with Factorial.doubleValue(int).

The result of calling this method is the same as calling the Factorial.doubleValue(int).

value(int) - Method in class org.apache.commons.numbers.combinatorics.LogFactorial
Computes \( log_e(n!) \).
value(int, int) - Static method in class org.apache.commons.numbers.combinatorics.BinomialCoefficient
Computes the binomial coefficient.
value(int, int) - Static method in class org.apache.commons.numbers.combinatorics.BinomialCoefficientDouble
Computes the binomial coefficient.
value(int, int) - Static method in class org.apache.commons.numbers.combinatorics.LogBinomialCoefficient
Computes the logarithm of the binomial coefficient.
value(Supplier<GeneralizedContinuedFraction.Coefficient>) - Static method in class org.apache.commons.numbers.fraction.GeneralizedContinuedFraction
Evaluates the continued fraction.
value(Supplier<GeneralizedContinuedFraction.Coefficient>, double) - Static method in class org.apache.commons.numbers.fraction.GeneralizedContinuedFraction
Evaluates the continued fraction.
value(Supplier<GeneralizedContinuedFraction.Coefficient>, double, int) - Static method in class org.apache.commons.numbers.fraction.GeneralizedContinuedFraction
Evaluates the continued fraction.
valueOf(String) - Static method in enum org.apache.commons.numbers.arrays.SortInPlace
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.numbers.core.Norm
Returns the enum constant of this type with the specified name.
values() - Static method in enum org.apache.commons.numbers.arrays.SortInPlace
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.numbers.core.Norm
Returns an array containing the constants of this enum type, in the order they are declared.

W

withCache(int) - Method in class org.apache.commons.numbers.combinatorics.FactorialDouble
Deprecated.
Since 1.1 this functionality has been replaced with Factorial.doubleValue(int).

This class no longer supports a cache. This method returns a reference to the same object.

withCache(int) - Method in class org.apache.commons.numbers.combinatorics.LogFactorial
Creates an instance with the specified cache size.
WITHIN_0_AND_1 - Static variable in class org.apache.commons.numbers.angle.Angle.Turn
Normalizing operator (result will be within the [0, 1[ interval).
WITHIN_0_AND_2PI - Static variable in class org.apache.commons.numbers.angle.Angle.Rad
Normalizing operator (result will be within the [0, 2π[ interval).
WITHIN_0_AND_360 - Static variable in class org.apache.commons.numbers.angle.Angle.Deg
Normalizing operator (result will be within the [0, 360[ interval).
WITHIN_MINUS_PI_AND_PI - Static variable in class org.apache.commons.numbers.angle.Angle.Rad
Normalizing operator (result will be within the [-π, π[ interval).

Z

zero() - Method in interface org.apache.commons.numbers.core.Addition
Identity element.
zero() - Method in class org.apache.commons.numbers.field.BigFractionField
zero() - Method in interface org.apache.commons.numbers.field.Field
 
zero() - Method in class org.apache.commons.numbers.field.FP64
Identity element.
zero() - Method in class org.apache.commons.numbers.field.FP64Field
zero() - Method in class org.apache.commons.numbers.field.FractionField
zero() - Method in class org.apache.commons.numbers.fraction.BigFraction
 
zero() - Method in class org.apache.commons.numbers.fraction.Fraction
 
ZERO - Static variable in class org.apache.commons.numbers.angle.Angle.Deg
Zero.
ZERO - Static variable in class org.apache.commons.numbers.angle.Angle.Rad
Zero.
ZERO - Static variable in class org.apache.commons.numbers.angle.Angle.Turn
Zero.
ZERO - Static variable in class org.apache.commons.numbers.complex.Complex
A complex number representing zero.
ZERO - Static variable in class org.apache.commons.numbers.fraction.BigFraction
A fraction representing "0".
ZERO - Static variable in class org.apache.commons.numbers.fraction.Fraction
A fraction representing "0".
ZERO - Static variable in class org.apache.commons.numbers.quaternion.Quaternion
Zero quaternion.
A B C D E F G H I J K L M N O P Q R S T V W Z 
All Classes All Packages