Hierarchy For All Packages
Package Hierarchies:- org.apache.commons.math,
- org.apache.commons.math.analysis,
- org.apache.commons.math.analysis.integration,
- org.apache.commons.math.analysis.interpolation,
- org.apache.commons.math.analysis.polynomials,
- org.apache.commons.math.analysis.solvers,
- org.apache.commons.math.complex,
- org.apache.commons.math.dfp,
- org.apache.commons.math.distribution,
- org.apache.commons.math.estimation,
- org.apache.commons.math.exception,
- org.apache.commons.math.exception.util,
- org.apache.commons.math.fraction,
- org.apache.commons.math.genetics,
- org.apache.commons.math.geometry,
- org.apache.commons.math.linear,
- org.apache.commons.math.ode,
- org.apache.commons.math.ode.events,
- org.apache.commons.math.ode.jacobians,
- org.apache.commons.math.ode.nonstiff,
- org.apache.commons.math.ode.sampling,
- org.apache.commons.math.optimization,
- org.apache.commons.math.optimization.direct,
- org.apache.commons.math.optimization.fitting,
- org.apache.commons.math.optimization.general,
- org.apache.commons.math.optimization.linear,
- org.apache.commons.math.optimization.univariate,
- org.apache.commons.math.random,
- org.apache.commons.math.special,
- org.apache.commons.math.stat,
- org.apache.commons.math.stat.clustering,
- org.apache.commons.math.stat.correlation,
- org.apache.commons.math.stat.descriptive,
- org.apache.commons.math.stat.descriptive.moment,
- org.apache.commons.math.stat.descriptive.rank,
- org.apache.commons.math.stat.descriptive.summary,
- org.apache.commons.math.stat.inference,
- org.apache.commons.math.stat.ranking,
- org.apache.commons.math.stat.regression,
- org.apache.commons.math.transform,
- org.apache.commons.math.util
Class Hierarchy
- java.lang.Object
- org.apache.commons.math.distribution.AbstractDistribution (implements org.apache.commons.math.distribution.Distribution, java.io.Serializable)
- org.apache.commons.math.distribution.AbstractContinuousDistribution (implements org.apache.commons.math.distribution.ContinuousDistribution, java.io.Serializable)
- org.apache.commons.math.distribution.BetaDistributionImpl (implements org.apache.commons.math.distribution.BetaDistribution)
- org.apache.commons.math.distribution.CauchyDistributionImpl (implements org.apache.commons.math.distribution.CauchyDistribution, java.io.Serializable)
- org.apache.commons.math.distribution.ChiSquaredDistributionImpl (implements org.apache.commons.math.distribution.ChiSquaredDistribution, java.io.Serializable)
- org.apache.commons.math.distribution.ExponentialDistributionImpl (implements org.apache.commons.math.distribution.ExponentialDistribution, java.io.Serializable)
- org.apache.commons.math.distribution.FDistributionImpl (implements org.apache.commons.math.distribution.FDistribution, java.io.Serializable)
- org.apache.commons.math.distribution.GammaDistributionImpl (implements org.apache.commons.math.distribution.GammaDistribution, java.io.Serializable)
- org.apache.commons.math.distribution.NormalDistributionImpl (implements org.apache.commons.math.distribution.NormalDistribution, java.io.Serializable)
- org.apache.commons.math.distribution.TDistributionImpl (implements java.io.Serializable, org.apache.commons.math.distribution.TDistribution)
- org.apache.commons.math.distribution.WeibullDistributionImpl (implements java.io.Serializable, org.apache.commons.math.distribution.WeibullDistribution)
- org.apache.commons.math.distribution.AbstractIntegerDistribution (implements org.apache.commons.math.distribution.IntegerDistribution, java.io.Serializable)
- org.apache.commons.math.distribution.BinomialDistributionImpl (implements org.apache.commons.math.distribution.BinomialDistribution, java.io.Serializable)
- org.apache.commons.math.distribution.HypergeometricDistributionImpl (implements org.apache.commons.math.distribution.HypergeometricDistribution, java.io.Serializable)
- org.apache.commons.math.distribution.PascalDistributionImpl (implements org.apache.commons.math.distribution.PascalDistribution, java.io.Serializable)
- org.apache.commons.math.distribution.PoissonDistributionImpl (implements org.apache.commons.math.distribution.PoissonDistribution, java.io.Serializable)
- org.apache.commons.math.distribution.ZipfDistributionImpl (implements java.io.Serializable, org.apache.commons.math.distribution.ZipfDistribution)
- org.apache.commons.math.distribution.AbstractContinuousDistribution (implements org.apache.commons.math.distribution.ContinuousDistribution, java.io.Serializable)
- org.apache.commons.math.estimation.AbstractEstimator (implements org.apache.commons.math.estimation.Estimator)
- org.apache.commons.math.estimation.GaussNewtonEstimator (implements java.io.Serializable)
- org.apache.commons.math.estimation.LevenbergMarquardtEstimator (implements java.io.Serializable)
- org.apache.commons.math.linear.AbstractFieldMatrix<T> (implements org.apache.commons.math.linear.FieldMatrix<T>)
- org.apache.commons.math.linear.Array2DRowFieldMatrix<T> (implements java.io.Serializable)
- org.apache.commons.math.linear.BlockFieldMatrix<T> (implements java.io.Serializable)
- org.apache.commons.math.linear.SparseFieldMatrix<T>
- org.apache.commons.math.ode.AbstractIntegrator (implements org.apache.commons.math.ode.FirstOrderIntegrator)
- org.apache.commons.math.ode.nonstiff.AdaptiveStepsizeIntegrator
- org.apache.commons.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
- org.apache.commons.math.ode.nonstiff.DormandPrince54Integrator
- org.apache.commons.math.ode.nonstiff.DormandPrince853Integrator
- org.apache.commons.math.ode.nonstiff.HighamHall54Integrator
- org.apache.commons.math.ode.nonstiff.GraggBulirschStoerIntegrator
- org.apache.commons.math.ode.MultistepIntegrator
- org.apache.commons.math.ode.nonstiff.AdamsIntegrator
- org.apache.commons.math.ode.nonstiff.AdamsBashforthIntegrator
- org.apache.commons.math.ode.nonstiff.AdamsMoultonIntegrator
- org.apache.commons.math.ode.nonstiff.AdamsIntegrator
- org.apache.commons.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
- org.apache.commons.math.ode.nonstiff.RungeKuttaIntegrator
- org.apache.commons.math.ode.nonstiff.ClassicalRungeKuttaIntegrator
- org.apache.commons.math.ode.nonstiff.EulerIntegrator
- org.apache.commons.math.ode.nonstiff.GillIntegrator
- org.apache.commons.math.ode.nonstiff.MidpointIntegrator
- org.apache.commons.math.ode.nonstiff.ThreeEighthesIntegrator
- org.apache.commons.math.ode.nonstiff.AdaptiveStepsizeIntegrator
- org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer (implements org.apache.commons.math.optimization.DifferentiableMultivariateVectorialOptimizer)
- org.apache.commons.math.optimization.general.GaussNewtonOptimizer
- org.apache.commons.math.optimization.general.LevenbergMarquardtOptimizer
- org.apache.commons.math.optimization.linear.AbstractLinearOptimizer (implements org.apache.commons.math.optimization.linear.LinearOptimizer)
- org.apache.commons.math.optimization.linear.SimplexSolver
- org.apache.commons.math.stat.regression.AbstractMultipleLinearRegression (implements org.apache.commons.math.stat.regression.MultipleLinearRegression)
- org.apache.commons.math.stat.regression.GLSMultipleLinearRegression
- org.apache.commons.math.stat.regression.OLSMultipleLinearRegression
- org.apache.commons.math.random.AbstractRandomGenerator (implements org.apache.commons.math.random.RandomGenerator)
- org.apache.commons.math.linear.AbstractRealMatrix (implements org.apache.commons.math.linear.RealMatrix)
- org.apache.commons.math.linear.Array2DRowRealMatrix (implements java.io.Serializable)
- org.apache.commons.math.linear.BlockRealMatrix (implements java.io.Serializable)
- org.apache.commons.math.linear.OpenMapRealMatrix (implements java.io.Serializable, org.apache.commons.math.linear.SparseRealMatrix)
- org.apache.commons.math.linear.RealMatrixImpl (implements java.io.Serializable)
- org.apache.commons.math.linear.AbstractRealVector (implements org.apache.commons.math.linear.RealVector)
- org.apache.commons.math.linear.ArrayRealVector (implements java.io.Serializable)
- org.apache.commons.math.linear.OpenMapRealVector (implements java.io.Serializable, org.apache.commons.math.linear.SparseRealVector)
- org.apache.commons.math.linear.AbstractRealVector.SparseEntryIterator (implements java.util.Iterator<E>)
- org.apache.commons.math.optimization.general.AbstractScalarDifferentiableOptimizer (implements org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer)
- org.apache.commons.math.optimization.general.NonLinearConjugateGradientOptimizer
- org.apache.commons.math.optimization.direct.PowellOptimizer
- org.apache.commons.math.ode.sampling.AbstractStepInterpolator (implements org.apache.commons.math.ode.sampling.StepInterpolator)
- org.apache.commons.math.ode.sampling.DummyStepInterpolator
- org.apache.commons.math.ode.sampling.NordsieckStepInterpolator
- org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic (implements org.apache.commons.math.stat.descriptive.UnivariateStatistic)
- org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic (implements org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic)
- org.apache.commons.math.stat.descriptive.moment.FirstMoment (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.moment.SecondMoment (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.moment.ThirdMoment (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.moment.FourthMoment (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.moment.ThirdMoment (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.moment.SecondMoment (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.moment.GeometricMean (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.moment.Kurtosis (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.rank.Max (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.moment.Mean (implements java.io.Serializable, org.apache.commons.math.stat.descriptive.WeightedEvaluation)
- org.apache.commons.math.stat.descriptive.rank.Min (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.summary.Product (implements java.io.Serializable, org.apache.commons.math.stat.descriptive.WeightedEvaluation)
- org.apache.commons.math.stat.descriptive.moment.Skewness (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.moment.StandardDeviation (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.summary.Sum (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.summary.SumOfLogs (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.summary.SumOfSquares (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.moment.Variance (implements java.io.Serializable, org.apache.commons.math.stat.descriptive.WeightedEvaluation)
- org.apache.commons.math.stat.descriptive.moment.FirstMoment (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.rank.Percentile (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.rank.Median (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.moment.SemiVariance (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic (implements org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic)
- org.apache.commons.math.ode.nonstiff.AdamsNordsieckTransformer
- org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics (implements java.io.Serializable, org.apache.commons.math.stat.descriptive.StatisticalSummary)
- org.apache.commons.math.exception.util.ArgUtils
- org.apache.commons.math.linear.ArrayFieldVector<T> (implements org.apache.commons.math.linear.FieldVector<T>, java.io.Serializable)
- org.apache.commons.math.special.Beta
- org.apache.commons.math.analysis.interpolation.BicubicSplineInterpolatingFunction (implements org.apache.commons.math.analysis.BivariateRealFunction)
- org.apache.commons.math.analysis.interpolation.BicubicSplineInterpolator (implements org.apache.commons.math.analysis.interpolation.BivariateRealGridInterpolator)
- org.apache.commons.math.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
- org.apache.commons.math.fraction.BigFractionField (implements org.apache.commons.math.Field<T>, java.io.Serializable)
- org.apache.commons.math.linear.BigMatrixImpl (implements org.apache.commons.math.linear.BigMatrix, java.io.Serializable)
- org.apache.commons.math.util.BigReal (implements java.lang.Comparable<T>, org.apache.commons.math.FieldElement<T>, java.io.Serializable)
- org.apache.commons.math.util.BigRealField (implements org.apache.commons.math.Field<T>, java.io.Serializable)
- org.apache.commons.math.analysis.BinaryFunction (implements org.apache.commons.math.analysis.BivariateRealFunction)
- org.apache.commons.math.genetics.BinaryMutation (implements org.apache.commons.math.genetics.MutationPolicy)
- org.apache.commons.math.random.BitsStreamGenerator (implements org.apache.commons.math.random.RandomGenerator)
- org.apache.commons.math.random.AbstractWell (implements java.io.Serializable)
- org.apache.commons.math.random.Well1024a
- org.apache.commons.math.random.Well19937a
- org.apache.commons.math.random.Well19937c
- org.apache.commons.math.random.Well44497a
- org.apache.commons.math.random.Well44497b
- org.apache.commons.math.random.Well512a
- org.apache.commons.math.random.MersenneTwister (implements java.io.Serializable)
- org.apache.commons.math.random.AbstractWell (implements java.io.Serializable)
- org.apache.commons.math.optimization.univariate.BracketFinder
- org.apache.commons.math.stat.inference.ChiSquareTestImpl (implements org.apache.commons.math.stat.inference.UnknownDistributionChiSquareTest)
- org.apache.commons.math.linear.CholeskyDecompositionImpl (implements org.apache.commons.math.linear.CholeskyDecomposition)
- org.apache.commons.math.genetics.Chromosome (implements java.lang.Comparable<T>, org.apache.commons.math.genetics.Fitness)
- org.apache.commons.math.genetics.AbstractListChromosome<T>
- org.apache.commons.math.genetics.BinaryChromosome
- org.apache.commons.math.genetics.RandomKey<T> (implements org.apache.commons.math.genetics.PermutationChromosome<T>)
- org.apache.commons.math.genetics.AbstractListChromosome<T>
- org.apache.commons.math.genetics.ChromosomePair
- org.apache.commons.math.stat.clustering.Cluster<T> (implements java.io.Serializable)
- org.apache.commons.math.ode.events.CombinedEventsManager
- org.apache.commons.math.complex.Complex (implements org.apache.commons.math.FieldElement<T>, java.io.Serializable)
- org.apache.commons.math.complex.ComplexField (implements org.apache.commons.math.Field<T>, java.io.Serializable)
- org.apache.commons.math.complex.ComplexUtils
- org.apache.commons.math.analysis.ComposableFunction (implements org.apache.commons.math.analysis.UnivariateRealFunction)
- org.apache.commons.math.util.ContinuedFraction
- org.apache.commons.math.ode.ContinuousOutputModel (implements java.io.Serializable, org.apache.commons.math.ode.sampling.StepHandler)
- org.apache.commons.math.ConvergingAlgorithmImpl (implements org.apache.commons.math.ConvergingAlgorithm)
- org.apache.commons.math.optimization.univariate.AbstractUnivariateRealOptimizer (implements org.apache.commons.math.optimization.UnivariateRealOptimizer)
- org.apache.commons.math.optimization.univariate.BrentOptimizer
- org.apache.commons.math.analysis.integration.UnivariateRealIntegratorImpl (implements org.apache.commons.math.analysis.integration.UnivariateRealIntegrator)
- org.apache.commons.math.analysis.integration.LegendreGaussIntegrator
- org.apache.commons.math.analysis.integration.RombergIntegrator
- org.apache.commons.math.analysis.integration.SimpsonIntegrator
- org.apache.commons.math.analysis.integration.TrapezoidIntegrator
- org.apache.commons.math.analysis.solvers.UnivariateRealSolverImpl (implements org.apache.commons.math.analysis.solvers.UnivariateRealSolver)
- org.apache.commons.math.analysis.solvers.BisectionSolver
- org.apache.commons.math.analysis.solvers.BrentSolver
- org.apache.commons.math.analysis.solvers.LaguerreSolver
- org.apache.commons.math.analysis.solvers.MullerSolver
- org.apache.commons.math.analysis.solvers.NewtonSolver
- org.apache.commons.math.analysis.solvers.RiddersSolver
- org.apache.commons.math.analysis.solvers.SecantSolver
- org.apache.commons.math.optimization.univariate.AbstractUnivariateRealOptimizer (implements org.apache.commons.math.optimization.UnivariateRealOptimizer)
- org.apache.commons.math.random.CorrelatedRandomVectorGenerator (implements org.apache.commons.math.random.RandomVectorGenerator)
- org.apache.commons.math.stat.correlation.Covariance
- org.apache.commons.math.optimization.fitting.CurveFitter
- org.apache.commons.math.linear.DefaultFieldMatrixChangingVisitor<T> (implements org.apache.commons.math.linear.FieldMatrixChangingVisitor<T>)
- org.apache.commons.math.linear.DefaultFieldMatrixPreservingVisitor<T> (implements org.apache.commons.math.linear.FieldMatrixPreservingVisitor<T>)
- org.apache.commons.math.linear.DefaultRealMatrixChangingVisitor (implements org.apache.commons.math.linear.RealMatrixChangingVisitor)
- org.apache.commons.math.linear.DefaultRealMatrixPreservingVisitor (implements org.apache.commons.math.linear.RealMatrixPreservingVisitor)
- org.apache.commons.math.util.DefaultTransformer (implements org.apache.commons.math.util.NumberTransformer, java.io.Serializable)
- org.apache.commons.math.stat.descriptive.DescriptiveStatistics (implements java.io.Serializable, org.apache.commons.math.stat.descriptive.StatisticalSummary)
- org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
- org.apache.commons.math.dfp.Dfp (implements org.apache.commons.math.FieldElement<T>)
- org.apache.commons.math.dfp.DfpDec
- org.apache.commons.math.dfp.DfpField (implements org.apache.commons.math.Field<T>)
- org.apache.commons.math.dfp.DfpMath
- org.apache.commons.math.optimization.direct.DirectSearchOptimizer (implements org.apache.commons.math.optimization.MultivariateRealOptimizer)
- org.apache.commons.math.optimization.direct.MultiDirectional
- org.apache.commons.math.optimization.direct.NelderMead
- org.apache.commons.math.analysis.interpolation.DividedDifferenceInterpolator (implements java.io.Serializable, org.apache.commons.math.analysis.interpolation.UnivariateRealInterpolator)
- org.apache.commons.math.exception.util.DummyLocalizable (implements org.apache.commons.math.exception.util.Localizable)
- org.apache.commons.math.ode.sampling.DummyStepHandler (implements org.apache.commons.math.ode.sampling.StepHandler)
- org.apache.commons.math.linear.EigenDecompositionImpl (implements org.apache.commons.math.linear.EigenDecomposition)
- org.apache.commons.math.random.EmpiricalDistributionImpl (implements org.apache.commons.math.random.EmpiricalDistribution, java.io.Serializable)
- org.apache.commons.math.special.Erf
- org.apache.commons.math.estimation.EstimatedParameter (implements java.io.Serializable)
- org.apache.commons.math.stat.clustering.EuclideanIntegerPoint (implements org.apache.commons.math.stat.clustering.Clusterable<T>, java.io.Serializable)
- org.apache.commons.math.ode.events.EventState
- org.apache.commons.math.transform.FastCosineTransformer (implements org.apache.commons.math.transform.RealTransformer)
- org.apache.commons.math.transform.FastFourierTransformer (implements java.io.Serializable)
- org.apache.commons.math.transform.FastHadamardTransformer (implements org.apache.commons.math.transform.RealTransformer)
- org.apache.commons.math.util.FastMath
- org.apache.commons.math.transform.FastSineTransformer (implements org.apache.commons.math.transform.RealTransformer)
- org.apache.commons.math.linear.FieldLUDecompositionImpl<T> (implements org.apache.commons.math.linear.FieldLUDecomposition<T>)
- org.apache.commons.math.ode.FirstOrderConverter (implements org.apache.commons.math.ode.FirstOrderDifferentialEquations)
- org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
- org.apache.commons.math.genetics.FixedGenerationCount (implements org.apache.commons.math.genetics.StoppingCondition)
- java.text.Format (implements java.lang.Cloneable, java.io.Serializable)
- org.apache.commons.math.util.CompositeFormat
- org.apache.commons.math.complex.ComplexFormat
- org.apache.commons.math.linear.RealVectorFormat
- org.apache.commons.math.geometry.Vector3DFormat
- java.text.NumberFormat
- org.apache.commons.math.fraction.AbstractFormat (implements java.io.Serializable)
- org.apache.commons.math.fraction.BigFractionFormat (implements java.io.Serializable)
- org.apache.commons.math.fraction.ProperBigFractionFormat
- org.apache.commons.math.fraction.FractionFormat
- org.apache.commons.math.fraction.ProperFractionFormat
- org.apache.commons.math.fraction.BigFractionFormat (implements java.io.Serializable)
- org.apache.commons.math.fraction.AbstractFormat (implements java.io.Serializable)
- org.apache.commons.math.util.CompositeFormat
- org.apache.commons.math.fraction.FractionField (implements org.apache.commons.math.Field<T>, java.io.Serializable)
- org.apache.commons.math.stat.Frequency (implements java.io.Serializable)
- org.apache.commons.math.special.Gamma
- org.apache.commons.math.optimization.fitting.GaussianDerivativeFunction (implements java.io.Serializable, org.apache.commons.math.analysis.UnivariateRealFunction)
- org.apache.commons.math.optimization.fitting.GaussianFitter
- org.apache.commons.math.optimization.fitting.GaussianFunction (implements org.apache.commons.math.analysis.DifferentiableUnivariateRealFunction, java.io.Serializable)
- org.apache.commons.math.optimization.fitting.GaussianParametersGuesser
- org.apache.commons.math.random.GaussianRandomGenerator (implements org.apache.commons.math.random.NormalizedRandomGenerator)
- org.apache.commons.math.genetics.GeneticAlgorithm
- org.apache.commons.math.optimization.fitting.HarmonicCoefficientsGuesser
- org.apache.commons.math.optimization.fitting.HarmonicFitter
- org.apache.commons.math.optimization.fitting.HarmonicFunction (implements org.apache.commons.math.analysis.DifferentiableUnivariateRealFunction)
- org.apache.commons.math.stat.clustering.KMeansPlusPlusClusterer<T>
- org.apache.commons.math.optimization.LeastSquaresConverter (implements org.apache.commons.math.analysis.MultivariateRealFunction)
- org.apache.commons.math.optimization.linear.LinearConstraint (implements java.io.Serializable)
- org.apache.commons.math.analysis.interpolation.LinearInterpolator (implements org.apache.commons.math.analysis.interpolation.UnivariateRealInterpolator)
- org.apache.commons.math.optimization.linear.LinearObjectiveFunction (implements java.io.Serializable)
- org.apache.commons.math.genetics.ListPopulation (implements org.apache.commons.math.genetics.Population)
- org.apache.commons.math.genetics.ElitisticListPopulation
- org.apache.commons.math.analysis.interpolation.LoessInterpolator (implements java.io.Serializable, org.apache.commons.math.analysis.interpolation.UnivariateRealInterpolator)
- org.apache.commons.math.linear.LUDecompositionImpl (implements org.apache.commons.math.linear.LUDecomposition)
- org.apache.commons.math.util.MathUtils
- org.apache.commons.math.linear.MatrixUtils
- org.apache.commons.math.exception.util.MessageFactory
- org.apache.commons.math.analysis.interpolation.MicrosphereInterpolatingFunction (implements org.apache.commons.math.analysis.MultivariateRealFunction)
- org.apache.commons.math.analysis.interpolation.MicrosphereInterpolator (implements org.apache.commons.math.analysis.interpolation.MultivariateRealInterpolator)
- org.apache.commons.math.util.MultidimensionalCounter (implements java.lang.Iterable<T>)
- org.apache.commons.math.util.MultidimensionalCounter.Iterator (implements java.util.Iterator<E>)
- org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateRealOptimizer (implements org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer)
- org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateVectorialOptimizer (implements org.apache.commons.math.optimization.DifferentiableMultivariateVectorialOptimizer)
- org.apache.commons.math.optimization.MultiStartMultivariateRealOptimizer (implements org.apache.commons.math.optimization.MultivariateRealOptimizer)
- org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer (implements org.apache.commons.math.optimization.UnivariateRealOptimizer)
- org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics (implements java.io.Serializable, org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary)
- org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
- org.apache.commons.math.stat.ranking.NaturalRanking (implements org.apache.commons.math.stat.ranking.RankingAlgorithm)
- org.apache.commons.math.analysis.interpolation.NevilleInterpolator (implements java.io.Serializable, org.apache.commons.math.analysis.interpolation.UnivariateRealInterpolator)
- java.lang.Number (implements java.io.Serializable)
- org.apache.commons.math.fraction.BigFraction (implements java.lang.Comparable<T>, org.apache.commons.math.FieldElement<T>, java.io.Serializable)
- org.apache.commons.math.fraction.Fraction (implements java.lang.Comparable<T>, org.apache.commons.math.FieldElement<T>, java.io.Serializable)
- org.apache.commons.math.genetics.OnePointCrossover<T> (implements org.apache.commons.math.genetics.CrossoverPolicy)
- org.apache.commons.math.stat.inference.OneWayAnovaImpl (implements org.apache.commons.math.stat.inference.OneWayAnova)
- org.apache.commons.math.util.OpenIntToDoubleHashMap (implements java.io.Serializable)
- org.apache.commons.math.util.OpenIntToDoubleHashMap.Iterator
- org.apache.commons.math.util.OpenIntToFieldHashMap<T> (implements java.io.Serializable)
- org.apache.commons.math.util.OpenIntToFieldHashMap.Iterator
- org.apache.commons.math.linear.OpenMapRealVector.OpenMapSparseIterator (implements java.util.Iterator<E>)
- org.apache.commons.math.optimization.fitting.ParametricGaussianFunction (implements org.apache.commons.math.optimization.fitting.ParametricRealFunction, java.io.Serializable)
- org.apache.commons.math.stat.correlation.PearsonsCorrelation
- org.apache.commons.math.optimization.fitting.PolynomialFitter
- org.apache.commons.math.analysis.polynomials.PolynomialFunction (implements org.apache.commons.math.analysis.DifferentiableUnivariateRealFunction, java.io.Serializable)
- org.apache.commons.math.analysis.polynomials.PolynomialFunctionLagrangeForm (implements org.apache.commons.math.analysis.UnivariateRealFunction)
- org.apache.commons.math.analysis.polynomials.PolynomialFunctionNewtonForm (implements org.apache.commons.math.analysis.UnivariateRealFunction)
- org.apache.commons.math.analysis.polynomials.PolynomialSplineFunction (implements org.apache.commons.math.analysis.DifferentiableUnivariateRealFunction)
- org.apache.commons.math.analysis.polynomials.PolynomialsUtils
- org.apache.commons.math.linear.QRDecompositionImpl (implements org.apache.commons.math.linear.QRDecomposition)
- java.util.Random (implements java.io.Serializable)
- org.apache.commons.math.random.JDKRandomGenerator (implements org.apache.commons.math.random.RandomGenerator)
- org.apache.commons.math.random.RandomAdaptor (implements org.apache.commons.math.random.RandomGenerator)
- org.apache.commons.math.random.RandomDataImpl (implements org.apache.commons.math.random.RandomData, java.io.Serializable)
- org.apache.commons.math.genetics.RandomKeyMutation (implements org.apache.commons.math.genetics.MutationPolicy)
- org.apache.commons.math.optimization.RealPointValuePair (implements java.io.Serializable)
- org.apache.commons.math.linear.RealVector.Entry
- org.apache.commons.math.linear.AbstractRealVector.EntryImpl
- org.apache.commons.math.linear.OpenMapRealVector.OpenMapEntry
- org.apache.commons.math.util.ResizableDoubleArray (implements org.apache.commons.math.util.DoubleArray, java.io.Serializable)
- org.apache.commons.math.geometry.Rotation (implements java.io.Serializable)
- org.apache.commons.math.geometry.RotationOrder
- org.apache.commons.math.estimation.SimpleEstimationProblem (implements org.apache.commons.math.estimation.EstimationProblem)
- org.apache.commons.math.optimization.SimpleRealPointChecker (implements org.apache.commons.math.optimization.RealConvergenceChecker)
- org.apache.commons.math.stat.regression.SimpleRegression (implements java.io.Serializable)
- org.apache.commons.math.optimization.SimpleScalarValueChecker (implements org.apache.commons.math.optimization.RealConvergenceChecker)
- org.apache.commons.math.optimization.SimpleVectorialPointChecker (implements org.apache.commons.math.optimization.VectorialConvergenceChecker)
- org.apache.commons.math.optimization.SimpleVectorialValueChecker (implements org.apache.commons.math.optimization.VectorialConvergenceChecker)
- org.apache.commons.math.linear.SingularValueDecompositionImpl (implements org.apache.commons.math.linear.SingularValueDecomposition)
- org.apache.commons.math.analysis.interpolation.SmoothingBicubicSplineInterpolator (implements org.apache.commons.math.analysis.interpolation.BivariateRealGridInterpolator)
- org.apache.commons.math.linear.SparseFieldVector<T> (implements org.apache.commons.math.linear.FieldVector<T>, java.io.Serializable)
- org.apache.commons.math.stat.correlation.SpearmansCorrelation
- org.apache.commons.math.analysis.interpolation.SplineInterpolator (implements org.apache.commons.math.analysis.interpolation.UnivariateRealInterpolator)
- org.apache.commons.math.stat.descriptive.StatisticalSummaryValues (implements java.io.Serializable, org.apache.commons.math.stat.descriptive.StatisticalSummary)
- org.apache.commons.math.stat.StatUtils
- org.apache.commons.math.ode.sampling.StepNormalizer (implements org.apache.commons.math.ode.sampling.StepHandler)
- org.apache.commons.math.stat.descriptive.SummaryStatistics (implements java.io.Serializable, org.apache.commons.math.stat.descriptive.StatisticalSummary)
- org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
- org.apache.commons.math.stat.inference.TestUtils
- java.lang.Throwable (implements java.io.Serializable)
- java.lang.Exception
- org.apache.commons.math.genetics.InvalidRepresentationException
- org.apache.commons.math.MathException (implements org.apache.commons.math.exception.MathThrowable)
- org.apache.commons.math.geometry.CardanEulerSingularityException
- org.apache.commons.math.ConvergenceException
- org.apache.commons.math.fraction.FractionConversionException
- org.apache.commons.math.MaxEvaluationsExceededException
- org.apache.commons.math.MaxIterationsExceededException
- org.apache.commons.math.optimization.OptimizationException
- org.apache.commons.math.optimization.linear.NoFeasibleSolutionException
- org.apache.commons.math.optimization.linear.UnboundedSolutionException
- org.apache.commons.math.ode.DerivativeException
- org.apache.commons.math.DimensionMismatchException
- org.apache.commons.math.DuplicateSampleAbscissaException
- org.apache.commons.math.estimation.EstimationException
- org.apache.commons.math.ode.events.EventException
- org.apache.commons.math.FunctionEvaluationException
- org.apache.commons.math.ArgumentOutsideDomainException
- org.apache.commons.math.ode.IntegratorException
- org.apache.commons.math.MathConfigurationException (implements java.io.Serializable)
- org.apache.commons.math.geometry.NotARotationMatrixException
- org.apache.commons.math.linear.NotPositiveDefiniteMatrixException
- org.apache.commons.math.linear.NotSymmetricMatrixException
- java.lang.RuntimeException
- java.lang.IllegalArgumentException
- org.apache.commons.math.exception.MathIllegalArgumentException (implements org.apache.commons.math.exception.MathThrowable)
- org.apache.commons.math.exception.MathIllegalNumberException
- org.apache.commons.math.exception.DimensionMismatchException
- org.apache.commons.math.exception.NonMonotonousSequenceException
- org.apache.commons.math.exception.NumberIsTooLargeException
- org.apache.commons.math.exception.NumberIsTooSmallException
- org.apache.commons.math.exception.NotPositiveException
- org.apache.commons.math.exception.NotStrictlyPositiveException
- org.apache.commons.math.exception.OutOfRangeException
- org.apache.commons.math.exception.ZeroException
- org.apache.commons.math.exception.NullArgumentException
- org.apache.commons.math.exception.MathIllegalNumberException
- org.apache.commons.math.exception.MathIllegalArgumentException (implements org.apache.commons.math.exception.MathThrowable)
- java.lang.IllegalStateException
- org.apache.commons.math.exception.MathIllegalStateException (implements org.apache.commons.math.exception.MathThrowable)
- org.apache.commons.math.exception.ConvergenceException
- org.apache.commons.math.exception.MathInternalError
- org.apache.commons.math.exception.NoDataException
- org.apache.commons.math.exception.MathIllegalStateException (implements org.apache.commons.math.exception.MathThrowable)
- org.apache.commons.math.MathRuntimeException (implements org.apache.commons.math.exception.MathThrowable)
- org.apache.commons.math.linear.InvalidMatrixException
- org.apache.commons.math.linear.NonSquareMatrixException
- org.apache.commons.math.linear.SingularMatrixException
- org.apache.commons.math.linear.MatrixIndexException
- org.apache.commons.math.linear.MatrixVisitorException
- org.apache.commons.math.linear.InvalidMatrixException
- java.lang.UnsupportedOperationException
- org.apache.commons.math.exception.MathUnsupportedOperationException (implements org.apache.commons.math.exception.MathThrowable)
- java.lang.IllegalArgumentException
- java.lang.Exception
- org.apache.commons.math.genetics.TournamentSelection (implements org.apache.commons.math.genetics.SelectionPolicy)
- org.apache.commons.math.util.TransformerMap (implements org.apache.commons.math.util.NumberTransformer, java.io.Serializable)
- org.apache.commons.math.analysis.interpolation.TricubicSplineInterpolatingFunction (implements org.apache.commons.math.analysis.TrivariateRealFunction)
- org.apache.commons.math.analysis.interpolation.TricubicSplineInterpolator (implements org.apache.commons.math.analysis.interpolation.TrivariateRealGridInterpolator)
- org.apache.commons.math.stat.inference.TTestImpl (implements org.apache.commons.math.stat.inference.TTest)
- org.apache.commons.math.random.UncorrelatedRandomVectorGenerator (implements org.apache.commons.math.random.RandomVectorGenerator)
- org.apache.commons.math.random.UniformRandomGenerator (implements org.apache.commons.math.random.NormalizedRandomGenerator)
- org.apache.commons.math.random.UnitSphereRandomVectorGenerator (implements org.apache.commons.math.random.RandomVectorGenerator)
- org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactory
- org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactoryImpl
- org.apache.commons.math.analysis.solvers.UnivariateRealSolverUtils
- org.apache.commons.math.random.ValueServer
- org.apache.commons.math.geometry.Vector3D (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.moment.VectorialCovariance (implements java.io.Serializable)
- org.apache.commons.math.stat.descriptive.moment.VectorialMean (implements java.io.Serializable)
- org.apache.commons.math.optimization.VectorialPointValuePair (implements java.io.Serializable)
- org.apache.commons.math.estimation.WeightedMeasurement (implements java.io.Serializable)
- org.apache.commons.math.optimization.fitting.WeightedObservedPoint (implements java.io.Serializable)
- org.apache.commons.math.distribution.AbstractDistribution (implements org.apache.commons.math.distribution.Distribution, java.io.Serializable)
Interface Hierarchy
- org.apache.commons.math.linear.AnyMatrix
- org.apache.commons.math.linear.BigMatrix
- org.apache.commons.math.linear.FieldMatrix<T>
- org.apache.commons.math.linear.RealMatrix
- org.apache.commons.math.linear.SparseRealMatrix
- org.apache.commons.math.analysis.BivariateRealFunction
- org.apache.commons.math.analysis.interpolation.BivariateRealGridInterpolator
- org.apache.commons.math.stat.inference.ChiSquareTest
- org.apache.commons.math.stat.inference.UnknownDistributionChiSquareTest
- org.apache.commons.math.linear.CholeskyDecomposition
- org.apache.commons.math.stat.clustering.Clusterable<T>
- org.apache.commons.math.ConvergingAlgorithm
- org.apache.commons.math.analysis.integration.UnivariateRealIntegrator
- org.apache.commons.math.optimization.UnivariateRealOptimizer
- org.apache.commons.math.analysis.solvers.UnivariateRealSolver
- org.apache.commons.math.genetics.CrossoverPolicy
- org.apache.commons.math.linear.DecompositionSolver
- org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer
- org.apache.commons.math.optimization.DifferentiableMultivariateVectorialOptimizer
- org.apache.commons.math.distribution.Distribution
- org.apache.commons.math.distribution.ContinuousDistribution
- org.apache.commons.math.distribution.BetaDistribution (also extends org.apache.commons.math.distribution.HasDensity<P>)
- org.apache.commons.math.distribution.CauchyDistribution
- org.apache.commons.math.distribution.ChiSquaredDistribution (also extends org.apache.commons.math.distribution.HasDensity<P>)
- org.apache.commons.math.distribution.ExponentialDistribution (also extends org.apache.commons.math.distribution.HasDensity<P>)
- org.apache.commons.math.distribution.FDistribution
- org.apache.commons.math.distribution.GammaDistribution (also extends org.apache.commons.math.distribution.HasDensity<P>)
- org.apache.commons.math.distribution.NormalDistribution (also extends org.apache.commons.math.distribution.HasDensity<P>)
- org.apache.commons.math.distribution.TDistribution
- org.apache.commons.math.distribution.WeibullDistribution
- org.apache.commons.math.distribution.DiscreteDistribution
- org.apache.commons.math.distribution.IntegerDistribution
- org.apache.commons.math.distribution.BinomialDistribution
- org.apache.commons.math.distribution.HypergeometricDistribution
- org.apache.commons.math.distribution.PascalDistribution
- org.apache.commons.math.distribution.PoissonDistribution
- org.apache.commons.math.distribution.ZipfDistribution
- org.apache.commons.math.distribution.IntegerDistribution
- org.apache.commons.math.distribution.ContinuousDistribution
- org.apache.commons.math.util.DoubleArray
- org.apache.commons.math.linear.EigenDecomposition
- org.apache.commons.math.random.EmpiricalDistribution
- org.apache.commons.math.estimation.EstimationProblem
- org.apache.commons.math.estimation.Estimator
- org.apache.commons.math.ode.events.EventHandler
- org.apache.commons.math.ode.jacobians.EventHandlerWithJacobians
- org.apache.commons.math.Field<T>
- org.apache.commons.math.linear.FieldDecompositionSolver<T>
- org.apache.commons.math.FieldElement<T>
- org.apache.commons.math.linear.FieldLUDecomposition<T>
- org.apache.commons.math.linear.FieldMatrixChangingVisitor<T>
- org.apache.commons.math.linear.FieldMatrixPreservingVisitor<T>
- org.apache.commons.math.linear.FieldVector<T>
- org.apache.commons.math.ode.FirstOrderDifferentialEquations
- org.apache.commons.math.ode.ExtendedFirstOrderDifferentialEquations
- org.apache.commons.math.ode.jacobians.ODEWithJacobians
- org.apache.commons.math.ode.jacobians.ParameterizedODE
- org.apache.commons.math.genetics.Fitness
- org.apache.commons.math.ode.sampling.FixedStepHandler
- org.apache.commons.math.distribution.HasDensity<P>
- org.apache.commons.math.distribution.BetaDistribution (also extends org.apache.commons.math.distribution.ContinuousDistribution)
- org.apache.commons.math.distribution.ChiSquaredDistribution (also extends org.apache.commons.math.distribution.ContinuousDistribution)
- org.apache.commons.math.distribution.ExponentialDistribution (also extends org.apache.commons.math.distribution.ContinuousDistribution)
- org.apache.commons.math.distribution.GammaDistribution (also extends org.apache.commons.math.distribution.ContinuousDistribution)
- org.apache.commons.math.distribution.NormalDistribution (also extends org.apache.commons.math.distribution.ContinuousDistribution)
- java.lang.Iterable<T>
- org.apache.commons.math.genetics.Population
- org.apache.commons.math.optimization.linear.LinearOptimizer
- org.apache.commons.math.linear.LUDecomposition
- org.apache.commons.math.exception.MathThrowable
- org.apache.commons.math.stat.regression.MultipleLinearRegression
- org.apache.commons.math.ode.MultistepIntegrator.NordsieckTransformer
- org.apache.commons.math.analysis.MultivariateMatrixFunction
- org.apache.commons.math.analysis.MultivariateRealFunction
- org.apache.commons.math.analysis.DifferentiableMultivariateRealFunction
- org.apache.commons.math.analysis.interpolation.MultivariateRealInterpolator
- org.apache.commons.math.optimization.MultivariateRealOptimizer
- org.apache.commons.math.analysis.MultivariateVectorialFunction
- org.apache.commons.math.analysis.DifferentiableMultivariateVectorialFunction
- org.apache.commons.math.genetics.MutationPolicy
- org.apache.commons.math.random.NormalizedRandomGenerator
- org.apache.commons.math.util.NumberTransformer
- org.apache.commons.math.ode.ODEIntegrator
- org.apache.commons.math.ode.FirstOrderIntegrator
- org.apache.commons.math.ode.SecondOrderIntegrator
- org.apache.commons.math.stat.inference.OneWayAnova
- org.apache.commons.math.optimization.fitting.ParametricRealFunction
- org.apache.commons.math.genetics.PermutationChromosome<T>
- org.apache.commons.math.optimization.general.Preconditioner
- org.apache.commons.math.linear.QRDecomposition
- org.apache.commons.math.random.RandomData
- org.apache.commons.math.random.RandomGenerator
- org.apache.commons.math.random.RandomVectorGenerator
- org.apache.commons.math.stat.ranking.RankingAlgorithm
- org.apache.commons.math.optimization.RealConvergenceChecker
- org.apache.commons.math.linear.RealMatrixChangingVisitor
- org.apache.commons.math.linear.RealMatrixPreservingVisitor
- org.apache.commons.math.transform.RealTransformer
- org.apache.commons.math.linear.RealVector
- org.apache.commons.math.linear.SparseRealVector
- org.apache.commons.math.ode.SecondOrderDifferentialEquations
- org.apache.commons.math.genetics.SelectionPolicy
- java.io.Serializable
- java.io.Externalizable
- org.apache.commons.math.ode.sampling.StepInterpolator
- org.apache.commons.math.ode.jacobians.StepInterpolatorWithJacobians
- org.apache.commons.math.exception.util.Localizable
- java.io.Externalizable
- org.apache.commons.math.linear.SingularValueDecomposition
- org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
- org.apache.commons.math.stat.descriptive.StatisticalSummary
- org.apache.commons.math.ode.sampling.StepHandler
- org.apache.commons.math.ode.jacobians.StepHandlerWithJacobians
- org.apache.commons.math.genetics.StoppingCondition
- org.apache.commons.math.analysis.TrivariateRealFunction
- org.apache.commons.math.analysis.interpolation.TrivariateRealGridInterpolator
- org.apache.commons.math.stat.inference.TTest
- org.apache.commons.math.analysis.UnivariateMatrixFunction
- org.apache.commons.math.analysis.DifferentiableUnivariateMatrixFunction
- org.apache.commons.math.analysis.UnivariateRealFunction
- org.apache.commons.math.analysis.DifferentiableUnivariateRealFunction
- org.apache.commons.math.analysis.interpolation.UnivariateRealInterpolator
- org.apache.commons.math.stat.descriptive.UnivariateStatistic
- org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
- org.apache.commons.math.analysis.UnivariateVectorialFunction
- org.apache.commons.math.analysis.DifferentiableUnivariateVectorialFunction
- org.apache.commons.math.optimization.VectorialConvergenceChecker
- org.apache.commons.math.stat.descriptive.WeightedEvaluation
Enum Hierarchy
- java.lang.Object
- java.lang.Enum<E> (implements java.lang.Comparable<T>, java.io.Serializable)
- org.apache.commons.math.optimization.general.ConjugateGradientFormula
- org.apache.commons.math.dfp.DfpField.RoundingMode
- org.apache.commons.math.optimization.GoalType (implements java.io.Serializable)
- org.apache.commons.math.stat.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
- org.apache.commons.math.exception.util.LocalizedFormats (implements org.apache.commons.math.exception.util.Localizable)
- org.apache.commons.math.util.MathUtils.OrderDirection
- org.apache.commons.math.stat.ranking.NaNStrategy
- org.apache.commons.math.optimization.linear.Relationship
- org.apache.commons.math.stat.descriptive.moment.SemiVariance.Direction
- org.apache.commons.math.stat.ranking.TiesStrategy
- java.lang.Enum<E> (implements java.lang.Comparable<T>, java.io.Serializable)