| Package | Description |
|---|---|
| com.imsl.datamining.neural |
Neural networks.
|
| com.imsl.math |
Mathematical functions and algorithms.
|
| com.imsl.stat |
Statistical methods.
|
| com.imsl.stat.distributions |
Probability distributions and parameter estimation.
|
| com.imsl.test.example.math |
Math examples.
|
| com.imsl.test.example.stat |
Statistics examples.
|
| Class and Description |
|---|
| MinUnconMultiVar.Function
Public interface for the user supplied function to the
MinUnconMultiVar object. |
| MinUnconMultiVar.Gradient
Public interface for the user supplied gradient to the
MinUnconMultiVar object. |
| Class and Description |
|---|
| BoundedLeastSquares.FalseConvergenceException
False convergence - The iterates appear to be converging to a noncritical
point.
|
| BoundedLeastSquares.Function
Public interface for the user-supplied function to evaluate the function
that defines the least-squares problem.
|
| BoundedLeastSquares.Jacobian
Public interface for the user-supplied function to compute the Jacobian.
|
| BoundedVariableLeastSquares.TooManyIterException
Maximum number of iterations exceeded.
|
| BSpline
BSpline represents and evaluates univariate B-splines.
|
| Cholesky.NotSPDException
The matrix is not symmetric, positive definite.
|
| Complex
Set of mathematical functions for complex numbers.
|
| ComplexEigen
Collection of complex Eigen System functions.
|
| ComplexEigen.DidNotConvergeException
The iteration did not converge.
|
| ComplexMatrix.MatrixType
Indicates which matrix type is used.
|
| ComplexSparseCholesky.NotSPDException
The matrix is not Hermitian, positive definite.
|
| ComplexSparseCholesky.NumericFactor
Data structures and functions for the numeric Cholesky factor.
|
| ComplexSparseCholesky.SymbolicFactor
Data structures and functions for the symbolic Cholesky factor.
|
| ComplexSparseMatrix
Sparse matrix of type
Complex. |
| ComplexSparseMatrix.SparseArray
The
SparseArray class uses public fields to hold
the data for a sparse matrix in the Java Sparse Array format. |
| ComplexSVD
Singular Value Decomposition (SVD) of a rectangular matrix of type
Complex. |
| ComplexSVD.DidNotConvergeException
The iteration did not converge
|
| ConjugateGradient.Function
Public interface for the user supplied function to
ConjugateGradient. |
| ConjugateGradient.NoConvergenceException
The conjugate gradient method did not converge within the allowed maximum
number of iterations.
|
| ConjugateGradient.NotDefiniteAMatrixException
The input matrix A is indefinite, that is the matrix is not positive or
negative definite.
|
| ConjugateGradient.NotDefiniteJacobiPreconditionerException
The Jacobi preconditioner is not strictly positive or negative definite.
|
| ConjugateGradient.NotDefinitePreconditionMatrixException
The Precondition matrix is indefinite.
|
| ConjugateGradient.SingularPreconditionMatrixException
The Precondition matrix is singular.
|
| CsShape.TooManyIterationsException
Too many iterations.
|
| DenseLP.AllConstraintsNotSatisfiedException
All constraints are not satisfied.
|
| DenseLP.BoundsInconsistentException
The bounds given are inconsistent.
|
| DenseLP.CyclingOccurringException
The algorithm appears to be cycling.
|
| DenseLP.MultipleSolutionsException
The problem has multiple solutions giving essentially the same
minimum.
|
| DenseLP.NoAcceptablePivotException
No acceptable pivot could be found.
|
| DenseLP.NoConstraintsAvailableException
The LP problem has no constraints.
|
| DenseLP.ProblemUnboundedException
The problem is unbounded.
|
| DenseLP.ProblemVacuousException
The problem is vacuous.
|
| DenseLP.SomeConstraintsDiscardedException
Some constraints were discarded because they were too linearly
dependent on other active constraints.
|
| Eigen.DidNotConvergeException
The iteration did not converge
|
| FeynmanKac.Boundaries
Public interface for user supplied boundary coefficients and terminal condition
the PDE must satisfy.
|
| FeynmanKac.BoundaryInconsistentException
The boundary conditions are inconsistent.
|
| FeynmanKac.ConstraintsInconsistentException
The constraints are inconsistent.
|
| FeynmanKac.CorrectorConvergenceException
Corrector failed to converge.
|
| FeynmanKac.ErrorTestException
Error test failure detected.
|
| FeynmanKac.ForcingTerm
Public interface for non-zero forcing term in the Feynman-Kac equation.
|
| FeynmanKac.InitialConstraintsException
The constraints at the initial point are inconsistent.
|
| FeynmanKac.InitialData
Public interface for adjustment of initial data or as an opportunity
for output during the integration steps.
|
| FeynmanKac.IterationMatrixSingularException
Iteration matrix is singular.
|
| FeynmanKac.PdeCoefficients
Public interface for user supplied PDE coefficients in the Feynman-Kac PDE.
|
| FeynmanKac.TcurrentTstopInconsistentException
The end value for the integration in time, tout, is not consistent with
the current time value, t.
|
| FeynmanKac.TEqualsToutException
The current integration point in time and the end point are equal.
|
| FeynmanKac.TimeIntervalTooSmallException
Distance between starting time point and end point for the integration is
too small.
|
| FeynmanKac.ToleranceTooSmallException
Tolerance is too small.
|
| FeynmanKac.TooManyIterationsException
Too many iterations required by the DAE solver.
|
| GenMinRes.Function
Public interface for the user supplied function to
GenMinRes. |
| GenMinRes.TooManyIterationsException
Maximum number of iterations exceeded.
|
| GenMinRes.VectorProducts
Public interface for the user supplied function to the
GenMinRes object used for the inner
product when the Gram-Schmidt implementation is used. |
| HyperRectangleQuadrature.Function
Public interface function for the HyperRectangleQuadrature class.
|
| LinearProgramming.BoundsInconsistentException
Deprecated.
|
| LinearProgramming.NumericDifficultyException
Deprecated.
|
| LinearProgramming.ProblemInfeasibleException
Deprecated.
|
| LinearProgramming.ProblemUnboundedException
Deprecated.
|
| Matrix.MatrixType
Indicates which matrix type is used.
|
| MinConGenLin.ConstraintsInconsistentException
The equality constraints are inconsistent.
|
| MinConGenLin.ConstraintsNotSatisfiedException
No vector x satisfies all of the constraints.
|
| MinConGenLin.EqualityConstraintsException
the variables are determined by the equality constraints.
|
| MinConGenLin.Function
Public interface for the user-supplied function to evaluate the function to be minimized.
|
| MinConGenLin.VarBoundsInconsistentException
The equality constraints and the bounds on the variables are found to be
inconsistent.
|
| MinConNLP.BadInitialGuessException
Penalty function point infeasible for original problem.
|
| MinConNLP.ConstraintEvaluationException
Constraint evaluation returns an error with current point.
|
| MinConNLP.Function
Public interface for the user supplied function to the
MinConNLP object. |
| MinConNLP.IllConditionedException
Problem is singular or ill-conditioned.
|
| MinConNLP.LimitingAccuracyException
Limiting accuracy reached for a singular problem.
|
| MinConNLP.LinearlyDependentGradientsException
Working set gradients are linearly dependent.
|
| MinConNLP.NoAcceptableStepsizeException
No acceptable stepsize in [SIGMA,SIGLA].
|
| MinConNLP.ObjectiveEvaluationException
Objective evaluation returns an error with current point.
|
| MinConNLP.PenaltyFunctionPointInfeasibleException
Penalty function point infeasible.
|
| MinConNLP.QPInfeasibleException
QP problem seemingly infeasible.
|
| MinConNLP.SingularException
Problem is singular.
|
| MinConNLP.TerminationCriteriaNotSatisfiedException
Termination criteria are not satisfied.
|
| MinConNLP.TooManyIterationsException
Maximum number of iterations exceeded.
|
| MinConNLP.WorkingSetSingularException
Working set is singular in dual extended QP.
|
| MinConNonlin.Function
Deprecated.
MinConNonlin has been replaced by MinConNLP. |
| MinConNonlin.LineSearchException
Deprecated.
MinConNonlin has been replaced by MinConNLP. |
| MinConNonlin.QPConstraintsException
Deprecated.
MinConNonlin has been replaced by MinConNLP. |
| MinConNonlin.TooManyIterationsException
Deprecated.
MinConNonlin has been replaced by MinConNLP. |
| MinConNonlin.UphillSearchCalcException
Deprecated.
MinConNonlin has been replaced by MinConNLP. |
| MinConNonlin.ZeroSearchDirectionException
Deprecated.
MinConNonlin has been replaced by MinConNLP. |
| MinUncon.Function
Public interface for the user supplied function to the
MinUncon object. |
| MinUnconMultiVar.FalseConvergenceException
False convergence error; the iterates appear to be converging to a
noncritical point.
|
| MinUnconMultiVar.Function
Public interface for the user supplied function to the
MinUnconMultiVar object. |
| MinUnconMultiVar.Gradient
Public interface for the user supplied gradient to the
MinUnconMultiVar object. |
| MinUnconMultiVar.MaxIterationsException
Maximum number of iterations exceeded.
|
| MinUnconMultiVar.UnboundedBelowException
Five consecutive steps of the maximum allowable stepsize have been taken,
either the function is unbounded below, or has a finite asymptote in some
direction or the maximum allowable step size is too small.
|
| NelderMead.Function
Public interface for the user-supplied function to evaluate the objective
function of the minimization problem.
|
| NonlinLeastSquares.Function
Public interface for the user supplied function to the
NonlinLeastSquares object. |
| NonlinLeastSquares.TooManyIterationsException
Too many iterations.
|
| NonNegativeLeastSquares.TooManyIterException
Maximum number of iterations has been exceeded.
|
| NonNegativeLeastSquares.TooMuchTimeException
Maximum time allowed for solve is exceeded.
|
| NumericalDerivatives.Function
Public interface function.
|
| ODE
ODE represents and solves an initial-value problem for ordinary differential
equations.
|
| OdeAdamsGear.DidNotConvergeException
The iteration did not converge within the maximum number of steps allowed (default 500).
|
| OdeAdamsGear.Function
Public interface for user supplied function to
OdeAdamsGear object. |
| OdeAdamsGear.MaxFcnEvalsExceededException
Maximum function evaluations exceeded.
|
| OdeAdamsGear.SingularMatrixException
The interpolation matrix is singular.
|
| OdeAdamsGear.ToleranceTooSmallException
Tolerance is too small or the problem is stiff.
|
| OdeRungeKutta.DidNotConvergeException
The iteration did not converge within the maximum number of steps allowed (default 500).
|
| OdeRungeKutta.Function
Public interface for user supplied function to
OdeRungeKutta object. |
| OdeRungeKutta.ToleranceTooSmallException
Tolerance is too small or the problem is stiff.
|
| Physical
Return the value of various mathematical and physical constants.
|
| PrintMatrix
Matrix printing utilities.
|
| PrintMatrixFormat
This class can be used to customize the actions of PrintMatrix.
|
| QuadraticProgramming.InconsistentSystemException
The system of constraints is inconsistent.
|
| QuadraticProgramming.NoLPSolutionException
No solution for the LP problem with h = 0 was found by
DenseLP. |
| QuadraticProgramming.ProblemUnboundedException
The objective value for the problem is unbounded.
|
| QuadraticProgramming.SolutionNotFoundException
A solution was not found.
|
| Quadrature.Function
Public interface function for the Quadrature class.
|
| RadialBasis.Function
Public interface for the user supplied function to the
RadialBasis
object. |
| SingularMatrixException
The matrix is singular.
|
| SparseCholesky.NotSPDException
The matrix is not symmetric, positive definite.
|
| SparseCholesky.NumericFactor
The numeric Cholesky factorization of a matrix.
|
| SparseCholesky.SymbolicFactor
The symbolic Cholesky factorization of a matrix.
|
| SparseLP.CholeskyFactorizationAccuracyException
The Cholesky factorization failed because of accuracy problems.
|
| SparseLP.DiagonalWeightMatrixException
A diagonal element of the diagonal weight matrix is too small.
|
| SparseLP.DualInfeasibleException
The dual problem is infeasible.
|
| SparseLP.IllegalBoundsException
The lower bound is greater than the upper bound.
|
| SparseLP.IncorrectlyActiveException
One or more LP variables are falsely characterized by the internal
presolver.
|
| SparseLP.IncorrectlyEliminatedException
One or more LP variables are falsely characterized by the internal
presolver.
|
| SparseLP.InitialSolutionInfeasibleException
The initial solution for the one-row linear program is infeasible.
|
| SparseLP.PrimalInfeasibleException
The primal problem is infeasible.
|
| SparseLP.PrimalUnboundedException
The primal problem is unbounded.
|
| SparseLP.ProblemUnboundedException
The problem is unbounded.
|
| SparseLP.TooManyIterationsException
The maximum number of iterations has been exceeded.
|
| SparseLP.ZeroColumnException
A column of the constraint matrix has no entries.
|
| SparseLP.ZeroRowException
A row of the constraint matrix has no entries.
|
| SparseMatrix
Sparse matrix of type
double. |
| SparseMatrix.SparseArray
The
SparseArray class uses public fields to hold
the data for a sparse matrix in the Java Sparse Array format. |
| Spline
Spline represents and evaluates univariate piecewise polynomial splines.
|
| Spline2D
Represents and evaluates tensor-product splines.
|
| SVD.DidNotConvergeException
The iteration did not converge
|
| ZeroFunction.Function
Deprecated.
ZeroFunction has been replaced by ZerosFunction. |
| ZeroPolynomial.DidNotConvergeException
The iteration did not converge
|
| ZerosFunction.Function
Public interface for the user supplied function to
ZerosFunction. |
| ZeroSystem.DidNotConvergeException
The iteration did not converge.
|
| ZeroSystem.Function
Public interface for user supplied function to
ZeroSystem
object. |
| ZeroSystem.ToleranceTooSmallException
Tolerance too small
|
| ZeroSystem.TooManyIterationsException
Too many iterations.
|
| Class and Description |
|---|
| Cholesky
Cholesky factorization of a matrix of type
double. |
| Cholesky.NotSPDException
The matrix is not symmetric, positive definite.
|
| SingularMatrixException
The matrix is singular.
|
| SVD.DidNotConvergeException
The iteration did not converge
|
| ZeroPolynomial.DidNotConvergeException
The iteration did not converge
|
| Class and Description |
|---|
| MinConNLP.BadInitialGuessException
Penalty function point infeasible for original problem.
|
| MinConNLP.ConstraintEvaluationException
Constraint evaluation returns an error with current point.
|
| MinConNLP.IllConditionedException
Problem is singular or ill-conditioned.
|
| MinConNLP.LimitingAccuracyException
Limiting accuracy reached for a singular problem.
|
| MinConNLP.LinearlyDependentGradientsException
Working set gradients are linearly dependent.
|
| MinConNLP.NoAcceptableStepsizeException
No acceptable stepsize in [SIGMA,SIGLA].
|
| MinConNLP.ObjectiveEvaluationException
Objective evaluation returns an error with current point.
|
| MinConNLP.PenaltyFunctionPointInfeasibleException
Penalty function point infeasible.
|
| MinConNLP.QPInfeasibleException
QP problem seemingly infeasible.
|
| MinConNLP.SingularException
Problem is singular.
|
| MinConNLP.TerminationCriteriaNotSatisfiedException
Termination criteria are not satisfied.
|
| MinConNLP.TooManyIterationsException
Maximum number of iterations exceeded.
|
| MinConNLP.WorkingSetSingularException
Working set is singular in dual extended QP.
|
| SingularMatrixException
The matrix is singular.
|
| Class and Description |
|---|
| ComplexEigen.DidNotConvergeException
The iteration did not converge.
|
| ComplexSVD.DidNotConvergeException
The iteration did not converge
|
| ConjugateGradient.Function
Public interface for the user supplied function to
ConjugateGradient. |
| ConjugateGradient.Preconditioner
Public interface for the user supplied function to
ConjugateGradient used for preconditioning. |
| Eigen.DidNotConvergeException
The iteration did not converge
|
| GenMinRes.Function
Public interface for the user supplied function to
GenMinRes. |
| GenMinRes.Norm
Public interface for the user supplied function to the
GenMinRes object used for the norm \( \Vert X \Vert \)
when the Gram-Schmidt implementation is used. |
| GenMinRes.Preconditioner
Public interface for the user supplied function to
GenMinRes used for preconditioning. |
| GenMinRes.VectorProducts
Public interface for the user supplied function to the
GenMinRes object used for the inner
product when the Gram-Schmidt implementation is used. |
| MinConNLP.Function
Public interface for the user supplied function to the
MinConNLP object. |
| MinConNLP.Gradient
Public interface for the user supplied function to compute the gradient for
MinConNLP object. |
| MinUncon.Derivative
Public interface for the user supplied function to the
MinUncon object. |
| MinUncon.Function
Public interface for the user supplied function to the
MinUncon object. |
| NonlinLeastSquares.TooManyIterationsException
Too many iterations.
|
| NumericalDerivatives
Compute the Jacobian matrix for a function \(f(y)\) with
m components in n independent variables.
|
| NumericalDerivatives.Function
Public interface function.
|
| PrintMatrixFormat
This class can be used to customize the actions of PrintMatrix.
|
| RadialBasis.Function
Public interface for the user supplied function to the
RadialBasis
object. |
| SingularMatrixException
The matrix is singular.
|
| SparseCholesky.NotSPDException
The matrix is not symmetric, positive definite.
|
| SVD.DidNotConvergeException
The iteration did not converge
|
| ZeroPolynomial.DidNotConvergeException
The iteration did not converge
|
| Class and Description |
|---|
| MinUnconMultiVar.Function
Public interface for the user supplied function to the
MinUnconMultiVar object. |
Copyright © 2020 Rogue Wave Software. All rights reserved.