Serialized Form

  • Package com.imsl

  • Package com.imsl.datamining

    • Class com.imsl.datamining.Apriori

      class Apriori extends Object implements Serializable
      serialVersionUID:
      6808756555725969696L
    • Class com.imsl.datamining.AssociationRule

      class AssociationRule extends Object implements Serializable
      serialVersionUID:
      6415075807613839556L
      • Serialized Fields

        • confidence
          double confidence
        • lift
          double lift
        • support
          int[] support
        • x
          int[] x
        • y
          int[] y
    • Class com.imsl.datamining.BootstrapAggregation

      class BootstrapAggregation extends Object implements Serializable
      serialVersionUID:
      7851450174088634307L
      • Serialized Fields

        • baggedPredictions
          double[] baggedPredictions
        • calculateVariableImportance
          boolean calculateVariableImportance
        • CPUs
          int CPUs
        • meanErrorMeasure
          double meanErrorMeasure
        • nCols
          int nCols
        • needsAggregation
          boolean needsAggregation
        • nPreds
          int nPreds
        • nRows
          int nRows
        • numberOfBootstrapSamples
          int numberOfBootstrapSamples
        • oobMeanErrorMeasure
          double oobMeanErrorMeasure
        • outOfBagPredictions
          double[] outOfBagPredictions
        • pc
          PredictiveModel pc
        • printLevel
          int printLevel
        • priorProbabilities
          double[] priorProbabilities
        • r
          Random r
        • sumDiff
          double[] sumDiff
        • sumSquaredDiff
          double[] sumSquaredDiff
        • testData
          double[][] testData
        • testDataWeights
          double[] testDataWeights
        • variableImportance
          double[] variableImportance
        • weights
          double[] weights
        • xy
          double[][] xy
    • Class com.imsl.datamining.CrossValidation

      class CrossValidation extends Object implements Serializable
      serialVersionUID:
      -6253667742905352073L
      • Serialized Fields

        • costMatrix
          double[][] costMatrix
        • CPUs
          int CPUs
        • doStratification
          boolean doStratification
        • Lossv
          double[][] Lossv
        • maxmink
          int maxmink
        • minCVerr
          double minCVerr
        • mink
          int mink
        • needsCrossValidation
          boolean needsCrossValidation
        • numberOfModels
          int numberOfModels
        • numberOfSampleFolds
          int numberOfSampleFolds
        • pc
          PredictiveModel pc
        • priorProbabilities
          double[] priorProbabilities
        • r
          Random r
        • Rcvk
          double[] Rcvk
        • responseIdx
          int responseIdx
        • SERcv
          double[] SERcv
        • wts
          double[] wts
        • xy
          double[][] xy
    • Class com.imsl.datamining.GradientBoosting

      class GradientBoosting extends PredictiveModel implements Serializable
      serialVersionUID:
      -6690486379148606339L
      • Serialized Fields

        • baseLearnerModel
          PredictiveModel baseLearnerModel
        • fittedValues
          double[] fittedValues
        • gammasList
          ArrayList<double[]> gammasList
        • gammasListMNL
          ArrayList<double[][]> gammasListMNL
        • HuberAlpha
          double[] HuberAlpha
        • HuberDeltas
          double[] HuberDeltas
        • initialValue
          double initialValue
        • iterationsArray
          int[] iterationsArray
        • lossType
          GradientBoosting.LossFunctionType lossType
        • lossValue
          double lossValue
        • M
          int M
        • missingTestY
          boolean missingTestY
        • mnlFittedValues
          double[][] mnlFittedValues
        • mnlY
          double[][] mnlY
        • sampleSize
          int sampleSize
        • sampleSizeProportion
          double sampleSizeProportion
        • saveTrees
          boolean saveTrees
        • shrinkage
          double shrinkage
        • testFittedValues
          double[] testFittedValues
        • testLossValue
          double testLossValue
        • testMnlFittedValues
          double[][] testMnlFittedValues
        • tol
          double tol
        • treeList
          ArrayList<Tree> treeList
    • Class com.imsl.datamining.GradientBoostingModelObject

      class GradientBoostingModelObject extends Object implements Serializable
      serialVersionUID:
      -4826192458314973388L
      • Serialized Fields

        • classProbabilities
          double[][] classProbabilities
        • gammasList
          ArrayList<double[]> gammasList
        • gammasListMNL
          ArrayList<double[][]> gammasListMNL
        • HuberDeltas
          double[] HuberDeltas
        • initialValue
          double initialValue
        • lossType
          GradientBoosting.LossFunctionType lossType
        • M
          int M
        • missingTestY
          boolean missingTestY
        • nClasses
          int nClasses
        • nCols
          int nCols
        • printLevel
          int printLevel
        • responseColIdx
          int responseColIdx
        • responseVarType
          PredictiveModel.VariableType responseVarType
        • shrinkage
          double shrinkage
        • testFittedValues
          double[] testFittedValues
        • testLossValue
          double testLossValue
        • testMnlFittedValues
          double[][] testMnlFittedValues
        • tol
          double tol
        • treeList
          ArrayList<Tree> treeList
    • Class com.imsl.datamining.Itemsets

      class Itemsets extends Object implements Serializable
      serialVersionUID:
      4091817323806302529L
      • Serialized Fields

        • is
          com.imsl.datamining.Itemset[] is
        • maxNumProducts
          int maxNumProducts
        • maxSetSize
          int maxSetSize
        • nTrx
          int nTrx
        • support
          double support
    • Class com.imsl.datamining.KohonenSOM

      class KohonenSOM extends Object implements Serializable
      serialVersionUID:
      6525536908856334263L
      • Serialized Fields

        • dim
          int dim
        • grid
          com.imsl.datamining.KohonenSOM.KohonenNode[][] grid
        • isHexagonalGrid
          boolean isHexagonalGrid
        • isWrapped
          boolean isWrapped
        • ncol
          int ncol
        • neighborhoodType
          int neighborhoodType
        • nrow
          int nrow
    • Class com.imsl.datamining.KohonenSOMTrainer

      class KohonenSOMTrainer extends Object implements Serializable
      serialVersionUID:
      -6794241692905183710L
      • Serialized Fields

        • CPUs
          int CPUs
        • iterations
          int iterations
        • kohonen
          KohonenSOM kohonen
    • Class com.imsl.datamining.LogisticRegression

      class LogisticRegression extends PredictiveModel implements Serializable
      serialVersionUID:
      -6690486379148606339L
      • Serialized Fields

        • coefficients
          double[] coefficients
        • confidenceIntervals
          double[][] confidenceIntervals
        • confidenceLevel
          double confidenceLevel
        • fittedValues
          double[] fittedValues
        • freqs
          double[] freqs
        • gradient
          double[] gradient
        • hessMatrix
          double[][] hessMatrix
        • indicatorIndex
          int indicatorIndex
        • initialLogLikelihood
          double initialLogLikelihood
        • logLikelihood
          double logLikelihood
        • lrstat
          double[] lrstat
        • meany
          double[] meany
        • numberOfClasses
          int numberOfClasses
        • numberOfCoefficients
          int numberOfCoefficients
        • numberOfInteractions
          int numberOfInteractions
        • numberOfObservations
          int numberOfObservations
        • numberOfPredictors
          int numberOfPredictors
        • predictorIndex
          int[] predictorIndex
        • responseColumnIndex
          int responseColumnIndex
        • standardErrors
          double[] standardErrors
        • tolerance
          double tolerance
        • userStartingCoefficients
          boolean userStartingCoefficients
        • xInteractionsIndex
          int[] xInteractionsIndex
        • xt
          double[][] xt
        • yt
          double[][] yt
    • Class com.imsl.datamining.LogisticRegressionModelObject

      class LogisticRegressionModelObject extends Object implements Serializable
      serialVersionUID:
      -4826192458314973388L
      • Serialized Fields

        • coefficients
          double[] coefficients
        • confidenceIntervals
          double[][] confidenceIntervals
        • confidenceLevel
          double confidenceLevel
        • gradient
          double[] gradient
        • hessian
          double[][] hessian
        • indicatorIntercept
          int indicatorIntercept
        • logLikelihood
          double logLikelihood
        • meany
          double[] meany
        • missingTestY
          boolean missingTestY
        • nCols
          int nCols
        • numberOfClasses
          int numberOfClasses
        • numberOfCoefficients
          int numberOfCoefficients
        • numberOfObservations
          int numberOfObservations
        • numberOfPredictors
          int numberOfPredictors
        • numberOfUpdates
          int numberOfUpdates
        • nXinteractions
          int nXinteractions
        • predictorIndex
          int[] predictorIndex
        • printLevel
          int printLevel
        • responseColIdx
          int responseColIdx
        • responseVarType
          PredictiveModel.VariableType responseVarType
        • standardErrors
          double[] standardErrors
        • tol
          double tol
        • xInteractions
          int[] xInteractions
    • Class com.imsl.datamining.NaiveBayesClassifier

      class NaiveBayesClassifier extends Object implements Serializable
      serialVersionUID:
      -2908897292221295491L
      • Serialized Fields

        • avg
          double[][] avg
        • clambda
          double clambda
        • classError
          double[] classError
        • classErrorsTable
          int[][] classErrorsTable
        • conditionalClassProb
          double[][][] conditionalClassProb
        • continuousInputs
          ArrayList<com.imsl.datamining.NaiveBayesClassifier.ContinuousAttribute> continuousInputs
        • dlambda
          double dlambda
        • ignoreMissingValues
          boolean ignoreMissingValues
        • keyMessage
          String keyMessage
        • log
          boolean log
        • logger
          Logger logger
        • nameClass
          String nameClass
        • nameMethod
          String nameMethod
        • nClasses
          int nClasses
        • nContinuous
          int nContinuous
        • nMissingTarget
          int[] nMissingTarget
        • nNominal
          int nNominal
        • nominalInputs
          ArrayList<com.imsl.datamining.NaiveBayesClassifier.NominalAttribute> nominalInputs
        • predictedClass
          int[] predictedClass
        • predictedClassProb
          double[][] predictedClassProb
        • stdev
          double[][] stdev
        • targetClassProb
          double[] targetClassProb
        • trainFirst
          boolean trainFirst
        • zeroCorrection
          double zeroCorrection
    • Class com.imsl.datamining.PredictiveModel

      class PredictiveModel extends Object implements Serializable
      serialVersionUID:
      -6946439007331089588L
      • Serialized Fields

        • classCounts
          double[] classCounts
        • classProbabilities
          double[][] classProbabilities
        • constantSeries
          boolean constantSeries
        • costMatrix
          double[][] costMatrix
        • isUserFixedNClasses
          boolean isUserFixedNClasses
        • labels
          String[] labels
        • maxIterations
          int maxIterations
        • maxNumberOfCategories
          int maxNumberOfCategories
        • modelId
          int modelId
        • mustFitModel
          boolean mustFitModel
        • nClasses
          int nClasses
        • nCols
          int nCols
        • nRows
          int nRows
        • numberOfModelVariations
          int numberOfModelVariations
        • numberOfPredictors
          int numberOfPredictors
        • nyMissing
          int nyMissing
        • predIdx
          int[] predIdx
        • predNumberOfValues
          int[] predNumberOfValues
        • predType
          PredictiveModel.VariableType[] predType
        • printLevel
          int printLevel
        • priorProbabilities
          double[] priorProbabilities
        • r
          Random r
        • responseColumnIndex
          int responseColumnIndex
        • responseVariableAverage
          double responseVariableAverage
        • responseVariableMaxClass
          int responseVariableMaxClass
        • responseVariableType
          PredictiveModel.VariableType responseVariableType
        • totalWeight
          double totalWeight
        • varType
          PredictiveModel.VariableType[] varType
        • weights
          double[] weights
        • x
          double[][] x
        • xy
          double[][] xy
        • y
          double[][] y
    • Exception com.imsl.datamining.PredictiveModel.CloneNotSupportedException

      class CloneNotSupportedException extends PredictiveModel.PredictiveModelException implements Serializable
      serialVersionUID:
      8198804095076540217L
    • Exception com.imsl.datamining.PredictiveModel.PredictiveModelException

      class PredictiveModelException extends IMSLException implements Serializable
      serialVersionUID:
      2408889980121048726L
    • Exception com.imsl.datamining.PredictiveModel.StateChangeException

      class StateChangeException extends PredictiveModel.PredictiveModelException implements Serializable
      serialVersionUID:
      -3389411923033832280L
    • Exception com.imsl.datamining.PredictiveModel.SumOfProbabilitiesNotOneException

      class SumOfProbabilitiesNotOneException extends PredictiveModel.PredictiveModelException implements Serializable
      serialVersionUID:
      1373536214132845305L
    • Class com.imsl.datamining.PrefixSpan

      class PrefixSpan extends Object implements Serializable
      serialVersionUID:
      6690486379148606339L
      • Serialized Fields

        • encodeItemIdsMap
          Map<Integer,Integer> encodeItemIdsMap
        • freqSeqDB
          SequenceDatabase freqSeqDB
        • freqSeqLevels
          com.imsl.datamining.PrefixSpan.SequenceLevels[] freqSeqLevels
        • maxNumberOfLevels
          int maxNumberOfLevels
        • maxNumberOfSequences
          int maxNumberOfSequences
        • maxSequenceLength
          int maxSequenceLength
        • minSupport
          int minSupport
        • printLevel
          int printLevel
        • revEncodeItemIdsMap
          Map<Integer,Integer> revEncodeItemIdsMap
        • seqDB
          SequenceDatabase seqDB
        • totalNumberOfFreqSequences
          int totalNumberOfFreqSequences
        • totalNumberOfLevels
          int totalNumberOfLevels
    • Class com.imsl.datamining.SequenceDatabase

      class SequenceDatabase extends Object implements Serializable
      serialVersionUID:
      237456351899434253L
      • Serialized Fields

        • dataLength
          int dataLength
        • numCustomers
          int numCustomers
        • numItems
          int numItems
        • numOrigSequences
          int numOrigSequences
        • numSequences
          int numSequences
        • printLevel
          int printLevel
        • sequenceData
          int[] sequenceData
        • support
          int[] support
  • Package com.imsl.datamining.decisionTree

  • Package com.imsl.datamining.neural

  • Package com.imsl.datamining.supportvectormachine

  • Package com.imsl.io

    • Exception com.imsl.io.AbstractFlatFile.FlatFileSQLException

      class FlatFileSQLException extends SQLException implements Serializable
      serialVersionUID:
      3195993761748901492L
    • Exception com.imsl.io.AbstractFlatFile.FlatFileSQLFeatureNotSupportedException

      class FlatFileSQLFeatureNotSupportedException extends SQLFeatureNotSupportedException implements Serializable
      serialVersionUID:
      -1958851473136522309L
    • Class com.imsl.io.MPSReader

      class MPSReader extends Object implements Serializable
      serialVersionUID:
      3687395835320383406L
      • Serialized Fields

        • boundsLower
          double[] boundsLower
          The lower bounds on the variables.
        • boundsUpper
          double[] boundsUpper
          The upper bounds on the variables.
        • integerVariables
          Set<Integer> integerVariables
          Set of integer variables.
        • listRows
          List<MPSReader.Row> listRows
          Ordered list of constraint rows
        • mapConstraintRow
          Map<com.imsl.io.MPSReader.CIString,MPSReader.Row> mapConstraintRow
          Map of (nameRow, Row) pairs
        • name
          String name
          Problem name
        • nameBounds
          com.imsl.io.MPSReader.CIString nameBounds
          Name of BOUNDS set to use. If not set by user, default to first in file.
        • nameListVariables
          com.imsl.io.MPSReader.NameList nameListVariables
          Names of the variables (column names).
        • nameObjective
          com.imsl.io.MPSReader.CIString nameObjective
          Name of the free row that is the objective row. If not set by user, default to first free row in file.
        • nameRanges
          com.imsl.io.MPSReader.CIString nameRanges
          Name of RANGES set to use. If not set by user, default to first in file.
        • nameRHS
          com.imsl.io.MPSReader.CIString nameRHS
          Name of RHS set to use. If not set by user, default to first in file.
        • nNonZeros
          int nNonZeros
          Number of non-zeros in the constraint matrix.
        • nVariables
          int nVariables
          Number of variables. This is also the number of columns.
        • objective
          MPSReader.Row objective
          The free row that is the objective.
        • setNameFreeRows
          Set<com.imsl.io.MPSReader.CIString> setNameFreeRows
          Set of names of free rows, not including the objective row.
    • Class com.imsl.io.MPSReader.Element

      class Element extends Object implements Serializable
      serialVersionUID:
      -5615049643952600388L
      • Serialized Fields

        • columnIndex
          int columnIndex
        • value
          double value
    • Exception com.imsl.io.MPSReader.InvalidMPSFileException

      class InvalidMPSFileException extends IMSLException implements Serializable
      serialVersionUID:
      8130351817245044904L
    • Class com.imsl.io.MPSReader.Row

      class Row extends Object implements Serializable
      serialVersionUID:
      1551916309678021439L
      • Serialized Fields

        • column
          List<MPSReader.Element> column
        • lowerRange
          double lowerRange
        • name
          com.imsl.io.MPSReader.CIString name
        • type
          int type
        • upperRange
          double upperRange
  • Package com.imsl.math

    • Class com.imsl.math.BoundedLeastSquares

      class BoundedLeastSquares extends Object implements Serializable
      serialVersionUID:
      -5119660262387612903L
      • Serialized Fields

        • afcn_tol
          double afcn_tol
        • aftol
          double aftol
        • CPUs
          int CPUs
        • deltap
          double[] deltap
        • errorCode
          int errorCode
        • falstl
          double falstl
        • fpnrmp
          double[] fpnrmp
        • gnleng
          double[] gnleng
        • grad_tol
          double grad_tol
        • gradtl
          double gradtl
        • iscale
          int iscale
        • l_fjac
          double[] l_fjac
        • l_fscale
          double[] l_fscale
        • l_fvec
          double[] l_fvec
        • l_ibtype
          int l_ibtype
        • l_m
          int l_m
        • l_n
          int l_n
        • l_xguess
          double[] l_xguess
        • l_xlb
          double[] l_xlb
        • l_xscale
          double[] l_xscale
        • l_xub
          double[] l_xub
        • lv_value
          double[] lv_value
        • max_step
          double max_step
        • maxfcn
          int maxfcn
        • maxfcnsf
          int maxfcnsf
        • maxitn
          int maxitn
        • maxjac
          int maxjac
        • maxjacobian
          int maxjacobian
        • mxiter
          int mxiter
        • ndigit
          int ndigit
        • nmaxs
          int[] nmaxs
        • nsing7
          int[] nsing7
        • phi
          double[] phi
        • phip
          double[] phip
        • phipi
          double[] phipi
        • rfcn_tol
          double rfcn_tol
        • rftol
          double rftol
        • sgnorm
          double[] sgnorm
        • step_tol
          double step_tol
        • steptl
          double steptl
        • trust_region
          double trust_region
        • user_fjac
          int user_fjac
        • user_fscale
          int user_fscale
        • user_jacobian
          int user_jacobian
        • user_xguess
          int user_xguess
        • user_xscale
          int user_xscale
    • Exception com.imsl.math.BoundedLeastSquares.FalseConvergenceException

      class FalseConvergenceException extends IMSLException implements Serializable
      serialVersionUID:
      9109987067770982906L
    • Class com.imsl.math.BoundedVariableLeastSquares

      class BoundedVariableLeastSquares extends Object implements Serializable
      serialVersionUID:
      4526516719725138726L
      • Serialized Fields

        • A
          double[][] A
        • ALPHA
          double ALPHA
        • B
          double[] B
        • BND
          double[][] BND
        • EPS
          double EPS
        • FIND
          boolean FIND
        • FREE
          boolean FREE
        • HITBND
          boolean HITBND
        • I
          int I
        • IBOUND
          int IBOUND
        • INDEX
          int[] INDEX
        • ITER
          int ITER
        • ITMAX
          int ITMAX
        • IZ
          int IZ
        • IZ1
          int IZ1
        • IZ2
          int IZ2
        • J
          int J
        • JJ
          int JJ
        • LBOUND
          int LBOUND
        • M
          int M
        • N
          int N
        • NPP1
          int NPP1
        • NSETP
          int NSETP
        • RNORM
          double RNORM
        • UP
          double UP
        • W
          double[] W
        • X
          double[] X
        • Z
          double[] Z
    • Exception com.imsl.math.BoundedVariableLeastSquares.TooManyIterException

      class TooManyIterException extends IMSLException implements Serializable
      serialVersionUID:
      -8749211180982347209L
    • Class com.imsl.math.BsInterpolate

      class BsInterpolate extends BSpline implements Serializable
      serialVersionUID:
      6875183274271772797L
    • Class com.imsl.math.BsLeastSquares

      class BsLeastSquares extends BSpline implements Serializable
      serialVersionUID:
      5058715506371854268L
      • Serialized Fields

        • nCoef
          int nCoef
          Number of B-spline coefficients.
        • weight
          double[] weight
          The weight array of length n, where n is the number of data points fit.
    • Class com.imsl.math.BSpline

      class BSpline extends Object implements Serializable
      serialVersionUID:
      5960165067553912440L
      • Serialized Fields

        • coef
          double[] coef
          The B-spline coefficient array.
        • knot
          double[] knot
          The knot array of length n + order, where n is the number of coefficients in the B-spline.
        • order
          int order
          Order of the spline.
    • Class com.imsl.math.Cholesky

      class Cholesky extends Object implements Serializable
      serialVersionUID:
      3911102039921011790L
      • Serialized Fields

        • factor
          double[][] factor
    • Exception com.imsl.math.Cholesky.NotSPDException

      class NotSPDException extends IMSLException implements Serializable
      serialVersionUID:
      -8958806756350122436L
    • Class com.imsl.math.Complex

      class Complex extends Number implements Serializable
      serialVersionUID:
      -633126172485117692L
      • Serialized Fields

        • im
          double im
          Imaginary part of the Complex.
        • re
          double re
          Real part of the Complex.
    • Class com.imsl.math.ComplexEigen

      class ComplexEigen extends Object implements Serializable
      serialVersionUID:
      -5001225270878554207L
      • Serialized Fields

        • a
          Complex[][] a
        • aImag
          double[] aImag
        • aReal
          double[] aReal
        • eigvalsImag
          double[] eigvalsImag
        • eigvalsReal
          double[] eigvalsReal
        • isSolved
          boolean isSolved
        • maximumIterations
          int maximumIterations
        • maxIterationsUserDefined
          boolean maxIterationsUserDefined
        • n
          int n
        • vectorsComputed
          boolean vectorsComputed
        • vrImag
          double[] vrImag
        • vrReal
          double[] vrReal
    • Exception com.imsl.math.ComplexEigen.DidNotConvergeException

      class DidNotConvergeException extends IMSLException implements Serializable
      serialVersionUID:
      8159922336404708480L
    • Class com.imsl.math.ComplexFFT

      class ComplexFFT extends Object implements Serializable
      serialVersionUID:
      6698415881930115764L
      • Serialized Fields

        • fac
          int[] fac
        • wa
          double[] wa
    • Class com.imsl.math.ComplexLU

      class ComplexLU extends Object implements Serializable
      serialVersionUID:
      7020680933234316977L
      • Serialized Fields

        • factor
          Complex[][] factor
          This is an n by n Complex matrix containing the LU factorization of the matrix A.
        • ipvt
          int[] ipvt
          Vector of length n containing the pivot sequence for the factorization.
    • Class com.imsl.math.ComplexSparseCholesky

      class ComplexSparseCholesky extends Object implements Serializable
      serialVersionUID:
      -8231160543440412420L
      • Serialized Fields

        • CSC_col_ptr
          int[] CSC_col_ptr
        • CSC_format
          int CSC_format
        • CSC_row_ind
          int[] CSC_row_ind
        • l_alnz
          Complex[] l_alnz
        • l_diag
          Complex[] l_diag
        • l_flag
          int[] l_flag
        • l_invp
          int[] l_invp
        • l_largest_diag
          double l_largest_diag
        • l_maxlnz
          int[] l_maxlnz
        • l_maxsub
          int[] l_maxsub
        • l_multifrontal_space
          int[] l_multifrontal_space
        • l_num_factor_nonzeros
          int l_num_factor_nonzeros
        • l_nzsub
          int[] l_nzsub
        • l_perm
          int[] l_perm
        • l_smallest_diag
          double l_smallest_diag
        • l_solution
          Complex[] l_solution
        • l_xlnz
          int[] l_xlnz
        • l_xnzsub
          int[] l_xnzsub
        • multifrontal
          int multifrontal
        • nNonzeros
          int nNonzeros
        • nRows
          int nRows
        • rhs
          Complex[] rhs
        • runNumericFactor
          boolean runNumericFactor
        • runSymbolicFactor
          boolean runSymbolicFactor
        • solve_only
          boolean solve_only
        • sparseMatrixA
          com.imsl.math.ComplexSparseCholeskyMatrix sparseMatrixA
        • supply_numeric_factor
          boolean supply_numeric_factor
        • supply_symbolic_factor
          boolean supply_symbolic_factor
    • Exception com.imsl.math.ComplexSparseCholesky.NotSPDException

      class NotSPDException extends IMSLException implements Serializable
      serialVersionUID:
      -8958806756350122436L
    • Class com.imsl.math.ComplexSparseCholesky.NumericFactor

      class NumericFactor extends Object implements Serializable
      serialVersionUID:
      -8982196143468680036L
      • Serialized Fields

        • alnz
          Complex[] alnz
        • diag
          Complex[] diag
        • nzsub
          int[] nzsub
        • perm
          int[] perm
        • xlnz
          int[] xlnz
        • xnzsub
          int[] xnzsub
    • Class com.imsl.math.ComplexSparseCholesky.SymbolicFactor

      class SymbolicFactor extends Object implements Serializable
      serialVersionUID:
      -2515460315704131562L
      • Serialized Fields

        • flag
          int flag
        • invp
          int[] invp
        • maxlnz
          int[] maxlnz
        • maxsub
          int[] maxsub
        • multifrontal_space
          int[] multifrontal_space
        • nzsub
          int[] nzsub
        • perm
          int[] perm
        • xlnz
          int[] xlnz
        • xnzsub
          int[] xnzsub
    • Class com.imsl.math.ComplexSparseMatrix

      class ComplexSparseMatrix extends Object implements Serializable
      serialVersionUID:
      4129725520868670733L
      • Serialized Fields

        • nColumns
          int nColumns
        • nRows
          int nRows
        • numberOfNonZeros
          long numberOfNonZeros
        • row
          com.imsl.math.ComplexSparseMatrix.Row[] row
    • Class com.imsl.math.ComplexSparseMatrix.SparseArray

      class SparseArray extends Object implements Serializable
      serialVersionUID:
      359354659983249941L
      • Serialized Fields

        • index
          int[][] index
          Jagged array containing column indices. The length of this array equals numberOfRows. The length of each row equals the number of nonzeros in that row of the sparse matrix.
        • numberOfColumns
          int numberOfColumns
          Number of columns in the matrix.
        • numberOfNonZeros
          long numberOfNonZeros
          Number of nonzeros in the matrix.
        • numberOfRows
          int numberOfRows
          Number of rows in the matrix.
        • values
          Complex[][] values
          Jagged array containing sparse array values. This array must have the same shape as index.
    • Class com.imsl.math.ComplexSuperLU

      class ComplexSuperLU extends Object implements Serializable
      serialVersionUID:
      1354786188534715610L
      • Serialized Fields

        • AA
          com.imsl.math.ComplexSuperMatrix AA
        • AC
          com.imsl.math.ComplexSuperMatrix AC
        • AlreadyFactored
          boolean AlreadyFactored
        • B
          com.imsl.math.ComplexSuperMatrix B
        • b_colptr
          int[] b_colptr
        • b_rowind
          int[] b_rowind
        • berr
          double[] berr
        • C
          double[] C
        • colequ
          boolean colequ
        • ColPerm
          int ColPerm
        • ConditionNumber
          int ConditionNumber
        • dense
          Complex[] dense
        • DiagPivotThresh
          double DiagPivotThresh
        • equed
          int equed
        • equil
          boolean equil
        • Equil
          boolean Equil
        • etree
          int[] etree
        • expanders
          com.imsl.math.ComplexSuperLU.ExpHeader[] expanders
        • Fact
          int Fact
        • ferr
          double[] ferr
        • first_bmod
          int first_bmod
        • first_dfs
          int first_dfs
        • first_kid
          int[] first_kid
        • Glu
          com.imsl.math.ComplexSuperLU.GlobalLU_t Glu
        • info
          int[] info
        • iter_zlacon
          int iter_zlacon
        • IterRefine
          boolean IterRefine
        • j_zlacon
          int j_zlacon
        • jump_zlacon
          int jump_zlacon
        • L
          com.imsl.math.ComplexSuperMatrix L
        • lwork
          int lwork
        • marker
          int[] marker
        • mem_usage
          com.imsl.math.ComplexSuperLU.mem_usage_t mem_usage
        • nColsA
          int nColsA
        • next_kid
          int[] next_kid
        • no_expand
          int no_expand
        • nofact
          boolean nofact
        • notran
          boolean notran
        • nRowsA
          int nRowsA
        • panel_lsub
          int[] panel_lsub
        • parent
          int[] parent
        • perm_c
          int[] perm_c
        • perm_r
          int[] perm_r
        • PivotGrowth
          boolean PivotGrowth
        • post
          int[] post
        • postnum
          int postnum
        • pp
          int[] pp
        • PrintStat
          int PrintStat
        • R
          double[] R
        • rcond
          double[] rcond
        • recip_pivot_growth
          double recip_pivot_growth
        • repfnz
          int[] repfnz
        • rowequ
          boolean rowequ
        • segrep
          int[] segrep
        • sluStats
          com.imsl.math.ComplexSuperLU.Statistics sluStats
        • sp_ienv
          int[] sp_ienv
        • stat
          com.imsl.math.ComplexSuperLU.SuperLUStat_t stat
        • superA
          com.imsl.math.ComplexSuperMatrix superA
        • SymmetricMode
          boolean SymmetricMode
        • t0
          long t0
        • tempv
          Complex[] tempv
        • Trans
          int Trans
        • trant
          int trant
        • U
          com.imsl.math.ComplexSuperMatrix U
        • utime
          long[] utime
        • X
          com.imsl.math.ComplexSuperMatrix X
        • xplore
          int[] xplore
        • xprune
          int[] xprune
    • Class com.imsl.math.ComplexSVD

      class ComplexSVD extends Object implements Serializable
      serialVersionUID:
      5116494209131940555L
      • Serialized Fields

        • d
          double[] d
        • globalInfo
          int globalInfo
        • nca
          int nca
        • nra
          int nra
        • rank
          int rank
        • tolerance
          double tolerance
        • UImag
          double[] UImag
        • UReal
          double[] UReal
        • VImag
          double[] VImag
        • VReal
          double[] VReal
    • Exception com.imsl.math.ComplexSVD.DidNotConvergeException

      class DidNotConvergeException extends IMSLException implements Serializable
      serialVersionUID:
      -4618584344611226581L
    • Class com.imsl.math.ConjugateGradient

      class ConjugateGradient extends Object implements Serializable
      serialVersionUID:
      -2515460315704131562L
      • Serialized Fields

        • alpha
          double[] alpha
        • alpold
          double[] alpold
        • defa
          double[] defa
        • defm
          double[] defm
        • eigest
          double[] eigest
        • eigold
          double[] eigold
        • gamold
          double[] gamold
        • imsl_beta
          double[] imsl_beta
        • iwork
          int[] iwork
        • jump
          int[] jump
        • l_b
          double[] l_b
        • l_count
          int l_count
        • l_diagonal
          double[] l_diagonal
        • l_M
          double[][] l_M
        • l_maxiter
          int l_maxiter
        • l_n
          int l_n
        • l_p
          double[] l_p
        • l_r
          double[] l_r
        • l_tri
          double[] l_tri
        • l_work
          double[] l_work
        • l_z
          double[] l_z
        • lv_iter
          int[] lv_iter
        • lv_jump
          int[] lv_jump
        • lv_solution
          double[] lv_solution
        • norm_b_eps
          double norm_b_eps
        • precondition
          boolean precondition
        • pz
          double[] pz
        • relerr
          double relerr
        • s
          double[] s
        • sparse_version
          int sparse_version
        • user_jacobi
          short user_jacobi
    • Exception com.imsl.math.ConjugateGradient.NoConvergenceException

      class NoConvergenceException extends IMSLException implements Serializable
      serialVersionUID:
      -5173981258758263300L
    • Exception com.imsl.math.ConjugateGradient.NotDefiniteAMatrixException

      class NotDefiniteAMatrixException extends IMSLException implements Serializable
      serialVersionUID:
      -9129877754617825172L
    • Exception com.imsl.math.ConjugateGradient.NotDefiniteJacobiPreconditionerException

      class NotDefiniteJacobiPreconditionerException extends IMSLException implements Serializable
      serialVersionUID:
      -759154778418239751L
    • Exception com.imsl.math.ConjugateGradient.NotDefinitePreconditionMatrixException

      class NotDefinitePreconditionMatrixException extends IMSLException implements Serializable
      serialVersionUID:
      4623022969561325864L
    • Exception com.imsl.math.ConjugateGradient.SingularPreconditionMatrixException

      class SingularPreconditionMatrixException extends IMSLException implements Serializable
      serialVersionUID:
      -2152773987921127746L
    • Class com.imsl.math.CsAkima

      class CsAkima extends Spline implements Serializable
      serialVersionUID:
      -8111955869602945951L
    • Class com.imsl.math.CsInterpolate

      class CsInterpolate extends Spline implements Serializable
      serialVersionUID:
      6509551214523140517L
    • Class com.imsl.math.CsPeriodic

      class CsPeriodic extends Spline implements Serializable
      serialVersionUID:
      3721996239849522098L
    • Class com.imsl.math.CsShape

      class CsShape extends Spline implements Serializable
      serialVersionUID:
      4869111194555872637L
    • Exception com.imsl.math.CsShape.TooManyIterationsException

      class TooManyIterationsException extends IMSLException implements Serializable
      serialVersionUID:
      5863349337242274171L
    • Class com.imsl.math.CsSmooth

      class CsSmooth extends Spline implements Serializable
      serialVersionUID:
      5282470638965246153L
    • Class com.imsl.math.CsSmoothC2

      class CsSmoothC2 extends Spline implements Serializable
      serialVersionUID:
      2672093147511539014L
    • Class com.imsl.math.CsTCB

      class CsTCB extends Spline implements Serializable
      serialVersionUID:
      -8111955869602945951L
      • Serialized Fields

        • Bias
          double[] Bias
        • Continuity
          double[] Continuity
        • id
          int[] id
        • Left
          double Left
        • Right
          double Right
        • Tension
          double[] Tension
        • xdata
          double[] xdata
        • ydata
          double[] ydata
    • Class com.imsl.math.DenseLP

      class DenseLP extends Object implements Serializable
      serialVersionUID:
      1173375432206988246L
      • Serialized Fields

        • _do0
          int _do0
        • _do1
          int _do1
        • _do10
          int _do10
        • _do100
          int _do100
        • _do101
          int _do101
        • _do102
          int _do102
        • _do103
          int _do103
        • _do104
          int _do104
        • _do105
          int _do105
        • _do106
          int _do106
        • _do107
          int _do107
        • _do108
          int _do108
        • _do109
          int _do109
        • _do11
          int _do11
        • _do110
          int _do110
        • _do111
          int _do111
        • _do112
          int _do112
        • _do113
          int _do113
        • _do114
          int _do114
        • _do115
          int _do115
        • _do116
          int _do116
        • _do117
          int _do117
        • _do118
          int _do118
        • _do119
          int _do119
        • _do12
          int _do12
        • _do120
          int _do120
        • _do121
          int _do121
        • _do122
          int _do122
        • _do123
          int _do123
        • _do124
          int _do124
        • _do125
          int _do125
        • _do126
          int _do126
        • _do127
          int _do127
        • _do128
          int _do128
        • _do129
          int _do129
        • _do13
          int _do13
        • _do130
          int _do130
        • _do131
          int _do131
        • _do132
          int _do132
        • _do133
          int _do133
        • _do134
          int _do134
        • _do135
          int _do135
        • _do136
          int _do136
        • _do137
          int _do137
        • _do138
          int _do138
        • _do139
          int _do139
        • _do14
          int _do14
        • _do140
          int _do140
        • _do141
          int _do141
        • _do142
          int _do142
        • _do143
          int _do143
        • _do144
          int _do144
        • _do145
          int _do145
        • _do146
          int _do146
        • _do147
          int _do147
        • _do148
          int _do148
        • _do149
          int _do149
        • _do15
          int _do15
        • _do150
          int _do150
        • _do151
          int _do151
        • _do152
          int _do152
        • _do153
          int _do153
        • _do154
          int _do154
        • _do155
          int _do155
        • _do156
          int _do156
        • _do157
          int _do157
        • _do158
          int _do158
        • _do159
          int _do159
        • _do16
          int _do16
        • _do160
          int _do160
        • _do161
          int _do161
        • _do162
          int _do162
        • _do163
          int _do163
        • _do164
          int _do164
        • _do165
          int _do165
        • _do166
          int _do166
        • _do167
          int _do167
        • _do168
          int _do168
        • _do169
          int _do169
        • _do17
          int _do17
        • _do170
          int _do170
        • _do171
          int _do171
        • _do172
          int _do172
        • _do173
          int _do173
        • _do174
          int _do174
        • _do175
          int _do175
        • _do176
          int _do176
        • _do177
          int _do177
        • _do178
          int _do178
        • _do179
          int _do179
        • _do18
          int _do18
        • _do180
          int _do180
        • _do181
          int _do181
        • _do182
          int _do182
        • _do183
          int _do183
        • _do184
          int _do184
        • _do185
          int _do185
        • _do186
          int _do186
        • _do187
          int _do187
        • _do188
          int _do188
        • _do189
          int _do189
        • _do19
          int _do19
        • _do190
          int _do190
        • _do191
          int _do191
        • _do192
          int _do192
        • _do193
          int _do193
        • _do194
          int _do194
        • _do195
          int _do195
        • _do196
          int _do196
        • _do197
          int _do197
        • _do198
          int _do198
        • _do199
          int _do199
        • _do2
          int _do2
        • _do20
          int _do20
        • _do200
          int _do200
        • _do201
          int _do201
        • _do202
          int _do202
        • _do203
          int _do203
        • _do204
          int _do204
        • _do205
          int _do205
        • _do206
          int _do206
        • _do207
          int _do207
        • _do208
          int _do208
        • _do209
          int _do209
        • _do21
          int _do21
        • _do210
          int _do210
        • _do22
          int _do22
        • _do23
          int _do23
        • _do24
          int _do24
        • _do25
          int _do25
        • _do26
          int _do26
        • _do27
          int _do27
        • _do28
          int _do28
        • _do29
          int _do29
        • _do3
          int _do3
        • _do30
          int _do30
        • _do31
          int _do31
        • _do32
          int _do32
        • _do33
          int _do33
        • _do34
          int _do34
        • _do35
          int _do35
        • _do36
          int _do36
        • _do37
          int _do37
        • _do38
          int _do38
        • _do39
          int _do39
        • _do4
          int _do4
        • _do40
          int _do40
        • _do41
          int _do41
        • _do42
          int _do42
        • _do43
          int _do43
        • _do44
          int _do44
        • _do45
          int _do45
        • _do46
          int _do46
        • _do47
          int _do47
        • _do48
          int _do48
        • _do49
          int _do49
        • _do5
          int _do5
        • _do50
          int _do50
        • _do51
          int _do51
        • _do52
          int _do52
        • _do53
          int _do53
        • _do54
          int _do54
        • _do55
          int _do55
        • _do56
          int _do56
        • _do57
          int _do57
        • _do58
          int _do58
        • _do59
          int _do59
        • _do6
          int _do6
        • _do60
          int _do60
        • _do61
          int _do61
        • _do62
          int _do62
        • _do63
          int _do63
        • _do64
          int _do64
        • _do65
          int _do65
        • _do66
          int _do66
        • _do67
          int _do67
        • _do68
          int _do68
        • _do69
          int _do69
        • _do7
          int _do7
        • _do70
          int _do70
        • _do71
          int _do71
        • _do72
          int _do72
        • _do73
          int _do73
        • _do74
          int _do74
        • _do75
          int _do75
        • _do76
          int _do76
        • _do77
          int _do77
        • _do78
          int _do78
        • _do79
          int _do79
        • _do8
          int _do8
        • _do80
          int _do80
        • _do81
          int _do81
        • _do82
          int _do82
        • _do83
          int _do83
        • _do84
          int _do84
        • _do85
          int _do85
        • _do86
          int _do86
        • _do87
          int _do87
        • _do88
          int _do88
        • _do89
          int _do89
        • _do9
          int _do9
        • _do90
          int _do90
        • _do91
          int _do91
        • _do92
          int _do92
        • _do93
          int _do93
        • _do94
          int _do94
        • _do95
          int _do95
        • _do96
          int _do96
        • _do97
          int _do97
        • _do98
          int _do98
        • _do99
          int _do99
        • _l0
          int _l0
        • _l1
          int _l1
        • _l2
          int _l2
        • _l3
          int _l3
        • _l4
          int _l4
        • absg
          double absg
        • alpha
          double alpha
        • badbig
          double badbig
        • badobj
          double badobj
        • badpi
          double badpi
        • bigpi
          double bigpi
        • depgra
          double depgra
        • depkkt
          double depkkt
        • DOPT_UNBOUNDED_FROM_ABOVE
          double DOPT_UNBOUNDED_FROM_ABOVE
        • DOPT_UNBOUNDED_FROM_BELOW
          double DOPT_UNBOUNDED_FROM_BELOW
        • dualSolution
          double[] dualSolution
        • edump
          int edump
        • endact
          int endact
        • enolm
          int enolm
        • eps
          double eps
        • fackkt
          double fackkt
        • fleftm
          double fleftm
        • frt
          double frt
        • gmaxim
          double gmaxim
        • gnormi
          double gnormi
        • gpiv
          double gpiv
        • i
          int i
        • i_
          int i_
        • i1
          int i1
        • i1_
          int i1_
        • i2
          int i2
        • i3
          int i3
        • iact
          int iact
        • ibeg
          int ibeg
        • idiw
          int idiw
        • ierror
          int ierror
        • ii
          int ii
        • iifail
          int iifail
        • IMSL_UNBOUNDED_FROM_ABOVE
          double IMSL_UNBOUNDED_FROM_ABOVE
        • IMSL_UNBOUNDED_FROM_BELOW
          double IMSL_UNBOUNDED_FROM_BELOW
        • imsls_ismax
          int imsls_ismax
        • inact
          int inact
        • infeas1
          int infeas1
        • iselct
          int iselct
        • itend
          int itend
        • iteration_count
          int iteration_count
        • iterationCount
          int iterationCount
        • itfil
          int itfil
        • itiw
          int itiw
        • itx
          int itx
        • j
          int j
        • j_
          int j_
        • j1
          int j1
        • j1_
          int j1_
        • j2
          int j2
        • j2_
          int j2_
        • jl
          int jl
        • jl_
          int jl_
        • jl1
          int jl1
        • jl1_
          int jl1_
        • jlbeg
          int jlbeg
        • jld
          int jld
        • jld_
          int jld_
        • jlp
          int jlp
        • jlp_
          int jlp_
        • jls
          int jls
        • jp
          int jp
        • jp_
          int jp_
        • jp1
          int jp1
        • jpiv
          int jpiv
        • jselct
          int jselct
        • k
          int k
        • k_
          int k_
        • k1
          int k1
        • k1_
          int k1_
        • k2
          int k2
        • k3
          int k3
        • kcold
          int kcold
        • kcolu
          int kcolu
        • kgod
          int kgod
        • kgop
          int kgop
        • kgou
          int kgou
        • kkt
          int kkt
        • kkt_
          int kkt_
        • kktsel
          int kktsel
        • kscale
          int kscale
        • ksee
          int ksee
        • kseec
          int kseec
        • kseety
          int kseety
        • ksep10
          int ksep10
        • ktfaip
          int ktfaip
        • l_a
          double[][] l_a
        • l_b
          double[] l_b
        • l_bu
          double[] l_bu
        • l_c
          double[] l_c
        • l_irtype
          int[] l_irtype
        • l_m
          int l_m
        • l_n
          int l_n
        • l_refinement
          int l_refinement
        • l_xlb
          double[] l_xlb
        • l_xub
          double[] l_xub
        • l1
          int l1
        • lastin
          int lastin
        • lastp
          int lastp
        • lastp_
          int lastp_
        • lbfre1
          int lbfre1
        • lbfre2
          int lbfre2
        • lcold
          int lcold
        • lcolu
          int lcolu
        • lcu
          int lcu
        • lenlt
          int lenlt
        • leqrow
          int leqrow
        • lgrop
          int lgrop
        • llopt
          int llopt
        • locx
          int locx
        • lopact
          int lopact
        • lopinc
          int[] lopinc
        • lx
          int lx
        • lx1
          int lx1
        • mloc
          int[] mloc
        • movbad
          int movbad
        • nfail
          int nfail
        • ni1
          int ni1
        • njpiv
          int njpiv
        • notkkt
          int notkkt
        • numx
          int numx
        • objref
          double objref
        • optimalValue
          double optimalValue
        • pivmin
          double pivmin
        • rpiv
          double rpiv
        • sellm
          double sellm
        • smamov
          double smamov
        • smapiv
          double smapiv
        • solution
          double[] solution
        • tolfea
          double tolfea
        • tp
          double tp
        • tp1
          double tp1
        • tp2
          double tp2
        • tp3
          double tp3
        • tp4
          double tp4
        • und64
          double und64
        • user_bu
          int user_bu
        • user_irtype
          int user_irtype
        • user_refinement
          int user_refinement
        • user_xlb
          int user_xlb
        • user_xub
          int user_xub
        • viobnd
          double viobnd
        • wtp
          double wtp
        • xcon
          double xcon
        • xerr
          double xerr
        • xnew
          double xnew
        • xpiv
          double xpiv
    • Exception com.imsl.math.DenseLP.AllConstraintsNotSatisfiedException

      class AllConstraintsNotSatisfiedException extends IMSLException implements Serializable
      serialVersionUID:
      -507605602024349233L
    • Exception com.imsl.math.DenseLP.BoundsInconsistentException

      class BoundsInconsistentException extends IMSLException implements Serializable
      serialVersionUID:
      3937098699235141037L
    • Exception com.imsl.math.DenseLP.CyclingOccurringException

      class CyclingOccurringException extends IMSLException implements Serializable
      serialVersionUID:
      4497244578710169347L
    • Exception com.imsl.math.DenseLP.MultipleSolutionsException

      class MultipleSolutionsException extends IMSLException implements Serializable
      serialVersionUID:
      -2279904030756421541L
    • Exception com.imsl.math.DenseLP.NoAcceptablePivotException

      class NoAcceptablePivotException extends IMSLException implements Serializable
      serialVersionUID:
      -8539960944266753971L
    • Exception com.imsl.math.DenseLP.NoConstraintsAvailableException

      class NoConstraintsAvailableException extends IMSLException implements Serializable
      serialVersionUID:
      -8539960944266753971L
    • Exception com.imsl.math.DenseLP.ProblemUnboundedException

      class ProblemUnboundedException extends IMSLException implements Serializable
      serialVersionUID:
      -8853574990048910088L
    • Exception com.imsl.math.DenseLP.ProblemVacuousException

      class ProblemVacuousException extends IMSLException implements Serializable
      serialVersionUID:
      -8099968917517060923L
    • Exception com.imsl.math.DenseLP.SomeConstraintsDiscardedException

      class SomeConstraintsDiscardedException extends IMSLException implements Serializable
      serialVersionUID:
      4576304658320505889L
    • Exception com.imsl.math.DenseLP.WrongConstraintTypeException

      class WrongConstraintTypeException extends IMSLException implements Serializable
      serialVersionUID:
      8381291277514966203L
    • Exception com.imsl.math.Eigen.DidNotConvergeException

      class DidNotConvergeException extends IMSLException implements Serializable
      serialVersionUID:
      2601109516729537550L
    • Class com.imsl.math.FeynmanKac

      class FeynmanKac extends Object implements Serializable
      serialVersionUID:
      -8143958867664367103L
      • Serialized Fields

        • atol_array
          double[] atol_array
        • atol_array_set
          boolean atol_array_set
        • atol_scalar
          double atol_scalar
        • atol_scalar_set
          boolean atol_scalar_set
        • fact
          double[][] fact
        • forceTerm
          FeynmanKac.ForcingTerm forceTerm
        • init_stepsize_set
          boolean init_stepsize_set
        • initData
          FeynmanKac.InitialData initData
        • ipvt
          int[] ipvt
        • l_atol
          double[] l_atol
        • l_deriv
          int l_deriv
        • l_initStepsize
          double l_initStepsize
        • l_istate
          int[] l_istate
        • l_maxBdfOrder
          int l_maxBdfOrder
        • l_maximumStepsize
          double l_maximumStepsize
        • l_maxSteps
          int l_maxSteps
        • l_ndeg
          int l_ndeg
        • l_rtol
          double[] l_rtol
        • l_stepControlMethod
          int l_stepControlMethod
        • l_tBarrier
          double l_tBarrier
        • l_tdepend
          int[] l_tdepend
        • l_tGrid
          double[] l_tGrid
        • l_timeFlag
          boolean[] l_timeFlag
        • l_xGrid
          double[] l_xGrid
        • luband
          com.imsl.math.LUBanded luband
        • max_stepsize_set
          boolean max_stepsize_set
        • nlbcd
          int nlbcd
        • nrbcd
          int nrbcd
        • ntGrid
          int ntGrid
        • nxGrid
          int nxGrid
        • rtol_array
          double[] rtol_array
        • rtol_array_set
          boolean rtol_array_set
        • rtol_scalar
          double rtol_scalar
        • rtol_scalar_set
          boolean rtol_scalar_set
        • time_barrier_set
          boolean time_barrier_set
        • y
          double[] y
        • y_prime
          double[] y_prime
    • Exception com.imsl.math.FeynmanKac.BoundaryInconsistentException

      class BoundaryInconsistentException extends IMSLException implements Serializable
      serialVersionUID:
      796371397287669062L
    • Exception com.imsl.math.FeynmanKac.ConstraintsInconsistentException

      class ConstraintsInconsistentException extends IMSLException implements Serializable
      serialVersionUID:
      -9058793304601417149L
    • Exception com.imsl.math.FeynmanKac.CorrectorConvergenceException

      class CorrectorConvergenceException extends IMSLException implements Serializable
      serialVersionUID:
      4773600929434175462L
    • Exception com.imsl.math.FeynmanKac.ErrorTestException

      class ErrorTestException extends IMSLException implements Serializable
      serialVersionUID:
      -1366814537523572647L
    • Exception com.imsl.math.FeynmanKac.InitialConstraintsException

      class InitialConstraintsException extends IMSLException implements Serializable
      serialVersionUID:
      -7525315352824802652L
    • Exception com.imsl.math.FeynmanKac.IterationMatrixSingularException

      class IterationMatrixSingularException extends IMSLException implements Serializable
      serialVersionUID:
      361721467196684138L
    • Exception com.imsl.math.FeynmanKac.TcurrentTstopInconsistentException

      class TcurrentTstopInconsistentException extends IMSLException implements Serializable
      serialVersionUID:
      560541976516767255L
    • Exception com.imsl.math.FeynmanKac.TEqualsToutException

      class TEqualsToutException extends IMSLException implements Serializable
      serialVersionUID:
      3165939008497912121L
    • Exception com.imsl.math.FeynmanKac.TimeIntervalTooSmallException

      class TimeIntervalTooSmallException extends IMSLException implements Serializable
      serialVersionUID:
      6794541590099251342L
    • Exception com.imsl.math.FeynmanKac.ToleranceTooSmallException

      class ToleranceTooSmallException extends IMSLException implements Serializable
      serialVersionUID:
      1755204035044152731L
    • Exception com.imsl.math.FeynmanKac.TooManyIterationsException

      class TooManyIterationsException extends IMSLException implements Serializable
      serialVersionUID:
      7116377632606238818L
    • Class com.imsl.math.FFT

      class FFT extends Object implements Serializable
      serialVersionUID:
      3953178093789121094L
      • Serialized Fields

        • fac
          int[] fac
        • wa
          double[] wa
    • Class com.imsl.math.GenMinRes

      class GenMinRes extends Object implements Serializable
      serialVersionUID:
      -7564677257597454296L
      • Serialized Fields

        • IDO
          int IDO
        • IMP
          int IMP
        • IPRINT
          int IPRINT
        • IRESUP
          int IRESUP
        • IRP
          int IRP
        • ITMAX
          int ITMAX
        • KDMAX
          int KDMAX
        • keyMessage
          String keyMessage
        • logger
          Logger logger
        • N
          int N
        • nameClass
          String nameClass
        • nameMethod
          String nameMethod
        • NCALL
          int NCALL
        • RELERR
          double RELERR
        • TMPV
          double[] TMPV
        • TOTLAVS
          int TOTLAVS
        • TOTLITER
          int TOTLITER
        • TOTLRTSLVS
          int TOTLRTSLVS
        • XGUESS
          double[] XGUESS
    • Exception com.imsl.math.GenMinRes.TooManyIterationsException

      class TooManyIterationsException extends IMSLException implements Serializable
      serialVersionUID:
      -8512568350386495209L
    • Class com.imsl.math.HyperRectangleQuadrature

      class HyperRectangleQuadrature extends Object implements Serializable
      serialVersionUID:
      -127777670730446008L
      • Serialized Fields

        • dim
          int dim
        • errorAbsolute
          double errorAbsolute
        • errorEstimate
          double errorEstimate
        • errorRelative
          double errorRelative
        • sequence
          RandomSequence sequence
    • Class com.imsl.math.LinearProgramming

      class LinearProgramming extends Object implements Serializable
      serialVersionUID:
      -4245078142849361700L
      • Serialized Fields

        • dualSolution
          double[] dualSolution
          Deprecated.
        • l_a
          double[] l_a
          Deprecated.
        • l_b
          double[] l_b
          Deprecated.
        • l_bu
          double[] l_bu
          Deprecated.
        • l_c
          double[] l_c
          Deprecated.
        • l_irtype
          int[] l_irtype
          Deprecated.
        • l_m
          int l_m
          Deprecated.
        • l_n
          int l_n
          Deprecated.
        • l_xlb
          double[] l_xlb
          Deprecated.
        • l_xub
          double[] l_xub
          Deprecated.
        • max_itn
          int max_itn
          Deprecated.
        • optimalValue
          double optimalValue
          Deprecated.
        • solution
          double[] solution
          Deprecated.
        • user_bu
          int user_bu
          Deprecated.
        • user_irtype
          int user_irtype
          Deprecated.
        • user_xlb
          int user_xlb
          Deprecated.
        • user_xub
          int user_xub
          Deprecated.
    • Exception com.imsl.math.LinearProgramming.BoundsInconsistentException

      class BoundsInconsistentException extends IMSLException implements Serializable
      serialVersionUID:
      7248656379913110342L
    • Exception com.imsl.math.LinearProgramming.NumericDifficultyException

      class NumericDifficultyException extends IMSLException implements Serializable
      serialVersionUID:
      -5924579010914568412L
    • Exception com.imsl.math.LinearProgramming.ProblemInfeasibleException

      class ProblemInfeasibleException extends LinearProgramming.NumericDifficultyException implements Serializable
      serialVersionUID:
      -2040222885506109934L
    • Exception com.imsl.math.LinearProgramming.ProblemUnboundedException

      class ProblemUnboundedException extends LinearProgramming.NumericDifficultyException implements Serializable
      serialVersionUID:
      -4409501575226458941L
    • Exception com.imsl.math.LinearProgramming.WrongConstraintTypeException

      class WrongConstraintTypeException extends IMSLException implements Serializable
      serialVersionUID:
      -3724576162438955721L
    • Class com.imsl.math.LU

      class LU extends Object implements Serializable
      serialVersionUID:
      -1832323710455882312L
      • Serialized Fields

        • factor
          double[][] factor
          This is an n by n matrix containing the LU factorization of the matrix A.
        • ipvt
          int[] ipvt
          Vector of length n containing the pivot sequence for the factorization.
    • Class com.imsl.math.MinConGenLin

      class MinConGenLin extends Object implements Serializable
      serialVersionUID:
      3503978826329167429L
      • Serialized Fields

        • active_constraints_user
          int active_constraints_user
        • alamda_user
          double[] alamda_user
        • CPUs
          int CPUs
        • iact_user
          int[] iact_user
        • l_a
          double[] l_a
        • l_b
          double[] l_b
        • l_maxfcn
          int l_maxfcn
        • l_nact
          int l_nact
        • l_ncon
          int l_ncon
        • l_neq
          int l_neq
        • l_nvar
          int l_nvar
        • l_obj
          double l_obj
        • l_tol
          double l_tol
        • l_xguess
          double[] l_xguess
        • l_xlb
          double[] l_xlb
        • l_xub
          double[] l_xub
        • lagrange_multipliers_user
          int lagrange_multipliers_user
        • lv_value
          double[] lv_value
        • user_xguess
          int user_xguess
    • Exception com.imsl.math.MinConGenLin.ConstraintsInconsistentException

      class ConstraintsInconsistentException extends IMSLException implements Serializable
      serialVersionUID:
      -8225163682057750355L
    • Exception com.imsl.math.MinConGenLin.ConstraintsNotSatisfiedException

      class ConstraintsNotSatisfiedException extends IMSLException implements Serializable
      serialVersionUID:
      -6025905638586109087L
    • Exception com.imsl.math.MinConGenLin.EqualityConstraintsException

      class EqualityConstraintsException extends IMSLException implements Serializable
      serialVersionUID:
      -1656124333235458266L
    • Exception com.imsl.math.MinConGenLin.VarBoundsInconsistentException

      class VarBoundsInconsistentException extends IMSLException implements Serializable
      serialVersionUID:
      -6786610974450916732L
    • Class com.imsl.math.MinConNLP

      class MinConNLP extends Object implements Serializable
      serialVersionUID:
      6787317003165897785L
      • Serialized Fields

        • A
          double[][] A
        • ACCINF
          double[][] ACCINF
        • AITR
          int[] AITR
        • ALIST
          int[] ALIST
        • ALPHA
          double ALPHA
        • ANALYT
          boolean ANALYT
        • B2N
          double B2N
        • B2N0
          double B2N0
        • BETA
          double BETA
        • BETAQ
          double[] BETAQ
        • BIND
          int[] BIND
        • BINe0
          int[] BINe0
        • BLOC
          boolean BLOC
        • C1D
          double C1D
        • CFINCR
          int CFINCR
        • CFUERR
          boolean[] CFUERR
        • CGRES
          int[] CGRES
        • CLOW
          int CLOW
        • COLD
          boolean COLD
        • COLLE
          double[] COLLE
        • COLNO
          int[] COLNO
        • CORR
          boolean CORR
        • COSPHI
          double COSPHI
        • CPUs
          int CPUs
        • CRES
          int[] CRES
        • CSCAL
          double[] CSCAL
        • D
          double[] D
        • DD
          double[] DD
        • DDUAL
          double[] DDUAL
        • DEL
          double DEL
        • DEL_MIN
          double DEL_MIN
        • DEL0
          double DEL0
        • DEL01
          double DEL01
        • DELDif
          double DELDif
        • DELFAC
          double[] DELFAC
        • DELMIN
          double DELMIN
        • DELTA
          double DELTA
        • DELTA0
          double DELTA0
        • DELTA1
          double DELTA1
        • DIAG
          double[] DIAG
        • DIAG0
          double[] DIAG0
        • DifFTYPE
          int DifFTYPE
        • DifX
          double[] DifX
        • DIRDER
          double DIRDER
        • DNORM
          double DNORM
        • DSCAL
          double DSCAL
        • E0
          double[] E0
        • e0NORM
          double e0NORM
        • EPSDif
          double EPSDif
        • EPSFCN
          double EPSFCN
        • EPSMAC
          double EPSMAC
        • EPSPHI
          double EPSPHI
        • EPSX
          double EPSX
        • EQRES
          boolean EQRES
        • ETA
          double ETA
        • FCOUNT
          int FCOUNT
        • FEPS
          double FEPS
        • FFUERR
          boolean FFUERR
        • FIVE
          double FIVE
        • FMIN
          double FMIN
        • FOUR
          double FOUR
        • FU
          double[] FU
        • FUD
          double[][] FUD
        • FUGRAD
          double[][] FUGRAD
        • FVALUE
          double FVALUE
        • FX
          double FX
        • FX0
          double FX0
        • FX1
          double FX1
        • FXST
          double FXST
        • GCONST
          boolean[] GCONST
        • GFN
          double GFN
        • GPHI0
          double[] GPHI0
        • GPHI1
          double[] GPHI1
        • GRADF
          double[] GRADF
        • GRES
          double[][] GRES
        • GRESN
          double[] GRESN
        • GUNIT
          int[][] GUNIT
        • IBTYPE
          int IBTYPE
        • ICF
          int ICF
        • ICGF
          int ICGF
        • IDENT
          boolean IDENT
        • IDTYPE
          int IDTYPE
        • ifILL1
          int ifILL1
        • INFEAS
          double INFEAS
        • INITIAL_DEL_MIN
          double INITIAL_DEL_MIN
        • INTAKT
          boolean INTAKT
        • INX
          boolean INX
        • IPRINT
          int IPRINT
        • IPTR
          int IPTR
        • IQ
          int IQ
        • IQTR
          int IQTR
        • ITERMA
          int ITERMA
        • ITSTEP
          int ITSTEP
        • keyMessage
          String keyMessage
        • LASTCH
          int LASTCH
        • LASTDW
          int LASTDW
        • LASTUP
          int LASTUP
        • LEVEL
          double LEVEL
        • LLOW
          boolean[] LLOW
        • logger
          Logger logger
        • LUP
          boolean[] LUP
        • M
          int M
        • MATSC
          double MATSC
        • MAX_CONSTRAINTS
          int MAX_CONSTRAINTS
        • maximumTime
          long maximumTime
        • MAXIT
          int MAXIT
        • MAXITN
          int MAXITN
        • ME
          int ME
        • MEU
          int MEU
        • MI
          int MI
        • N
          int N
        • NAME
          String NAME
        • nameClass
          String nameClass
        • nameMethod
          String nameMethod
        • NBOUNDS
          int NBOUNDS
        • NDUAL
          int NDUAL
        • NG
          int NG
        • NH
          int NH
        • NP
          double[] NP
        • NR
          int NR
        • NRES
          int NRES
        • NRESET
          int NRESET
        • NRESM
          int NRESM
        • NSTEP
          int NSTEP
        • NUMSM
          int NUMSM
        • NVAR
          int NVAR
        • NX
          int NX
        • NY
          double NY
        • OG
          double[] OG
        • ONE
          double ONE
        • ONEP3
          double ONEP3
        • OPTITE
          double OPTITE
        • P2
          double P2
        • P4
          double P4
        • P5
          double P5
        • P7
          double P7
        • P8
          double P8
        • P9
          double P9
        • PENALTY
          double PENALTY
        • PERM
          int[] PERM
        • PERM1
          int[] PERM1
        • PHASE
          int PHASE
        • PHI
          double PHI
        • PHI0
          double PHI0
        • PHI1
          double PHI1
        • PHIMIN
          double PHIMIN
        • PROU
          int PROU
        • PSI
          double PSI
        • PSI0
          double PSI0
        • PSI1
          double PSI1
        • PSIMIN
          double PSIMIN
        • PSIST
          double PSIST
        • QGF
          double[] QGF
        • QPTERM
          int QPTERM
        • QR
          double[][] QR
        • R
          double[][] R
        • RANK
          int RANK
        • RELPRE
          double RELPRE
        • RES
          double[] RES
        • RES0
          double[] RES0
        • RES1
          double[] RES1
        • RESMIN
          double[] RESMIN
        • RESST
          double[] RESST
        • RESX
          double[] RESX
        • RHO
          double RHO
        • RHO1
          double RHO1
        • RIITR
          double RIITR
        • RLOW
          double RLOW
        • RNORM
          double RNORM
        • RUNTIM
          double RUNTIM
        • SCALM
          double SCALM
        • SCALM2
          double SCALM2
        • SCF
          double SCF
        • SCF_MAX
          double SCF_MAX
        • SCF0
          double SCF0
        • SCFMAX
          double SCFMAX
        • SEVEN
          double SEVEN
        • SIG
          double SIG
        • SIG0
          double SIG0
        • SIGLA
          double SIGLA
        • SIGMIN
          double SIGMIN
        • SIGSM
          double SIGSM
        • SILENT
          boolean SILENT
        • SINGUL
          boolean SINGUL
        • SIX
          double SIX
        • SLACK
          double[] SLACK
        • SMALL_W
          double SMALL_W
        • SMALLD
          double SMALLD
        • SMALLW
          double SMALLW
        • SORT
          int[] SORT
        • SSTR
          double SSTR
        • startTime
          long startTime
        • STD
          boolean STD
        • STMAXL
          double STMAXL
        • STPTRM
          double STPTRM
        • TAU
          double TAU
        • TAU0
          double TAU0
        • TAUBND
          double TAUBND
        • TAUFAC
          double TAUFAC
        • TAUMAX
          double TAUMAX
        • TAUQP
          double TAUQP
        • TBND
          double TBND
        • TE0
          boolean TE0
        • TE1
          boolean TE1
        • TE2
          boolean TE2
        • TE3
          boolean TE3
        • THETA
          double THETA
        • THREE
          double THREE
        • TM1
          double TM1
        • TM10
          double TM10
        • TM2
          double TM2
        • TM3
          double TM3
        • TM4
          double TM4
        • TM5
          double TM5
        • TM6
          double TM6
        • TM8
          double TM8
        • TMPBUL
          boolean[] TMPBUL
        • TOL
          double TOL
        • TOLMAC
          double TOLMAC
        • TP1
          double TP1
        • TP2
          double TP2
        • TP3
          double TP3
        • TP4
          double TP4
        • TWO
          double TWO
        • TWOM2
          double TWOM2
        • TWOP11
          double TWOP11
        • TWOP4
          double TWOP4
        • U
          double[] U
        • U0
          double[] U0
        • UD
          double[] UD
        • UD1
          double[] UD1
        • UG
          double[] UG
        • UPDMY0
          double UPDMY0
        • UPSI
          double UPSI
        • UPSI0
          double UPSI0
        • UPSI1
          double UPSI1
        • UPSIM
          double UPSIM
        • UPSIST
          double UPSIST
        • USER_GRAD
          boolean USER_GRAD
        • VAL
          boolean[] VAL
        • VALID
          boolean VALID
        • VIOLIS
          int[] VIOLIS
        • W
          double[] W
        • W1
          double[] W1
        • WORK
          double[] WORK
        • X
          double[] X
        • X0
          double[] X0
        • X0NORM
          double X0NORM
        • X1
          double[] X1
        • XGUESS
          double[] XGUESS
        • XJ
          double[][] XJ
        • XLB
          double[] XLB
        • XMIN
          double[] XMIN
        • XNORM
          double XNORM
        • XSC
          double[] XSC
        • XSCALE
          double[] XSCALE
        • XST
          double[] XST
        • XTR
          double[] XTR
        • XUB
          double[] XUB
        • YU
          double[] YU
        • ZERO
          double ZERO
    • Exception com.imsl.math.MinConNLP.BadInitialGuessException

      class BadInitialGuessException extends IMSLException implements Serializable
      serialVersionUID:
      824046244480121232L
    • Exception com.imsl.math.MinConNLP.ConstraintEvaluationException

      class ConstraintEvaluationException extends IMSLException implements Serializable
      serialVersionUID:
      4638938599627567186L
    • Exception com.imsl.math.MinConNLP.IllConditionedException

      class IllConditionedException extends IMSLException implements Serializable
      serialVersionUID:
      -6239533571841853338L
    • Exception com.imsl.math.MinConNLP.LimitingAccuracyException

      class LimitingAccuracyException extends IMSLException implements Serializable
      serialVersionUID:
      -517778327113933630L
    • Exception com.imsl.math.MinConNLP.LinearlyDependentGradientsException

      class LinearlyDependentGradientsException extends IMSLException implements Serializable
      serialVersionUID:
      -8727831268603670192L
    • Exception com.imsl.math.MinConNLP.NoAcceptableStepsizeException

      class NoAcceptableStepsizeException extends IMSLException implements Serializable
      serialVersionUID:
      8604377814184281341L
    • Exception com.imsl.math.MinConNLP.ObjectiveEvaluationException

      class ObjectiveEvaluationException extends IMSLException implements Serializable
      serialVersionUID:
      -2382166115613859634L
    • Exception com.imsl.math.MinConNLP.PenaltyFunctionPointInfeasibleException

      class PenaltyFunctionPointInfeasibleException extends IMSLException implements Serializable
      serialVersionUID:
      1274539706620007738L
    • Exception com.imsl.math.MinConNLP.QPInfeasibleException

      class QPInfeasibleException extends IMSLException implements Serializable
      serialVersionUID:
      -2004830721581005800L
    • Exception com.imsl.math.MinConNLP.SingularException

      class SingularException extends IMSLException implements Serializable
      serialVersionUID:
      48978810541006124L
    • Exception com.imsl.math.MinConNLP.TerminationCriteriaNotSatisfiedException

      class TerminationCriteriaNotSatisfiedException extends IMSLException implements Serializable
      serialVersionUID:
      -4510253973338523250L
    • Exception com.imsl.math.MinConNLP.TooManyIterationsException

      class TooManyIterationsException extends IMSLException implements Serializable
      serialVersionUID:
      -8512568350386495209L
    • Exception com.imsl.math.MinConNLP.TooMuchTimeException

      class TooMuchTimeException extends MinConNLP.TooManyIterationsException implements Serializable
      serialVersionUID:
      -3795120922420602897L
    • Exception com.imsl.math.MinConNLP.WorkingSetSingularException

      class WorkingSetSingularException extends IMSLException implements Serializable
      serialVersionUID:
      -488522113396021474L
    • Class com.imsl.math.MinConNonlin

      class MinConNonlin extends Object implements Serializable
      serialVersionUID:
      4973982380200729347L
      • Serialized Fields

        • acc
          double acc
          Deprecated.
        • ACC
          double ACC
          Deprecated.
        • alm
          double alm
          Deprecated.
        • amue
          double amue
          Deprecated.
        • beta
          double beta
          Deprecated.
        • dbd
          double dbd
          Deprecated.
        • dbdfac
          double dbdfac
          Deprecated.
        • delta
          double delta
          Deprecated.
        • dfdel
          double dfdel
          Deprecated.
        • f
          double f
          Deprecated.
        • FVALUE
          double FVALUE
          Deprecated.
        • ifail
          int ifail
          Deprecated.
        • ILWLS
          int ILWLS
          Deprecated.
        • IMERIT
          int IMERIT
          Deprecated.
        • ITER
          int ITER
          Deprecated.
        • ITERC
          int ITERC
          Deprecated.
        • ITREF
          int ITREF
          Deprecated.
        • IWA
          int IWA
          Deprecated.
        • IWD
          int IWD
          Deprecated.
        • IWR
          int IWR
          Deprecated.
        • IWS
          int IWS
          Deprecated.
        • IWW
          int IWW
          Deprecated.
        • IWZ
          int IWZ
          Deprecated.
        • JFLAG
          int JFLAG
          Deprecated.
        • KDROP
          int KDROP
          Deprecated.
        • KFLAG
          int KFLAG
          Deprecated.
        • KNEXT
          int KNEXT
          Deprecated.
        • lact
          int lact
          Deprecated.
        • LFLAG
          int LFLAG
          Deprecated.
        • LIWQL
          int LIWQL
          Deprecated.
        • llise
          boolean llise
          Deprecated.
        • lmerit
          boolean lmerit
          Deprecated.
        • lql
          boolean lql
          Deprecated.
        • LWAQL
          int LWAQL
          Deprecated.
        • m
          int m
          Deprecated.
        • M
          int M
          Deprecated.
        • MAX_CONSTRAINTS
          int MAX_CONSTRAINTS
          Deprecated.
        • maxfun
          int maxfun
          Deprecated.
        • maxit
          int maxit
          Deprecated.
        • me
          int me
          Deprecated.
        • ME
          int ME
          Deprecated.
        • MFLAG
          int MFLAG
          Deprecated.
        • MN
          int MN
          Deprecated.
        • mnn
          int mnn
          Deprecated.
        • mode
          int mode
          Deprecated.
        • MXITER
          int MXITER
          Deprecated.
        • N
          int N
          Deprecated.
        • n1
          int n1
          Deprecated.
        • N2
          int N2
          Deprecated.
        • NFCN
          int NFCN
          Deprecated.
        • NFLAG
          int NFLAG
          Deprecated.
        • NGRAD
          int NGRAD
          Deprecated.
        • nmnn
          int nmnn
          Deprecated.
        • no1
          int no1
          Deprecated.
        • NU
          int NU
          Deprecated.
        • OF
          double OF
          Deprecated.
        • ON
          double ON
          Deprecated.
        • PARINC
          double PARINC
          Deprecated.
        • PARNEW
          double PARNEW
          Deprecated.
        • RATIO
          double RATIO
          Deprecated.
        • RES
          double RES
          Deprecated.
        • rpeno
          double rpeno
          Deprecated.
        • rpens
          double rpens
          Deprecated.
        • rpenu
          double rpenu
          Deprecated.
        • SCBND
          double SCBND
          Deprecated.
        • scbou
          double scbou
          Deprecated.
        • SQACC
          double SQACC
          Deprecated.
        • STEPSZ
          double STEPSZ
          Deprecated.
        • SUM
          double SUM
          Deprecated.
        • UF
          double UF
          Deprecated.
        • VFACT
          double VFACT
          Deprecated.
        • XGUESS
          double[] XGUESS
          Deprecated.
        • XLB
          double[] XLB
          Deprecated.
        • XMAG
          double XMAG
          Deprecated.
        • XMAGR
          double XMAGR
          Deprecated.
        • XSCALE
          double[] XSCALE
          Deprecated.
        • XUB
          double[] XUB
          Deprecated.
        • ZE
          double ZE
          Deprecated.
        • zefac
          double zefac
          Deprecated.
        • zefacu
          double zefacu
          Deprecated.
    • Exception com.imsl.math.MinConNonlin.LineSearchException

      class LineSearchException extends IMSLException implements Serializable
      serialVersionUID:
      5616495964686910982L
    • Exception com.imsl.math.MinConNonlin.QPConstraintsException

      class QPConstraintsException extends IMSLException implements Serializable
      serialVersionUID:
      3723219894085311292L
    • Exception com.imsl.math.MinConNonlin.TooManyIterationsException

      class TooManyIterationsException extends IMSLException implements Serializable
      serialVersionUID:
      -5529269091291382922L
    • Exception com.imsl.math.MinConNonlin.UphillSearchCalcException

      class UphillSearchCalcException extends IMSLException implements Serializable
      serialVersionUID:
      4339899305712791006L
    • Exception com.imsl.math.MinConNonlin.ZeroSearchDirectionException

      class ZeroSearchDirectionException extends IMSLException implements Serializable
      serialVersionUID:
      8141352038037655488L
    • Class com.imsl.math.MinUncon

      class MinUncon extends Object implements Serializable
      serialVersionUID:
      4973982380200729347L
      • Serialized Fields

        • BOUND
          double BOUND
        • GTOL
          double GTOL
        • MAXFN
          int MAXFN
        • STEP
          double STEP
        • XACC
          double XACC
        • XGUESS
          double XGUESS
    • Class com.imsl.math.MinUnconMultiVar

      class MinUnconMultiVar extends Object implements Serializable
      serialVersionUID:
      4973982380200729347L
      • Serialized Fields

        • AFTOL
          double AFTOL
        • CPUs
          int CPUs
        • errorStatus
          int errorStatus
        • FALSTL
          double FALSTL
        • FDIGIT
          double FDIGIT
        • FSCALE
          double FSCALE
        • GRADTL
          double GRADTL
        • GTOL
          double GTOL
        • IHESS
          int IHESS
        • ITER
          int ITER
        • MXITER
          int MXITER
        • N
          int N
        • NFCN
          int NFCN
        • NGRAD
          int NGRAD
        • NMAXS
          int NMAXS
        • NNFCN
          int[] NNFCN
        • NNGRAD
          int[] NNGRAD
        • RFTOL
          double RFTOL
        • STEPMX
          double STEPMX
        • STEPMXSet
          boolean STEPMXSet
        • STEPTL
          double STEPTL
        • XACC
          double XACC
        • XGUESS
          double[] XGUESS
        • XSCALE
          double[] XSCALE
    • Exception com.imsl.math.MinUnconMultiVar.ApproximateMinimumException

      class ApproximateMinimumException extends IMSLException implements Serializable
      serialVersionUID:
      2601109516729537550L
    • Exception com.imsl.math.MinUnconMultiVar.FalseConvergenceException

      class FalseConvergenceException extends IMSLException implements Serializable
      serialVersionUID:
      2601109516729537550L
    • Exception com.imsl.math.MinUnconMultiVar.MaxIterationsException

      class MaxIterationsException extends IMSLException implements Serializable
      serialVersionUID:
      2601109516729537550L
    • Exception com.imsl.math.MinUnconMultiVar.UnboundedBelowException

      class UnboundedBelowException extends IMSLException implements Serializable
      serialVersionUID:
      2601109516729537550L
    • Class com.imsl.math.NelderMead

      class NelderMead extends Object implements Serializable
      serialVersionUID:
      -3015419272598014495L
      • Serialized Fields

        • actualFcnIterations
          int[] actualFcnIterations
        • alpha
          double alpha
        • averageDistance
          double[] averageDistance
        • beta
          double beta
        • centroid
          double[] centroid
        • centroidDistance
          double centroidDistance
        • CPUs
          int CPUs
        • fcn
          NelderMead.Function fcn
        • functionValues
          double[] functionValues
        • gamma
          double gamma
        • guess
          double[] guess
        • initialComplex
          double[][] initialComplex
        • initialComplexSet
          boolean initialComplexSet
        • isUnconstrained
          boolean isUnconstrained
        • maxFcnIterations
          int maxFcnIterations
        • numberOfVertices
          int numberOfVertices
        • nVars
          int nVars
        • objectiveValue
          double objectiveValue
        • randomGenerator
          Random randomGenerator
        • requiredNumberOfFcnEvals
          int requiredNumberOfFcnEvals
        • requiredNumberOfThreads
          int requiredNumberOfThreads
        • solution
          double[] solution
        • tolerance
          double tolerance
        • xComplex
          double[][] xComplex
        • xe
          double[] xe
        • xlb
          double[] xlb
        • xr
          double[] xr
        • xub
          double[] xub
    • Class com.imsl.math.NonlinLeastSquares

      class NonlinLeastSquares extends Object implements Serializable
      serialVersionUID:
      -5122953694111997241L
      • Serialized Fields

        • AFTOL
          double AFTOL
        • CPUs
          int CPUs
        • DELTA
          double DELTA
        • FALSTL
          double FALSTL
        • first
          boolean first
        • FSCALE
          double[] FSCALE
        • gauss
          boolean gauss
        • GRADTL
          double GRADTL
        • INFO
          int INFO
        • IPARAM
          int[] IPARAM
        • m
          int m
        • M
          int M
        • MAXFCN
          int MAXFCN
        • MAXJAC
          int MAXJAC
        • MXITER
          int MXITER
        • mxtake
          boolean mxtake
        • n
          int n
        • N
          int N
        • NGOOD
          int NGOOD
        • RFTOL
          double RFTOL
        • RPARAM
          double[] RPARAM
        • STEPMX
          double STEPMX
        • STEPTL
          double STEPTL
        • x
          double[] x
        • XGUESS
          double[] XGUESS
        • XSCALE
          double[] XSCALE
    • Exception com.imsl.math.NonlinLeastSquares.TooManyIterationsException

      class TooManyIterationsException extends IMSLException implements Serializable
      serialVersionUID:
      5863349337242274171L
    • Class com.imsl.math.NonNegativeLeastSquares

      class NonNegativeLeastSquares extends Object implements Serializable
      serialVersionUID:
      -5957808312952790045L
      • Serialized Fields

        • A
          double[][] A
          Transposed copy of the input matrix.
        • B
          double[] B
          Copy of the input right hand side.
        • dualTolerance
          double dualTolerance
          Stop if largest dual is smaller. Can be made larger.
        • guess
          double[] guess
          Initial guess
        • M
          int M
          Number of rows.
        • maximumIterations
          int maximumIterations
        • maximumTime
          long maximumTime
        • N
          int N
          Number of columns and variables.
        • NORMAL
          boolean NORMAL
        • normTolerance
          double normTolerance
          Stop if current residual norm <= normTolerance*norm(B). Can be made larger if problem tolerates it.
        • numberIterations
          int numberIterations
        • rankTolerance
          double rankTolerance
          Rank deficient incoming column check. Can be made larger.
        • residualNorm
          double residualNorm
          The computed norm of the residual.
        • W
          double[] W
          The dual solution.
        • X
          double[] X
          The least-squares solution.
    • Exception com.imsl.math.NonNegativeLeastSquares.TooManyIterException

      class TooManyIterException extends IMSLException implements Serializable
      serialVersionUID:
      2079712456478518309L
    • Exception com.imsl.math.NonNegativeLeastSquares.TooMuchTimeException

      class TooMuchTimeException extends IMSLException implements Serializable
      serialVersionUID:
      897077977492786578L
    • Class com.imsl.math.NumericalDerivatives

      class NumericalDerivatives extends Object implements Serializable
      serialVersionUID:
      -4051001369214912260L
      • Serialized Fields

        • copyWK
          boolean copyWK
        • f
          double[] f
        • fac
          double[] fac
        • fjac
          double[][] fjac
        • iopt
          int[] iopt
        • iopt_tmp
          int[] iopt_tmp
        • iwk
          int[] iwk
        • liwk
          int liwk
        • m
          int m
        • mode
          int mode
        • tmpWK
          double[] tmpWK
        • wk
          double[] wk
        • y
          double[] y
        • y_orig
          double[] y_orig
        • yscale
          double[] yscale
    • Class com.imsl.math.ODE

      class ODE extends Object implements Serializable
      serialVersionUID:
      4999733042990553333L
      • Serialized Fields

        • floor
          double floor
        • hInitial
          double hInitial
        • hMax
          double hMax
        • hMin
          double hMin
        • inorm
          int inorm
        • maxNumberSteps
          int maxNumberSteps
        • scale
          double scale
        • tolerance
          double tolerance
        • usrInitialStepsize
          double usrInitialStepsize
        • usrMaxStepsize
          double usrMaxStepsize
        • usrMinStepsize
          double usrMinStepsize
        • usrScale
          double usrScale
    • Class com.imsl.math.OdeAdamsGear

      class OdeAdamsGear extends ODE implements Serializable
      serialVersionUID:
      -2952823127854719678L
      • Serialized Fields

        • ayi
          double ayi
        • bnd
          double bnd
        • crate
          double crate
        • d
          double d
        • d1
          double d1
        • dd
          double dd
        • dd1
          double dd1
        • e
          double e
        • edn
          double edn
        • el
          double[] el
        • eps
          double eps
        • epsj
          double epsj
        • epsold
          double epsold
        • error
          double[] error
        • eup
          double eup
        • F_HALF
          double F_HALF
        • F_ONE
          double F_ONE
        • F_SIX
          double F_SIX
        • F_TEN
          double F_TEN
        • F_THREE
          double F_THREE
        • F_TWO
          double F_TWO
        • F_ZERO
          double F_ZERO
        • h
          double h
        • hinit
          double hinit
        • hl0
          double hl0
        • hmax
          double hmax
        • hmin
          double hmin
        • hold
          double hold
        • hused
          double hused
        • iatype
          int iatype
        • ido
          int ido
        • idol
          int idol
        • idoub
          int idoub
        • ier
          int ier
        • intrp1
          int intrp1
        • intrp2
          int intrp2
        • ipvt
          int[] ipvt
        • iredo
          int iredo
        • iret
          int iret
        • isave
          int isave
        • istat
          int istat
        • istop
          int istop
        • iweval
          int iweval
        • ixend
          int ixend
        • j1
          int j1
        • j2
          int j2
        • jer
          int jer
        • jstart
          int jstart
        • ker
          int ker
        • kflag
          int kflag
        • l
          int l
        • lda
          int lda
        • ldfac
          int ldfac
        • ldpw
          int ldpw
        • lmax
          int lmax
        • lu
          LU lu
        • m
          int m
        • maxder
          int maxder
        • maxord
          int maxord
        • meo
          int meo
        • meth
          int meth
        • method
          int method
        • mf
          int mf
        • mfold
          int mfold
        • mio
          int mio
        • miter
          int miter
        • mtype
          int mtype
        • mxfcn
          int mxfcn
        • n
          int n
        • n1rty
          int n1rty
        • neq
          int neq
        • newq
          int newq
        • nfcn
          int nfcn
        • nhcut
          int nhcut
        • nipvt
          int nipvt
        • nje
          int nje
        • nlc
          int nlc
        • nmeth
          int nmeth
        • nold
          int nold
        • npw
          int npw
        • nq
          int nq
        • nra
          int nra
        • nstep
          int nstep
        • nstepj
          int nstepj
        • nuc
          int nuc
        • numberFcn
          int numberFcn
        • numberJac
          int numberJac
        • numberSteps
          int numberSteps
        • nwk
          int nwk
        • oldl0
          double oldl0
        • pr1
          double pr1
        • pr2
          double pr2
        • pr3
          double pr3
        • pw
          double[] pw
        • r1
          double r1
        • rc
          double rc
        • rh
          double rh
        • rmax
          double rmax
        • save1
          double[] save1
        • save2
          double[] save2
        • t
          double t
        • tEnd
          double tEnd
        • tEndPrevious
          double tEndPrevious
        • told
          double told
        • toutp
          double toutp
        • tq
          double[] tq
        • uround
          double uround
        • usrMiter
          int usrMiter
        • xendpv
          double xendpv
        • xsave
          double xsave
        • yprime_in_fcnj
          double[] yprime_in_fcnj
        • ytemp
          double[] ytemp
    • Exception com.imsl.math.OdeAdamsGear.DidNotConvergeException

      class DidNotConvergeException extends IMSLException implements Serializable
      serialVersionUID:
      2601109516729537550L
    • Exception com.imsl.math.OdeAdamsGear.MaxFcnEvalsExceededException

      class MaxFcnEvalsExceededException extends IMSLException implements Serializable
      serialVersionUID:
      -2664854595423168722L
    • Exception com.imsl.math.OdeAdamsGear.SingularMatrixException

      class SingularMatrixException extends IMSLException implements Serializable
      serialVersionUID:
      -2664854595423168722L
    • Exception com.imsl.math.OdeAdamsGear.ToleranceTooSmallException

      class ToleranceTooSmallException extends IMSLException implements Serializable
      serialVersionUID:
      -2664854595423168722L
    • Class com.imsl.math.OdeRungeKutta

      class OdeRungeKutta extends ODE implements Serializable
      serialVersionUID:
      -2952823127854719678L
    • Exception com.imsl.math.OdeRungeKutta.DidNotConvergeException

      class DidNotConvergeException extends IMSLException implements Serializable
      serialVersionUID:
      2601109516729537550L
    • Exception com.imsl.math.OdeRungeKutta.ToleranceTooSmallException

      class ToleranceTooSmallException extends IMSLException implements Serializable
      serialVersionUID:
      -2664854595423168722L
    • Class com.imsl.math.Physical

      class Physical extends Number implements Serializable
      serialVersionUID:
      3184419887986270832L
      • Serialized Fields

        • dim
          int[] dim
        • value
          double value
    • Class com.imsl.math.QR

      class QR extends Object implements Serializable
      serialVersionUID:
      1107610505222116600L
      • Serialized Fields

        • jpvt
          int[] jpvt
        • qr
          double[][] qr
        • qraux
          double[] qraux
    • Exception com.imsl.math.QuadraticProgramming.InconsistentSystemException

      class InconsistentSystemException extends IMSLException implements Serializable
      serialVersionUID:
      21002984005902215L
    • Exception com.imsl.math.QuadraticProgramming.NoLPSolutionException

      class NoLPSolutionException extends IMSLException implements Serializable
      serialVersionUID:
      -234237576860697403L
    • Exception com.imsl.math.QuadraticProgramming.ProblemUnboundedException

      class ProblemUnboundedException extends IMSLException implements Serializable
      serialVersionUID:
      -8330678910301086803L
    • Exception com.imsl.math.QuadraticProgramming.SolutionNotFoundException

      class SolutionNotFoundException extends IMSLException implements Serializable
      serialVersionUID:
      3738684727319253938L
    • Class com.imsl.math.Quadrature

      class Quadrature extends Object implements Serializable
      serialVersionUID:
      4473825263205812500L
      • Serialized Fields

        • doExtrapolation
          boolean doExtrapolation
        • errorAbsolute
          double errorAbsolute
        • errorEstimate
          double errorEstimate
        • errorRelative
          double errorRelative
        • errorStatus
          int errorStatus
        • maxSubintervals
          int maxSubintervals
        • rule
          int rule
    • Class com.imsl.math.RadialBasis

      class RadialBasis extends Object implements Serializable
      serialVersionUID:
      7552093779084269389L
      • Serialized Fields

        • centers
          double[][] centers
        • coefficients
          double[] coefficients
        • haveIntercept
          boolean haveIntercept
        • listData
          com.imsl.math.RadialBasis.ListData listData
        • lr
          LinearRegression lr
        • nCenters
          int nCenters
        • nDim
          int nDim
        • radialFunction
          RadialBasis.Function radialFunction
    • Exception com.imsl.math.SingularMatrixException

      class SingularMatrixException extends IMSLException implements Serializable
      serialVersionUID:
      -8931775643377062703L
    • Class com.imsl.math.SparseCholesky

      class SparseCholesky extends Object implements Serializable
      serialVersionUID:
      4073874860190911941L
      • Serialized Fields

        • A
          com.imsl.math.SparseCholeskyMatrix A
        • ALREADY_NUMERICALLY_FACTORED
          boolean ALREADY_NUMERICALLY_FACTORED
        • ALREADY_SYMBOLICALLY_FACTORED
          boolean ALREADY_SYMBOLICALLY_FACTORED
        • compute_numeric_factor
          int compute_numeric_factor
        • compute_symbolic_factor
          int compute_symbolic_factor
        • CSC_col_ptr
          int[] CSC_col_ptr
        • CSC_format
          int CSC_format
        • CSC_row_ind
          int[] CSC_row_ind
        • eps
          double eps
        • l_alnz
          double[] l_alnz
        • l_diag
          double[] l_diag
        • l_flag
          int[] l_flag
        • l_invp
          int[] l_invp
        • l_largest_diag
          double l_largest_diag
        • l_maxlnz
          int[] l_maxlnz
        • l_maxsub
          int[] l_maxsub
        • l_multifrontal_space
          int[] l_multifrontal_space
        • l_n
          int l_n
        • l_num_factor_nonzeros
          int l_num_factor_nonzeros
        • l_nzsub
          int[] l_nzsub
        • l_perm
          int[] l_perm
        • l_smallest_diag
          double l_smallest_diag
        • l_solution
          double[] l_solution
        • l_xlnz
          int[] l_xlnz
        • l_xnzsub
          int[] l_xnzsub
        • multifrontal
          int multifrontal
        • numeric_factor_only
          int numeric_factor_only
        • NUMERIC_FACTOR_ONLY
          int NUMERIC_FACTOR_ONLY
          Indicates that only the numeric factorization should be computed.
        • NUMERIC_FACTOR_SUPPLY
          int NUMERIC_FACTOR_SUPPLY
          Indicates that the numeric factor is supplied by the user.
        • nz
          int nz
        • return_largest_diag
          int return_largest_diag
        • return_num_factor_nonzeros
          int return_num_factor_nonzeros
        • return_numeric_factor
          int return_numeric_factor
        • return_smallest_diag
          int return_smallest_diag
        • return_symbolic_factor
          int return_symbolic_factor
        • rhs
          double[] rhs
        • solve_only
          int solve_only
        • SOLVE_ONLY
          int SOLVE_ONLY
          Indicates that only the system \(Ax=b\) should be solved.
        • supply_numeric_factor
          int supply_numeric_factor
        • supply_symbolic_factor
          int supply_symbolic_factor
        • symbolic_factor_only
          int symbolic_factor_only
        • SYMBOLIC_FACTOR_ONLY
          int SYMBOLIC_FACTOR_ONLY
          Indicates that only the symbolic factorization should be computed.
        • SYMBOLIC_FACTOR_SUPPLY
          int SYMBOLIC_FACTOR_SUPPLY
          Indicates that the symbolic factor is supplied by the user.
    • Exception com.imsl.math.SparseCholesky.NotSPDException

      class NotSPDException extends IMSLException implements Serializable
      serialVersionUID:
      -8958806756350122436L
    • Class com.imsl.math.SparseCholesky.NumericFactor

      class NumericFactor extends Object implements Serializable
      serialVersionUID:
      -7517777057466887737L
      • Serialized Fields

        • alnz
          double[] alnz
        • diag
          double[] diag
        • nzsub
          int[] nzsub
        • perm
          int[] perm
        • xlnz
          int[] xlnz
        • xnzsub
          int[] xnzsub
    • Class com.imsl.math.SparseCholesky.SymbolicFactor

      class SymbolicFactor extends Object implements Serializable
      serialVersionUID:
      -2515460315704131562L
      • Serialized Fields

        • flag
          int flag
        • invp
          int[] invp
        • maxlnz
          int[] maxlnz
        • maxsub
          int[] maxsub
        • multifrontal_space
          int[] multifrontal_space
        • nzsub
          int[] nzsub
        • perm
          int[] perm
        • xlnz
          int[] xlnz
        • xnzsub
          int[] xnzsub
    • Class com.imsl.math.SparseLP

      class SparseLP extends Object implements Serializable
      serialVersionUID:
      543468537251185077L
      • Serialized Fields

        • a
          SparseMatrix a
        • b
          double[] b
        • BIG
          double BIG
        • bu
          double[] bu
        • c
          double[] c
        • cp_largest
          double cp_largest
        • cp_smallest
          double cp_smallest
        • dlinf_tol
          double dlinf_tol
        • err_b
          double err_b
        • err_c
          double err_c
        • err_u
          double err_u
        • FALSE
          int FALSE
        • HB_col_ptr
          int[] HB_col_ptr
        • HB_format
          int HB_format
        • HB_row_ind
          int[] HB_row_ind
        • HB_values
          double[] HB_values
        • HOPDM_UNBOUNDED_FROM_ABOVE
          double HOPDM_UNBOUNDED_FROM_ABOVE
        • HOPDM_UNBOUNDED_FROM_BELOW
          double HOPDM_UNBOUNDED_FROM_BELOW
        • imdo
          int imdo
        • iprint
          int iprint
        • irtype
          int[] irtype
        • iteration_count
          int iteration_count
        • lv_isinqp
          int[] lv_isinqp
        • lv_L
          com.imsl.math.SparseLP.Mf_splinquadprog_Pb lv_L
        • lv_x
          double[] lv_x
        • m
          int m
        • max_itn
          int max_itn
        • n
          int n
        • nza
          int nza
        • obj
          double obj
        • obj_cnst
          double obj_cnst
        • opt_tol
          double[] opt_tol
        • pdual
          double[] pdual
        • presolve
          int presolve
        • prinf_tol
          double prinf_tol
        • term_status
          int term_status
        • TRUE
          int TRUE
        • user_bu
          int user_bu
        • xlb
          double[] xlb
        • xub
          double[] xub
    • Exception com.imsl.math.SparseLP.CholeskyFactorizationAccuracyException

      class CholeskyFactorizationAccuracyException extends IMSLException implements Serializable
      serialVersionUID:
      -5999241036816036044L
    • Exception com.imsl.math.SparseLP.DiagonalWeightMatrixException

      class DiagonalWeightMatrixException extends IMSLException implements Serializable
      serialVersionUID:
      -707963404562325415L
    • Exception com.imsl.math.SparseLP.DualInfeasibleException

      class DualInfeasibleException extends IMSLException implements Serializable
      serialVersionUID:
      -7329337025099565877L
    • Exception com.imsl.math.SparseLP.IllegalBoundsException

      class IllegalBoundsException extends IMSLException implements Serializable
      serialVersionUID:
      -6955348018064649521L
    • Exception com.imsl.math.SparseLP.IncorrectlyActiveException

      class IncorrectlyActiveException extends IMSLException implements Serializable
      serialVersionUID:
      7667214205556271946L
    • Exception com.imsl.math.SparseLP.IncorrectlyEliminatedException

      class IncorrectlyEliminatedException extends IMSLException implements Serializable
      serialVersionUID:
      5620077633836301940L
    • Exception com.imsl.math.SparseLP.InitialSolutionInfeasibleException

      class InitialSolutionInfeasibleException extends IMSLException implements Serializable
      serialVersionUID:
      6688729576613263681L
    • Exception com.imsl.math.SparseLP.PrimalInfeasibleException

      class PrimalInfeasibleException extends IMSLException implements Serializable
      serialVersionUID:
      4848584861951348656L
    • Exception com.imsl.math.SparseLP.PrimalUnboundedException

      class PrimalUnboundedException extends IMSLException implements Serializable
      serialVersionUID:
      -3421850266880073571L
    • Exception com.imsl.math.SparseLP.ProblemUnboundedException

      class ProblemUnboundedException extends IMSLException implements Serializable
      serialVersionUID:
      9022794977879141345L
    • Exception com.imsl.math.SparseLP.TooManyIterationsException

      class TooManyIterationsException extends IMSLException implements Serializable
      serialVersionUID:
      5038927651911140858L
    • Exception com.imsl.math.SparseLP.ZeroColumnException

      class ZeroColumnException extends IMSLException implements Serializable
      serialVersionUID:
      -4755983054123365682L
    • Exception com.imsl.math.SparseLP.ZeroRowException

      class ZeroRowException extends IMSLException implements Serializable
      serialVersionUID:
      2090453454838042719L
    • Class com.imsl.math.SparseMatrix

      class SparseMatrix extends Object implements Serializable
      serialVersionUID:
      4129725520868670733L
      • Serialized Fields

        • nColumns
          int nColumns
        • nRows
          int nRows
        • numberOfNonZeros
          long numberOfNonZeros
        • row
          com.imsl.math.SparseMatrix.Row[] row
    • Class com.imsl.math.Spline

      class Spline extends Object implements Serializable
      serialVersionUID:
      4999733042990553333L
      • Serialized Fields

        • breakPoint
          double[] breakPoint
          The breakpoint array of length n, where n is the number of piecewise polynomials.
        • coef
          double[][] coef
          Coefficients of the piecewise polynomials. This is an n by k array, where n is the number of piecewise polynomials and k is the order (degree+1) of the piecewise polynomials.

          coef[i] contains the coefficients for the piecewise polynomial valid in the interval [x[k],x[k+1]).

    • Class com.imsl.math.Spline2D

      class Spline2D extends Object implements Serializable
      serialVersionUID:
      -5972109423312292659L
      • Serialized Fields

        • b42j
          int b42j
        • b5itg_ilo
          int b5itg_ilo
        • deltal
          double[] deltal
        • deltar
          double[] deltar
        • derivative_x
          int derivative_x
        • derivative_y
          int derivative_y
        • grid
          int grid
        • lv_value
          double lv_value
        • output_vector
          double[] output_vector
        • spline_coef
          double[][] spline_coef
        • spline_domain_dim
          int spline_domain_dim
        • spline_knots
          double[][] spline_knots
        • spline_num_coef
          int[] spline_num_coef
        • spline_num_knots
          int[] spline_num_knots
        • spline_order
          int[] spline_order
        • spline_target_dim
          int spline_target_dim
        • x
          double x
        • xvec
          double[] xvec
        • y
          double y
        • yvec
          double[] yvec
    • Class com.imsl.math.Spline2DInterpolate

      class Spline2DInterpolate extends Spline2D implements Serializable
      serialVersionUID:
      -4200479299333083908L
      • Serialized Fields

        • fdata
          double[] fdata
        • knots_given
          int knots_given
        • order_given
          int order_given
        • users_knots
          double[][] users_knots
        • users_xorder
          int users_xorder
        • users_yorder
          int users_yorder
        • xdata
          double[] xdata
        • ydata
          double[] ydata
    • Class com.imsl.math.Spline2DLeastSquares

      class Spline2DLeastSquares extends Spline2D implements Serializable
      serialVersionUID:
      5055137588123530398L
      • Serialized Fields

        • fdata
          double[] fdata
        • order
          int[] order
        • sse
          double sse
        • users_knots
          double[][] users_knots
        • weights
          double[][] weights
        • x_spline_space_dim
          int x_spline_space_dim
        • xdata
          double[] xdata
        • y_spline_space_dim
          int y_spline_space_dim
        • ydata
          double[] ydata
    • Class com.imsl.math.SuperLU

      class SuperLU extends Object implements Serializable
      serialVersionUID:
      1972815006442816189L
      • Serialized Fields

        • A
          com.imsl.math.SuperMatrix A
        • AA
          com.imsl.math.SuperMatrix AA
        • AC
          com.imsl.math.SuperMatrix AC
        • AlreadyFactored
          boolean AlreadyFactored
        • B
          com.imsl.math.SuperMatrix B
        • b_colptr
          int[] b_colptr
        • b_rowind
          int[] b_rowind
        • berr
          double[] berr
        • C
          double[] C
        • colequ
          boolean colequ
        • ColPerm
          int ColPerm
        • ConditionNumber
          int ConditionNumber
        • dense
          double[] dense
        • DiagPivotThresh
          double DiagPivotThresh
        • equed
          int equed
        • equil
          boolean equil
        • Equil
          boolean Equil
        • etree
          int[] etree
        • expanders
          com.imsl.math.SuperLU.ExpHeader[] expanders
        • Fact
          int Fact
        • ferr
          double[] ferr
        • first_bmod
          int first_bmod
        • first_dfs
          int first_dfs
        • first_kid
          int[] first_kid
        • Glu
          com.imsl.math.SuperLU.GlobalLU_t Glu
        • info
          int[] info
        • iter_dlacon
          int iter_dlacon
        • IterRefine
          boolean IterRefine
        • j_dlacon
          int j_dlacon
        • jump_dlacon
          int jump_dlacon
        • L
          com.imsl.math.SuperMatrix L
        • lwork
          int lwork
        • marker
          int[] marker
        • mem_usage
          com.imsl.math.SuperLU.mem_usage_t mem_usage
        • nColsA
          int nColsA
        • next_kid
          int[] next_kid
        • no_expand
          int no_expand
        • nofact
          boolean nofact
        • notran
          boolean notran
        • nRowsA
          int nRowsA
        • panel_lsub
          int[] panel_lsub
        • parent
          int[] parent
        • perm_c
          int[] perm_c
        • perm_r
          int[] perm_r
        • PivotGrowth
          boolean PivotGrowth
        • post
          int[] post
        • postnum
          int postnum
        • pp
          int[] pp
        • PrintStat
          int PrintStat
        • R
          double[] R
        • rcond
          double[] rcond
        • recip_pivot_growth
          double recip_pivot_growth
        • repfnz
          int[] repfnz
        • rowequ
          boolean rowequ
        • segrep
          int[] segrep
        • sluStats
          com.imsl.math.SuperLU.Statistics sluStats
        • sp_ienv
          int[] sp_ienv
        • stat
          com.imsl.math.SuperLU.SuperLUStat_t stat
        • SymmetricMode
          boolean SymmetricMode
        • t0
          long t0
        • tempv
          double[] tempv
        • Trans
          int Trans
        • trant
          int trant
        • U
          com.imsl.math.SuperMatrix U
        • utime
          long[] utime
        • X
          com.imsl.math.SuperMatrix X
        • xplore
          int[] xplore
        • xprune
          int[] xprune
    • Exception com.imsl.math.SVD.DidNotConvergeException

      class DidNotConvergeException extends IMSLException implements Serializable
      serialVersionUID:
      2601109516729537550L
    • Class com.imsl.math.Transport

      class Transport extends Object implements Serializable
      serialVersionUID:
      -2674388895109448889L
      • Serialized Fields

        • costs
          double[][] costs
        • CPUs
          int CPUs
        • destinations
          double[] destinations
        • dual
          double[] dual
        • maxInteriorPointSteps
          int maxInteriorPointSteps
        • maxSimplexSteps
          int maxSimplexSteps
        • method
          Transport.SolutionMethod method
        • ns
          int ns
        • nw
          int nw
        • optimalRouting
          double[] optimalRouting
        • sources
          double[] sources
        • totalCost
          double[] totalCost
    • Exception com.imsl.math.Transport.TooManyIterationsException

      class TooManyIterationsException extends IMSLException implements Serializable
      serialVersionUID:
      2873236823188057550L
    • Exception com.imsl.math.Transport.UnexpectedErrorException

      class UnexpectedErrorException extends IMSLException implements Serializable
      serialVersionUID:
      5902813505053939219L
    • Class com.imsl.math.ZeroFunction

      class ZeroFunction extends Object implements Serializable
      serialVersionUID:
      -2378005396432268407L
      • Serialized Fields

        • errorAbsolute
          double errorAbsolute
          Deprecated.
        • errorRelative
          double errorRelative
          Deprecated.
        • iterations
          int[] iterations
          Deprecated.
        • maxIterations
          int maxIterations
          Deprecated.
        • spread
          double spread
          Deprecated.
        • spreadTolerance
          double spreadTolerance
          Deprecated.
    • Class com.imsl.math.ZeroPolynomial

      class ZeroPolynomial extends Object implements Serializable
      serialVersionUID:
      -7610934510539833820L
      • Serialized Fields

        • err
          boolean[] err
        • maxIterations
          int maxIterations
        • radius
          double[] radius
        • root
          Complex[] root
    • Exception com.imsl.math.ZeroPolynomial.DidNotConvergeException

      class DidNotConvergeException extends IMSLException implements Serializable
      serialVersionUID:
      2601109516729537550L
    • Class com.imsl.math.ZerosFunction

      class ZerosFunction extends Object implements Serializable
      serialVersionUID:
      -2378005396432268407L
      • Serialized Fields

        • compute
          boolean compute
        • eps
          double eps
        • errorAbsolute
          double errorAbsolute
        • errorX
          double errorX
        • haveBound
          boolean haveBound
        • lowerBound
          double lowerBound
        • maxEvals
          int maxEvals
        • minSeparation
          double minSeparation
        • nEvals
          int nEvals
        • numRoots
          int numRoots
        • numRootsFound
          int numRootsFound
        • roots
          double[] roots
        • toleranceMuller
          double toleranceMuller
        • upperBound
          double upperBound
        • userGuess
          boolean userGuess
        • xGuess
          double[] xGuess
        • xScale
          double xScale
    • Class com.imsl.math.ZeroSystem

      class ZeroSystem extends Object implements Serializable
      serialVersionUID:
      -1026233461882319787L
      • Serialized Fields

        • errorRelative
          double errorRelative
        • keyMessage
          String keyMessage
        • log
          boolean log
        • logger
          Logger logger
        • maxIterations
          int maxIterations
        • n
          int n
        • nameClass
          String nameClass
        • nameMethod
          String nameMethod
        • pmf
          PrintMatrixFormat pmf
        • x
          double[] x
        • xinit
          double[] xinit
    • Exception com.imsl.math.ZeroSystem.DidNotConvergeException

      class DidNotConvergeException extends IMSLException implements Serializable
      serialVersionUID:
      2601109516729537550L
    • Exception com.imsl.math.ZeroSystem.ToleranceTooSmallException

      class ToleranceTooSmallException extends IMSLException implements Serializable
      serialVersionUID:
      -2664854595423168722L
    • Exception com.imsl.math.ZeroSystem.TooManyIterationsException

      class TooManyIterationsException extends IMSLException implements Serializable
      serialVersionUID:
      5863349337242274171L
  • Package com.imsl.stat

    • Class com.imsl.stat.ANCOVA

      class ANCOVA extends Object implements Serializable
      serialVersionUID:
      377696961867547883L
      • Serialized Fields

        • anova
          double[] anova
        • anovaTables
          double[][] anovaTables
        • coef
          double[][] coef
        • coefTables
          double[][][] coefTables
        • covariates
          double[][][] covariates
        • covb
          double[][] covb
        • covm
          double[][] covm
        • ICALL
          int ICALL
        • ignore
          boolean[][] ignore
        • ldxy
          int ldxy
        • ni
          int[] ni
        • nmiss
          int[] nmiss
        • NPARM
          int NPARM
        • ntotal
          int ntotal
        • ptss
          double[] ptss
        • r
          double[][] r
        • responses
          double[][] responses
        • testpl
          double[] testpl
        • xymean
          double[][] xymean
    • Class com.imsl.stat.ANOVA

      class ANOVA extends Object implements Serializable
      serialVersionUID:
      5165916116763962117L
      • Serialized Fields

        • anova
          double[] anova
        • groupStdev
          double[] groupStdev
        • ngroups
          int ngroups
        • nmissing
          int nmissing
        • stat
          double[][] stat
        • y
          double[][] y
    • Class com.imsl.stat.ANOVAFactorial

      class ANOVAFactorial extends Object implements Serializable
      serialVersionUID:
      -4855462832688335499L
      • Serialized Fields

        • l_aov
          double[] l_aov
        • l_efss
          double[][] l_efss
        • l_model_order
          int l_model_order
        • l_model_user
          int l_model_user
        • l_nlevels
          int[] l_nlevels
        • l_nsubscripts
          int l_nsubscripts
        • l_sign_intera
          int l_sign_intera
        • l_y
          double[] l_y
        • l_ymeans
          double[] l_ymeans
    • Class com.imsl.stat.ARAutoUnivariate

      class ARAutoUnivariate extends Object implements Serializable
      serialVersionUID:
      -180470275739731115L
      • Serialized Fields

        • aic
          double aic
        • aicc
          double aicc
        • armaAR
          double[] armaAR
        • armaConstant
          double armaConstant
        • armaVar
          double armaVar
        • backwardOrigin
          int backwardOrigin
        • bic
          double bic
        • center
          boolean center
        • compute_flag
          boolean compute_flag
        • confidence
          double confidence
        • constant
          double constant
        • forecast_matrix
          double[][] forecast_matrix
        • iprint
          int iprint
        • keyMessage
          String keyMessage
        • l_convergence_tolerance
          double l_convergence_tolerance
        • l_dev
          double[] l_dev
        • l_forecast
          double[] l_forecast
        • l_infoCriterion
          int l_infoCriterion
        • l_psiWeights
          double[] l_psiWeights
        • logger
          Logger logger
        • maxarma_likelihood
          double maxarma_likelihood
        • maxit
          int maxit
        • maxlag
          int maxlag
        • method
          int method
        • nameClass
          String nameClass
        • nameMethod
          String nameMethod
        • nobs
          int nobs
        • npar
          int npar
        • p_constant
          double[] p_constant
        • par
          double[] par
        • residuals
          double[] residuals
        • success
          boolean success
        • variance
          double variance
        • z
          double[] z
        • z_mean
          double z_mean
    • Exception com.imsl.stat.ARAutoUnivariate.TriangularMatrixSingularException

      class TriangularMatrixSingularException extends IMSLException implements Serializable
      serialVersionUID:
      -463665995292370597L
    • Class com.imsl.stat.ARMA

      class ARMA extends Object implements Serializable
      serialVersionUID:
      7970084079175789473L
      • Serialized Fields

        • arma_info
          com.imsl.stat.ARMA.ARMAInfo arma_info
        • errorCode
          int errorCode
        • isComputed
          boolean isComputed
        • l_a_variance
          double l_a_variance
        • l_ar_init
          double[] l_ar_init
        • l_ar_lags
          int[] l_ar_lags
        • l_autocov
          double[] l_autocov
        • l_backward_origin
          int l_backward_origin
        • l_center
          int l_center
        • l_confidence
          double l_confidence
        • l_convergence_tolerance
          double l_convergence_tolerance
        • l_dev
          double[] l_dev
        • l_forecast
          double[] l_forecast
        • l_init_arlag
          int l_init_arlag
        • l_init_back
          int l_init_back
        • l_init_conv_tol
          int l_init_conv_tol
        • l_init_malag
          int l_init_malag
        • l_init_max_iter
          int l_init_max_iter
        • l_init_mean
          int l_init_mean
        • l_init_rel_error
          int l_init_rel_error
        • l_initial_est
          int l_initial_est
        • l_length
          int l_length
        • l_ma_init
          double[] l_ma_init
        • l_ma_lags
          int[] l_ma_lags
        • l_max_fcn_evaluations
          int l_max_fcn_evaluations
        • l_max_iterations
          int l_max_iterations
        • l_method
          int l_method
        • l_mutual_est
          int l_mutual_est
        • l_mutual_ls
          int l_mutual_ls
        • l_nobs
          int l_nobs
        • l_p
          int l_p
        • l_param_est_cov
          double[] l_param_est_cov
        • l_q
          int l_q
        • l_relative_error
          double l_relative_error
        • l_residual
          double[] l_residual
        • l_rw_mean
          double l_rw_mean
        • l_ss_residual
          double l_ss_residual
        • l_tolerance
          double l_tolerance
        • l_weight
          double[] l_weight
        • l_z
          double[] l_z
        • lv_aftol
          double lv_aftol
        • lv_arma
          double[] lv_arma
        • lv_deltap
          double lv_deltap
        • lv_falstl
          double lv_falstl
        • lv_fjactl
          double lv_fjactl
        • lv_fpnrmp
          double lv_fpnrmp
        • lv_gnleng
          double lv_gnleng
        • lv_maxfcn
          int lv_maxfcn
        • lv_maxjac
          int lv_maxjac
        • lv_mxiter
          int lv_mxiter
        • lv_nmaxs
          int lv_nmaxs
        • lv_nsing
          int lv_nsing
        • lv_phi
          double lv_phi
        • lv_phip
          double lv_phip
        • lv_phipi
          double lv_phipi
        • lv_rftol
          double lv_rftol
        • lv_sgnorm
          double lv_sgnorm
        • lv_steptl
          double lv_steptl
    • Exception com.imsl.stat.ARMA.IllConditionedException

      class IllConditionedException extends IMSLException implements Serializable
      serialVersionUID:
      6715068679376449398L
    • Exception com.imsl.stat.ARMA.IncreaseErrRelException

      class IncreaseErrRelException extends IMSLException implements Serializable
      serialVersionUID:
      -387792023600504312L
    • Exception com.imsl.stat.ARMA.MatrixSingularException

      class MatrixSingularException extends IMSLException implements Serializable
      serialVersionUID:
      5401198573160501348L
    • Exception com.imsl.stat.ARMA.NewInitialGuessException

      class NewInitialGuessException extends IMSLException implements Serializable
      serialVersionUID:
      7942990000530615355L
    • Exception com.imsl.stat.ARMA.ResidualsTooLargeException

      class ResidualsTooLargeException extends IMSLException implements Serializable
      serialVersionUID:
      -7564620735555256186L
    • Exception com.imsl.stat.ARMA.TooManyCallsException

      class TooManyCallsException extends IMSLException implements Serializable
      serialVersionUID:
      5613846061733543507L
    • Exception com.imsl.stat.ARMA.TooManyFcnEvalException

      class TooManyFcnEvalException extends IMSLException implements Serializable
      serialVersionUID:
      6042896554046301828L
    • Exception com.imsl.stat.ARMA.TooManyITNException

      class TooManyITNException extends IMSLException implements Serializable
      serialVersionUID:
      -7774212741650440569L
    • Exception com.imsl.stat.ARMA.TooManyJacobianEvalException

      class TooManyJacobianEvalException extends IMSLException implements Serializable
      serialVersionUID:
      -297544808360026173L
    • Class com.imsl.stat.ARMAEstimateMissing

      class ARMAEstimateMissing extends Object implements Serializable
      serialVersionUID:
      -6597006279833674216L
      • Serialized Fields

        • constant
          double constant
        • index
          double[] index
        • init_conv_tol
          int init_conv_tol
        • init_max_iter
          int init_max_iter
        • init_mean
          boolean init_mean
        • init_rel_error
          int init_rel_error
        • l_ar
          double[] l_ar
        • l_ar_method
          int l_ar_method
        • l_convergence_tolerance
          double l_convergence_tolerance
        • l_ma
          double[] l_ma
        • l_maxIteration
          int l_maxIteration
        • l_maxlag
          int l_maxlag
        • l_method
          int l_method
        • l_nobs
          int l_nobs
        • l_relative_error
          double l_relative_error
        • l_series
          double[] l_series
        • l_times
          int[] l_times
        • l_tpoints
          int[] l_tpoints
        • l_z
          double[] l_z
        • miss_index
          int[] miss_index
        • n_missing
          int n_missing
        • ner
          int ner
        • npar
          double npar
        • ntimes
          int ntimes
        • p_x
          double[] p_x
        • resx
          double[] resx
        • temp_ptr
          double[] temp_ptr
        • z_mean
          double z_mean
    • Class com.imsl.stat.ARMAMaxLikelihood

      class ARMAMaxLikelihood extends Object implements Serializable
      serialVersionUID:
      -1950325441449967597L
      • Serialized Fields

        • arSet
          boolean arSet
        • iprint
          int iprint
        • l_aic
          double l_aic
        • l_alph
          double[] l_alph
        • l_ar
          double[] l_ar
        • l_arma
          ARMA l_arma
        • l_backwardOrigin
          int l_backwardOrigin
        • l_confidence
          double l_confidence
        • l_constant
          double l_constant
        • l_dev
          double[] l_dev
        • l_eps3
          double l_eps3
        • l_eps4
          double l_eps4
        • l_epsa
          double l_epsa
        • l_f
          double[][] l_f
        • l_forecast
          double[] l_forecast
        • l_g
          double[] l_g
        • l_hs
          double[] l_hs
        • l_init_arlag
          int l_init_arlag
        • l_init_malag
          int l_init_malag
        • l_init_mean
          int l_init_mean
        • l_likelihood
          double l_likelihood
        • l_ma
          double[] l_ma
        • l_maxIterations
          int l_maxIterations
        • l_nobs
          int l_nobs
        • l_p
          int l_p
        • l_psiWeights
          double[] l_psiWeights
        • l_q
          int l_q
        • l_residuals
          double[] l_residuals
        • l_variance
          double l_variance
        • l_w_mean
          double l_w_mean
        • l_z
          double[] l_z
        • maSet
          boolean maSet
        • notComputed
          boolean notComputed
        • userInitialValues
          boolean userInitialValues
    • Exception com.imsl.stat.ARMAMaxLikelihood.NonInvertibleException

      class NonInvertibleException extends IMSLException implements Serializable
      serialVersionUID:
      -3156973066136974059L
    • Exception com.imsl.stat.ARMAMaxLikelihood.NonStationaryException

      class NonStationaryException extends IMSLException implements Serializable
      serialVersionUID:
      7206735494078835305L
    • Class com.imsl.stat.ARMAOutlierIdentification

      class ARMAOutlierIdentification extends Object implements Serializable
      serialVersionUID:
      3940075251439298502L
      • Serialized Fields

        • isComputed
          boolean isComputed
        • isForecasted
          boolean isForecasted
        • l_aic
          double[] l_aic
        • l_aicc
          double[] l_aicc
        • l_bic
          double[] l_bic
        • l_confidence
          double l_confidence
        • l_critical
          double l_critical
        • l_d
          int l_d
        • l_delta
          double l_delta
        • l_dev
          double[] l_dev
        • l_epsilon
          double l_epsilon
        • l_model
          int[] l_model
        • l_outfree_forecast
          double[] l_outfree_forecast
        • l_outlier_forecast
          double[] l_outlier_forecast
        • l_p
          int l_p
        • l_parameters
          double[] l_parameters
        • l_psi_weights
          double[] l_psi_weights
        • l_q
          int l_q
        • l_relative_error
          double l_relative_error
        • l_s
          int l_s
        • l_z
          double[] l_z
        • n_obs
          int n_obs
        • num_outliers
          int[] num_outliers
        • omega_arr
          double[] omega_arr
        • out_free_series
          double[] out_free_series
        • outlier_stat
          int[][] outlier_stat
        • res_series
          double[] res_series
        • res_sigma
          double res_sigma
        • sigma_arr
          double[] sigma_arr
        • tau_arr
          double[] tau_arr
    • Class com.imsl.stat.ARSeasonalFit

      class ARSeasonalFit extends Object implements Serializable
      serialVersionUID:
      5916508844888010928L
      • Serialized Fields

        • aic
          double aic
        • aicc
          double aicc
        • ar
          double[] ar
        • arOrder
          int arOrder
        • bic
          double bic
        • center
          int center
        • dInit
          int[][] dInit
        • exclude
          boolean exclude
        • l_infoCriterion
          int l_infoCriterion
        • maxlag
          int maxlag
        • nDifferences
          int nDifferences
        • nLost
          int nLost
        • notComputed
          boolean notComputed
        • optD
          int[] optD
        • optS
          int[] optS
        • par
          double[] par
        • sInit
          int[][] sInit
        • ts
          double[] ts
        • y
          double[] y
        • z
          double[] z
    • Class com.imsl.stat.AutoARIMA

      class AutoARIMA extends Object implements Serializable
      serialVersionUID:
      -4350310585155725070L
      • Serialized Fields

        • isComputed
          boolean isComputed
        • isForecasted
          boolean isForecasted
        • l_aic
          double[] l_aic
        • l_aicc
          double[] l_aicc
        • l_bic
          double[] l_bic
        • l_completeTimes
          int[] l_completeTimes
        • l_confidence
          double l_confidence
        • l_critical
          double l_critical
        • l_delta
          double l_delta
        • l_dev
          double[] l_dev
        • l_epsilon
          double l_epsilon
        • l_gapFreeSeries
          double[] l_gapFreeSeries
        • l_infoCriterion
          int l_infoCriterion
        • l_maxARLag
          int l_maxARLag
        • l_orders
          int[][] l_orders
        • l_outfree_forecast
          double[] l_outfree_forecast
        • l_outlier_forecast
          double[] l_outlier_forecast
        • l_parameters
          double[] l_parameters
        • l_periods
          int[][] l_periods
        • l_psi_weights
          double[] l_psi_weights
        • l_relativeError
          double l_relativeError
        • l_times
          int[] l_times
        • l_x
          double[] l_x
        • n_obs
          int n_obs
        • nObs
          int nObs
        • nObsActual
          int nObsActual
        • num_outliers
          int[] num_outliers
        • omega
          double[] omega
        • optimumModel
          int[] optimumModel
        • out_free_series
          double[] out_free_series
        • outlier_stat
          int[][] outlier_stat
        • res_series
          double[] res_series
        • res_sigma
          double[] res_sigma
    • Exception com.imsl.stat.AutoARIMA.NoAcceptableModelFoundException

      class NoAcceptableModelFoundException extends IMSLException implements Serializable
      serialVersionUID:
      7356132910652450123L
    • Class com.imsl.stat.AutoCorrelation

      class AutoCorrelation extends Object implements Serializable
      serialVersionUID:
      -8876255994124268413L
      • Serialized Fields

        • CPUs
          int CPUs
        • data
          double[] data
        • maxlag
          int maxlag
        • nobs
          int nobs
        • xmean
          double xmean
    • Exception com.imsl.stat.AutoCorrelation.NonPosVariancesException

      class NonPosVariancesException extends IMSLException implements Serializable
      serialVersionUID:
      -4710876870121028483L
    • Exception com.imsl.stat.CategoricalGenLinModel.ClassificationVariableException

      class ClassificationVariableException extends IMSLException implements Serializable
      serialVersionUID:
      2381793969232592891L
    • Exception com.imsl.stat.CategoricalGenLinModel.ClassificationVariableLimitException

      class ClassificationVariableLimitException extends IMSLException implements Serializable
      serialVersionUID:
      2666282754326775544L
    • Exception com.imsl.stat.CategoricalGenLinModel.ClassificationVariableValueException

      class ClassificationVariableValueException extends IMSLException implements Serializable
      serialVersionUID:
      -5556278926019721567L
    • Exception com.imsl.stat.CategoricalGenLinModel.DeleteObservationsException

      class DeleteObservationsException extends IMSLException implements Serializable
      serialVersionUID:
      8518088934840006476L
    • Exception com.imsl.stat.CategoricalGenLinModel.RankDeficientException

      class RankDeficientException extends IMSLException implements Serializable
      serialVersionUID:
      -5556278926019721567L
    • Exception com.imsl.stat.ChiSquaredTest.DidNotConvergeException

      class DidNotConvergeException extends IMSLException implements Serializable
      serialVersionUID:
      2601109516729537550L
    • Exception com.imsl.stat.ChiSquaredTest.NoObservationsException

      class NoObservationsException extends IMSLRuntimeException implements Serializable
      serialVersionUID:
      -7057390540654811891L
    • Exception com.imsl.stat.ChiSquaredTest.NotCDFException

      class NotCDFException extends IMSLRuntimeException implements Serializable
      serialVersionUID:
      -8168773442133345921L
    • Class com.imsl.stat.ClusterHierarchical

      class ClusterHierarchical extends Object implements Serializable
      serialVersionUID:
      5746430995559206476L
      • Serialized Fields

        • clevel
          double[] clevel
        • dist
          double[][] dist
        • errorCode
          int errorCode
        • iclson
          int[] iclson
        • icrson
          int[] icrson
        • method
          int method
        • npt
          int npt
        • transform
          int transform
    • Class com.imsl.stat.ClusterKMeans

      class ClusterKMeans extends Object implements Serializable
      serialVersionUID:
      -465564486042443473L
      • Serialized Fields

        • k
          int k
        • l_cm
          double[][] l_cm
        • l_freq
          double[] l_freq
        • l_ic1
          int[] l_ic1
        • l_maxit
          int l_maxit
        • l_nc
          int[] l_nc
        • l_nobs
          int l_nobs
        • l_swt
          double[][] l_swt
        • l_user_freq
          int l_user_freq
        • l_user_wt
          int l_user_wt
        • l_wss
          double[] l_wss
        • l_wt
          double[] l_wt
        • l_x
          double[][] l_x
        • mustCompute
          boolean mustCompute
        • startingCenters
          double[][] startingCenters
    • Exception com.imsl.stat.ClusterKMeans.ClusterNoPointsException

      class ClusterNoPointsException extends IMSLException implements Serializable
      serialVersionUID:
      8589841104103617978L
    • Exception com.imsl.stat.ClusterKMeans.NoConvergenceException

      class NoConvergenceException extends IMSLException implements Serializable
      serialVersionUID:
      8589841104103617978L
    • Exception com.imsl.stat.ClusterKMeans.NonnegativeFreqException

      class NonnegativeFreqException extends IMSLException implements Serializable
      serialVersionUID:
      5282683200869918415L
    • Exception com.imsl.stat.ClusterKMeans.NonnegativeWeightException

      class NonnegativeWeightException extends IMSLException implements Serializable
      serialVersionUID:
      -7659772815705384035L
    • Class com.imsl.stat.ClusterKNN

      class ClusterKNN extends Object implements Serializable
      serialVersionUID:
      3457098529504217970L
      • Serialized Fields

        • cat
          int[] cat
        • data
          double[][] data
        • distanceMethod
          int distanceMethod
        • M
          int M
        • N
          int N
        • n_cat
          int n_cat
        • ucat
          int[] ucat
    • Class com.imsl.stat.ContingencyTable

      class ContingencyTable extends Object implements Serializable
      serialVersionUID:
      5681667858818141882L
      • Serialized Fields

        • l_chi_squared
          double l_chi_squared
        • l_chi_squared_contributions
          double[] l_chi_squared_contributions
        • l_chi_squared_stats
          double[] l_chi_squared_stats
        • l_degree_freedom
          int l_degree_freedom
        • l_expected
          double[] l_expected
        • l_g_squared
          double l_g_squared
        • l_ncolumns
          int l_ncolumns
        • l_nrows
          int l_nrows
        • l_p_value
          double l_p_value
        • l_p_value2
          double l_p_value2
        • l_statistics
          double[] l_statistics
        • l_table
          double[] l_table
    • Class com.imsl.stat.Covariances

      class Covariances extends Object implements Serializable
      serialVersionUID:
      -1829942353762349947L
      • Serialized Fields

        • l_incidenceMatrix
          int[] l_incidenceMatrix
        • l_means
          double[] l_means
        • l_missingValueMethod
          int l_missingValueMethod
        • l_nrmiss
          int l_nrmiss
        • l_nrows
          int l_nrows
        • l_nvariables
          int l_nvariables
        • l_sum_weight
          double l_sum_weight
        • l_sumfreq
          int l_sumfreq
        • l_x
          double[] l_x
        • user_freq
          double[] user_freq
        • user_weights
          double[] user_weights
    • Exception com.imsl.stat.Covariances.DiffObsDeletedException

      class DiffObsDeletedException extends IMSLException implements Serializable
      serialVersionUID:
      -5468439983382059579L
    • Exception com.imsl.stat.Covariances.MoreObsDelThanEnteredException

      class MoreObsDelThanEnteredException extends IMSLException implements Serializable
      serialVersionUID:
      5387130416565002353L
    • Exception com.imsl.stat.Covariances.NonnegativeFreqException

      class NonnegativeFreqException extends IMSLException implements Serializable
      serialVersionUID:
      5282683200869918415L
    • Exception com.imsl.stat.Covariances.NonnegativeWeightException

      class NonnegativeWeightException extends IMSLException implements Serializable
      serialVersionUID:
      -7659772815705384035L
    • Exception com.imsl.stat.Covariances.TooManyObsDeletedException

      class TooManyObsDeletedException extends IMSLException implements Serializable
      serialVersionUID:
      -4516751236894295518L
    • Class com.imsl.stat.CrossCorrelation

      class CrossCorrelation extends Object implements Serializable
      serialVersionUID:
      -4449383558194661651L
      • Serialized Fields

        • dataX
          double[] dataX
        • dataY
          double[] dataY
        • maxlag
          int maxlag
        • meanX
          double meanX
        • meanY
          double meanY
        • nobs
          int nobs
    • Exception com.imsl.stat.CrossCorrelation.NonPosVariancesException

      class NonPosVariancesException extends IMSLException implements Serializable
      serialVersionUID:
      -4019180420350040444L
    • Class com.imsl.stat.DBSCAN

      class DBSCAN extends Object implements Serializable
      serialVersionUID:
      1876311602427313454L
      • Serialized Fields

        • CPUs
          int CPUs
        • distMatrix
          double[][] distMatrix
        • fcn
          DBSCAN.Function fcn
        • marker
          int[] marker
        • mustCompute
          boolean mustCompute
        • nElemsEpsEnv
          int[] nElemsEpsEnv
        • nObs
          int nObs
        • numClusters
          int numClusters
        • rStarTree
          int[][] rStarTree
    • Class com.imsl.stat.DBSCAN.DBSCANParams

      class DBSCANParams extends Object implements Serializable
      serialVersionUID:
      -1411057336910975624L
      • Serialized Fields

        • epsilon
          double epsilon
        • minPts
          int minPts
    • Class com.imsl.stat.Difference

      class Difference extends Object implements Serializable
      serialVersionUID:
      7580610626473671643L
      • Serialized Fields

        • imiss
          int imiss
        • iord
          int[] iord
        • iper
          int[] iper
        • ndiff
          int ndiff
        • nlost
          int nlost
        • nobsx
          int nobsx
        • user_supplied_order
          boolean user_supplied_order
    • Exception com.imsl.stat.DiscriminantAnalysis.CovarianceSingularException

      class CovarianceSingularException extends IMSLException implements Serializable
      serialVersionUID:
      -7905726011128187706L
    • Exception com.imsl.stat.DiscriminantAnalysis.EmptyGroupException

      class EmptyGroupException extends IMSLException implements Serializable
      serialVersionUID:
      7014912576719860840L
    • Exception com.imsl.stat.DiscriminantAnalysis.SumOfWeightsNegException

      class SumOfWeightsNegException extends IMSLException implements Serializable
      serialVersionUID:
      -5497503384035651323L
    • Class com.imsl.stat.Dissimilarities

      class Dissimilarities extends Object implements Serializable
      serialVersionUID:
      4861802467963720094L
      • Serialized Fields

        • distanceMatrix
          double[][] distanceMatrix
        • distanceMethod
          int distanceMethod
        • distanceScale
          int distanceScale
        • errorCode
          int errorCode
        • indexArray
          int[] indexArray
        • indexSet
          boolean indexSet
        • iRow
          int iRow
        • x
          double[][] x
    • Exception com.imsl.stat.Dissimilarities.NoPositiveVarianceException

      class NoPositiveVarianceException extends IMSLException implements Serializable
      serialVersionUID:
      6570223128306315531L
    • Exception com.imsl.stat.Dissimilarities.ScaleFactorZeroException

      class ScaleFactorZeroException extends IMSLException implements Serializable
      serialVersionUID:
      -4567123316299394964L
    • Exception com.imsl.stat.Dissimilarities.ZeroNormException

      class ZeroNormException extends IMSLException implements Serializable
      serialVersionUID:
      1021598580263564303L
    • Class com.imsl.stat.EGARCH

      class EGARCH extends ExtendedGARCH implements Serializable
      serialVersionUID:
      583842132094519955L
    • Class com.imsl.stat.EmpiricalQuantiles

      class EmpiricalQuantiles extends Object implements Serializable
      serialVersionUID:
      7275015374683873211L
      • Serialized Fields

        • AMACH3
          double AMACH3
        • AMACH4
          double AMACH4
        • AMACH8
          double AMACH8
        • nMissing
          int nMissing
        • NOBS
          int NOBS
        • nqprop
          int nqprop
        • Q
          double[] Q
        • XHi
          double[] XHi
        • XLo
          double[] XLo
    • Exception com.imsl.stat.EmpiricalQuantiles.ScaleFactorZeroException

      class ScaleFactorZeroException extends IMSLException implements Serializable
      serialVersionUID:
      -4567123316299394964L
    • Class com.imsl.stat.ExtendedGARCH

      class ExtendedGARCH extends Object implements Serializable
      serialVersionUID:
      -1005054131088120724L
      • Serialized Fields

        • archLags
          int archLags
        • arma
          ARMA arma
        • data
          double[] data
        • epsilon
          double[] epsilon
        • finalLogLikelihood
          double finalLogLikelihood
        • garchLags
          int garchLags
        • includeMean
          boolean includeMean
        • initialConditionalVariance
          boolean initialConditionalVariance
        • initialSigma2
          double[] initialSigma2
        • maxEvaluations
          int maxEvaluations
        • maxLag
          int maxLag
        • meanModel
          int[] meanModel
        • meanModelParameters
          double[] meanModelParameters
        • mustEstimate
          boolean mustEstimate
        • numberOfExogenousVars
          int numberOfExogenousVars
        • numberOfParameters
          int numberOfParameters
        • numberOfThreads
          int numberOfThreads
        • parameterLowerBounds
          double[] parameterLowerBounds
        • parameters
          double[] parameters
        • parameterUpperBounds
          double[] parameterUpperBounds
        • randomObject
          Random randomObject
        • sigma2
          double[] sigma2
        • solver
          ExtendedGARCH.Solver solver
        • T
          int T
        • tolerance
          double tolerance
        • values
          double[] values
        • xData
          double[][] xData
    • Class com.imsl.stat.FactorAnalysis

      class FactorAnalysis extends Object implements Serializable
      serialVersionUID:
      3013756310322875816L
      • Serialized Fields

        • A
          double[][] A
        • COV
          double[][] COV
        • DER
          double[] DER
        • EPS
          double EPS
        • EPSE
          double EPSE
        • EVAL
          double[] EVAL
        • EVEC
          double[][] EVEC
        • EVEC1
          double[][] EVEC1
        • GOTVECTORS
          boolean GOTVECTORS
        • ICOV
          int ICOV
        • IMTH
          int IMTH
        • IMTH1
          int IMTH1
        • INIT
          int INIT
        • initUniqueVars
          double[] initUniqueVars
        • inverseCovarianceMatrix
          double[][] inverseCovarianceMatrix
        • MAXIT
          int MAXIT
        • MAXSTP
          int MAXSTP
        • NDF
          int NDF
        • NF
          int NF
        • NVAR
          int NVAR
        • STAT
          double[] STAT
        • UNIQ
          double[] UNIQ
        • uniqueVarsArrayDefined
          boolean uniqueVarsArrayDefined
    • Exception com.imsl.stat.FactorAnalysis.BadVarianceException

      class BadVarianceException extends IMSLException implements Serializable
      serialVersionUID:
      -6970912099665971496L
    • Exception com.imsl.stat.FactorAnalysis.EigenvalueException

      class EigenvalueException extends IMSLException implements Serializable
      serialVersionUID:
      -3349915448942896802L
    • Exception com.imsl.stat.FactorAnalysis.NonPositiveEigenvalueException

      class NonPositiveEigenvalueException extends IMSLException implements Serializable
      serialVersionUID:
      -2075515127789038450L
    • Exception com.imsl.stat.FactorAnalysis.NotPositiveDefiniteException

      class NotPositiveDefiniteException extends IMSLException implements Serializable
      serialVersionUID:
      5873735064762060916L
    • Exception com.imsl.stat.FactorAnalysis.NotPositiveSemiDefiniteException

      class NotPositiveSemiDefiniteException extends IMSLException implements Serializable
      serialVersionUID:
      7149546182081549553L
    • Exception com.imsl.stat.FactorAnalysis.NotSemiDefiniteException

      class NotSemiDefiniteException extends IMSLException implements Serializable
      serialVersionUID:
      5989990002526018958L
    • Exception com.imsl.stat.FactorAnalysis.RankException

      class RankException extends IMSLException implements Serializable
      serialVersionUID:
      6136240998250904876L
    • Exception com.imsl.stat.FactorAnalysis.SingularException

      class SingularException extends IMSLException implements Serializable
      serialVersionUID:
      3836453898038287574L
    • Class com.imsl.stat.FaureSequence

      class FaureSequence extends Object implements Serializable
      serialVersionUID:
      8835883300561535875L
      • Serialization Methods

      • Serialized Fields

        • base
          int base
        • digitsN
          int[] digitsN
        • digitsY
          int[][] digitsY
        • nSkip
          int nSkip
    • Class com.imsl.stat.GammaDistribution

      class GammaDistribution extends Object implements Serializable
      serialVersionUID:
      -2100487246831529723L
      • Serialized Fields

        • gMean
          double gMean
        • logMean
          double logMean
        • mean
          double mean
        • scaleParameter
          double scaleParameter
        • shapeParameter
          double shapeParameter
    • Class com.imsl.stat.GARCH

      class GARCH extends Object implements Serializable
      serialVersionUID:
      5162634875950624877L
      • Serialized Fields

        • l_a
          double l_a
        • l_aic
          double l_aic
        • l_m
          int l_m
        • l_max_sigma
          double l_max_sigma
        • l_p
          int l_p
        • l_q
          int l_q
        • l_var
          double[] l_var
        • l_xguess
          double[] l_xguess
        • l_y
          double[] l_y
        • lv_coef_vector
          double[] lv_coef_vector
    • Exception com.imsl.stat.GARCH.ConstrInconsistentException

      class ConstrInconsistentException extends IMSLException implements Serializable
      serialVersionUID:
      8363339034536305334L
    • Exception com.imsl.stat.GARCH.EqConstrInconsistentException

      class EqConstrInconsistentException extends IMSLException implements Serializable
      serialVersionUID:
      -3980735923419642875L
    • Exception com.imsl.stat.GARCH.NoVectorXException

      class NoVectorXException extends IMSLException implements Serializable
      serialVersionUID:
      984478868740406324L
    • Exception com.imsl.stat.GARCH.TooManyIterationsException

      class TooManyIterationsException extends IMSLException implements Serializable
      serialVersionUID:
      -2775235009911054422L
    • Exception com.imsl.stat.GARCH.VarsDeterminedException

      class VarsDeterminedException extends IMSLException implements Serializable
      serialVersionUID:
      -4848764340361710192L
    • Class com.imsl.stat.HoltWintersExponentialSmoothing

      class HoltWintersExponentialSmoothing extends Object implements Serializable
      serialVersionUID:
      6316326508706575079L
      • Serialized Fields

        • confidence
          double confidence
        • cov
          double[] cov
        • f
          double[] f
        • incy
          int incy
        • isComputed
          boolean isComputed
        • isSetNumberEval
          boolean isSetNumberEval
        • lxlb
          double[] lxlb
        • lxub
          double[] lxub
        • n_obs
          int n_obs
        • nforecast
          int nforecast
        • ns
          int ns
        • nsamples
          int nsamples
        • nvars
          int nvars
        • params
          double[] params
        • params_user
          int params_user
        • sequences
          double[][] sequences
        • series_additive
          int series_additive
        • series_init
          int series_init
        • ts
          com.imsl.stat.HoltWintersExponentialSmoothing.TS ts
        • want_confidence
          int want_confidence
        • want_forecast
          int want_forecast
        • y
          double[] y
        • ysm
          double[] ysm
    • Class com.imsl.stat.InverseCdf

      class InverseCdf extends Object implements Serializable
      serialVersionUID:
      856736791554587805L
      • Serialized Fields

    • Exception com.imsl.stat.InverseCdf.DidNotConvergeException

      class DidNotConvergeException extends IMSLException implements Serializable
      serialVersionUID:
      2601109516729537550L
    • Class com.imsl.stat.KalmanFilter

      class KalmanFilter extends Object implements Serializable
      serialVersionUID:
      4313511618028926306L
      • Serialized Fields

        • l_alndet
          double[] l_alndet
        • l_b
          double[] l_b
        • l_covb
          double[] l_covb
        • l_covv
          double[] l_covv
        • l_iq
          int l_iq
        • l_it
          int l_it
        • l_n
          int[] l_n
        • l_nb
          int l_nb
        • l_ny
          int l_ny
        • l_q
          double[] l_q
        • l_r
          double[] l_r
        • l_ss
          double[] l_ss
        • l_t
          double[] l_t
        • l_tol
          double l_tol
        • l_update
          int l_update
        • l_v
          double[] l_v
        • l_y
          double[] l_y
        • l_z
          double[] l_z
    • Class com.imsl.stat.KaplanMeierECDF

      class KaplanMeierECDF extends Object implements Serializable
      serialVersionUID:
      -1662518781663172491L
      • Serialized Fields

        • cn
          int[] cn
        • dy
          double[] dy
        • fr
          int[] fr
        • have_censor
          boolean have_censor
        • have_freq
          boolean have_freq
        • isEvaluated
          boolean isEvaluated
        • nx
          int nx
        • x
          double[] x
        • ylen
          int ylen
    • Class com.imsl.stat.KaplanMeierEstimates

      class KaplanMeierEstimates extends Object implements Serializable
      serialVersionUID:
      7580610626473671643L
      • Serialized Fields

        • atRisk
          int[] atRisk
        • censorcol
          boolean censorcol
        • censorIndex
          int censorIndex
        • computed
          boolean computed
        • computed2
          boolean computed2
        • freqcol
          boolean freqcol
        • frequencyIndex
          int frequencyIndex
        • GroupIndex
          int GroupIndex
        • indkey
          int[] indkey
        • iperm
          int[] iperm
        • isrt
          int isrt
        • issorted
          boolean issorted
        • ncol
          int ncol
        • nFailing
          int[] nFailing
        • nobs
          int nobs
        • nrmiss
          int nrmiss
        • nStrata
          int nStrata
        • ProductLimitLikelihood
          double[] ProductLimitLikelihood
        • responseIndex
          int responseIndex
        • sprob
          double[][] sprob
        • stratumcol
          boolean stratumcol
        • stratumIndex
          int stratumIndex
        • TotalFailing
          int[] TotalFailing
        • TotalNumber
          int[] TotalNumber
        • wk
          double[] wk
        • X
          double[][] X
    • Class com.imsl.stat.KolmogorovOneSample

      class KolmogorovOneSample extends Object implements Serializable
      serialVersionUID:
      -6092171209181629650L
      • Serialized Fields

        • nTies
          int nTies
        • numberMissing
          int numberMissing
        • pdif
          double[] pdif
    • Class com.imsl.stat.KolmogorovTwoSample

      class KolmogorovTwoSample extends Object implements Serializable
      serialVersionUID:
      -3799159537586353443L
      • Serialized Fields

        • numberMissingX
          int numberMissingX
        • numberMissingY
          int numberMissingY
        • pdif
          double[] pdif
    • Class com.imsl.stat.LifeTables

      class LifeTables extends Object implements Serializable
      serialVersionUID:
      2998502234266666654L
      • Serialized Fields

        • a
          double[] a
        • age
          double[] age
        • idth
          int[] idth
        • ipop
          int[] ipop
        • n
          int n
        • npop
          int npop
        • table
          double[][] table
    • Class com.imsl.stat.LinearRegression

      class LinearRegression extends Object implements Serializable
      serialVersionUID:
      -9070175427330103613L
      • Serialized Fields

        • computeHouseholderQR
          boolean computeHouseholderQR
        • dfe
          double dfe
        • dfesv
          double dfesv
        • hasIntercept
          boolean hasIntercept
        • initialized
          boolean initialized
        • intcep
          int intcep
        • invPerm
          int[] invPerm
        • matrixR
          double[][] matrixR
        • ncoef
          int ncoef
        • nObservations
          int nObservations
        • nRank
          int nRank
        • nVariables
          int nVariables
        • pcmsv
          double pcmsv
        • pcpsv
          double pcpsv
        • perm
          int[] perm
        • rank
          double rank
        • rhs
          double[] rhs
        • sse
          double sse
        • sst
          double sst
        • sumW
          double sumW
        • sumY
          double sumY
        • tmsv
          double tmsv
        • tpsv
          double tpsv
    • Class com.imsl.stat.LinearRegression.CoefficientTTests

      class CoefficientTTests extends Object implements Serializable
      serialVersionUID:
      -8916227984228664483L
      • Serialized Fields

        • coef
          double[] coef
        • pValue
          double[] pValue
        • stderr
          double[] stderr
        • tstat
          double[] tstat
    • Class com.imsl.stat.LogNormalDistribution

      class LogNormalDistribution extends Object implements Serializable
      serialVersionUID:
      6938338633091805131L
      • Serialized Fields

        • mean
          double mean
        • standardDeviation
          double standardDeviation
    • Class com.imsl.stat.MersenneTwister

      class MersenneTwister extends Object implements Serializable
      serialVersionUID:
      8826443504868881672L
      • Serialized Fields

        • mt
          int[] mt
          State vector.
        • mti
          int mti
          Index into the state vector of the next random number.
    • Class com.imsl.stat.MersenneTwister64

      class MersenneTwister64 extends Object implements Serializable
      serialVersionUID:
      3018424897970696296L
      • Serialized Fields

        • mt
          long[] mt
          State vector.
        • mti
          int mti
          Index into the state vector of the next random number.
    • Class com.imsl.stat.MultiCrossCorrelation

      class MultiCrossCorrelation extends Object implements Serializable
      serialVersionUID:
      -1338307980684807806L
      • Serialized Fields

        • dataX
          double[][] dataX
        • dataY
          double[][] dataY
        • maxlag
          int maxlag
        • meanX
          double[] meanX
        • meanY
          double[] meanY
        • nchanX
          int nchanX
        • nchanY
          int nchanY
        • nobsX
          int nobsX
        • nobsY
          int nobsY
    • Exception com.imsl.stat.MultiCrossCorrelation.NonPosVariancesException

      class NonPosVariancesException extends IMSLException implements Serializable
      serialVersionUID:
      -4019180420350040444L
    • Class com.imsl.stat.MultidimensionalScaling

      class MultidimensionalScaling extends Object implements Serializable
      serialVersionUID:
      -2399336312858953424L
      • Serialized Fields

        • a
          double[] a
        • b
          double[] b
        • cfl
          double[] cfl
        • dissimilarityMatrix
          double[] dissimilarityMatrix
        • dist
          double[] dist
        • ICALL
          int ICALL
        • icnvt
          int icnvt
        • iprint
          int iprint
        • istrs
          int istrs
        • itrans
          int itrans
        • ldcfl
          int ldcfl
        • ldw
          int ldw
        • model
          int model
        • ndim
          int ndim
        • nstim
          int nstim
        • nsub
          int nsub
        • printMatrixConfig
          double[][] printMatrixConfig
        • printMatrixDist
          double[][] printMatrixDist
        • printSubjectWeights
          double[][] printSubjectWeights
        • printVectors
          double[] printVectors
        • resid
          double[] resid
        • strs
          double[] strs
        • strss
          double[] strss
        • w
          double[] w
        • wt
          double[] wt
    • Exception com.imsl.stat.MultidimensionalScaling.IllDefinedHessianException

      class IllDefinedHessianException extends IMSLException implements Serializable
      serialVersionUID:
      -4067245282573258298L
    • Exception com.imsl.stat.MultidimensionalScaling.NotEnoughPositiveEigenvaluesException

      class NotEnoughPositiveEigenvaluesException extends IMSLException implements Serializable
      serialVersionUID:
      -6657387502689726299L
    • Class com.imsl.stat.MultipleComparisons

      class MultipleComparisons extends Object implements Serializable
      serialVersionUID:
      4618755903674943586L
      • Serialized Fields

        • l_alpha
          double l_alpha
        • l_df
          int l_df
        • l_means
          double[] l_means
        • l_ngroups
          int l_ngroups
        • l_std_error
          double l_std_error
        • l_user_alpha
          int l_user_alpha
    • Class com.imsl.stat.NGARCH

      class NGARCH extends ExtendedGARCH implements Serializable
    • Exception com.imsl.stat.NonlinearRegression.NegativeFreqException

      class NegativeFreqException extends IMSLException implements Serializable
      serialVersionUID:
      8588234055587157665L
    • Exception com.imsl.stat.NonlinearRegression.NegativeWeightException

      class NegativeWeightException extends IMSLException implements Serializable
      serialVersionUID:
      -4377196587831506145L
    • Exception com.imsl.stat.NonlinearRegression.TooManyIterationsException

      class TooManyIterationsException extends IMSLException implements Serializable
      serialVersionUID:
      919296408977576890L
    • Class com.imsl.stat.NormalDistribution

      class NormalDistribution extends Object implements Serializable
      serialVersionUID:
      3612154147484926139L
      • Serialized Fields

        • mean
          double mean
        • stdDev
          double stdDev
    • Class com.imsl.stat.NormalityTest

      class NormalityTest extends Object implements Serializable
      serialVersionUID:
      2386246865937472472L
      • Serialized Fields

        • l_chi
          double l_chi
        • l_df
          double l_df
        • l_max
          double l_max
        • l_n
          int l_n
        • l_nobs
          int l_nobs
        • l_w
          double l_w
        • l_x
          double[] l_x
    • Exception com.imsl.stat.NormalityTest.NoVariationInputException

      class NoVariationInputException extends IMSLException implements Serializable
      serialVersionUID:
      7154577503639797028L
    • Class com.imsl.stat.NormOneSample

      class NormOneSample extends Object implements Serializable
      serialVersionUID:
      3530554923668996562L
      • Serialized Fields

        • chi_sqr_df
          int chi_sqr_df
        • chi_Sqr_Null
          double chi_Sqr_Null
        • chi_sqr_p_value
          double chi_sqr_p_value
        • chi_Sqr_Test
          int chi_Sqr_Test
        • chi_squared
          double chi_squared
        • ci_Variance
          int ci_Variance
        • ciMean
          int ciMean
        • code
          int code
        • confLevMean
          double confLevMean
        • confLevVar
          double confLevVar
        • data
          double[] data
        • denom
          double denom
        • ner
          int ner
        • num
          double num
        • return_Std
          int return_Std
        • summary
          Summary summary
        • t
          double t
        • t_df
          int t_df
        • t_Null
          double t_Null
        • t_p_value
          double t_p_value
        • t_Test
          int t_Test
    • Class com.imsl.stat.NormTwoSample

      class NormTwoSample extends Object implements Serializable
      serialVersionUID:
      2982545713331629393L
      • Serialized Fields

        • chiSqrNull
          double chiSqrNull
        • confLevMean
          double confLevMean
        • confLevVar
          double confLevVar
        • data1
          double[] data1
        • data1_len
          int data1_len
        • data2
          double[] data2
        • data2_len
          int data2_len
        • df_eq
          int df_eq
        • df_uneq
          double df_uneq
        • dirty
          boolean dirty
        • equalVar
          boolean equalVar
        • evCILowLimit
          double evCILowLimit
        • evCIUpLimit
          double evCIUpLimit
        • fProb
          double fProb
        • fval
          double fval
        • lowConfRatio
          double lowConfRatio
        • lower_conf_common
          double lower_conf_common
        • pooledVar
          double pooledVar
        • pval_eq
          double pval_eq
        • pval_uneq
          double pval_uneq
        • sdu
          double sdu
        • signx
          double signx
        • signy
          double signy
        • tNull
          double tNull
        • tval_eq
          double tval_eq
        • tval_uneq
          double tval_uneq
        • UpConfRatio
          double UpConfRatio
        • upper_conf_common
          double upper_conf_common
        • uvCILowLimit
          double uvCILowLimit
        • uvCIUpLimit
          double uvCIUpLimit
        • x1_mean
          double x1_mean
        • x1_miss
          double x1_miss
        • x1_nobs
          int x1_nobs
        • x1_var
          double x1_var
        • x1_var_calc
          double x1_var_calc
        • x2_mean
          double x2_mean
        • x2_miss
          double x2_miss
        • x2_nobs
          int x2_nobs
        • x2_var
          double x2_var
        • x2_var_calc
          double x2_var_calc
    • Class com.imsl.stat.PartialCovariances

      class PartialCovariances extends Object implements Serializable
      serialVersionUID:
      4298696628742302845L
      • Serialized Fields

        • dependent
          int[] dependent
          An array of containing the indices of the dependent variables. They have a one offset.
        • df
          int df
          Number of degrees of freedom associated with the input matrix.
        • irank
          int irank
          Rank of the dependent variables.
        • partialCovariances
          double[][] partialCovariances
          An array of containing the partial covariances.
    • Exception com.imsl.stat.PartialCovariances.InvalidMatrixException

      class InvalidMatrixException extends IMSLException implements Serializable
      serialVersionUID:
      -3741733686772839530L
    • Exception com.imsl.stat.PartialCovariances.InvalidPartialCorrelationException

      class InvalidPartialCorrelationException extends IMSLException implements Serializable
      serialVersionUID:
      -730455386899217387L
    • Exception com.imsl.stat.Pdf.AltSeriesAccuracyLossException

      class AltSeriesAccuracyLossException extends IMSLException implements Serializable
      serialVersionUID:
      -5497503384035651323L
    • Class com.imsl.stat.PoissonDistribution

      class PoissonDistribution extends Object implements Serializable
      serialVersionUID:
      7328077668315499996L
      • Serialized Fields

        • theta
          double theta
    • Class com.imsl.stat.PooledCovariances

      class PooledCovariances extends Object implements Serializable
      serialVersionUID:
      -1382128343263606613L
      • Serialized Fields

        • cov
          double[][] cov
        • d
          double[] d
        • dif
          double[] dif
        • frequencies
          double[] frequencies
        • groups
          int[] groups
        • haveCov
          boolean haveCov
        • haveFrq
          boolean haveFrq
        • haveWt
          boolean haveWt
        • ngroup
          int ngroup
        • ni
          int[] ni
        • nrmiss
          int nrmiss
        • nrow
          int nrow
        • nTotalObs
          int nTotalObs
        • nvar
          int nvar
        • ob
          double[] ob
        • sparam
          double[] sparam
        • sumwt
          double[] sumwt
        • weights
          double[] weights
        • x
          double[][] x
        • xmean
          double[][] xmean
        • xval
          double[][] xval
    • Class com.imsl.stat.ProportionalHazards

      class ProportionalHazards extends Object implements Serializable
      serialVersionUID:
      7580610626473671643L
      • Serialized Fields

        • ALGL
          double ALGL
        • atRisk
          int[] atRisk
        • case_
          double[][] case_
        • censorcol
          boolean censorcol
        • clval
          double[] clval
        • cnt
          int cnt
        • coef
          double[][] coef
        • computed
          boolean computed
        • computed2
          boolean computed2
        • cov
          double[][] cov
        • eps
          double eps
        • fixcol
          boolean fixcol
        • freqcol
          boolean freqcol
        • gr
          double[] gr
        • GroupIndex
          int GroupIndex
        • icen
          int icen
        • ifix
          int ifix
        • ifrq
          int ifrq
        • IGRP
          int[] IGRP
        • indcl
          int[] indcl
        • indef
          int[] indef
        • indkey
          int[] indkey
        • init
          int init
        • InitialEstSet
          boolean InitialEstSet
        • iperm
          int[] iperm
        • irt
          int irt
        • istrat
          int istrat
        • itie
          int itie
        • keyMessage
          String keyMessage
        • log
          boolean log
        • logger
          Logger logger
        • ltcol
          boolean ltcol
        • maxcl
          int maxcl
        • maxit
          int maxit
        • nameClass
          String nameClass
        • nameMethod
          String nameMethod
        • nclval
          int[] nclval
        • nclvar
          int nclvar
        • ncoef
          int[] ncoef
        • ncol
          int ncol
        • nef
          int nef
        • nFailing
          int[] nFailing
        • nobs
          int nobs
        • nrmiss
          int[] nrmiss
        • nrow
          int nrow
        • nvef
          int[] nvef
        • parcol
          boolean parcol
        • pmf
          PrintMatrixFormat pmf
        • pmf_exp
          PrintMatrixFormat pmf_exp
        • pms
          com.imsl.math.PrintMatrixString pms
        • ProductLimitLikelihood
          double[] ProductLimitLikelihood
        • ratio
          double ratio
        • rtcol
          boolean rtcol
        • SavedInitialEstimates
          double[] SavedInitialEstimates
        • savedIterationCount
          int savedIterationCount
        • sprob
          double[][] sprob
        • stratumcol
          boolean stratumcol
        • TotalFailing
          int[] TotalFailing
        • TotalNumber
          int[] TotalNumber
        • WantHessian
          boolean WantHessian
        • wk
          double[] wk
        • X
          double[][] X
        • xmean
          double[] xmean
    • Exception com.imsl.stat.ProportionalHazards.ClassificationVariableLimitException

      class ClassificationVariableLimitException extends IMSLException implements Serializable
      serialVersionUID:
      2666282754326775544L
    • Class com.imsl.stat.Random

      class Random extends Random implements Serializable
      serialVersionUID:
      -5897953277302592472L
      • Serialized Fields

        • baseGenerator
          Random.BaseGenerator baseGenerator
        • DUiwk
          int[] DUiwk
        • DUwk
          double[] DUwk
        • multiplier
          long multiplier
        • probs
          double[] probs
        • seed
          long seed
    • Class com.imsl.stat.RegressorsForGLM

      class RegressorsForGLM extends Object implements Serializable
      serialVersionUID:
      351364096931914156L
      • Serialized Fields

        • classColumns
          int[] classColumns
          Array of length equal to nClassVariables containing the indices of the class columns in the data matrix x.
        • classValues
          Map<Double,Integer>[] classValues
          Array of length equal to nClassVariables. Each element contains a mapping from a double to its integer encoding.
        • dummyMethod
          int dummyMethod
          The dummy method.
        • effects
          int[][] effects
          The effects array. This is a jagged array. The number of rows equals the number of effects.
        • nClassVariables
          int nClassVariables
          The number of classifcation variables.
        • nContinuousVariables
          int nContinuousVariables
          The number of continuous variables.
        • numberOfMissingRows
          int numberOfMissingRows
          The number of rows containing missing data (NaNs in the data matrix).
        • nVariables
          int nVariables
          The number of variables.
        • x
          double[][] x
          The data matrix.
    • Class com.imsl.stat.SelectionRegression

      class SelectionRegression extends Object implements Serializable
      serialVersionUID:
      7150561244213300145L
      • Serialized Fields

        • covMatrix
          double[][] covMatrix
        • icrit
          int icrit
        • nbest
          int nbest
        • ngood
          int ngood
        • nObservations
          int nObservations
        • nsize
          int nsize
        • numBestModels
          int numBestModels
        • nVariables
          int nVariables
        • srStats
          SelectionRegression.Statistics srStats
    • Exception com.imsl.stat.SelectionRegression.NoVariablesException

      class NoVariablesException extends IMSLException implements Serializable
      serialVersionUID:
      1278104567386284922L
    • Class com.imsl.stat.SelectionRegression.Statistics

      class Statistics extends Object implements Serializable
      serialVersionUID:
      7816350226388810467L
      • Serialized Fields

        • coef
          double[][] coef
        • crit
          double[] crit
        • ibest
          int ibest
        • icoefx
          int[] icoefx
        • icritx
          int[] icritx
        • indvar
          int[] indvar
        • ivarx
          int[] ivarx
    • Class com.imsl.stat.SignTest

      class SignTest extends Object implements Serializable
      serialVersionUID:
      -3915910002123092365L
      • Serialized Fields

        • l_nobs
          int l_nobs
        • l_npos
          int l_npos
        • l_ntie
          int l_ntie
        • l_percentage
          double l_percentage
        • l_percentage_user
          int l_percentage_user
        • l_percentile
          double l_percentile
        • l_percentile_user
          int l_percentile_user
        • l_x
          double[] l_x
    • Class com.imsl.stat.StepwiseRegression

      class StepwiseRegression extends Object implements Serializable
      serialVersionUID:
      8924001906082644703L
      • Serialized Fields

        • anova
          ANOVA anova
        • aov
          double[] aov
        • coef
          double[][] coef
        • covb
          double[][] covb
        • covMatrix
          double[][] covMatrix
        • endFlag
          boolean endFlag
        • hist
          double[] hist
        • iend
          int[] iend
        • initFlag
          boolean initFlag
        • invoke
          int invoke
        • istep
          int istep
        • level
          int[] level
        • nforce
          int nforce
        • nObservations
          int nObservations
        • nstep
          int nstep
        • nVariables
          int nVariables
        • pValueIn
          double pValueIn
        • pValueOut
          double pValueOut
        • swept
          double[] swept
        • tolerance
          double tolerance
        • xmean
          double[] xmean
        • xmeanFlag
          boolean xmeanFlag
    • Class com.imsl.stat.StepwiseRegression.CoefficientTTests

      class CoefficientTTests extends Object implements Serializable
      serialVersionUID:
      -8036185823167623551L
      • Serialized Fields

        • coefEst
          double[] coefEst
        • pValue
          double[] pValue
        • stderr
          double[] stderr
        • tstat
          double[] tstat
    • Exception com.imsl.stat.StepwiseRegression.CyclingIsOccurringException

      class CyclingIsOccurringException extends IMSLException implements Serializable
      serialVersionUID:
      -6294071609821925385L
    • Exception com.imsl.stat.StepwiseRegression.NoVariablesEnteredException

      class NoVariablesEnteredException extends IMSLException implements Serializable
      serialVersionUID:
      1278104567386284922L
    • Class com.imsl.stat.Summary

      class Summary extends Object implements Serializable
      serialVersionUID:
      8891031865797959919L
      • Serialized Fields

        • max
          double max
          Contains the smallest and largest values seen so far.
        • min
          double min
          Contains the smallest and largest values seen so far.
        • nObs
          int nObs
          Contains the total number of observations.
        • sumw
          double sumw
          Contain the sums of x, (x-xmean)^2, (x-xmean)^3, (x-xmean)^4, and w.
        • sumx
          double sumx
          Contain the sums of x, (x-xmean)^2, (x-xmean)^3, (x-xmean)^4, and w.
        • sumx2
          double sumx2
          Contain the sums of x, (x-xmean)^2, (x-xmean)^3, (x-xmean)^4, and w.
        • sumx3
          double sumx3
          Contain the sums of x, (x-xmean)^2, (x-xmean)^3, (x-xmean)^4, and w.
        • sumx4
          double sumx4
          Contain the sums of x, (x-xmean)^2, (x-xmean)^3, (x-xmean)^4, and w.
    • Class com.imsl.stat.TableMultiWay

      class TableMultiWay extends Object implements Serializable
      serialVersionUID:
      7971175809241686181L
      • Serialized Fields

        • frq
          double[] frq
        • ifrq
          int ifrq
        • indkeys
          int[] indkeys
        • iperm
          int[] iperm
        • n_keys
          int n_keys
        • ncol
          int ncol
        • nrow
          int nrow
        • ra
          double[][] ra
        • sortd
          com.imsl.stat.OldSort.SortData sortd
    • Class com.imsl.stat.TableOneWay

      class TableOneWay extends Object implements Serializable
      serialVersionUID:
      6958839014602683978L
      • Serialized Fields

        • nIntervals
          int nIntervals
        • xData
          double[] xData
    • Class com.imsl.stat.TableTwoWay

      class TableTwoWay extends Object implements Serializable
      serialVersionUID:
      -7425749030256908047L
      • Serialized Fields

        • xData
          double[] xData
        • xIntervals
          int xIntervals
        • yData
          double[] yData
        • yIntervals
          int yIntervals
    • Class com.imsl.stat.TimeSeries

      class TimeSeries extends Object implements Serializable
      serialVersionUID:
      -3945936197903253164L
      • Serialized Fields

        • calendar
          GregorianCalendar calendar
        • dateIncrement
          long dateIncrement
        • dates
          Date[] dates
        • hasDates
          boolean hasDates
        • incrementInMillis
          boolean incrementInMillis
        • missingIndicator
          int[][] missingIndicator
        • numMissing
          int numMissing
        • numSeries
          int numSeries
        • startDate
          Date startDate
        • timeIndex
          int[] timeIndex
        • values
          double[][] values
        • xdata
          double[][] xdata
    • Class com.imsl.stat.TimeSeriesOperations

      class TimeSeriesOperations extends Object implements Serializable
      serialVersionUID:
      1869062097234018028L
    • Class com.imsl.stat.VectorAutoregression

      class VectorAutoregression extends Object implements Serializable
      serialVersionUID:
      -1760137286598051962L
      • Serialized Fields

        • A0
          boolean A0
        • A0Indicator
          int A0Indicator
        • ARConstants
          double[] ARConstants
        • arLag
          int arLag
        • ARModel
          int[] ARModel
        • center
          boolean center
        • forecasts
          double[][] forecasts
        • K
          int K
        • MAConstants
          double[] MAConstants
        • maLag
          int maLag
        • MAModel
          int[] MAModel
        • maxLag
          int maxLag
        • maxSteps
          int maxSteps
        • modelConstants
          double[][] modelConstants
        • modelParameters
          int[][] modelParameters
        • mustEstimate
          boolean mustEstimate
        • mustSetUpModel
          boolean mustSetUpModel
        • nT
          int nT
        • numVars
          int numVars
        • parameterEstimates
          double[] parameterEstimates
        • residuals
          double[] residuals
        • scale
          boolean scale
        • T
          int T
        • trend
          boolean trend
        • ts
          TimeSeries ts
        • xData
          double[][] xData
        • y
          double[][] y
    • Class com.imsl.stat.WelchsTTest

      class WelchsTTest extends Object implements Serializable
    • Class com.imsl.stat.WilcoxonRankSum

      class WilcoxonRankSum extends Object implements Serializable
      serialVersionUID:
      -3581964675326465291L
      • Serialized Fields

        • l_fuzz
          double l_fuzz
        • l_mann_whitney
          double l_mann_whitney
        • l_nmissx
          int l_nmissx
        • l_nmissy
          int l_nmissy
        • l_nobsx
          int l_nobsx
        • l_nobsy
          int l_nobsy
        • l_pvalues
          double[] l_pvalues
        • l_stat
          double[] l_stat
        • l_user_fuzz
          int l_user_fuzz
        • l_x
          double[] l_x
        • l_y
          double[] l_y
  • Package com.imsl.stat.distributions

  • Package com.imsl.test.example.datamining

  • Package com.imsl.test.example.datamining.neural

  • Package com.imsl.test.example.math