Class Hierarchy
- java.lang.Object
- org.apache.commons.math3.analysis.function.Abs (implements org.apache.commons.math3.analysis.UnivariateFunction)
- org.apache.commons.math3.optimization.AbstractConvergenceChecker<PAIR> (implements org.apache.commons.math3.optimization.ConvergenceChecker<PAIR>)
- org.apache.commons.math3.linear.AbstractFieldMatrix<T> (implements org.apache.commons.math3.linear.FieldMatrix<T>)
- org.apache.commons.math3.distribution.AbstractIntegerDistribution (implements org.apache.commons.math3.distribution.IntegerDistribution, java.io.Serializable)
- org.apache.commons.math3.ode.AbstractIntegrator (implements org.apache.commons.math3.ode.FirstOrderIntegrator)
- org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer (implements org.apache.commons.math3.optimization.linear.LinearOptimizer)
- org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression (implements org.apache.commons.math3.stat.regression.MultipleLinearRegression)
- org.apache.commons.math3.ode.AbstractParameterizable (implements org.apache.commons.math3.ode.Parameterizable)
- org.apache.commons.math3.random.AbstractRandomGenerator (implements org.apache.commons.math3.random.RandomGenerator)
- org.apache.commons.math3.distribution.AbstractRealDistribution (implements org.apache.commons.math3.distribution.RealDistribution, java.io.Serializable)
- org.apache.commons.math3.geometry.partitioning.AbstractRegion<S,T> (implements org.apache.commons.math3.geometry.partitioning.Region<S>)
- org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
- org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
- org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
- org.apache.commons.math3.optimization.direct.AbstractSimplex
- org.apache.commons.math3.ode.sampling.AbstractStepInterpolator (implements org.apache.commons.math3.ode.sampling.StepInterpolator)
- org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane<S,T> (implements org.apache.commons.math3.geometry.partitioning.SubHyperplane<S>)
- org.apache.commons.math3.geometry.euclidean.twod.SubLine
- org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
- org.apache.commons.math3.geometry.euclidean.threed.SubPlane
- org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic (implements org.apache.commons.math3.stat.descriptive.UnivariateStatistic)
- org.apache.commons.math3.analysis.function.Acos (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Acosh (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
- org.apache.commons.math3.analysis.function.Add (implements org.apache.commons.math3.analysis.BivariateFunction)
- org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics (implements java.io.Serializable, org.apache.commons.math3.stat.descriptive.StatisticalSummary)
- org.apache.commons.math3.exception.util.ArgUtils
- org.apache.commons.math3.util.ArithmeticUtils
- org.apache.commons.math3.linear.ArrayFieldVector<T> (implements org.apache.commons.math3.linear.FieldVector<T>, java.io.Serializable)
- org.apache.commons.math3.analysis.function.Asin (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Asinh (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Atan (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Atan2 (implements org.apache.commons.math3.analysis.BivariateFunction)
- org.apache.commons.math3.analysis.function.Atanh (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.geometry.partitioning.utilities.AVLTree<T>
- org.apache.commons.math3.geometry.partitioning.utilities.AVLTree.Node
- org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer<FUNC> (implements org.apache.commons.math3.optimization.BaseMultivariateOptimizer<FUNC>)
- org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer<FUNC> (implements org.apache.commons.math3.optimization.BaseMultivariateVectorOptimizer<FUNC>)
- org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator (implements org.apache.commons.math3.analysis.integration.UnivariateIntegrator)
- org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer (implements org.apache.commons.math3.optimization.univariate.UnivariateOptimizer)
- org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver<FUNC> (implements org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver<FUNC>)
- org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer<FUNC> (implements org.apache.commons.math3.optimization.BaseMultivariateOptimizer<FUNC>)
- org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer<FUNC> (implements org.apache.commons.math3.optimization.BaseMultivariateVectorOptimizer<FUNC>)
- org.apache.commons.math3.special.Beta
- org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction (implements org.apache.commons.math3.analysis.BivariateFunction)
- org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolator (implements org.apache.commons.math3.analysis.interpolation.BivariateGridInterpolator)
- org.apache.commons.math3.fraction.BigFractionField (implements org.apache.commons.math3.Field<T>, java.io.Serializable)
- org.apache.commons.math3.util.BigReal (implements java.lang.Comparable<T>, org.apache.commons.math3.FieldElement<T>, java.io.Serializable)
- org.apache.commons.math3.util.BigRealField (implements org.apache.commons.math3.Field<T>, java.io.Serializable)
- org.apache.commons.math3.genetics.BinaryMutation (implements org.apache.commons.math3.genetics.MutationPolicy)
- org.apache.commons.math3.random.BitsStreamGenerator (implements org.apache.commons.math3.random.RandomGenerator)
- org.apache.commons.math3.geometry.partitioning.BoundaryAttribute<S>
- org.apache.commons.math3.optimization.univariate.BracketFinder
- org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
- org.apache.commons.math3.geometry.partitioning.BSPTree<S>
- org.apache.commons.math3.analysis.function.Cbrt (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Ceil (implements org.apache.commons.math3.analysis.UnivariateFunction)
- org.apache.commons.math3.stat.inference.ChiSquareTest
- org.apache.commons.math3.linear.CholeskyDecomposition
- org.apache.commons.math3.genetics.Chromosome (implements java.lang.Comparable<T>, org.apache.commons.math3.genetics.Fitness)
- org.apache.commons.math3.genetics.ChromosomePair
- org.apache.commons.math3.stat.clustering.Cluster<T> (implements java.io.Serializable)
- org.apache.commons.math3.complex.Complex (implements org.apache.commons.math3.FieldElement<T>, java.io.Serializable)
- org.apache.commons.math3.complex.ComplexField (implements org.apache.commons.math3.Field<T>, java.io.Serializable)
- org.apache.commons.math3.complex.ComplexFormat
- org.apache.commons.math3.complex.ComplexUtils
- org.apache.commons.math3.util.CompositeFormat
- org.apache.commons.math3.analysis.function.Constant (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.util.ContinuedFraction
- org.apache.commons.math3.ode.ContinuousOutputModel (implements java.io.Serializable, org.apache.commons.math3.ode.sampling.StepHandler)
- org.apache.commons.math3.random.CorrelatedRandomVectorGenerator (implements org.apache.commons.math3.random.RandomVectorGenerator)
- org.apache.commons.math3.analysis.function.Cos (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Cosh (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.stat.correlation.Covariance
- org.apache.commons.math3.optimization.fitting.CurveFitter
- org.apache.commons.math3.linear.DefaultFieldMatrixChangingVisitor<T> (implements org.apache.commons.math3.linear.FieldMatrixChangingVisitor<T>)
- org.apache.commons.math3.linear.DefaultFieldMatrixPreservingVisitor<T> (implements org.apache.commons.math3.linear.FieldMatrixPreservingVisitor<T>)
- org.apache.commons.math3.filter.DefaultMeasurementModel (implements org.apache.commons.math3.filter.MeasurementModel)
- org.apache.commons.math3.filter.DefaultProcessModel (implements org.apache.commons.math3.filter.ProcessModel)
- org.apache.commons.math3.linear.DefaultRealMatrixChangingVisitor (implements org.apache.commons.math3.linear.RealMatrixChangingVisitor)
- org.apache.commons.math3.linear.DefaultRealMatrixPreservingVisitor (implements org.apache.commons.math3.linear.RealMatrixPreservingVisitor)
- org.apache.commons.math3.util.DefaultTransformer (implements org.apache.commons.math3.util.NumberTransformer, java.io.Serializable)
- org.apache.commons.math3.stat.descriptive.DescriptiveStatistics (implements java.io.Serializable, org.apache.commons.math3.stat.descriptive.StatisticalSummary)
- org.apache.commons.math3.dfp.Dfp (implements org.apache.commons.math3.FieldElement<T>)
- org.apache.commons.math3.dfp.DfpDec
- org.apache.commons.math3.dfp.DfpField (implements org.apache.commons.math3.Field<T>)
- org.apache.commons.math3.dfp.DfpMath
- org.apache.commons.math3.analysis.function.Divide (implements org.apache.commons.math3.analysis.BivariateFunction)
- org.apache.commons.math3.analysis.interpolation.DividedDifferenceInterpolator (implements java.io.Serializable, org.apache.commons.math3.analysis.interpolation.UnivariateInterpolator)
- org.apache.commons.math3.exception.util.DummyLocalizable (implements org.apache.commons.math3.exception.util.Localizable)
- org.apache.commons.math3.ode.sampling.DummyStepHandler (implements org.apache.commons.math3.ode.sampling.StepHandler)
- org.apache.commons.math3.linear.EigenDecomposition
- org.apache.commons.math3.random.EmpiricalDistribution (implements java.io.Serializable)
- org.apache.commons.math3.ode.EquationsMapper (implements java.io.Serializable)
- org.apache.commons.math3.special.Erf
- org.apache.commons.math3.geometry.euclidean.oned.Euclidean1D (implements java.io.Serializable, org.apache.commons.math3.geometry.Space)
- org.apache.commons.math3.geometry.euclidean.twod.Euclidean2D (implements java.io.Serializable, org.apache.commons.math3.geometry.Space)
- org.apache.commons.math3.geometry.euclidean.threed.Euclidean3D (implements java.io.Serializable, org.apache.commons.math3.geometry.Space)
- org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint (implements org.apache.commons.math3.stat.clustering.Clusterable<T>, java.io.Serializable)
- java.util.EventObject (implements java.io.Serializable)
- org.apache.commons.math3.ode.events.EventState
- org.apache.commons.math3.exception.util.ExceptionContext (implements java.io.Serializable)
- org.apache.commons.math3.analysis.function.Exp (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.ode.ExpandableStatefulODE
- org.apache.commons.math3.analysis.function.Expm1 (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.transform.FastCosineTransformer (implements org.apache.commons.math3.transform.RealTransformer, java.io.Serializable)
- org.apache.commons.math3.transform.FastFourierTransformer (implements java.io.Serializable)
- org.apache.commons.math3.transform.FastHadamardTransformer (implements org.apache.commons.math3.transform.RealTransformer, java.io.Serializable)
- org.apache.commons.math3.util.FastMath
- org.apache.commons.math3.transform.FastSineTransformer (implements org.apache.commons.math3.transform.RealTransformer, java.io.Serializable)
- org.apache.commons.math3.linear.FieldLUDecomposition<T>
- org.apache.commons.math3.ode.FirstOrderConverter (implements org.apache.commons.math3.ode.FirstOrderDifferentialEquations)
- org.apache.commons.math3.genetics.FixedGenerationCount (implements org.apache.commons.math3.genetics.StoppingCondition)
- org.apache.commons.math3.analysis.function.Floor (implements org.apache.commons.math3.analysis.UnivariateFunction)
- java.text.Format (implements java.lang.Cloneable, java.io.Serializable)
- org.apache.commons.math3.fraction.FractionField (implements org.apache.commons.math3.Field<T>, java.io.Serializable)
- org.apache.commons.math3.stat.Frequency (implements java.io.Serializable)
- org.apache.commons.math3.analysis.FunctionUtils
- org.apache.commons.math3.special.Gamma
- org.apache.commons.math3.analysis.function.Gaussian (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Gaussian.Parametric (implements org.apache.commons.math3.analysis.ParametricUnivariateFunction)
- org.apache.commons.math3.optimization.fitting.GaussianFitter.ParameterGuesser
- org.apache.commons.math3.random.GaussianRandomGenerator (implements org.apache.commons.math3.random.NormalizedRandomGenerator)
- org.apache.commons.math3.genetics.GeneticAlgorithm
- org.apache.commons.math3.optimization.fitting.HarmonicFitter.ParameterGuesser
- org.apache.commons.math3.analysis.function.HarmonicOscillator (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.HarmonicOscillator.Parametric (implements org.apache.commons.math3.analysis.ParametricUnivariateFunction)
- org.apache.commons.math3.analysis.function.Identity (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.util.Incrementor
- org.apache.commons.math3.geometry.euclidean.oned.Interval
- org.apache.commons.math3.analysis.function.Inverse (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.util.IterationManager
- org.apache.commons.math3.linear.IterativeLinearSolver
- org.apache.commons.math3.ode.JacobianMatrices
- org.apache.commons.math3.filter.KalmanFilter
- org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer<T>
- org.apache.commons.math3.distribution.KolmogorovSmirnovDistribution (implements java.io.Serializable)
- org.apache.commons.math3.optimization.LeastSquaresConverter (implements org.apache.commons.math3.analysis.MultivariateFunction)
- org.apache.commons.math3.geometry.euclidean.threed.Line (implements org.apache.commons.math3.geometry.partitioning.Embedding<S,T>)
- org.apache.commons.math3.geometry.euclidean.twod.Line (implements org.apache.commons.math3.geometry.partitioning.Embedding<S,T>, org.apache.commons.math3.geometry.partitioning.Hyperplane<S>)
- org.apache.commons.math3.optimization.linear.LinearConstraint (implements java.io.Serializable)
- org.apache.commons.math3.analysis.interpolation.LinearInterpolator (implements org.apache.commons.math3.analysis.interpolation.UnivariateInterpolator)
- org.apache.commons.math3.optimization.linear.LinearObjectiveFunction (implements java.io.Serializable)
- org.apache.commons.math3.genetics.ListPopulation (implements org.apache.commons.math3.genetics.Population)
- org.apache.commons.math3.analysis.interpolation.LoessInterpolator (implements java.io.Serializable, org.apache.commons.math3.analysis.interpolation.UnivariateInterpolator)
- org.apache.commons.math3.analysis.function.Log (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Log10 (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Log1p (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Logistic (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Logistic.Parametric (implements org.apache.commons.math3.analysis.ParametricUnivariateFunction)
- org.apache.commons.math3.analysis.function.Logit (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Logit.Parametric (implements org.apache.commons.math3.analysis.ParametricUnivariateFunction)
- org.apache.commons.math3.linear.LUDecomposition
- org.apache.commons.math3.stat.inference.MannWhitneyUTest
- org.apache.commons.math3.util.MathArrays
- org.apache.commons.math3.util.MathUtils
- org.apache.commons.math3.linear.MatrixUtils
- org.apache.commons.math3.analysis.function.Max (implements org.apache.commons.math3.analysis.BivariateFunction)
- org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolatingFunction (implements org.apache.commons.math3.analysis.MultivariateFunction)
- org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator (implements org.apache.commons.math3.analysis.interpolation.MultivariateInterpolator)
- org.apache.commons.math3.stat.regression.MillerUpdatingRegression (implements org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression)
- org.apache.commons.math3.analysis.function.Min (implements org.apache.commons.math3.analysis.BivariateFunction)
- org.apache.commons.math3.analysis.function.Minus (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.util.MultidimensionalCounter (implements java.lang.Iterable<T>)
- org.apache.commons.math3.util.MultidimensionalCounter.Iterator (implements java.util.Iterator<E>)
- org.apache.commons.math3.analysis.function.Multiply (implements org.apache.commons.math3.analysis.BivariateFunction)
- org.apache.commons.math3.optimization.direct.MultivariateFunctionMappingAdapter (implements org.apache.commons.math3.analysis.MultivariateFunction)
- org.apache.commons.math3.optimization.direct.MultivariateFunctionPenaltyAdapter (implements org.apache.commons.math3.analysis.MultivariateFunction)
- org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics (implements java.io.Serializable, org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary)
- org.apache.commons.math3.stat.ranking.NaturalRanking (implements org.apache.commons.math3.stat.ranking.RankingAlgorithm)
- org.apache.commons.math3.analysis.interpolation.NevilleInterpolator (implements java.io.Serializable, org.apache.commons.math3.analysis.interpolation.UnivariateInterpolator)
- org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer.IdentityPreconditioner (implements org.apache.commons.math3.optimization.general.Preconditioner)
- java.lang.Number (implements java.io.Serializable)
- org.apache.commons.math3.genetics.OnePointCrossover<T> (implements org.apache.commons.math3.genetics.CrossoverPolicy)
- org.apache.commons.math3.stat.inference.OneWayAnova
- org.apache.commons.math3.util.OpenIntToDoubleHashMap (implements java.io.Serializable)
- org.apache.commons.math3.util.OpenIntToDoubleHashMap.Iterator
- org.apache.commons.math3.util.OpenIntToFieldHashMap<T> (implements java.io.Serializable)
- org.apache.commons.math3.util.OpenIntToFieldHashMap.Iterator
- org.apache.commons.math3.linear.OpenMapRealVector.OpenMapSparseIterator (implements java.util.Iterator<E>)
- org.apache.commons.math3.geometry.partitioning.utilities.OrderedTuple (implements java.lang.Comparable<T>)
- org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint (implements org.apache.commons.math3.geometry.partitioning.Hyperplane<S>)
- org.apache.commons.math3.geometry.euclidean.threed.OutlineExtractor
- org.apache.commons.math3.util.Pair<K,V>
- org.apache.commons.math3.stat.correlation.PearsonsCorrelation
- org.apache.commons.math3.geometry.euclidean.threed.Plane (implements org.apache.commons.math3.geometry.partitioning.Embedding<S,T>, org.apache.commons.math3.geometry.partitioning.Hyperplane<S>)
- org.apache.commons.math3.analysis.polynomials.PolynomialFunction (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction, java.io.Serializable)
- org.apache.commons.math3.analysis.polynomials.PolynomialFunction.Parametric (implements org.apache.commons.math3.analysis.ParametricUnivariateFunction)
- org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm (implements org.apache.commons.math3.analysis.UnivariateFunction)
- org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm (implements org.apache.commons.math3.analysis.UnivariateFunction)
- org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
- org.apache.commons.math3.analysis.function.Pow (implements org.apache.commons.math3.analysis.BivariateFunction)
- org.apache.commons.math3.analysis.function.Power (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.util.Precision
- org.apache.commons.math3.linear.QRDecomposition
- java.util.Random (implements java.io.Serializable)
- org.apache.commons.math3.random.RandomDataImpl (implements org.apache.commons.math3.random.RandomData, java.io.Serializable)
- org.apache.commons.math3.genetics.RandomKeyMutation (implements org.apache.commons.math3.genetics.MutationPolicy)
- org.apache.commons.math3.linear.RealLinearOperator
- org.apache.commons.math3.linear.RealVector
- org.apache.commons.math3.linear.RealVector.Entry
- org.apache.commons.math3.linear.RealVector.SparseEntryIterator (implements java.util.Iterator<E>)
- org.apache.commons.math3.linear.RealVectorFormat
- org.apache.commons.math3.linear.RectangularCholeskyDecomposition
- org.apache.commons.math3.geometry.partitioning.RegionFactory<S>
- org.apache.commons.math3.stat.regression.RegressionResults (implements java.io.Serializable)
- org.apache.commons.math3.util.ResizableDoubleArray (implements org.apache.commons.math3.util.DoubleArray, java.io.Serializable)
- org.apache.commons.math3.analysis.function.Rint (implements org.apache.commons.math3.analysis.UnivariateFunction)
- org.apache.commons.math3.complex.RootsOfUnity (implements java.io.Serializable)
- org.apache.commons.math3.geometry.euclidean.threed.Rotation (implements java.io.Serializable)
- org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
- org.apache.commons.math3.geometry.euclidean.threed.Segment
- org.apache.commons.math3.geometry.euclidean.twod.Segment
- org.apache.commons.math3.analysis.function.Sigmoid (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Sigmoid.Parametric (implements org.apache.commons.math3.analysis.ParametricUnivariateFunction)
- org.apache.commons.math3.analysis.function.Signum (implements org.apache.commons.math3.analysis.UnivariateFunction)
- org.apache.commons.math3.stat.regression.SimpleRegression (implements java.io.Serializable, org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression)
- org.apache.commons.math3.analysis.function.Sin (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Sinc (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.linear.SingularValueDecomposition
- org.apache.commons.math3.analysis.function.Sinh (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.linear.SparseFieldVector<T> (implements org.apache.commons.math3.linear.FieldVector<T>, java.io.Serializable)
- org.apache.commons.math3.stat.correlation.SpearmansCorrelation
- org.apache.commons.math3.analysis.interpolation.SplineInterpolator (implements org.apache.commons.math3.analysis.interpolation.UnivariateInterpolator)
- org.apache.commons.math3.analysis.function.Sqrt (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.random.StableRandomGenerator (implements org.apache.commons.math3.random.NormalizedRandomGenerator)
- org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues (implements java.io.Serializable, org.apache.commons.math3.stat.descriptive.StatisticalSummary)
- org.apache.commons.math3.stat.StatUtils
- org.apache.commons.math3.analysis.function.StepFunction (implements org.apache.commons.math3.analysis.UnivariateFunction)
- org.apache.commons.math3.ode.sampling.StepNormalizer (implements org.apache.commons.math3.ode.sampling.StepHandler)
- org.apache.commons.math3.geometry.partitioning.SubHyperplane.SplitSubHyperplane<U>
- org.apache.commons.math3.geometry.euclidean.threed.SubLine
- org.apache.commons.math3.analysis.function.Subtract (implements org.apache.commons.math3.analysis.BivariateFunction)
- org.apache.commons.math3.stat.descriptive.SummaryStatistics (implements java.io.Serializable, org.apache.commons.math3.stat.descriptive.StatisticalSummary)
- org.apache.commons.math3.analysis.function.Tan (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.analysis.function.Tanh (implements org.apache.commons.math3.analysis.DifferentiableUnivariateFunction)
- org.apache.commons.math3.stat.inference.TestUtils
- java.lang.Throwable (implements java.io.Serializable)
- org.apache.commons.math3.genetics.TournamentSelection (implements org.apache.commons.math3.genetics.SelectionPolicy)
- org.apache.commons.math3.util.TransformerMap (implements org.apache.commons.math3.util.NumberTransformer, java.io.Serializable)
- org.apache.commons.math3.transform.TransformUtils
- org.apache.commons.math3.analysis.interpolation.TricubicSplineInterpolatingFunction (implements org.apache.commons.math3.analysis.TrivariateFunction)
- org.apache.commons.math3.analysis.interpolation.TricubicSplineInterpolator (implements org.apache.commons.math3.analysis.interpolation.TrivariateGridInterpolator)
- org.apache.commons.math3.stat.inference.TTest
- org.apache.commons.math3.analysis.function.Ulp (implements org.apache.commons.math3.analysis.UnivariateFunction)
- org.apache.commons.math3.random.UncorrelatedRandomVectorGenerator (implements org.apache.commons.math3.random.RandomVectorGenerator)
- org.apache.commons.math3.random.UniformRandomGenerator (implements org.apache.commons.math3.random.NormalizedRandomGenerator)
- org.apache.commons.math3.random.UnitSphereRandomVectorGenerator (implements org.apache.commons.math3.random.RandomVectorGenerator)
- org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer<FUNC> (implements org.apache.commons.math3.optimization.univariate.BaseUnivariateOptimizer<FUNC>)
- org.apache.commons.math3.analysis.interpolation.UnivariatePeriodicInterpolator (implements org.apache.commons.math3.analysis.interpolation.UnivariateInterpolator)
- org.apache.commons.math3.optimization.univariate.UnivariatePointValuePair (implements java.io.Serializable)
- org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
- org.apache.commons.math3.random.ValueServer
- org.apache.commons.math3.geometry.euclidean.oned.Vector1D (implements org.apache.commons.math3.geometry.Vector<S>)
- org.apache.commons.math3.geometry.euclidean.twod.Vector2D (implements org.apache.commons.math3.geometry.Vector<S>)
- org.apache.commons.math3.geometry.euclidean.threed.Vector3D (implements java.io.Serializable, org.apache.commons.math3.geometry.Vector<S>)
- org.apache.commons.math3.geometry.VectorFormat<S>
- org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance (implements java.io.Serializable)
- org.apache.commons.math3.stat.descriptive.moment.VectorialMean (implements java.io.Serializable)
- org.apache.commons.math3.optimization.fitting.WeightedObservedPoint (implements java.io.Serializable)
- org.apache.commons.math3.stat.inference.WilcoxonSignedRankTest
Interface Hierarchy
Enum Hierarchy
Copyright © 2003-2012 The Apache Software Foundation. All Rights Reserved.