Uses of Class
org.hipparchus.exception.NullArgumentException
Package
Description
Common classes used throughout the Hipparchus library.
The
function
package contains function objects that wrap the
methods contained in Math
, as well as common
mathematical functions such as the gaussian and sinc functions.Numerical integration (quadrature) algorithms for univariate real functions.
Univariate real functions interpolation algorithms.
Univariate real polynomials implementations, seen as differentiable
univariate real functions.
Root finding algorithms, for univariate real functions.
Complex number type and implementations of complex transcendental
functions.
Fraction number type and fraction number formatting.
Linear algebra support.
Random number and random data generators.
Convenience routines and common data structures used throughout the Hipparchus library.
-
Uses of NullArgumentException in org.hipparchus
-
Uses of NullArgumentException in org.hipparchus.analysis.function
Modifier and TypeMethodDescriptiondouble[]
Gaussian.Parametric.gradient
(double x, double... param) Computes the value of the gradient atx
.double[]
HarmonicOscillator.Parametric.gradient
(double x, double... param) Computes the value of the gradient atx
.double[]
Logistic.Parametric.gradient
(double x, double... param) Computes the value of the gradient atx
.double[]
Logit.Parametric.gradient
(double x, double... param) Computes the value of the gradient atx
.double[]
Sigmoid.Parametric.gradient
(double x, double... param) Computes the value of the gradient atx
.double
Gaussian.Parametric.value
(double x, double... param) Computes the value of the Gaussian atx
.double
HarmonicOscillator.Parametric.value
(double x, double... param) Computes the value of the harmonic oscillator atx
.double
Logistic.Parametric.value
(double x, double... param) Computes the value of the sigmoid atx
.double
Logit.Parametric.value
(double x, double... param) Computes the value of the logit atx
.double
Sigmoid.Parametric.value
(double x, double... param) Computes the value of the sigmoid atx
.ModifierConstructorDescriptionStepFunction
(double[] x, double[] y) Builds a step function from a list of arguments and the corresponding values. -
Uses of NullArgumentException in org.hipparchus.analysis.integration
Modifier and TypeMethodDescriptionBaseAbstractFieldUnivariateIntegrator.integrate
(int maxEval, CalculusFieldUnivariateFunction<T> f, T lower, T upper) Integrate the function in the given interval.double
BaseAbstractUnivariateIntegrator.integrate
(int maxEval, UnivariateFunction f, double lower, double upper) Integrate the function in the given interval.FieldUnivariateIntegrator.integrate
(int maxEval, CalculusFieldUnivariateFunction<T> f, T min, T max) Integrate the function in the given interval.double
UnivariateIntegrator.integrate
(int maxEval, UnivariateFunction f, double min, double max) Integrate the function in the given interval.protected void
BaseAbstractFieldUnivariateIntegrator.setup
(int maxEval, CalculusFieldUnivariateFunction<T> f, T lower, T upper) Prepare for computation.protected void
BaseAbstractUnivariateIntegrator.setup
(int maxEval, UnivariateFunction f, double lower, double upper) Prepare for computation. -
Uses of NullArgumentException in org.hipparchus.analysis.interpolation
Modifier and TypeMethodDescriptionfinal void
FieldHermiteInterpolator.addSamplePoint
(T x, T[]... value) Add a sample point.T[][]
FieldHermiteInterpolator.derivatives
(T x, int order) Interpolate value and first derivatives at a specified abscissa.double[][]
HermiteInterpolator.derivatives
(double x, int order) Interpolate value and first derivatives at a specified abscissa.MicrosphereProjectionInterpolator.interpolate
(double[][] xval, double[] yval) Computes an interpolating function for the data set.MultivariateInterpolator.interpolate
(double[][] xval, double[] yval) Computes an interpolating function for the data set.PiecewiseBicubicSplineInterpolator.interpolate
(double[] xval, double[] yval, double[][] fval) Compute an interpolating function for the dataset.T[]
Interpolate value at a specified abscissa.ModifierConstructorDescriptionPiecewiseBicubicSplineInterpolatingFunction
(double[] x, double[] y, double[][] f) Simple constructor. -
Uses of NullArgumentException in org.hipparchus.analysis.polynomials
Modifier and TypeMethodDescriptionprotected static <T extends CalculusFieldElement<T>>
T[]FieldPolynomialFunction.differentiate
(T[] coefficients) Returns the coefficients of the derivative of the polynomial with the given coefficients.protected static double[]
PolynomialFunction.differentiate
(double[] coefficients) Returns the coefficients of the derivative of the polynomial with the given coefficients.protected static <T extends CalculusFieldElement<T>>
TFieldPolynomialFunction.evaluate
(T[] coefficients, T argument) Uses Horner's Method to evaluate the polynomial with the given coefficients at the argument.protected static double
PolynomialFunction.evaluate
(double[] coefficients, double argument) Uses Horner's Method to evaluate the polynomial with the given coefficients at the argument.static double
PolynomialFunctionNewtonForm.evaluate
(double[] a, double[] c, double z) Evaluate the Newton polynomial using nested multiplication.<T extends Derivative<T>>
TPolynomialFunction.value
(T t) Compute the value for the function.<T extends CalculusFieldElement<T>>
TPolynomialFunction.value
(T t) Compute the value of the function.protected static void
PolynomialFunctionNewtonForm.verifyInputArray
(double[] a, double[] c) Verifies that the input arrays are valid.ModifierConstructorDescriptionFieldPolynomialFunction
(T[] c) Construct a polynomial with the given coefficients.FieldPolynomialSplineFunction
(T[] knots, FieldPolynomialFunction<T>[] polynomials) Construct a polynomial spline function with the given segment delimiters and interpolating polynomials.PolynomialFunction
(double... c) Construct a polynomial with the given coefficients.PolynomialFunctionNewtonForm
(double[] a, double[] c) Construct a Newton polynomial with the given a[] and c[].PolynomialSplineFunction
(double[] knots, PolynomialFunction[] polynomials) Construct a polynomial spline function with the given segment delimiters and interpolating polynomials. -
Uses of NullArgumentException in org.hipparchus.analysis.solvers
Modifier and TypeMethodDescriptionstatic <T extends CalculusFieldElement<T>>
T[]UnivariateSolverUtils.bracket
(CalculusFieldUnivariateFunction<T> function, T initial, T lowerBound, T upperBound) This method simply callsbracket(function, initial, lowerBound, upperBound, q, r, maximumIterations)
withq
andr
set to 1.0 andmaximumIterations
set toInteger.MAX_VALUE
.static <T extends CalculusFieldElement<T>>
T[]UnivariateSolverUtils.bracket
(CalculusFieldUnivariateFunction<T> function, T initial, T lowerBound, T upperBound, int maximumIterations) This method simply callsbracket(function, initial, lowerBound, upperBound, q, r, maximumIterations)
withq
andr
set to 1.0.static double[]
UnivariateSolverUtils.bracket
(UnivariateFunction function, double initial, double lowerBound, double upperBound) This method simply callsbracket(function, initial, lowerBound, upperBound, q, r, maximumIterations)
withq
andr
set to 1.0 andmaximumIterations
set toInteger.MAX_VALUE
.static double[]
UnivariateSolverUtils.bracket
(UnivariateFunction function, double initial, double lowerBound, double upperBound, int maximumIterations) This method simply callsbracket(function, initial, lowerBound, upperBound, q, r, maximumIterations)
withq
andr
set to 1.0.static boolean
UnivariateSolverUtils.isBracketing
(UnivariateFunction function, double lower, double upper) Check whether the interval bounds bracket a root.protected void
Prepare for computation.FieldBracketingNthOrderBrentSolver.solve
(int maxEval, CalculusFieldUnivariateFunction<T> f, T min, T max, AllowedSolution allowedSolution) Solve for a zero in the given interval.FieldBracketingNthOrderBrentSolver.solve
(int maxEval, CalculusFieldUnivariateFunction<T> f, T min, T max, T startValue, AllowedSolution allowedSolution) Solve for a zero in the given interval, start atstartValue
.static double
UnivariateSolverUtils.solve
(UnivariateFunction function, double x0, double x1) Convenience method to find a zero of a univariate real function.static double
UnivariateSolverUtils.solve
(UnivariateFunction function, double x0, double x1, double absoluteAccuracy) Convenience method to find a zero of a univariate real function.Complex[]
LaguerreSolver.solveAllComplex
(double[] coefficients, double initial) Find all complex roots for the polynomial with the given coefficients, starting from the given initial value.Complex[]
LaguerreSolver.solveAllComplex
(double[] coefficients, int maxEval, double initial) Find all complex roots for the polynomial with the given coefficients, starting from the given initial value.LaguerreSolver.solveComplex
(double[] coefficients, double initial) Find a complex root for the polynomial with the given coefficients, starting from the given initial value.protected void
BaseAbstractUnivariateSolver.verifyBracketing
(double lower, double upper) Check that the endpoints specify an interval and the function takes opposite signs at the endpoints.static void
UnivariateSolverUtils.verifyBracketing
(UnivariateFunction function, double lower, double upper) Check that the endpoints specify an interval and the end points bracket a root. -
Uses of NullArgumentException in org.hipparchus.complex
Modifier and TypeMethodDescriptionReturns aComplex
whose value is(this + addend)
.FieldComplex.add
(FieldComplex<T> addend) Returns aComplex
whose value is(this + addend)
.Returns aComplex
whose value is(this / divisor)
.FieldComplex.divide
(FieldComplex<T> divisor) Returns aComplex
whose value is(this / divisor)
.static ComplexFormat
ComplexFormat.getComplexFormat
(String imaginaryCharacter, Locale locale) Returns the default complex format for the given locale.Returns aComplex
whose value isthis * factor
.FieldComplex.multiply
(FieldComplex<T> factor) Returns aComplex
whose value isthis * factor
.Returns of value of this complex number raised to the power ofx
.FieldComplex.pow
(FieldComplex<T> x) Returns of value of this complex number raised to the power ofx
.Returns aComplex
whose value is(this - subtrahend)
.FieldComplex.subtract
(FieldComplex<T> subtrahend) Returns aComplex
whose value is(this - subtrahend)
.ModifierConstructorDescriptionComplexFormat
(String imaginaryCharacter) Create an instance with a custom imaginary character, and the default number format for both real and imaginary parts.ComplexFormat
(String imaginaryCharacter, NumberFormat format) Create an instance with a custom imaginary character, and a custom number format for both real and imaginary parts.ComplexFormat
(String imaginaryCharacter, NumberFormat realFormat, NumberFormat imaginaryFormat) 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.ComplexFormat
(NumberFormat format) Create an instance with a custom number format for both real and imaginary parts.ComplexFormat
(NumberFormat realFormat, NumberFormat imaginaryFormat) Create an instance with a custom number format for the real part and a custom number format for the imaginary part. -
Uses of NullArgumentException in org.hipparchus.fraction
Modifier and TypeMethodDescriptionBigFraction.add
(BigInteger bg) Adds the value of this fraction to the passedBigInteger
, returning the result in reduced form. -
Uses of NullArgumentException in org.hipparchus.linear
Modifier and TypeMethodDescriptionConstruct a vector by appending a T to this vector.protected static void
IterativeLinearSolver.checkParameters
(RealLinearOperator a, RealVector b, RealVector x0) Performs all dimension checks on the parameters ofsolve
andsolveInPlace
, and throws an exception if one of the checks fails.protected static void
PreconditionedIterativeLinearSolver.checkParameters
(RealLinearOperator a, RealLinearOperator m, RealVector b, RealVector x0) Performs all dimension checks on the parameters ofsolve
andsolveInPlace
, and throws an exception if one of the checks fails.protected void
AbstractFieldMatrix.checkSubMatrixIndex
(int[] selectedRows, int[] selectedColumns) Check if submatrix ranges indices are valid.static void
MatrixUtils.checkSubMatrixIndex
(AnyMatrix m, int[] selectedRows, int[] selectedColumns) Check if submatrix ranges indices are valid.void
AbstractFieldMatrix.copySubMatrix
(int[] selectedRows, int[] selectedColumns, T[][] destination) Copy a submatrix.void
AbstractRealMatrix.copySubMatrix
(int[] selectedRows, int[] selectedColumns, double[][] destination) Copy a submatrix.void
FieldMatrix.copySubMatrix
(int[] selectedRows, int[] selectedColumns, T[][] destination) Copy a submatrix.void
RealMatrix.copySubMatrix
(int[] selectedRows, int[] selectedColumns, double[][] destination) Copy a submatrix.static <T extends FieldElement<T>>
FieldMatrix<T>MatrixUtils.createColumnFieldMatrix
(T[] columnData) Creates a columnFieldMatrix
using the data from the input array.static RealMatrix
MatrixUtils.createColumnRealMatrix
(double[] columnData) Creates a columnRealMatrix
using the data from the input array.static <T extends FieldElement<T>>
FieldMatrix<T>MatrixUtils.createFieldMatrix
(T[][] data) Returns aFieldMatrix
whose entries are the the values in the the input array.static <T extends FieldElement<T>>
FieldVector<T>MatrixUtils.createFieldVector
(T[] data) Creates aFieldVector
using the data from the input array.static RealMatrix
MatrixUtils.createRealMatrix
(double[][] data) Returns aRealMatrix
whose entries are the the values in the the input array.static RealVector
MatrixUtils.createRealVector
(double[] data) Creates aRealVector
using the data from the input array.static <T extends FieldElement<T>>
FieldMatrix<T>MatrixUtils.createRowFieldMatrix
(T[] rowData) Create a rowFieldMatrix
using the data from the input array.static RealMatrix
MatrixUtils.createRowRealMatrix
(double[] rowData) Create a rowRealMatrix
using the data from the input array.protected static <T extends FieldElement<T>>
Field<T>AbstractFieldMatrix.extractField
(T[][] d) Get the elements type from an array.AbstractFieldMatrix.getSubMatrix
(int[] selectedRows, int[] selectedColumns) Get a submatrix.AbstractRealMatrix.getSubMatrix
(int[] selectedRows, int[] selectedColumns) Gets a submatrix.FieldMatrix.getSubMatrix
(int[] selectedRows, int[] selectedColumns) Get a submatrix.RealMatrix.getSubMatrix
(int[] selectedRows, int[] selectedColumns) Gets a submatrix.static RealMatrix
MatrixUtils.inverse
(RealMatrix matrix) Computes the inverse of the given matrix.static RealMatrix
MatrixUtils.inverse
(RealMatrix matrix, double threshold) Computes the inverse of the given matrix.Map an addition operation to each entry.Map an addition operation to each entry.Map an addition operation to each entry.ArrayFieldVector.mapAddToSelf
(T d) Map an addition operation to each entry.FieldVector.mapAddToSelf
(T d) Map an addition operation to each entry.SparseFieldVector.mapAddToSelf
(T d) Map an addition operation to each entry.Map a division operation to each entry.Map a division operation to each entry.Map a division operation to each entry.ArrayFieldVector.mapDivideToSelf
(T d) Map a division operation to each entry.FieldVector.mapDivideToSelf
(T d) Map a division operation to each entry.SparseFieldVector.mapDivideToSelf
(T d) Map a division operation to each entry.ArrayFieldVector.mapMultiply
(T d) Map a multiplication operation to each entry.FieldVector.mapMultiply
(T d) Map a multiplication operation to each entry.SparseFieldVector.mapMultiply
(T d) Map a multiplication operation to each entry.ArrayFieldVector.mapMultiplyToSelf
(T d) Map a multiplication operation to each entry.FieldVector.mapMultiplyToSelf
(T d) Map a multiplication operation to each entry.SparseFieldVector.mapMultiplyToSelf
(T d) Map a multiplication operation to each entry.ArrayFieldVector.mapSubtract
(T d) Map a subtraction operation to each entry.FieldVector.mapSubtract
(T d) Map a subtraction operation to each entry.SparseFieldVector.mapSubtract
(T d) Map a subtraction operation to each entry.ArrayFieldVector.mapSubtractToSelf
(T d) Map a subtraction operation to each entry.FieldVector.mapSubtractToSelf
(T d) Map a subtraction operation to each entry.SparseFieldVector.mapSubtractToSelf
(T d) Map a subtraction operation to each entry.void
Set a single element.void
AbstractFieldMatrix.setSubMatrix
(T[][] subMatrix, int row, int column) Replace the submatrix starting at(row, column)
using data in the inputsubMatrix
array.void
AbstractRealMatrix.setSubMatrix
(double[][] subMatrix, int row, int column) Replace the submatrix starting atrow, column
using data in the inputsubMatrix
array.void
Array2DRowFieldMatrix.setSubMatrix
(T[][] subMatrix, int row, int column) Replace the submatrix starting at(row, column)
using data in the inputsubMatrix
array.void
Array2DRowRealMatrix.setSubMatrix
(double[][] subMatrix, int row, int column) Replace the submatrix starting atrow, column
using data in the inputsubMatrix
array.void
BlockFieldMatrix.setSubMatrix
(T[][] subMatrix, int row, int column) Replace the submatrix starting at(row, column)
using data in the inputsubMatrix
array.void
BlockRealMatrix.setSubMatrix
(double[][] subMatrix, int row, int column) Replace the submatrix starting atrow, column
using data in the inputsubMatrix
array.void
FieldMatrix.setSubMatrix
(T[][] subMatrix, int row, int column) Replace the submatrix starting at(row, column)
using data in the inputsubMatrix
array.void
RealMatrix.setSubMatrix
(double[][] subMatrix, int row, int column) Replace the submatrix starting atrow, column
using data in the inputsubMatrix
array.IterativeLinearSolver.solve
(RealLinearOperator a, RealVector b) Returns an estimate of the solution to the linear system A · x = b.IterativeLinearSolver.solve
(RealLinearOperator a, RealVector b, RealVector x0) Returns an estimate of the solution to the linear system A · x = b.PreconditionedIterativeLinearSolver.solve
(RealLinearOperator a, RealLinearOperator m, RealVector b) Returns an estimate of the solution to the linear system A · x = b.PreconditionedIterativeLinearSolver.solve
(RealLinearOperator a, RealLinearOperator m, RealVector b, RealVector x0) Returns an estimate of the solution to the linear system A · x = b.PreconditionedIterativeLinearSolver.solve
(RealLinearOperator a, RealVector b) Returns an estimate of the solution to the linear system A · x = b.PreconditionedIterativeLinearSolver.solve
(RealLinearOperator a, RealVector b, RealVector x0) Returns an estimate of the solution to the linear system A · x = b.SymmLQ.solve
(RealLinearOperator a, RealLinearOperator m, RealVector b) Returns an estimate of the solution to the linear system A · x = b.SymmLQ.solve
(RealLinearOperator a, RealLinearOperator m, RealVector b, boolean goodb, double shift) Returns an estimate of the solution to the linear system (A - shift · I) · x = b.SymmLQ.solve
(RealLinearOperator a, RealLinearOperator m, RealVector b, RealVector x) Returns an estimate of the solution to the linear system A · x = b.SymmLQ.solve
(RealLinearOperator a, RealVector b) Returns an estimate of the solution to the linear system A · x = b.SymmLQ.solve
(RealLinearOperator a, RealVector b, boolean goodb, double shift) Returns the solution to the system (A - shift · I) · x = b.SymmLQ.solve
(RealLinearOperator a, RealVector b, RealVector x) Returns an estimate of the solution to the linear system A · x = b.ConjugateGradient.solveInPlace
(RealLinearOperator a, RealLinearOperator m, RealVector b, RealVector x0) Returns an estimate of the solution to the linear system A · x = b.abstract RealVector
IterativeLinearSolver.solveInPlace
(RealLinearOperator a, RealVector b, RealVector x0) Returns an estimate of the solution to the linear system A · x = b.abstract RealVector
PreconditionedIterativeLinearSolver.solveInPlace
(RealLinearOperator a, RealLinearOperator m, RealVector b, RealVector x0) Returns an estimate of the solution to the linear system A · x = b.PreconditionedIterativeLinearSolver.solveInPlace
(RealLinearOperator a, RealVector b, RealVector x0) Returns an estimate of the solution to the linear system A · x = b.SymmLQ.solveInPlace
(RealLinearOperator a, RealLinearOperator m, RealVector b, RealVector x) Returns an estimate of the solution to the linear system A · x = b.SymmLQ.solveInPlace
(RealLinearOperator a, RealLinearOperator m, RealVector b, RealVector x, boolean goodb, double shift) Returns an estimate of the solution to the linear system (A - shift · I) · x = b.SymmLQ.solveInPlace
(RealLinearOperator a, RealVector b, RealVector x) Returns an estimate of the solution to the linear system A · x = b.ModifierConstructorDescriptionArray2DRowFieldMatrix
(Field<T> field, T[][] d) Create a newFieldMatrix<T>
using the input array as the underlying data array.Array2DRowFieldMatrix
(Field<T> field, T[][] d, boolean copyArray) Create a newFieldMatrix<T>
using the input array as the underlying data array.Array2DRowFieldMatrix
(T[][] d) Create a newFieldMatrix<T>
using the input array as the underlying data array.Array2DRowFieldMatrix
(T[][] d, boolean copyArray) Create a newFieldMatrix<T>
using the input array as the underlying data array.Array2DRowRealMatrix
(double[][] d) Create a newRealMatrix
using the input array as the underlying data array.Array2DRowRealMatrix
(double[][] d, boolean copyArray) Create a new RealMatrix using the input array as the underlying data array.ArrayFieldVector
(Field<T> field, T[] d) Construct a vector from an array, copying the input array.ArrayFieldVector
(Field<T> field, T[] d, boolean copyArray) Create a new ArrayFieldVector using the input array as the underlying data array.ArrayFieldVector
(Field<T> field, T[] d, int pos, int size) Construct a vector from part of a array.ArrayFieldVector
(Field<T> field, T[] v1, T[] v2) Construct a vector by appending one vector to another vector.Construct a vector from another vector, using a deep copy.ArrayFieldVector
(ArrayFieldVector<T> v, boolean deep) Construct a vector from another vector.Construct a vector from another vector, using a deep copy.ArrayFieldVector
(FieldVector<T> v1, FieldVector<T> v2) Construct a vector by appending one vector to another vector.ArrayFieldVector
(FieldVector<T> v1, T[] v2) Construct a vector by appending one vector to another vector.ArrayFieldVector
(T[] d) Construct a vector from an array, copying the input array.ArrayFieldVector
(T[] d, boolean copyArray) Create a new ArrayFieldVector using the input array as the underlying data array.ArrayFieldVector
(T[] d, int pos, int size) Construct a vector from part of a array.ArrayFieldVector
(T[] v1, FieldVector<T> v2) Construct a vector by appending one vector to another vector.ArrayFieldVector
(T[] v1, T[] v2) Construct a vector by appending one vector to another vector.ArrayRealVector
(double[] d, boolean copyArray) Create a new ArrayRealVector using the input array as the underlying data array.ArrayRealVector
(double[] d, int pos, int size) Construct a vector from part of a array.ArrayRealVector
(Double[] d, int pos, int size) Construct a vector from part of an array.Construct a vector from another vector, using a deep copy.Construct a vector from another vector, using a deep copy.ConjugateGradient
(IterationManager manager, double delta, boolean check) Creates a new instance of this class, with default stopping criterion and custom iteration manager.DiagonalMatrix
(double[] d, boolean copyArray) Creates a matrix using the input array as the underlying data.IterativeLinearSolver
(IterationManager manager) Creates a new instance of this class, with custom iteration manager.Creates a new instance of this class, with custom iteration manager.SparseFieldVector
(Field<T> field, T[] values) Create from a Field array. -
Uses of NullArgumentException in org.hipparchus.random
ModifierConstructorDescriptionHaltonSequenceGenerator
(int dimension, int[] bases, int[] weights) Construct a new Halton sequence generator with the given base numbers and weights for each dimension.StableRandomGenerator
(RandomGenerator generator, double alpha, double beta) Create a new generator. -
Uses of NullArgumentException in org.hipparchus.util
Modifier and TypeMethodDescriptionstatic void
MathUtils.checkNotNull
(Object o) Checks that an object is not null.static void
MathUtils.checkNotNull
(Object o, Localizable pattern, Object... args) Checks that an object is not null.static void
MathArrays.checkRectangular
(long[][] in) Throws MathIllegalArgumentException if the input array is not rectangular.static double[]
MathArrays.convolve
(double[] x, double[] h) Calculates the convolution between two sequences.static void
MathArrays.sortInPlace
(double[] x, double[]... yList) Sort an array in ascending order in place and perform the same reordering of entries on other arrays.static void
MathArrays.sortInPlace
(double[] x, MathArrays.OrderDirection dir, double[]... yList) Sort an array in place and perform the same reordering of entries on other arrays.ModifierConstructorDescriptionIncrementor
(int max, Incrementor.MaxCountExceededCallback cb) Creates an Incrementor.KthSelector
(PivotingStrategy pivotingStrategy) Constructor with specified pivoting strategyResizableDoubleArray
(ResizableDoubleArray original) Copy constructor.