Uses of Interface
org.ojalgo.matrix.store.MatrixStore
Packages that use MatrixStore
Package
Description
-
Uses of MatrixStore in org.ojalgo.ann
Methods in org.ojalgo.ann that return MatrixStoreModifier and TypeMethodDescription(package private) MatrixStore
<Double> CalculationLayer.getLogicalWeights()
The input argument is typed asAccess1D
which essentially means it can be anything.(package private) MatrixStore
<Double> WrappedANN.invoke
(Access1D<Double> input, TrainingConfiguration configuration) Methods in org.ojalgo.ann that return types with arguments of type MatrixStoreModifier and TypeMethodDescription(package private) List
<MatrixStore<Double>> ArtificialNeuralNetwork.getWeights()
(package private) List
<MatrixStore<Double>> WrappedANN.getWeights()
-
Uses of MatrixStore in org.ojalgo.data.image
Classes in org.ojalgo.data.image that implement MatrixStoreModifier and TypeClassDescriptionclass
Treats an image as a matrix.(package private) static final class
Methods in org.ojalgo.data.image with parameters of type MatrixStoreModifier and TypeMethodDescriptionstatic ImageData
ImageData.fromFrequencyDomain
(MatrixStore<ComplexNumber> transformed) Creates a new image, transforming the input (back) from the frequency domain to the spatial domain using the inverse discrete Fourier transform. -
Uses of MatrixStore in org.ojalgo.data.transform
Methods in org.ojalgo.data.transform that return MatrixStoreModifier and TypeMethodDescriptionstatic MatrixStore
<ComplexNumber> This method computes the discrete Fourier transform (DFT) of a sequence of real numbers.final MatrixStore
<ComplexNumber> DiscreteFourierTransform.inverse
(Access1D<ComplexNumber> input) static MatrixStore
<ComplexNumber> DiscreteFourierTransform.inverse2D
(MatrixStore<?> input) static MatrixStore
<ComplexNumber> DiscreteFourierTransform.sample
(DoubleUnaryOperator function, PrimitiveFunction.SampleDomain sampleDomain) Sample, and transform, a function using the Discrete Fourier Transform.static MatrixStore
<ComplexNumber> DiscreteFourierTransform.sample
(PeriodicFunction function, int nbSamples) static <N extends Comparable<N>>
MatrixStore<N> DiscreteFourierTransform.shift
(MatrixStore<N> matrix) There is a symmetry in the DFT matrix.DiscreteFourierTransform.FFT.transform
(double... input) DiscreteFourierTransform.transform
(double... input) final MatrixStore
<ComplexNumber> static MatrixStore
<ComplexNumber> DiscreteFourierTransform.transform2D
(MatrixStore<?> input) Perform a 2D Discrete Fourier Transform on the input matrix.Methods in org.ojalgo.data.transform with parameters of type MatrixStoreModifier and TypeMethodDescriptionstatic MatrixStore
<ComplexNumber> DiscreteFourierTransform.inverse2D
(MatrixStore<?> input) static <N extends Comparable<N>>
MatrixStore<N> DiscreteFourierTransform.shift
(MatrixStore<N> matrix) There is a symmetry in the DFT matrix.static MatrixStore
<ComplexNumber> DiscreteFourierTransform.transform2D
(MatrixStore<?> input) Perform a 2D Discrete Fourier Transform on the input matrix.static void
DiscreteFourierTransform.transform2D
(MatrixStore<?> input, DiscreteFourierTransform.Directive directive, TransformableRegion<ComplexNumber> output) -
Uses of MatrixStore in org.ojalgo.function.multiary
Fields in org.ojalgo.function.multiary declared as MatrixStoreModifier and TypeFieldDescriptionprivate final MatrixStore
<N> AffineFunction.myCoefficients
private final MatrixStore
<N> LinearFunction.myCoefficients
private final MatrixStore
<N> PureQuadraticFunction.myCoefficients
Methods in org.ojalgo.function.multiary that return MatrixStoreModifier and TypeMethodDescriptionAffineFunction.getGradient
(Access1D<N> point) ConstantFunction.getGradient
(Access1D<N> point) FirstOrderApproximation.getGradient
(Access1D<N> point) LinearFunction.getGradient
(Access1D<N> point) MultiaryFunction.TwiceDifferentiable.getGradient
(Access1D<N> point) The gradient of a scalar field is a vector field that points in the direction of the greatest rate of increase of the scalar field, and whose magnitude is that rate of increase.PureQuadraticFunction.getGradient
(Access1D<N> point) QuadraticFunction.getGradient
(Access1D<N> point) SecondOrderApproximation.getGradient
(Access1D<N> point) AffineFunction.getHessian
(Access1D<N> point) ConstantFunction.getHessian
(Access1D<N> point) FirstOrderApproximation.getHessian
(Access1D<N> point) LinearFunction.getHessian
(Access1D<N> point) MultiaryFunction.TwiceDifferentiable.getHessian
(Access1D<N> point) The Hessian matrix or Hessian is a square matrix of second-order partial derivatives of a function.PureQuadraticFunction.getHessian
(Access1D<N> point) QuadraticFunction.getHessian
(Access1D<N> point) SecondOrderApproximation.getHessian
(Access1D<N> point) AffineFunction.getLinearFactors
(boolean negated) ApproximateFunction.getLinearFactors
(boolean negated) ConstantFunction.getLinearFactors
(boolean negated) LinearFunction.getLinearFactors
(boolean negated) MultiaryFunction.TwiceDifferentiable.getLinearFactors
(boolean negated) PureQuadraticFunction.getLinearFactors
(boolean negated) QuadraticFunction.getLinearFactors
(boolean negated) Constructors in org.ojalgo.function.multiary with parameters of type MatrixStoreModifierConstructorDescription(package private)
AffineFunction
(MatrixStore<N> coefficients) (package private)
LinearFunction
(MatrixStore<N> coefficients) (package private)
PureQuadraticFunction
(MatrixStore<N> coefficients) (package private)
QuadraticFunction
(MatrixStore<N> quadratic, MatrixStore<N> linear) -
Uses of MatrixStore in org.ojalgo.matrix
Fields in org.ojalgo.matrix declared as MatrixStoreMethods in org.ojalgo.matrix that return MatrixStoreMethods in org.ojalgo.matrix that return types with arguments of type MatrixStoreModifier and TypeMethodDescriptionprivate Provider2D.Inverse
<Optional<MatrixStore<N>>> BasicMatrix.getInverseProvider
(boolean safe) private Provider2D.Solution
<Optional<MatrixStore<N>>> BasicMatrix.getSolutionProvider
(boolean safe, Access2D<?> rhs) Methods in org.ojalgo.matrix with parameters of type MatrixStoreModifier and TypeMethodDescription(package private) abstract M
DenseMutator2D.instantiate
(MatrixStore<N> store) (package private) MatrixC128
MatrixC128.DenseReceiver.instantiate
(MatrixStore<ComplexNumber> store) (package private) MatrixC128
MatrixC128.SparseReceiver.instantiate
(MatrixStore<ComplexNumber> store) (package private) MatrixH256
MatrixH256.DenseReceiver.instantiate
(MatrixStore<Quaternion> store) (package private) MatrixH256
MatrixH256.SparseReceiver.instantiate
(MatrixStore<Quaternion> store) (package private) MatrixQ128
MatrixQ128.DenseReceiver.instantiate
(MatrixStore<RationalNumber> store) (package private) MatrixQ128
MatrixQ128.SparseReceiver.instantiate
(MatrixStore<RationalNumber> store) (package private) MatrixR032
MatrixR032.DenseReceiver.instantiate
(MatrixStore<Double> store) (package private) MatrixR032
MatrixR032.SparseReceiver.instantiate
(MatrixStore<Double> store) (package private) MatrixR064
MatrixR064.DenseReceiver.instantiate
(MatrixStore<Double> store) (package private) MatrixR064
MatrixR064.SparseReceiver.instantiate
(MatrixStore<Double> store) (package private) MatrixR128
MatrixR128.DenseReceiver.instantiate
(MatrixStore<Quadruple> store) (package private) MatrixR128
MatrixR128.SparseReceiver.instantiate
(MatrixStore<Quadruple> store) (package private) abstract M
SparseMutator2D.instantiate
(MatrixStore<N> store) -
Uses of MatrixStore in org.ojalgo.matrix.decomposition
Subinterfaces of MatrixStore in org.ojalgo.matrix.decompositionModifier and TypeInterfaceDescriptioninterface
DecompositionStore<N extends Comparable<N>>
Only classes that will act as a delegate to a MatrixDecomposition implementation from this package should implement this interface.Fields in org.ojalgo.matrix.decomposition declared as MatrixStoreModifier and TypeFieldDescriptionprivate MatrixStore
<N> EigenvalueDecomposition.myD
private MatrixStore
<N> SingularValueDecomposition.myD
private MatrixStore
<N> TridiagonalDecomposition.myD
private MatrixStore
<N> HermitianEvD.myInverse
private MatrixStore
<Double> RawEigenvalue.myInverse
private MatrixStore
<N> SingularValueDecomposition.myInverse
private MatrixStore
<N> SingularValueDecomposition.myU
private MatrixStore
<N> EigenvalueDecomposition.myV
private MatrixStore
<N> SingularValueDecomposition.myV
Methods in org.ojalgo.matrix.decomposition that return MatrixStoreModifier and TypeMethodDescriptionprotected final MatrixStore
<N> GenericDecomposition.collect
(Access2D.Collectable<N, ? super DecompositionStore<N>> source) protected MatrixStore
<Double> RawDecomposition.collect
(Access2D.Collectable<Double, ? super DecompositionStore<Double>> source) private MatrixStore
<Double> RawCholesky.doGetInverse
(PhysicalStore<Double> preallocated) private MatrixStore
<Double> RawLU.doGetInverse
(PhysicalStore<Double> preallocated) private MatrixStore
<Double> RawQR.doGetInverse
(R064Store preallocated) Makes no use ofpreallocated
at all.(package private) MatrixStore
<Double> RawSingularValue.doGetInverse
(R064Store preallocated) private MatrixStore
<Double> RawCholesky.doSolve
(PhysicalStore<Double> preallocated) private MatrixStore
<Double> RawLU.doSolve
(PhysicalStore<Double> preallocated) private MatrixStore
<Double> RawSingularValue.getCovariance()
SingularValue.getCovariance()
SingularValueDecomposition.getCovariance()
Bidiagonal.getD()
BidiagonalDecomposition.getD()
Eigenvalue.getD()
The only requirements on [D] are that it should contain the eigenvalues and that [A][V] = [V][D].final MatrixStore
<N> EigenvalueDecomposition.getD()
LDL.getD()
LDLDecomposition.getD()
RawEigenvalue.getD()
Return the block diagonal eigenvalue matrixRawSingularValue.getD()
SingularValue.getD()
SingularValueDecomposition.getD()
Tridiagonal.getD()
final MatrixStore
<N> TridiagonalDecomposition.getD()
default MatrixStore
<ComplexNumber> Eigenvalue.getEigenvectors()
Hessenberg.getH()
final MatrixStore
<N> HessenbergDecomposition.getH()
CholeskyDecomposition.getInverse
(PhysicalStore<N> preallocated) GeneralEvD.getInverse()
GeneralEvD.getInverse
(DecompositionStore<N> newPreallocated) HermitianEvD.getInverse()
HermitianEvD.getInverse
(PhysicalStore<N> preallocated) InPlaceDecomposition.getInverse()
InPlaceDecomposition.getInverse
(PhysicalStore<N> preallocated) LDLDecomposition.getInverse
(PhysicalStore<N> preallocated) LUDecomposition.getInverse
(PhysicalStore<N> preallocated) MatrixDecomposition.Solver.getInverse()
The output must be a "right inverse" and a "generalised inverse".MatrixDecomposition.Solver.getInverse
(PhysicalStore<N> preallocated) Implementing this method is optional.QRDecomposition.getInverse
(PhysicalStore<N> preallocated) RawCholesky.getInverse()
RawCholesky.getInverse
(PhysicalStore<Double> preallocated) RawEigenvalue.getInverse()
RawEigenvalue.getInverse
(PhysicalStore<Double> preallocated) RawLU.getInverse()
RawLU.getInverse
(PhysicalStore<Double> preallocated) RawQR.getInverse()
RawQR.getInverse
(PhysicalStore<Double> preallocated) RawSingularValue.getInverse()
RawSingularValue.getInverse
(PhysicalStore<Double> preallocated) SingularValueDecomposition.getInverse()
SingularValueDecomposition.getInverse
(PhysicalStore<N> preallocated) private MatrixStore
<N> SingularValueDecomposition.getInverseOldVersion
(DecompositionStore<N> preallocated) default MatrixStore
<N> Cholesky.getL()
Must implement eitherCholesky.getL()
orCholesky.getR()
.CholeskyDecomposition.getL()
default MatrixStore
<N> LDL.getL()
Must implement eitherLDL.getL()
orLDL.getR()
.LDLDecomposition.getL()
LU.getL()
LUDecomposition.getL()
RawCholesky.getL()
RawLU.getL()
Bidiagonal.getLQ()
BidiagonalDecomposition.getLQ()
Hessenberg.getQ()
final MatrixStore
<N> HessenbergDecomposition.getQ()
QR.getQ()
QRDecomposition.getQ()
Tridiagonal.getQ()
final MatrixStore
<N> TridiagonalDecomposition.getQ()
default MatrixStore
<N> Cholesky.getR()
Must implement eitherCholesky.getL()
orCholesky.getR()
.default MatrixStore
<N> LDL.getR()
Must implement eitherLDL.getL()
orLDL.getR()
.QR.getR()
QRDecomposition.getR()
RawQR.getR()
Return the upper triangular factorBidiagonal.getRQ()
BidiagonalDecomposition.getRQ()
CholeskyDecomposition.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs) CholeskyDecomposition.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs, PhysicalStore<N> preallocated) Solves [this][X] = [rhs] by first solvingHermitianEvD.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs) HermitianEvD.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs, PhysicalStore<N> preallocated) LDLDecomposition.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs) LDLDecomposition.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs, PhysicalStore<N> preallocated) LUDecomposition.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs) LUDecomposition.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs, PhysicalStore<N> preallocated) Solves [this][X] = [rhs] by first solvingMatrixDecomposition.Solver.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs) [A][X]=[B] or [this][return]=[rhs]MatrixDecomposition.Solver.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs, PhysicalStore<N> preallocated) Implementing this method is optional.QRDecomposition.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs) QRDecomposition.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs, PhysicalStore<N> preallocated) Solve [A]*[X]=[B] by first solving [Q]*[Y]=[B] and then [R]*[X]=[Y].RawCholesky.getSolution
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs) RawCholesky.getSolution
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs, PhysicalStore<Double> preallocated) RawEigenvalue.getSolution
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs, PhysicalStore<Double> preallocated) RawEigenvalue.Symmetric.getSolution
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs) RawLU.getSolution
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs) RawLU.getSolution
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs, PhysicalStore<Double> preallocated) RawQR.getSolution
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs) RawQR.getSolution
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs, PhysicalStore<Double> preallocated) RawSingularValue.getSolution
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs) RawSingularValue.getSolution
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs, PhysicalStore<Double> preallocated) SingularValueDecomposition.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs) SingularValueDecomposition.getSolution
(Access2D.Collectable<N, ? super PhysicalStore<N>> rhs, PhysicalStore<N> preallocated) LU.getU()
http://en.wikipedia.org/wiki/Row_echelon_form
This is the same as [D][U].LUDecomposition.getU()
RawLU.getU()
RawSingularValue.getU()
SingularValue.getU()
If [A] is m-by-n and its rank is r, then: The first r columns of [U] span the column space, range or image of [A]. The last m-r columns of [U] span the left nullspace or cokernel of [A]. Calculating the QR decomposition of [A] is a faster alternative.SingularValueDecomposition.getU()
Eigenvalue.getV()
The columns of [V] represent the eigenvectors of [A] in the sense that [A][V] = [V][D].final MatrixStore
<N> EigenvalueDecomposition.getV()
RawEigenvalue.getV()
Return the eigenvector matrixRawSingularValue.getV()
SingularValue.getV()
If [A] is m-by-n and its rank is r, then: The first r columns of [V] span the row space or coimage of [A]. The last n-r columns of [V] span the nullspace or kernel of [A]. Calculating the QR decomposition of [A]T is a faster alternative.SingularValueDecomposition.getV()
CholeskyDecomposition.invert
(Access2D<?> original, PhysicalStore<N> preallocated) HermitianEvD.invert
(Access2D<?> original, PhysicalStore<N> preallocated) LDLDecomposition.invert
(Access2D<?> original, PhysicalStore<N> preallocated) LUDecomposition.invert
(Access2D<?> original, PhysicalStore<N> preallocated) QRDecomposition.invert
(Access2D<?> original, PhysicalStore<N> preallocated) RawCholesky.invert
(Access2D<?> original, PhysicalStore<Double> preallocated) RawEigenvalue.invert
(Access2D<?> original, PhysicalStore<Double> preallocated) RawLU.invert
(Access2D<?> original, PhysicalStore<Double> preallocated) RawQR.invert
(Access2D<?> original, PhysicalStore<Double> preallocated) RawSingularValue.invert
(Access2D<?> original, PhysicalStore<Double> preallocated) SingularValueDecomposition.invert
(Access2D<?> original, PhysicalStore<N> preallocated) (package private) MatrixStore
<N> DeferredTridiagonal.makeD()
protected MatrixStore
<N> DynamicEvD.makeD()
protected abstract MatrixStore
<N> EigenvalueDecomposition.makeD()
protected final MatrixStore
<N> GeneralEvD.makeD()
protected MatrixStore
<N> GeneralisedEvD.makeD()
protected MatrixStore
<N> HermitianEvD.makeD()
protected MatrixStore
<Double> RawEigenvalue.makeD
(double[] d, double[] e) protected MatrixStore
<Double> RawEigenvalue.Symmetric.makeD
(double[] d, double[] e) (package private) MatrixStore
<Double> SimultaneousTridiagonal.makeD()
protected MatrixStore
<N> SingularValueDecomposition.makeD()
(package private) abstract MatrixStore
<N> TridiagonalDecomposition.makeD()
protected final MatrixStore
<N> GenericDecomposition.makeIdentity
(int dimension) protected final MatrixStore
<N> GeneralEvD.makeInverse()
protected MatrixStore
<N> DynamicEvD.makeV()
protected abstract MatrixStore
<N> EigenvalueDecomposition.makeV()
protected MatrixStore
<N> GeneralEvD.makeV()
protected MatrixStore
<N> GeneralisedEvD.makeV()
protected MatrixStore
<N> HermitianEvD.makeV()
default MatrixStore
<N> Bidiagonal.reconstruct()
default MatrixStore
<N> Cholesky.reconstruct()
default MatrixStore
<N> Eigenvalue.reconstruct()
GeneralisedEvD.reconstruct()
default MatrixStore
<N> Hessenberg.reconstruct()
default MatrixStore
<N> LDL.reconstruct()
default MatrixStore
<N> LU.reconstruct()
MatrixDecomposition.reconstruct()
default MatrixStore
<N> QR.reconstruct()
default MatrixStore
<N> SingularValue.reconstruct()
default MatrixStore
<N> SingularValue.reconstruct
(int k) default MatrixStore
<N> Tridiagonal.reconstruct()
(package private) MatrixStore
<N> GeneralisedEvD.recover
(MatrixStore<N> reduced) CholeskyDecomposition.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated) HermitianEvD.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated) LDLDecomposition.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated) LUDecomposition.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated) QRDecomposition.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated) RawCholesky.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<Double> preallocated) RawEigenvalue.solve
(MatrixStore<Double> rhs, DecompositionStore<Double> preallocated) RawEigenvalue.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<Double> preallocated) RawLU.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<Double> preallocated) RawQR.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<Double> preallocated) RawSingularValue.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<Double> preallocated) SingularValueDecomposition.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated) protected final MatrixStore
<N> Methods in org.ojalgo.matrix.decomposition that return types with arguments of type MatrixStoreModifier and TypeMethodDescriptiondefault Optional
<MatrixStore<N>> MatrixDecomposition.Solver.invert()
default Optional
<MatrixStore<N>> default Provider2D.Inverse
<Optional<MatrixStore<N>>> MatrixDecomposition.Solver.toInverseProvider
(ElementsSupplier<N> original, Supplier<MatrixStore<N>> alternativeOriginalSupplier) default Provider2D.Solution
<Optional<MatrixStore<N>>> MatrixDecomposition.Solver.toSolutionProvider
(ElementsSupplier<N> body, Supplier<MatrixStore<N>> alternativeBodySupplier, Access2D<?> rhs) Methods in org.ojalgo.matrix.decomposition with parameters of type MatrixStoreModifier and TypeMethodDescriptionboolean
CholeskyDecomposition.checkAndDecompose
(MatrixStore<N> matrix) boolean
DynamicEvD.checkAndDecompose
(MatrixStore<N> matrix) boolean
GeneralEvD.checkAndDecompose
(MatrixStore<N> matrix) boolean
HermitianEvD.checkAndDecompose
(MatrixStore<N> matrix) default boolean
MatrixDecomposition.Hermitian.checkAndDecompose
(MatrixStore<N> matrix) Absolutely must check if the matrix is hermitian or not.boolean
RawCholesky.checkAndDecompose
(MatrixStore<Double> matrix) static <N extends Comparable<N>>
booleanBidiagonal.equals
(MatrixStore<N> matrix, Bidiagonal<N> decomposition, NumberContext context) static <N extends Comparable<N>>
booleanCholesky.equals
(MatrixStore<N> matrix, Cholesky<N> decomposition, NumberContext context) static <N extends Comparable<N>>
booleanEigenvalue.equals
(MatrixStore<N> matrix, Eigenvalue<N> decomposition, NumberContext context) static <N extends Comparable<N>>
booleanHessenberg.equals
(MatrixStore<N> matrix, Hessenberg<N> decomposition, NumberContext context) static <N extends Comparable<N>>
booleanLDL.equals
(MatrixStore<N> matrix, LDL<N> decomposition, NumberContext context) static <N extends Comparable<N>>
booleanLU.equals
(MatrixStore<N> matrix, LU<N> decomposition, NumberContext context) static <N extends Comparable<N>>
booleanQR.equals
(MatrixStore<N> matrix, QR<N> decomposition, NumberContext context) static <N extends Comparable<N>>
booleanSingularValue.equals
(MatrixStore<N> matrix, SingularValue<N> decomposition, NumberContext context) static <N extends Comparable<N>>
booleanTridiagonal.equals
(MatrixStore<N> matrix, Tridiagonal<N> decomposition, NumberContext context) (package private) MatrixStore
<N> GeneralisedEvD.recover
(MatrixStore<N> reduced) (package private) final void
EigenvalueDecomposition.setD
(MatrixStore<N> newD) (package private) void
SingularValueDecomposition.setD
(MatrixStore<N> someD) (package private) final void
EigenvalueDecomposition.setV
(MatrixStore<N> newV) private void
BidiagonalDecomposition.solve
(PhysicalStore<N> aMtrxV, MatrixStore<N> aMtrxD, DiagonalStore<N, ?> aMtrxSimilar) Will solve the equation system [aMtrxV][aMtrxD][X]=[aMtrxSimilar]T and overwrite the solution [X] to [aV].RawEigenvalue.solve
(MatrixStore<Double> rhs, DecompositionStore<Double> preallocated) private DecompositionStore
<N> BidiagonalDecomposition.solve2
(PhysicalStore<N> aMtrxV, MatrixStore<N> aMtrxD, DiagonalStore<N, ?> aMtrxSimilar) Method parameters in org.ojalgo.matrix.decomposition with type arguments of type MatrixStoreModifier and TypeMethodDescriptiondefault Provider2D.Determinant
<N> MatrixDecomposition.Determinant.toDeterminantProvider
(ElementsSupplier<N> original, Supplier<MatrixStore<N>> alternativeOriginalSupplier) default Provider2D.Inverse
<Optional<MatrixStore<N>>> MatrixDecomposition.Solver.toInverseProvider
(ElementsSupplier<N> original, Supplier<MatrixStore<N>> alternativeOriginalSupplier) default Provider2D.Solution
<Optional<MatrixStore<N>>> MatrixDecomposition.Solver.toSolutionProvider
(ElementsSupplier<N> body, Supplier<MatrixStore<N>> alternativeBodySupplier, Access2D<?> rhs) -
Uses of MatrixStore in org.ojalgo.matrix.store
Subinterfaces of MatrixStore in org.ojalgo.matrix.storeModifier and TypeInterfaceDescriptioninterface
PhysicalStore<N extends Comparable<N>>
PhysicalStore:s, as opposed to MatrixStore:s, are mutable.Classes in org.ojalgo.matrix.store that implement MatrixStoreModifier and TypeClassDescription(package private) final class
AboveBelowStore<N extends Comparable<N>>
A merger of two MatrixStore instances by placing one store below the other.(package private) class
AbstractStore<N extends Comparable<N>>
(package private) final class
ColumnsStore<N extends Comparable<N>>
A selection (re-ordering) of columns.final class
ColumnsSupplier<N extends Comparable<N>>
Sparse columns – columns can be added and removed.(package private) class
ComposingStore<N extends Comparable<N>>
(package private) final class
ConjugatedStore<N extends Comparable<N>>
ConjugatedStorefinal class
DiagonalStore<N extends Comparable<N>,
D extends Access1D<?>> (package private) class
FactoryStore<N extends Comparable<N>>
final class
GenericStore<N extends Scalar<N>>
A generic implementation of PhysicalStore.(package private) final class
IdentityStore<N extends Comparable<N>>
IdentityStore(package private) final class
LeftRightStore<N extends Comparable<N>>
A merger of two MatrixStore instances by placing one store to the right of the other.(package private) final class
LimitStore<N extends Comparable<N>>
(package private) class
LogicalStore<N extends Comparable<N>>
Logical stores are (intended to be) immutable.(package private) final class
LowerHessenbergStore<N extends Comparable<N>>
A Hessenberg matrix is one that is "almost" triangular.(package private) final class
LowerSymmetricStore<N extends Comparable<N>>
(package private) final class
LowerTriangularStore<N extends Comparable<N>>
(package private) final class
OffsetStore<N extends Comparable<N>>
final class
Ainvalid reference
float
final class
Ainvalid reference
double
final class
Uses double[][] internally.(package private) final class
RepeatedColumnsStore<N extends Comparable<N>>
(package private) final class
RepeatedRowsStore<N extends Comparable<N>>
(package private) final class
RowsStore<N extends Comparable<N>>
A selection (re-ordering) of rows.final class
RowsSupplier<N extends Comparable<N>>
Sparse rows – rows can be added and removed.(package private) class
SelectingStore<N extends Comparable<N>>
Selects (rearranges) existing rows and/or columns.(package private) class
ShadingStore<N extends Comparable<N>>
Does not change the matrix size/shape, but applies some structure to the elements.(package private) final class
SingleStore<N extends Comparable<N>>
final class
SparseStore<N extends Comparable<N>>
A sparse matrix (this implementation) is not thread safe.(package private) final class
SuperimposedStore<N extends Comparable<N>>
SuperimposedStore(package private) class
TransjugatedStore<N extends Comparable<N>>
(package private) final class
TransposedStore<N extends Comparable<N>>
(package private) final class
UnaryOperatoStore<N extends Comparable<N>>
(package private) final class
UpperHessenbergStore<N extends Comparable<N>>
A Hessenberg matrix is one that is "almost" triangular.(package private) final class
UpperSymmetricStore<N extends Comparable<N>>
(package private) final class
UpperTriangularStore<N extends Comparable<N>>
(package private) final class
WrapperStore<N extends Comparable<N>>
(package private) final class
ZeroStore<N extends Comparable<N>>
ZeroStoreFields in org.ojalgo.matrix.store declared as MatrixStoreModifier and TypeFieldDescriptionprivate final MatrixStore
<N> LogicalStore.myBase
private final MatrixStore
<N> MatrixPipeline.ColumnsReducer.myBase
private final MatrixStore
<N> MatrixPipeline.RowsReducer.myBase
private final MatrixStore
<N> AboveBelowStore.myBelow
private final MatrixStore
<N> SuperimposedStore.myDiff
private final MatrixStore
<N> LeftRightStore.myRight
private final MatrixStore
<N> MatrixPipeline.Multiplication.myRight
Methods in org.ojalgo.matrix.store that return MatrixStoreModifier and TypeMethodDescriptiondefault MatrixStore
<N> MatrixStore.above
(long numberOfRows) default MatrixStore
<N> default MatrixStore
<N> default MatrixStore
<N> MatrixStore.add
(double scalarAddend) default MatrixStore
<N> default MatrixStore
<N> MatrixStore.add
(MatrixStore<N> addend) ZeroStore.add
(MatrixStore<N> addend) (package private) final MatrixStore
<N> LogicalStore.base()
default MatrixStore
<N> MatrixStore.below
(long numberOfRows) default MatrixStore
<N> default MatrixStore
<N> default MatrixStore
<N> MatrixStore.bidiagonal
(boolean upper) (package private) static <N extends Comparable<N>>
MatrixStore<N> AbstractStore.buildColumn
(PhysicalStore.Factory<N, ?> factory, long rowsCount, N... columnElements) (package private) static <N extends Comparable<N>>
MatrixStore<N> AbstractStore.buildColumn
(PhysicalStore.Factory<N, ?> factory, long rowsCount, Access2D<N> columnStore) (package private) static <N extends Comparable<N>>
MatrixStore<N> AbstractStore.buildColumn
(PhysicalStore.Factory<N, ?> factory, long rowsCount, Access2D<N>... columnStores) (package private) static <N extends Comparable<N>>
MatrixStore<N> AbstractStore.buildRow
(PhysicalStore.Factory<N, ?> factory, long colsCount, N... rowElements) (package private) static <N extends Comparable<N>>
MatrixStore<N> AbstractStore.buildRow
(PhysicalStore.Factory<N, ?> factory, long colsCount, Access2D<N> rowStore) (package private) static <N extends Comparable<N>>
MatrixStore<N> AbstractStore.buildRow
(PhysicalStore.Factory<N, ?> factory, long colsCount, Access2D<N>... rowStores) (package private) static <N extends Comparable<N>>
MatrixStore<N> AbstractStore.cast
(PhysicalStore.Factory<N, ?> factory, Access2D<?> access) default MatrixStore
<N> MatrixStore.column
(int column) default MatrixStore
<N> MatrixStore.column
(long column) ColumnsSupplier.columns
(int... columns) default MatrixStore
<N> MatrixStore.columns
(int... columns) A selection (re-ordering) of columns.default MatrixStore
<N> MatrixStore.columns
(long... columns) ConjugatedStore.conjugate()
GenericStore.conjugate()
IdentityStore.conjugate()
default MatrixStore
<N> MatrixStore.conjugate()
Returns the conjugate transpose of this matrix.R032Store.conjugate()
R064Store.conjugate()
RawStore.conjugate()
SingleStore.conjugate()
ZeroStore.conjugate()
default MatrixStore
<N> MatrixStore.diagonal()
default MatrixStore
<N> MatrixStore.diagonally
(Access2D<N>... diagonally) default MatrixStore
<N> MatrixStore.divide
(double scalarDivisor) default MatrixStore
<N> GenericStore.get()
default MatrixStore
<N> MatrixStore.get()
Deprecated.R064Store.get()
RawStore.get()
final MatrixStore
<N> TransjugatedStore.getOriginal()
default MatrixStore
<N> MatrixStore.hermitian
(boolean upper) default MatrixStore
<N> MatrixStore.hessenberg
(boolean upper) default MatrixStore
<N> MatrixStore.left
(long numberOfColumns) default MatrixStore
<N> default MatrixStore
<N> default MatrixStore
<N> MatrixStore.limits
(long rowLimit, long columnLimit) Setting either limit to < 0 is interpreted as "no limit" (useful when you only want to limit either the rows or columns, and don't know the size of the other)default MatrixStore
<N> MatrixStore.logical()
Deprecated.v50 No need asMatrixStore
now implementsinvalid reference
Logical
default MatrixStore
<N> PhysicalStore.Factory.makeIdentity
(long dimension) default MatrixStore
<N> PhysicalStore.Factory.makeSingle
(double element) default MatrixStore
<N> PhysicalStore.Factory.makeSingle
(N element) default MatrixStore
<N> PhysicalStore.Factory.makeWrapper
(Access2D<?> access) default MatrixStore
<N> PhysicalStore.Factory.makeWrapperColumn
(Access1D<?> access) default MatrixStore
<N> PhysicalStore.Factory.makeZero
(long rowsCount, long columnsCount) default MatrixStore
<N> PhysicalStore.Factory.makeZero
(Structure2D shape) AboveBelowStore.multiply
(double scalar) AboveBelowStore.multiply
(MatrixStore<N> right) ConjugatedStore.multiply
(MatrixStore<N> right) GenericStore.multiply
(MatrixStore<N> right) IdentityStore.multiply
(double scalar) IdentityStore.multiply
(MatrixStore<N> right) LeftRightStore.multiply
(double scalar) LeftRightStore.multiply
(MatrixStore<N> right) default MatrixStore
<N> MatrixStore.multiply
(double scalarMultiplicand) default MatrixStore
<N> default MatrixStore
<N> MatrixStore.multiply
(MatrixStore<N> right) R032Store.multiply
(MatrixStore<Double> right) R064Store.multiply
(MatrixStore<Double> right) SingleStore.multiply
(double scalar) SingleStore.multiply
(MatrixStore<N> right) SparseStore.multiply
(double scalar) SparseStore.multiply
(MatrixStore<N> right) SuperimposedStore.multiply
(double scalar) SuperimposedStore.multiply
(MatrixStore<N> right) TransposedStore.multiply
(MatrixStore<N> right) default MatrixStore
<N> MatrixStore.negate()
default MatrixStore
<N> MatrixStore.offsets
(long rowOffset, long columnOffset) default MatrixStore
<N> MatrixStore.onAll
(UnaryFunction<N> operator) default MatrixStore
<N> MatrixStore.power
(int power) Multiply this matrix by itselfpower
times.LeftRightStore.premultiply
(Access1D<N> left) default MatrixStore
<N> MatrixStore.repeat
(int rowsRepetitions, int columnsRepetitions) default MatrixStore
<N> MatrixStore.right
(long numberOfColumns) default MatrixStore
<N> default MatrixStore
<N> default MatrixStore
<N> MatrixStore.row
(int row) default MatrixStore
<N> MatrixStore.row
(long row) default MatrixStore
<N> MatrixStore.rows
(int... rows) A selection (re-ordering) of rows.default MatrixStore
<N> MatrixStore.rows
(long... rows) RowsSupplier.rows
(int... rows) default MatrixStore
<N> MatrixStore.select
(int[] rows, int[] columns) default MatrixStore
<N> MatrixStore.select
(long[] rows, long[] columns) default MatrixStore
<N> MatrixStore.signum()
default MatrixStore
<N> MatrixStore.subtract
(double scalarSubtrahend) default MatrixStore
<N> default MatrixStore
<N> MatrixStore.subtract
(MatrixStore<N> subtrahend) default MatrixStore
<N> MatrixStore.superimpose
(long row, long col, Access2D<N> matrix) default MatrixStore
<N> MatrixStore.superimpose
(Access2D<N> matrix) default MatrixStore
<N> MatrixStore.symmetric
(boolean upper) GenericStore.transpose()
IdentityStore.transpose()
default MatrixStore
<N> MatrixStore.transpose()
RawStore.transpose()
SingleStore.transpose()
TransposedStore.transpose()
ZeroStore.transpose()
default MatrixStore
<N> MatrixStore.triangular
(boolean upper, boolean assumeOne) default MatrixStore
<N> MatrixStore.tridiagonal()
Methods in org.ojalgo.matrix.store that return types with arguments of type MatrixStoreModifier and TypeMethodDescriptionprotected final Future
<MatrixStore<N>> LogicalStore.executeMultiply
(double scalar) protected final Future
<MatrixStore<N>> LogicalStore.executeMultiply
(N scalar) protected final Future
<MatrixStore<N>> LogicalStore.executeMultiply
(MatrixStore<N> right) Methods in org.ojalgo.matrix.store with parameters of type MatrixStoreModifier and TypeMethodDescriptiondefault MatrixStore
<N> MatrixStore.add
(MatrixStore<N> addend) ZeroStore.add
(MatrixStore<N> addend) default boolean
MatrixStore.equals
(MatrixStore<N> other, NumberContext context) protected final Future
<MatrixStore<N>> LogicalStore.executeMultiply
(MatrixStore<N> right) AboveBelowStore.multiply
(MatrixStore<N> right) ConjugatedStore.multiply
(MatrixStore<N> right) GenericStore.multiply
(MatrixStore<N> right) IdentityStore.multiply
(MatrixStore<N> right) LeftRightStore.multiply
(MatrixStore<N> right) default MatrixStore
<N> MatrixStore.multiply
(MatrixStore<N> right) R032Store.multiply
(MatrixStore<Double> right) R064Store.multiply
(MatrixStore<Double> right) RawStore.multiply
(MatrixStore<Double> right) SingleStore.multiply
(MatrixStore<N> right) SparseStore.multiply
(MatrixStore<N> right) SuperimposedStore.multiply
(MatrixStore<N> right) TransposedStore.multiply
(MatrixStore<N> right) ZeroStore.multiply
(MatrixStore<N> right) default MatrixStore
<N> MatrixStore.subtract
(MatrixStore<N> subtrahend) Constructors in org.ojalgo.matrix.store with parameters of type MatrixStoreModifierConstructorDescription(package private)
AboveBelowStore
(MatrixStore<N> base, MatrixStore<N> below) (package private)
ColumnsReducer
(MatrixStore<N> base, Aggregator aggregator) (package private)
ColumnsStore
(MatrixStore<N> base, int[] columns) protected
ComposingStore
(MatrixStore<N> base, int rowsCount, int columnsCount) protected
ComposingStore
(MatrixStore<N> base, long rowsCount, long columnsCount) (package private)
ConjugatedStore
(MatrixStore<N> base) (package private)
LeftRightStore
(MatrixStore<N> base, MatrixStore<N> right) (package private)
LimitStore
(int rowsCount, int columnsCount, MatrixStore<N> base) (package private)
LimitStore
(long rowsCount, long columnsCount, MatrixStore<N> base) protected
LogicalStore
(MatrixStore<N> base, int rowsCount, int columnsCount) protected
LogicalStore
(MatrixStore<N> base, long rowsCount, long columnsCount) (package private)
LowerHessenbergStore
(MatrixStore<N> base) (package private)
LowerSymmetricStore
(MatrixStore<N> base, boolean hermitian) (package private)
LowerTriangularStore
(MatrixStore<N> base, boolean unitDiagonal) (package private)
Multiplication
(Access1D<N> left, MatrixStore<N> right) (package private)
OffsetStore
(MatrixStore<N> base, int rowOffset, int columnOffset) (package private)
OffsetStore
(MatrixStore<N> base, long rowOffset, long columnOffset) (package private)
RepeatedColumnsStore
(MatrixStore<N> base, int repetitions) (package private)
RepeatedRowsStore
(MatrixStore<N> base, int repetitions) (package private)
RowsReducer
(MatrixStore<N> base, Aggregator aggregator) (package private)
RowsStore
(MatrixStore<N> base, int... rows) protected
SelectingStore
(MatrixStore<N> base, int rowsCount, int columnsCount) protected
SelectingStore
(MatrixStore<N> base, long rowsCount, long columnsCount) protected
ShadingStore
(MatrixStore<N> base) (package private)
SuperimposedStore
(MatrixStore<N> base, long row, long col, MatrixStore<N> diff) (package private)
SuperimposedStore
(MatrixStore<N> base, MatrixStore<N> diff) protected
TransjugatedStore
(MatrixStore<N> base) private
TransjugatedStore
(MatrixStore<N> base, int rows, int columns) (package private)
TransposedStore
(MatrixStore<N> base) (package private)
UnaryOperatoStore
(MatrixStore<N> base, UnaryFunction<N> operator) (package private)
UpperHessenbergStore
(MatrixStore<N> base) (package private)
UpperSymmetricStore
(MatrixStore<N> base, boolean hermitian) (package private)
UpperTriangularStore
(MatrixStore<N> base, boolean unitDiagonal) -
Uses of MatrixStore in org.ojalgo.matrix.task
Methods in org.ojalgo.matrix.task that return MatrixStoreModifier and TypeMethodDescriptionfinal MatrixStore
<Double> default MatrixStore
<N> The output must be a "right inverse" and a "generalised inverse".InverterTask.invert
(Access2D<?> original, PhysicalStore<N> preallocated) Exactly how (if at all) a specific implementation makes use ofpreallocated
is not specified by this interface.[A][X]=[B] or [body][return]=[rhs]default MatrixStore
<N> [A][X]=[B] or [body][return]=[rhs]SolverTask.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated) Exactly how (if at all) a specific implementation makes use ofpreallocated
is not specified by this interface.Methods in org.ojalgo.matrix.task that return types with arguments of type MatrixStoreModifier and TypeMethodDescriptiondefault Provider2D.Inverse
<Optional<MatrixStore<N>>> InverterTask.toInverseProvider
(ElementsSupplier<N> original, Supplier<MatrixStore<N>> alternativeOriginalSupplier) default Provider2D.Solution
<Optional<MatrixStore<N>>> SolverTask.toSolutionProvider
(ElementsSupplier<N> body, Supplier<MatrixStore<N>> alternativeBodySupplier, Access2D<?> rhs) Methods in org.ojalgo.matrix.task with parameters of type MatrixStoreModifier and TypeMethodDescriptionfinal DeterminantTask
<N> DeterminantTask.Factory.make
(MatrixStore<N> template) InverterTask.Factory.make
(MatrixStore<N> template) SolverTask.Factory.make
(MatrixStore<N> templateBody, MatrixStore<N> templateRHS) Method parameters in org.ojalgo.matrix.task with type arguments of type MatrixStoreModifier and TypeMethodDescriptiondefault Provider2D.Determinant
<N> DeterminantTask.toDeterminantProvider
(ElementsSupplier<N> original, Supplier<MatrixStore<N>> alternativeOriginalSupplier) default Provider2D.Inverse
<Optional<MatrixStore<N>>> InverterTask.toInverseProvider
(ElementsSupplier<N> original, Supplier<MatrixStore<N>> alternativeOriginalSupplier) default Provider2D.Solution
<Optional<MatrixStore<N>>> SolverTask.toSolutionProvider
(ElementsSupplier<N> body, Supplier<MatrixStore<N>> alternativeBodySupplier, Access2D<?> rhs) -
Uses of MatrixStore in org.ojalgo.matrix.task.iterative
Methods in org.ojalgo.matrix.task.iterative that return MatrixStoreModifier and TypeMethodDescriptionConjugateGradientSolver.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<Double> preallocated) GaussSeidelSolver.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<Double> current) JacobiSolver.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<Double> current) MutableSolver.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<Double> current) ParallelGaussSeidelSolver.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<Double> current) Methods in org.ojalgo.matrix.task.iterative that return types with arguments of type MatrixStoreModifier and TypeMethodDescriptionfinal Optional
<MatrixStore<Double>> IterativeSolverTask.solve
(MatrixStore<Double> body, MatrixStore<Double> rhs) Methods in org.ojalgo.matrix.task.iterative with parameters of type MatrixStoreModifier and TypeMethodDescriptionfinal Optional
<MatrixStore<Double>> IterativeSolverTask.solve
(MatrixStore<Double> body, MatrixStore<Double> rhs) -
Uses of MatrixStore in org.ojalgo.matrix.transformation
Fields in org.ojalgo.matrix.transformation declared as MatrixStoreModifier and TypeFieldDescriptionprivate final MatrixStore
<N> HouseholderColumn.myStore
private final MatrixStore
<N> HouseholderRow.myStore
Methods in org.ojalgo.matrix.transformation with parameters of type MatrixStoreModifier and TypeMethodDescriptionstatic <N extends Comparable<N>>
HouseholderReference<N> HouseholderReference.make
(MatrixStore<N> matrix, boolean column) static <N extends Comparable<N>>
HouseholderReference<N> HouseholderReference.makeColumn
(MatrixStore<N> matrix) static <N extends Comparable<N>>
HouseholderReference<N> HouseholderReference.makeRow
(MatrixStore<N> matrix) Constructors in org.ojalgo.matrix.transformation with parameters of type MatrixStoreModifierConstructorDescriptionHouseholderColumn
(MatrixStore<N> store) HouseholderRow
(MatrixStore<N> store) -
Uses of MatrixStore in org.ojalgo.optimisation
Fields in org.ojalgo.optimisation declared as MatrixStoreModifier and TypeFieldDescriptionprivate MatrixStore
<Double> GenericSolver.Builder.myBE
private MatrixStore
<Double> GenericSolver.Builder.myBI
Methods in org.ojalgo.optimisation that return MatrixStoreModifier and TypeMethodDescriptionprivate static MatrixStore
<Double> GenericSolver.Builder.add
(RowsSupplier<Double> baseA, MatrixStore<Double> baseB, Access2D<?> addA, Access1D<?> addB) Expression.getAdjustedGradient
(Access1D<?> point) Expression.getAdjustedHessian()
protected MatrixStore
<Double> GenericSolver.Builder.getAE()
Equality constraints body: [AE][X] == [BE]protected MatrixStore
<Double> GenericSolver.Builder.getAI()
Inequality constraints body: [AI][X] invalid input: '<'= [BI]protected MatrixStore
<Double> GenericSolver.Builder.getBE()
Equality constraints RHS: [AE][X] == [BE]protected MatrixStore
<Double> GenericSolver.Builder.getBI()
Inequality constraints RHS: [AI][X] invalid input: '<'= [BI]protected MatrixStore
<Double> GenericSolver.Builder.getC()
Methods in org.ojalgo.optimisation with parameters of type MatrixStoreModifier and TypeMethodDescriptionprivate static MatrixStore
<Double> GenericSolver.Builder.add
(RowsSupplier<Double> baseA, MatrixStore<Double> baseB, Access2D<?> addA, Access1D<?> addB) (package private) void
GenericSolver.Builder.addEqualities
(MatrixStore<?> mtrxAE, MatrixStore<?> mtrxBE) (package private) void
GenericSolver.Builder.addInequalities
(MatrixStore<?> mtrxAI, MatrixStore<?> mtrxBI) protected static final void
GenericSolver.Builder.append
(StringBuilder builder, String label, MatrixStore<Double> matrix) -
Uses of MatrixStore in org.ojalgo.optimisation.convex
Classes in org.ojalgo.optimisation.convex that implement MatrixStoreModifier and TypeClassDescription(package private) final class
The equation system body is the (negated) Schur complement (of the Q-matrix in the full KKT-system).Fields in org.ojalgo.optimisation.convex declared as MatrixStoreMethods in org.ojalgo.optimisation.convex that return MatrixStoreModifier and TypeMethodDescriptionprotected MatrixStore
<Double> ActiveSetSolver.extractSolution()
protected MatrixStore
<Double> BasePrimitiveSolver.extractSolution()
ConvexData.getBE()
Equality constraints RHS: [AE][X] == [BE](package private) MatrixStore
<N> ConvexData.getBI()
Inequality constraints RHS: [AI][X] invalid input: '<'= [BI]ConvexObjectiveFunction.getGradient
(Access1D<N> point) ConvexObjectiveFunction.getHessian
(Access1D<N> point) (package private) MatrixStore
<Double> ActiveSetSolver.getInvQC()
(package private) MatrixStore
<Double> ActiveSetSolver.getIterationA()
(package private) abstract MatrixStore
<Double> ConstrainedSolver.getIterationA()
(package private) MatrixStore
<Double> QPESolver.getIterationA()
(package private) MatrixStore
<Double> ActiveSetSolver.getIterationB()
(package private) abstract MatrixStore
<Double> ConstrainedSolver.getIterationB()
(package private) MatrixStore
<Double> QPESolver.getIterationB()
(package private) MatrixStore
<Double> ActiveSetSolver.getIterationC()
(package private) abstract MatrixStore
<Double> ConstrainedSolver.getIterationC()
(package private) MatrixStore
<Double> QPESolver.getIterationC()
protected MatrixStore
<Double> UnconstrainedSolver.getIterationKKT()
(package private) MatrixStore
<Double> ConstrainedSolver.getIterationL
(int[] included) protected MatrixStore
<Double> UnconstrainedSolver.getIterationRHS()
ConvexObjectiveFunction.getLinearFactors
(boolean negated) protected MatrixStore
<Double> BasePrimitiveSolver.getMatrixAE()
protected MatrixStore
<Double> BasePrimitiveSolver.getMatrixAI()
protected MatrixStore
<Double> BasePrimitiveSolver.getMatrixBE()
protected MatrixStore
<Double> BasePrimitiveSolver.getMatrixBI()
protected MatrixStore
<Double> BasePrimitiveSolver.getMatrixBI
(int[] selector) protected MatrixStore
<Double> BasePrimitiveSolver.getMatrixC()
(package private) MatrixStore
<Double> ActiveSetSolver.getSlackI
(int[] rows) protected MatrixStore
<Double> BasePrimitiveSolver.getSolutionGeneral
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs) protected MatrixStore
<Double> BasePrimitiveSolver.getSolutionGeneral
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs, PhysicalStore<Double> preallocated) protected MatrixStore
<Double> BasePrimitiveSolver.getSolutionQ
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs) protected MatrixStore
<Double> BasePrimitiveSolver.getSolutionQ
(Access2D.Collectable<Double, ? super PhysicalStore<Double>> rhs, PhysicalStore<Double> preallocated) Methods in org.ojalgo.optimisation.convex with parameters of type MatrixStoreModifier and TypeMethodDescription(package private) static ConvexSolver.Builder
BasePrimitiveSolver.builder
(MatrixStore<Double>[] matrices) private static Optimisation.Result
IterativeRefinementSolver.buildResult
(MatrixStore<Quadruple> Q0, MatrixStore<Quadruple> C0, MatrixStore<Quadruple> x0, MatrixStore<Quadruple> y0, Optimisation.State state) private static Optimisation.Result
IterativeRefinementSolver.doIteration
(MatrixStore<Quadruple> H, MatrixStore<Quadruple> g, MatrixStore<Quadruple> AE, MatrixStore<Quadruple> BE, MatrixStore<Quadruple> AI, MatrixStore<Quadruple> BI, Optimisation.Options options, Optimisation.Result startValue) (package private) static Optimisation.Result
IterativeRefinementSolver.doSolve
(MatrixStore<Quadruple> Q_in, MatrixStore<Quadruple> C_in, MatrixStore<Quadruple> ae_in, MatrixStore<Quadruple> be_in, MatrixStore<Quadruple> ai_in, MatrixStore<Quadruple> bi_in, Optimisation.Options options) ConvexSolver.Builder.objective
(MatrixStore<?> mtrxQ, MatrixStore<?> mtrxC) (package private) static ConvexSolver
BasePrimitiveSolver.of
(MatrixStore<Double>[] matrices) (package private) static ConvexObjectiveFunction
<Double> BasePrimitiveSolver.toObjectiveFunction
(MatrixStore<?> mtrxQ, MatrixStore<?> mtrxC) Constructors in org.ojalgo.optimisation.convex with parameters of type MatrixStore -
Uses of MatrixStore in org.ojalgo.optimisation.integer
Methods in org.ojalgo.optimisation.integer that return MatrixStore -
Uses of MatrixStore in org.ojalgo.optimisation.linear
Fields in org.ojalgo.optimisation.linear declared as MatrixStoreMethods in org.ojalgo.optimisation.linear with parameters of type MatrixStoreModifier and TypeMethodDescriptionprivate void
RevisedStore.doExclTranspMult
(MatrixStore<Double> lambda, PhysicalStore<Double> results) final LinearSolver.Builder
LinearSolver.Builder.objective
(MatrixStore<Double> mtrxC) (package private) void
ProductFormInverse.reset
(MatrixStore<Double> basis) Update the product form inverse to reflect a replaced column.(package private) static LinearFunction
<Double> LinearSolver.toObjectiveFunction
(MatrixStore<Double> mtrxC) (package private) void
ProductFormInverse.update
(MatrixStore<Double> basis, int index, SparseArray<Double> values) Update the inverse to reflect a replaced column in the basis. -
Uses of MatrixStore in org.ojalgo.random
Fields in org.ojalgo.random declared as MatrixStoreModifier and TypeFieldDescriptionprivate final MatrixStore
<Double> Random1D.myCholeskiedCorrelations
-
Uses of MatrixStore in org.ojalgo.random.process
Methods in org.ojalgo.random.process that return MatrixStoreModifier and TypeMethodDescription(package private) MatrixStore
<Double> (package private) MatrixStore
<Double> (package private) MatrixStore
<Double> (package private) MatrixStore
<Double> GaussianProcess.getCovariances()
(package private) MatrixStore
<Double> (package private) MatrixStore
<Double> GaussianField.getM2()
(package private) MatrixStore
<Double> GaussianField.getM2differenses()
(package private) MatrixStore
<Double> GaussianField.getRegressionCoefficients
(K[] args) -
Uses of MatrixStore in org.ojalgo.scalar
Methods in org.ojalgo.scalar that return MatrixStoreModifier and TypeMethodDescriptionQuaternion.toComplexMatrix()
ComplexNumber.toMultiplicationMatrix()
Quaternion.toMultiplicationMatrix()
ComplexNumber.toMultiplicationVector()
Quaternion.toMultiplicationVector()
ComplexNumber.toRotationMatrix()
Quaternion.toRotationMatrix()
(package private) MatrixStore
<Double> Quaternion.toRotationMatrixVersor()
-
Uses of MatrixStore in org.ojalgo.series.primitive
Methods in org.ojalgo.series.primitive that return MatrixStoreModifier and TypeMethodDescriptionCoordinatedSet.getSamples()
CoordinatedSet.getSamples
(UnaryOperator<PrimitiveSeries> operator)
MatrixStore
now implementsinvalid reference