Uses of Class
org.apache.commons.math4.legacy.exception.MathIllegalArgumentException
-
Packages that use MathIllegalArgumentException Package Description org.apache.commons.math4.legacy.analysis.differentiation This package holds the main interfaces and basic building block classes dealing with differentiation.org.apache.commons.math4.legacy.analysis.interpolation Univariate real functions interpolation algorithms.org.apache.commons.math4.legacy.analysis.solvers Root finding algorithms, for univariate real functions.org.apache.commons.math4.legacy.exception Specialized exceptions for algorithms errors.org.apache.commons.math4.legacy.genetics This package provides Genetic Algorithms components and implementations.org.apache.commons.math4.legacy.linear Linear algebra support.org.apache.commons.math4.legacy.ode This package provides classes to solve Ordinary Differential Equations problems.org.apache.commons.math4.legacy.special Implementations of special functions such as Beta and Gamma.org.apache.commons.math4.legacy.stat Data storage, manipulation and summary routines.org.apache.commons.math4.legacy.stat.correlation Correlations/Covariance computations.org.apache.commons.math4.legacy.stat.descriptive Generic univariate summary statistic objects.org.apache.commons.math4.legacy.stat.descriptive.moment Summary statistics based on moments.org.apache.commons.math4.legacy.stat.descriptive.rank Summary statistics based on ranks.org.apache.commons.math4.legacy.stat.descriptive.summary Other summary statistics.org.apache.commons.math4.legacy.stat.inference Classes providing hypothesis testing.org.apache.commons.math4.legacy.stat.regression Statistical routines involving multivariate data.org.apache.commons.math4.legacy.util Convenience routines and common data structures used throughout the commons-math library. -
-
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.analysis.differentiation
Methods in org.apache.commons.math4.legacy.analysis.differentiation that throw MathIllegalArgumentException Modifier and Type Method Description DerivativeStructure[]MultivariateDifferentiableVectorFunction. value(DerivativeStructure[] point)Compute the value for the function at the given point.DerivativeStructure[][]UnivariateDifferentiableMatrixFunction. value(DerivativeStructure x)Compute the value for the function.DerivativeStructure[]UnivariateDifferentiableVectorFunction. value(DerivativeStructure x)Compute the value for the function. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.analysis.interpolation
Methods in org.apache.commons.math4.legacy.analysis.interpolation that throw MathIllegalArgumentException Modifier and Type Method Description MultivariateFunctionMultivariateInterpolator. interpolate(double[][] xval, double[] yval)Computes an interpolating function for the data set. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.analysis.solvers
Methods in org.apache.commons.math4.legacy.analysis.solvers that throw MathIllegalArgumentException Modifier and Type Method Description doubleBaseUnivariateSolver. solve(int maxEval, FUNC f, double min, double max)Solve for a zero root in the given interval.doubleBaseUnivariateSolver. solve(int maxEval, FUNC f, double min, double max, double startValue)Solve for a zero in the given interval, start atstartValue. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.exception
Subclasses of MathIllegalArgumentException in org.apache.commons.math4.legacy.exception Modifier and Type Class Description classDimensionMismatchExceptionException to be thrown when two dimensions differ.classInsufficientDataExceptionException to be thrown when there is insufficient data to perform a computation.classMathIllegalNumberExceptionBase class for exceptions raised by a wrong number.classMultiDimensionMismatchExceptionException to be thrown when two sets of dimensions differ.classNoBracketingExceptionException to be thrown when function values have the same sign at both ends of an interval.classNoDataExceptionException to be thrown when the required data is missing.classNonMonotonicSequenceExceptionException to be thrown when the a sequence of values is not monotonically increasing or decreasing.classNotANumberExceptionException to be thrown when a number is not a number.classNotFiniteNumberExceptionException to be thrown when a number is not finite.classNotPositiveExceptionException to be thrown when the argument is negative.classNotStrictlyPositiveExceptionException to be thrown when the argument is not greater than 0.classNumberIsTooLargeExceptionException to be thrown when a number is too large.classNumberIsTooSmallExceptionException to be thrown when a number is too small.classOutOfRangeExceptionException to be thrown when some argument is out of range.classZeroExceptionException to be thrown when zero is provided where it is not allowed. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.genetics
Subclasses of MathIllegalArgumentException in org.apache.commons.math4.legacy.genetics Modifier and Type Class Description classInvalidRepresentationExceptionException indicating that the representation of a chromosome is not valid.Methods in org.apache.commons.math4.legacy.genetics that throw MathIllegalArgumentException Modifier and Type Method Description ChromosomePairCrossoverPolicy. crossover(Chromosome first, Chromosome second)Perform a crossover operation on the given chromosomes.ChromosomePairCycleCrossover. crossover(Chromosome first, Chromosome second)Perform a crossover operation on the given chromosomes.ChromosomePairNPointCrossover. crossover(Chromosome first, Chromosome second)Performs a N-point crossover.ChromosomePairOnePointCrossover. crossover(Chromosome first, Chromosome second)Performs one point crossover.ChromosomePairOrderedCrossover. crossover(Chromosome first, Chromosome second)Perform a crossover operation on the given chromosomes.ChromosomePairUniformCrossover. crossover(Chromosome first, Chromosome second)Perform a crossover operation on the given chromosomes.static <S> List<Double>RandomKey. inducedPermutation(List<S> originalData, List<S> permutedData)Generates a representation of a permutation corresponding to a permutation which yieldspermutedDatawhen applied tooriginalData.ChromosomeBinaryMutation. mutate(Chromosome original)Mutate the given chromosome.ChromosomeMutationPolicy. mutate(Chromosome original)Mutate the given chromosome.ChromosomeRandomKeyMutation. mutate(Chromosome original)Mutate the given chromosome.ChromosomePairSelectionPolicy. select(Population population)Select two chromosomes from the population.ChromosomePairTournamentSelection. select(Population population)Select two chromosomes from the population. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.linear
Subclasses of MathIllegalArgumentException in org.apache.commons.math4.legacy.linear Modifier and Type Class Description classIllConditionedOperatorExceptionAn exception to be thrown when the condition number of aRealLinearOperatoris too high.classMatrixDimensionMismatchExceptionException to be thrown when either the number of rows or the number of columns of a matrix do not match the expected values.classNonPositiveDefiniteMatrixExceptionException to be thrown when a positive definite matrix is expected.classNonPositiveDefiniteOperatorExceptionException to be thrown when a symmetric, definite positiveRealLinearOperatoris expected.classNonSelfAdjointOperatorExceptionException to be thrown when a self-adjointRealLinearOperatoris expected.classNonSquareMatrixExceptionException to be thrown when a square matrix is expected.classNonSquareOperatorExceptionException to be thrown when a square linear operator is expected.classNonSymmetricMatrixExceptionException to be thrown when a symmetric matrix is expected.classSingularMatrixExceptionException to be thrown when a non-singular matrix is expected.classSingularOperatorExceptionException to be thrown when trying to invert a singular operator. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.ode
Subclasses of MathIllegalArgumentException in org.apache.commons.math4.legacy.ode Modifier and Type Class Description static classJacobianMatrices.MismatchedEquationsSpecial exception for equations mismatch.classUnknownParameterExceptionException to be thrown when a parameter is unknown.Methods in org.apache.commons.math4.legacy.ode that throw MathIllegalArgumentException Modifier and Type Method Description voidContinuousOutputFieldModel. append(ContinuousOutputFieldModel<T> model)Append another model at the end of the instance.voidContinuousOutputModel. append(ContinuousOutputModel model)Append another model at the end of the instance.T[]FieldEquationsMapper. extractEquationData(int index, T[] complete)Extract equation data from a complete state or derivative array.voidSecondOrderIntegrator. integrate(SecondOrderDifferentialEquations equations, double t0, double[] y0, double[] yDot0, double t, double[] y, double[] yDot)Integrate the differential equations up to the given time. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.special
Methods in org.apache.commons.math4.legacy.special that throw MathIllegalArgumentException Modifier and Type Method Description doubleBesselJ. value(double x)Returns the value of the constructed Bessel function of the first kind, for the passed argument.static doubleBesselJ. value(double order, double x)Returns the first Bessel function, \(J_{order}(x)\). -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.stat
Methods in org.apache.commons.math4.legacy.stat that throw MathIllegalArgumentException Modifier and Type Method Description static doubleStatUtils. geometricMean(double[] values)Returns the geometric mean of the entries in the input array, orDouble.NaNif the array is empty.static doubleStatUtils. geometricMean(double[] values, int begin, int length)Returns the geometric mean of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.static doubleStatUtils. max(double[] values)Returns the maximum of the entries in the input array, orDouble.NaNif the array is empty.static doubleStatUtils. max(double[] values, int begin, int length)Returns the maximum of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.static doubleStatUtils. mean(double[] values)Returns the arithmetic mean of the entries in the input array, orDouble.NaNif the array is empty.static doubleStatUtils. mean(double[] values, int begin, int length)Returns the arithmetic mean of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.static doubleStatUtils. min(double[] values)Returns the minimum of the entries in the input array, orDouble.NaNif the array is empty.static doubleStatUtils. min(double[] values, int begin, int length)Returns the minimum of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.static double[]StatUtils. mode(double[] sample)Returns the sample mode(s).static doubleStatUtils. percentile(double[] values, double p)Returns an estimate of thepth percentile of the values in thevaluesarray.static doubleStatUtils. percentile(double[] values, int begin, int length, double p)Returns an estimate of thepth percentile of the values in thevaluesarray, starting with the element in (0-based) positionbeginin the array and includinglengthvalues.static doubleStatUtils. populationVariance(double[] values)Returns the population variance of the entries in the input array, orDouble.NaNif the array is empty.static doubleStatUtils. populationVariance(double[] values, double mean)Returns the population variance of the entries in the input array, using the precomputed mean value.static doubleStatUtils. populationVariance(double[] values, double mean, int begin, int length)Returns the population variance of the entries in the specified portion of the input array, using the precomputed mean value.static doubleStatUtils. populationVariance(double[] values, int begin, int length)Returns the population variance of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.static doubleStatUtils. product(double[] values)Returns the product of the entries in the input array, orDouble.NaNif the array is empty.static doubleStatUtils. product(double[] values, int begin, int length)Returns the product of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.static doubleStatUtils. sum(double[] values)Returns the sum of the values in the input array, orDouble.NaNif the array is empty.static doubleStatUtils. sum(double[] values, int begin, int length)Returns the sum of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.static doubleStatUtils. sumLog(double[] values)Returns the sum of the natural logs of the entries in the input array, orDouble.NaNif the array is empty.static doubleStatUtils. sumLog(double[] values, int begin, int length)Returns the sum of the natural logs of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.static doubleStatUtils. sumSq(double[] values)Returns the sum of the squares of the entries in the input array, orDouble.NaNif the array is empty.static doubleStatUtils. sumSq(double[] values, int begin, int length)Returns the sum of the squares of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.static doubleStatUtils. variance(double[] values)Returns the variance of the entries in the input array, orDouble.NaNif the array is empty.static doubleStatUtils. variance(double[] values, double mean)Returns the variance of the entries in the input array, using the precomputed mean value.static doubleStatUtils. variance(double[] values, double mean, int begin, int length)Returns the variance of the entries in the specified portion of the input array, using the precomputed mean value.static doubleStatUtils. variance(double[] values, int begin, int length)Returns the variance of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.stat.correlation
Methods in org.apache.commons.math4.legacy.stat.correlation that throw MathIllegalArgumentException Modifier and Type Method Description protected RealMatrixCovariance. computeCovarianceMatrix(double[][] data)Create a covariance matrix from a rectangular array whose columns represent covariates.protected RealMatrixCovariance. computeCovarianceMatrix(double[][] data, boolean biasCorrected)Compute a covariance matrix from a rectangular array whose columns represent covariates.protected RealMatrixCovariance. computeCovarianceMatrix(RealMatrix matrix)Create a covariance matrix from a matrix whose columns represent covariates.protected RealMatrixCovariance. computeCovarianceMatrix(RealMatrix matrix, boolean biasCorrected)Compute a covariance matrix from a matrix whose columns represent covariates.doubleCovariance. covariance(double[] xArray, double[] yArray)Computes the covariance between the two arrays, using the bias-corrected formula.doubleCovariance. covariance(double[] xArray, double[] yArray, boolean biasCorrected)Computes the covariance between the two arrays.Constructors in org.apache.commons.math4.legacy.stat.correlation that throw MathIllegalArgumentException Constructor Description Covariance(double[][] data)Create a Covariance matrix from a rectangular array whose columns represent covariates.Covariance(double[][] data, boolean biasCorrected)Create a Covariance matrix from a rectangular array whose columns represent covariates.Covariance(RealMatrix matrix)Create a covariance matrix from a matrix whose columns represent covariates.Covariance(RealMatrix matrix, boolean biasCorrected)Create a covariance matrix from a matrix whose columns represent covariates.SpearmansCorrelation(RealMatrix dataMatrix, RankingAlgorithm rankingAlgorithm)Create a SpearmansCorrelation with the given input data matrix and ranking algorithm.SpearmansCorrelation(RankingAlgorithm rankingAlgorithm)Create a SpearmansCorrelation with the given ranking algorithm. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.stat.descriptive
Methods in org.apache.commons.math4.legacy.stat.descriptive that throw MathIllegalArgumentException Modifier and Type Method Description doubleAbstractStorelessUnivariateStatistic. evaluate(double[] values)This default implementation creates a copy of thisStorelessUnivariateStatisticinstance, callsAbstractStorelessUnivariateStatistic.clear()on it, then callsAbstractStorelessUnivariateStatistic.incrementAll(double[])with the specified portion of the input array, and then usesAbstractStorelessUnivariateStatistic.getResult()to compute the return value.doubleAbstractStorelessUnivariateStatistic. evaluate(double[] values, int begin, int length)This default implementation creates a copy of thisStorelessUnivariateStatisticinstance, callsAbstractStorelessUnivariateStatistic.clear()on it, then callsAbstractStorelessUnivariateStatistic.incrementAll(double[])with the specified portion of the input array, and then usesAbstractStorelessUnivariateStatistic.getResult()to compute the return value.doubleAbstractUnivariateStatistic. evaluate()Returns the result of evaluating the statistic over the stored data.doubleAbstractUnivariateStatistic. evaluate(double[] values)Returns the result of evaluating the statistic over the input array.abstract doubleAbstractUnivariateStatistic. evaluate(double[] values, int begin, int length)Returns the result of evaluating the statistic over the specified entries in the input array.doubleUnivariateStatistic. evaluate(double[] values)Returns the result of evaluating the statistic over the input array.doubleUnivariateStatistic. evaluate(double[] values, int begin, int length)Returns the result of evaluating the statistic over the specified entries in the input array.doubleWeightedEvaluation. evaluate(double[] values, double[] weights)Returns the result of evaluating the statistic over the input array, using the supplied weights.doubleWeightedEvaluation. evaluate(double[] values, double[] weights, int begin, int length)Returns the result of evaluating the statistic over the specified entries in the input array, using corresponding entries in the supplied weights array.doubleDescriptiveStatistics. getPercentile(double p)Returns an estimate for the pth percentile of the stored values.voidAbstractStorelessUnivariateStatistic. incrementAll(double[] values)This default implementation just callsAbstractStorelessUnivariateStatistic.increment(double)in a loop over the input array.voidAbstractStorelessUnivariateStatistic. incrementAll(double[] values, int begin, int length)This default implementation just callsAbstractStorelessUnivariateStatistic.increment(double)in a loop over the specified portion of the input array.voidStorelessUnivariateStatistic. incrementAll(double[] values)Updates the internal state of the statistic to reflect addition of all values in the values array.voidStorelessUnivariateStatistic. incrementAll(double[] values, int start, int length)Updates the internal state of the statistic to reflect addition of the values in the designated portion of the values array.voidAbstractUnivariateStatistic. setData(double[] values, int begin, int length)Set the data array.voidDescriptiveStatistics. setPercentileImpl(UnivariateStatistic percentileImpl)Sets the implementation to be used byDescriptiveStatistics.getPercentile(double).voidDescriptiveStatistics. setWindowSize(int windowSize)WindowSize controls the number of values that contribute to the reported statistics.voidSynchronizedDescriptiveStatistics. setWindowSize(int windowSize)WindowSize controls the number of values that contribute to the reported statistics.Constructors in org.apache.commons.math4.legacy.stat.descriptive that throw MathIllegalArgumentException Constructor Description DescriptiveStatistics(int window)Construct aDescriptiveStatisticsinstance with the specified window.SynchronizedDescriptiveStatistics(int window)Construct an instance with finite window. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.stat.descriptive.moment
Methods in org.apache.commons.math4.legacy.stat.descriptive.moment that throw MathIllegalArgumentException Modifier and Type Method Description doubleGeometricMean. evaluate(double[] values, int begin, int length)Returns the geometric mean of the entries in the specified portion of the input array.doubleKurtosis. evaluate(double[] values, int begin, int length)Returns the kurtosis of the entries in the specified portion of the input array.doubleMean. evaluate(double[] values, double[] weights)Returns the weighted arithmetic mean of the entries in the input array.doubleMean. evaluate(double[] values, double[] weights, int begin, int length)Returns the weighted arithmetic mean of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.doubleMean. evaluate(double[] values, int begin, int length)Returns the arithmetic mean of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.doubleSemiVariance. evaluate(double[] values, double cutoff)Returns theSemiVarianceof the designated values against the cutoff, using instance properties variancDirection and biasCorrection.doubleSemiVariance. evaluate(double[] values, double cutoff, SemiVariance.Direction direction)Returns theSemiVarianceof the designated values against the cutoff in the given direction, using the current value of the biasCorrection instance property.doubleSemiVariance. evaluate(double[] values, double cutoff, SemiVariance.Direction direction, boolean corrected, int start, int length)Returns theSemiVarianceof the designated values against the cutoff in the given direction with the provided bias correction.doubleSemiVariance. evaluate(double[] values, int start, int length)Returns theSemiVarianceof the designated values against the mean, using instance properties varianceDirection and biasCorrection.doubleSemiVariance. evaluate(double[] values, SemiVariance.Direction direction)This method calculatesSemiVariancefor the entire array against the mean, using the current value of the biasCorrection instance property.doubleSkewness. evaluate(double[] values, int begin, int length)Returns the Skewness of the entries in the specified portion of the input array.doubleStandardDeviation. evaluate(double[] values)Returns the Standard Deviation of the entries in the input array, orDouble.NaNif the array is empty.doubleStandardDeviation. evaluate(double[] values, double mean)Returns the Standard Deviation of the entries in the input array, using the precomputed mean value.doubleStandardDeviation. evaluate(double[] values, double mean, int begin, int length)Returns the Standard Deviation of the entries in the specified portion of the input array, using the precomputed mean value.doubleStandardDeviation. evaluate(double[] values, int begin, int length)Returns the Standard Deviation of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.doubleVariance. evaluate(double[] values)Returns the variance of the entries in the input array, orDouble.NaNif the array is empty.doubleVariance. evaluate(double[] values, double mean)Returns the variance of the entries in the input array, using the precomputed mean value.doubleVariance. evaluate(double[] values, double[] weights)Returns the weighted variance of the entries in the input array.doubleVariance. evaluate(double[] values, double[] weights, double mean)Returns the weighted variance of the values in the input array, using the precomputed weighted mean value.doubleVariance. evaluate(double[] values, double[] weights, double mean, int begin, int length)Returns the weighted variance of the entries in the specified portion of the input array, using the precomputed weighted mean value.doubleVariance. evaluate(double[] values, double[] weights, int begin, int length)Returns the weighted variance of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.doubleVariance. evaluate(double[] values, double mean, int begin, int length)Returns the variance of the entries in the specified portion of the input array, using the precomputed mean value.doubleVariance. evaluate(double[] values, int begin, int length)Returns the variance of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.stat.descriptive.rank
Methods in org.apache.commons.math4.legacy.stat.descriptive.rank that throw MathIllegalArgumentException Modifier and Type Method Description doubleMax. evaluate(double[] values, int begin, int length)Returns the maximum of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.doubleMin. evaluate(double[] values, int begin, int length)Returns the minimum of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.stat.descriptive.summary
Methods in org.apache.commons.math4.legacy.stat.descriptive.summary that throw MathIllegalArgumentException Modifier and Type Method Description doubleProduct. evaluate(double[] values, double[] weights)Returns the weighted product of the entries in the input array.doubleProduct. evaluate(double[] values, double[] weights, int begin, int length)Returns the weighted product of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.doubleProduct. evaluate(double[] values, int begin, int length)Returns the product of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.doubleSum. evaluate(double[] values, double[] weights)The weighted sum of the entries in the input array.doubleSum. evaluate(double[] values, double[] weights, int begin, int length)The weighted sum of the entries in the specified portion of the input array, or 0 if the designated subarray is empty.doubleSum. evaluate(double[] values, int begin, int length)The sum of the entries in the specified portion of the input array, or 0 if the designated subarray is empty.doubleSumOfLogs. evaluate(double[] values, int begin, int length)Returns the sum of the natural logs of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty.doubleSumOfSquares. evaluate(double[] values, int begin, int length)Returns the sum of the squares of the entries in the specified portion of the input array, orDouble.NaNif the designated subarray is empty. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.stat.inference
Methods in org.apache.commons.math4.legacy.stat.inference that throw MathIllegalArgumentException Modifier and Type Method Description protected doubleTTest. tTest(double m, double mu, double v, double n)Computes p-value for 2-sided, 1-sample t-test. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.stat.regression
Subclasses of MathIllegalArgumentException in org.apache.commons.math4.legacy.stat.regression Modifier and Type Class Description classModelSpecificationExceptionException thrown when a regression model is not correctly specified.Methods in org.apache.commons.math4.legacy.stat.regression that throw MathIllegalArgumentException Modifier and Type Method Description voidOLSMultipleLinearRegression. newSampleData(double[] y, double[][] x)Loads model x and y sample data, overriding any previous sample.RegressionResultsSimpleRegression. regress(int[] variablesToInclude)Performs a regression on data present in buffers including only regressors.RegressionResultsUpdatingMultipleLinearRegression. regress(int[] variablesToInclude)Performs a regression on data present in buffers including only regressors.protected voidAbstractMultipleLinearRegression. validateSampleData(double[][] x, double[] y)Validates sample data. -
Uses of MathIllegalArgumentException in org.apache.commons.math4.legacy.util
Methods in org.apache.commons.math4.legacy.util that throw MathIllegalArgumentException Modifier and Type Method Description StringBufferComplexFormat. format(Object obj, StringBuffer toAppendTo, FieldPosition pos)Formats a object to produce a string.
-