Uses of Interface
org.ojalgo.matrix.store.MatrixStore
-
-
Uses of MatrixStore in org.ojalgo.ann
Methods in org.ojalgo.ann that return MatrixStore Modifier and Type Method Description (package private) MatrixStore<java.lang.Double>
CalculationLayer. getLogicalWeights()
MatrixStore<java.lang.Double>
NetworkInvoker. invoke(Access1D<java.lang.Double> input)
The input argument is typed asAccess1D
which essentially means it can be anything.(package private) MatrixStore<java.lang.Double>
WrappedANN. invoke(Access1D<java.lang.Double> input, TrainingConfiguration configuration)
Methods in org.ojalgo.ann that return types with arguments of type MatrixStore Modifier and Type Method Description (package private) java.util.List<MatrixStore<java.lang.Double>>
ArtificialNeuralNetwork. getWeights()
(package private) java.util.List<MatrixStore<java.lang.Double>>
WrappedANN. getWeights()
-
Uses of MatrixStore in org.ojalgo.data.image
Classes in org.ojalgo.data.image that implement MatrixStore Modifier and Type Class Description class
ImageData
Treats an image as a matrix.(package private) static class
ImageData.SingleChannel
Methods in org.ojalgo.data.image with parameters of type MatrixStore Modifier and Type Method Description static 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 MatrixStore Modifier and Type Method Description static MatrixStore<ComplexNumber>
ZTransform. doDFT(Access1D<?> input)
This method computes the discrete Fourier transform (DFT) of a sequence of real numbers.MatrixStore<ComplexNumber>
DiscreteFourierTransform. inverse(Access1D<ComplexNumber> input)
static MatrixStore<ComplexNumber>
DiscreteFourierTransform. inverse2D(MatrixStore<?> input)
static MatrixStore<ComplexNumber>
DiscreteFourierTransform. sample(java.util.function.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 java.lang.Comparable<N>>
MatrixStore<N>DiscreteFourierTransform. shift(MatrixStore<N> matrix)
There is a symmetry in the DFT matrix.MatrixStore<ComplexNumber>
DiscreteFourierTransform.FFT. transform(double... input)
MatrixStore<ComplexNumber>
DiscreteFourierTransform. transform(double... input)
MatrixStore<ComplexNumber>
DiscreteFourierTransform. transform(Access1D<?> input)
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 MatrixStore Modifier and Type Method Description static MatrixStore<ComplexNumber>
DiscreteFourierTransform. inverse2D(MatrixStore<?> input)
static <N extends java.lang.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 MatrixStore Modifier and Type Field Description private MatrixStore<N>
AffineFunction. myCoefficients
private MatrixStore<N>
LinearFunction. myCoefficients
private MatrixStore<N>
PureQuadraticFunction. myCoefficients
Methods in org.ojalgo.function.multiary that return MatrixStore Modifier and Type Method Description MatrixStore<N>
AffineFunction. getGradient(Access1D<N> point)
MatrixStore<N>
ConstantFunction. getGradient(Access1D<N> point)
MatrixStore<N>
FirstOrderApproximation. getGradient(Access1D<N> point)
MatrixStore<N>
LinearFunction. getGradient(Access1D<N> point)
MatrixStore<N>
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.MatrixStore<N>
PureQuadraticFunction. getGradient(Access1D<N> point)
MatrixStore<N>
QuadraticFunction. getGradient(Access1D<N> point)
MatrixStore<N>
SecondOrderApproximation. getGradient(Access1D<N> point)
MatrixStore<N>
AffineFunction. getHessian(Access1D<N> point)
MatrixStore<N>
ConstantFunction. getHessian(Access1D<N> point)
MatrixStore<N>
FirstOrderApproximation. getHessian(Access1D<N> point)
MatrixStore<N>
LinearFunction. getHessian(Access1D<N> point)
MatrixStore<N>
MultiaryFunction.TwiceDifferentiable. getHessian(Access1D<N> point)
The Hessian matrix or Hessian is a square matrix of second-order partial derivatives of a function.MatrixStore<N>
PureQuadraticFunction. getHessian(Access1D<N> point)
MatrixStore<N>
QuadraticFunction. getHessian(Access1D<N> point)
MatrixStore<N>
SecondOrderApproximation. getHessian(Access1D<N> point)
MatrixStore<N>
AffineFunction. getLinearFactors(boolean negated)
MatrixStore<N>
ApproximateFunction. getLinearFactors(boolean negated)
MatrixStore<N>
ConstantFunction. getLinearFactors(boolean negated)
MatrixStore<N>
LinearFunction. getLinearFactors(boolean negated)
MatrixStore<N>
MultiaryFunction.TwiceDifferentiable. getLinearFactors(boolean negated)
MatrixStore<N>
PureQuadraticFunction. getLinearFactors(boolean negated)
MatrixStore<N>
QuadraticFunction. getLinearFactors(boolean negated)
Constructors in org.ojalgo.function.multiary with parameters of type MatrixStore Constructor Description AffineFunction(MatrixStore<N> coefficients)
LinearFunction(MatrixStore<N> coefficients)
PureQuadraticFunction(MatrixStore<N> coefficients)
QuadraticFunction(MatrixStore<N> quadratic, MatrixStore<N> linear)
-
Uses of MatrixStore in org.ojalgo.matrix
Fields in org.ojalgo.matrix declared as MatrixStore Modifier and Type Field Description private MatrixStore<N>
BasicMatrix. myStore
Methods in org.ojalgo.matrix that return MatrixStore Modifier and Type Method Description (package private) MatrixStore<N>
BasicMatrix. store()
Methods in org.ojalgo.matrix that return types with arguments of type MatrixStore Modifier and Type Method Description private Provider2D.Inverse<java.util.Optional<MatrixStore<N>>>
BasicMatrix. getInverseProvider(boolean safe)
private Provider2D.Solution<java.util.Optional<MatrixStore<N>>>
BasicMatrix. getSolutionProvider(boolean safe, Access2D<?> rhs)
Methods in org.ojalgo.matrix with parameters of type MatrixStore Modifier and Type Method Description (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<java.lang.Double> store)
(package private) MatrixR032
MatrixR032.SparseReceiver. instantiate(MatrixStore<java.lang.Double> store)
(package private) MatrixR064
MatrixR064.DenseReceiver. instantiate(MatrixStore<java.lang.Double> store)
(package private) MatrixR064
MatrixR064.SparseReceiver. instantiate(MatrixStore<java.lang.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.decomposition Modifier and Type Interface Description interface
DecompositionStore<N extends java.lang.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 MatrixStore Modifier and Type Field Description private MatrixStore<N>
EigenvalueDecomposition. myD
private MatrixStore<N>
SingularValueDecomposition. myD
private MatrixStore<N>
TridiagonalDecomposition. myD
private MatrixStore<N>
HermitianEvD. myInverse
private MatrixStore<java.lang.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 MatrixStore Modifier and Type Method Description protected MatrixStore<N>
GenericDecomposition. collect(Access2D.Collectable<N,? super DecompositionStore<N>> source)
protected MatrixStore<java.lang.Double>
RawDecomposition. collect(Access2D.Collectable<java.lang.Double,? super DecompositionStore<java.lang.Double>> source)
private MatrixStore<java.lang.Double>
RawCholesky. doGetInverse(PhysicalStore<java.lang.Double> preallocated)
private MatrixStore<java.lang.Double>
RawLU. doGetInverse(PhysicalStore<java.lang.Double> preallocated)
private MatrixStore<java.lang.Double>
RawQR. doGetInverse(R064Store preallocated)
Makes no use ofpreallocated
at all.(package private) MatrixStore<java.lang.Double>
RawSingularValue. doGetInverse(R064Store preallocated)
private MatrixStore<java.lang.Double>
RawCholesky. doSolve(PhysicalStore<java.lang.Double> preallocated)
private MatrixStore<java.lang.Double>
RawLU. doSolve(PhysicalStore<java.lang.Double> preallocated)
private MatrixStore<java.lang.Double>
RawQR. doSolve(R064Store preallocated)
MatrixStore<java.lang.Double>
RawSingularValue. getCovariance()
MatrixStore<N>
SingularValue. getCovariance()
MatrixStore<N>
SingularValueDecomposition. getCovariance()
MatrixStore<N>
Bidiagonal. getD()
MatrixStore<N>
BidiagonalDecomposition. getD()
MatrixStore<N>
Eigenvalue. getD()
The only requirements on [D] are that it should contain the eigenvalues and that [A][V] = [V][D].MatrixStore<N>
EigenvalueDecomposition. getD()
MatrixStore<N>
LDL. getD()
MatrixStore<N>
LDLDecomposition. getD()
MatrixStore<java.lang.Double>
RawEigenvalue. getD()
Return the block diagonal eigenvalue matrixMatrixStore<java.lang.Double>
RawSingularValue. getD()
MatrixStore<N>
SingularValue. getD()
MatrixStore<N>
SingularValueDecomposition. getD()
MatrixStore<N>
Tridiagonal. getD()
MatrixStore<N>
TridiagonalDecomposition. getD()
default MatrixStore<ComplexNumber>
Eigenvalue. getEigenvectors()
MatrixStore<N>
Hessenberg. getH()
MatrixStore<N>
HessenbergDecomposition. getH()
MatrixStore<N>
CholeskyDecomposition. getInverse(PhysicalStore<N> preallocated)
MatrixStore<N>
GeneralEvD. getInverse()
MatrixStore<N>
GeneralEvD. getInverse(DecompositionStore<N> newPreallocated)
MatrixStore<N>
HermitianEvD. getInverse()
MatrixStore<N>
HermitianEvD. getInverse(PhysicalStore<N> preallocated)
MatrixStore<N>
InPlaceDecomposition. getInverse()
MatrixStore<N>
InPlaceDecomposition. getInverse(PhysicalStore<N> preallocated)
MatrixStore<N>
LDLDecomposition. getInverse(PhysicalStore<N> preallocated)
MatrixStore<N>
LUDecomposition. getInverse(PhysicalStore<N> preallocated)
MatrixStore<N>
MatrixDecomposition.Solver. getInverse()
The output must be a "right inverse" and a "generalised inverse".MatrixStore<N>
MatrixDecomposition.Solver. getInverse(PhysicalStore<N> preallocated)
Implementing this method is optional.MatrixStore<N>
QRDecomposition. getInverse(PhysicalStore<N> preallocated)
MatrixStore<java.lang.Double>
RawCholesky. getInverse()
MatrixStore<java.lang.Double>
RawCholesky. getInverse(PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawEigenvalue. getInverse()
MatrixStore<java.lang.Double>
RawEigenvalue. getInverse(PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawLU. getInverse()
MatrixStore<java.lang.Double>
RawLU. getInverse(PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawQR. getInverse()
MatrixStore<java.lang.Double>
RawQR. getInverse(PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawSingularValue. getInverse()
MatrixStore<java.lang.Double>
RawSingularValue. getInverse(PhysicalStore<java.lang.Double> preallocated)
MatrixStore<N>
SingularValueDecomposition. getInverse()
MatrixStore<N>
SingularValueDecomposition. getInverse(PhysicalStore<N> preallocated)
private MatrixStore<N>
SingularValueDecomposition. getInverseOldVersion(DecompositionStore<N> preallocated)
default MatrixStore<N>
Cholesky. getL()
Must implement eitherCholesky.getL()
orCholesky.getR()
.MatrixStore<N>
CholeskyDecomposition. getL()
default MatrixStore<N>
LDL. getL()
Must implement eitherLDL.getL()
orLDL.getR()
.MatrixStore<N>
LDLDecomposition. getL()
MatrixStore<N>
LU. getL()
MatrixStore<N>
LUDecomposition. getL()
MatrixStore<java.lang.Double>
RawCholesky. getL()
MatrixStore<java.lang.Double>
RawLU. getL()
MatrixStore<N>
Bidiagonal. getLQ()
MatrixStore<N>
BidiagonalDecomposition. getLQ()
MatrixStore<N>
Hessenberg. getQ()
MatrixStore<N>
HessenbergDecomposition. getQ()
MatrixStore<N>
QR. getQ()
MatrixStore<N>
QRDecomposition. getQ()
MatrixStore<N>
Tridiagonal. getQ()
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()
.MatrixStore<N>
QR. getR()
MatrixStore<N>
QRDecomposition. getR()
MatrixStore<java.lang.Double>
RawQR. getR()
Return the upper triangular factorMatrixStore<N>
Bidiagonal. getRQ()
MatrixStore<N>
BidiagonalDecomposition. getRQ()
MatrixStore<N>
CholeskyDecomposition. getSolution(Access2D.Collectable<N,? super PhysicalStore<N>> rhs)
MatrixStore<N>
CholeskyDecomposition. getSolution(Access2D.Collectable<N,? super PhysicalStore<N>> rhs, PhysicalStore<N> preallocated)
Solves [this][X] = [rhs] by first solvingMatrixStore<N>
HermitianEvD. getSolution(Access2D.Collectable<N,? super PhysicalStore<N>> rhs)
MatrixStore<N>
HermitianEvD. getSolution(Access2D.Collectable<N,? super PhysicalStore<N>> rhs, PhysicalStore<N> preallocated)
MatrixStore<N>
LDLDecomposition. getSolution(Access2D.Collectable<N,? super PhysicalStore<N>> rhs)
MatrixStore<N>
LDLDecomposition. getSolution(Access2D.Collectable<N,? super PhysicalStore<N>> rhs, PhysicalStore<N> preallocated)
MatrixStore<N>
LUDecomposition. getSolution(Access2D.Collectable<N,? super PhysicalStore<N>> rhs)
MatrixStore<N>
LUDecomposition. getSolution(Access2D.Collectable<N,? super PhysicalStore<N>> rhs, PhysicalStore<N> preallocated)
Solves [this][X] = [rhs] by first solvingMatrixStore<N>
MatrixDecomposition.Solver. getSolution(Access2D.Collectable<N,? super PhysicalStore<N>> rhs)
[A][X]=[B] or [this][return]=[rhs]MatrixStore<N>
MatrixDecomposition.Solver. getSolution(Access2D.Collectable<N,? super PhysicalStore<N>> rhs, PhysicalStore<N> preallocated)
Implementing this method is optional.MatrixStore<N>
QRDecomposition. getSolution(Access2D.Collectable<N,? super PhysicalStore<N>> rhs)
MatrixStore<N>
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].MatrixStore<java.lang.Double>
RawCholesky. getSolution(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs)
MatrixStore<java.lang.Double>
RawCholesky. getSolution(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawEigenvalue. getSolution(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawEigenvalue.Symmetric. getSolution(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs)
MatrixStore<java.lang.Double>
RawLU. getSolution(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs)
MatrixStore<java.lang.Double>
RawLU. getSolution(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawQR. getSolution(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs)
MatrixStore<java.lang.Double>
RawQR. getSolution(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawSingularValue. getSolution(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs)
MatrixStore<java.lang.Double>
RawSingularValue. getSolution(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<N>
SingularValueDecomposition. getSolution(Access2D.Collectable<N,? super PhysicalStore<N>> rhs)
MatrixStore<N>
SingularValueDecomposition. getSolution(Access2D.Collectable<N,? super PhysicalStore<N>> rhs, PhysicalStore<N> preallocated)
MatrixStore<N>
LU. getU()
http://en.wikipedia.org/wiki/Row_echelon_form
This is the same as [D][U].MatrixStore<N>
LUDecomposition. getU()
MatrixStore<java.lang.Double>
RawLU. getU()
MatrixStore<java.lang.Double>
RawSingularValue. getU()
MatrixStore<N>
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.MatrixStore<N>
SingularValueDecomposition. getU()
MatrixStore<N>
Eigenvalue. getV()
The columns of [V] represent the eigenvectors of [A] in the sense that [A][V] = [V][D].MatrixStore<N>
EigenvalueDecomposition. getV()
MatrixStore<java.lang.Double>
RawEigenvalue. getV()
Return the eigenvector matrixMatrixStore<java.lang.Double>
RawSingularValue. getV()
MatrixStore<N>
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.MatrixStore<N>
SingularValueDecomposition. getV()
MatrixStore<N>
CholeskyDecomposition. invert(Access2D<?> original)
MatrixStore<N>
CholeskyDecomposition. invert(Access2D<?> original, PhysicalStore<N> preallocated)
MatrixStore<N>
HermitianEvD. invert(Access2D<?> original)
MatrixStore<N>
HermitianEvD. invert(Access2D<?> original, PhysicalStore<N> preallocated)
MatrixStore<N>
LDLDecomposition. invert(Access2D<?> original)
MatrixStore<N>
LDLDecomposition. invert(Access2D<?> original, PhysicalStore<N> preallocated)
MatrixStore<N>
LUDecomposition. invert(Access2D<?> original)
MatrixStore<N>
LUDecomposition. invert(Access2D<?> original, PhysicalStore<N> preallocated)
MatrixStore<N>
QRDecomposition. invert(Access2D<?> original)
MatrixStore<N>
QRDecomposition. invert(Access2D<?> original, PhysicalStore<N> preallocated)
MatrixStore<java.lang.Double>
RawCholesky. invert(Access2D<?> original, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawEigenvalue. invert(Access2D<?> original, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawLU. invert(Access2D<?> original, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawQR. invert(Access2D<?> original, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawSingularValue. invert(Access2D<?> original, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<N>
SingularValueDecomposition. invert(Access2D<?> original)
MatrixStore<N>
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 MatrixStore<N>
GeneralEvD. makeD()
protected MatrixStore<N>
GeneralisedEvD. makeD()
protected MatrixStore<N>
HermitianEvD. makeD()
protected MatrixStore<java.lang.Double>
RawEigenvalue. makeD(double[] d, double[] e)
protected MatrixStore<java.lang.Double>
RawEigenvalue.Symmetric. makeD(double[] d, double[] e)
(package private) MatrixStore<java.lang.Double>
SimultaneousTridiagonal. makeD()
protected MatrixStore<N>
SingularValueDecomposition. makeD()
(package private) abstract MatrixStore<N>
TridiagonalDecomposition. makeD()
protected MatrixStore<N>
GenericDecomposition. makeIdentity(int dimension)
protected 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()
MatrixStore<N>
GeneralisedEvD. reconstruct()
default MatrixStore<N>
Hessenberg. reconstruct()
default MatrixStore<N>
LDL. reconstruct()
default MatrixStore<N>
LU. reconstruct()
MatrixStore<N>
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)
MatrixStore<N>
CholeskyDecomposition. solve(Access2D<?> body, Access2D<?> rhs)
MatrixStore<N>
CholeskyDecomposition. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated)
MatrixStore<N>
HermitianEvD. solve(Access2D<?> body, Access2D<?> rhs)
MatrixStore<N>
HermitianEvD. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated)
MatrixStore<N>
LDLDecomposition. solve(Access2D<?> body, Access2D<?> rhs)
MatrixStore<N>
LDLDecomposition. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated)
MatrixStore<N>
LUDecomposition. solve(Access2D<?> body, Access2D<?> rhs)
MatrixStore<N>
LUDecomposition. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated)
MatrixStore<N>
QRDecomposition. solve(Access2D<?> body, Access2D<?> rhs)
MatrixStore<N>
QRDecomposition. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated)
MatrixStore<java.lang.Double>
RawCholesky. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawEigenvalue. solve(MatrixStore<java.lang.Double> rhs, DecompositionStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawEigenvalue. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawLU. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawQR. solve(Access2D<?> body, Access2D<?> rhs)
MatrixStore<java.lang.Double>
RawQR. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
RawSingularValue. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<N>
SingularValueDecomposition. solve(Access2D<?> body, Access2D<?> rhs)
MatrixStore<N>
SingularValueDecomposition. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated)
protected MatrixStore<N>
GenericDecomposition. wrap(Access2D<?> source)
Methods in org.ojalgo.matrix.decomposition that return types with arguments of type MatrixStore Modifier and Type Method Description default java.util.Optional<MatrixStore<N>>
MatrixDecomposition.Solver. invert()
default java.util.Optional<MatrixStore<N>>
MatrixDecomposition.Solver. solve(Access2D<?> rhs)
default Provider2D.Inverse<java.util.Optional<MatrixStore<N>>>
MatrixDecomposition.Solver. toInverseProvider(ElementsSupplier<N> original, java.util.function.Supplier<MatrixStore<N>> alternativeOriginalSupplier)
default Provider2D.Solution<java.util.Optional<MatrixStore<N>>>
MatrixDecomposition.Solver. toSolutionProvider(ElementsSupplier<N> body, java.util.function.Supplier<MatrixStore<N>> alternativeBodySupplier, Access2D<?> rhs)
Methods in org.ojalgo.matrix.decomposition with parameters of type MatrixStore Modifier and Type Method Description boolean
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<java.lang.Double> matrix)
static <N extends java.lang.Comparable<N>>
booleanBidiagonal. equals(MatrixStore<N> matrix, Bidiagonal<N> decomposition, NumberContext context)
static <N extends java.lang.Comparable<N>>
booleanCholesky. equals(MatrixStore<N> matrix, Cholesky<N> decomposition, NumberContext context)
static <N extends java.lang.Comparable<N>>
booleanEigenvalue. equals(MatrixStore<N> matrix, Eigenvalue<N> decomposition, NumberContext context)
static <N extends java.lang.Comparable<N>>
booleanHessenberg. equals(MatrixStore<N> matrix, Hessenberg<N> decomposition, NumberContext context)
static <N extends java.lang.Comparable<N>>
booleanLDL. equals(MatrixStore<N> matrix, LDL<N> decomposition, NumberContext context)
static <N extends java.lang.Comparable<N>>
booleanLU. equals(MatrixStore<N> matrix, LU<N> decomposition, NumberContext context)
static <N extends java.lang.Comparable<N>>
booleanQR. equals(MatrixStore<N> matrix, QR<N> decomposition, NumberContext context)
static <N extends java.lang.Comparable<N>>
booleanSingularValue. equals(MatrixStore<N> matrix, SingularValue<N> decomposition, NumberContext context)
static <N extends java.lang.Comparable<N>>
booleanTridiagonal. equals(MatrixStore<N> matrix, Tridiagonal<N> decomposition, NumberContext context)
(package private) MatrixStore<N>
GeneralisedEvD. recover(MatrixStore<N> reduced)
(package private) void
EigenvalueDecomposition. setD(MatrixStore<N> newD)
(package private) void
SingularValueDecomposition. setD(MatrixStore<N> someD)
(package private) 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].MatrixStore<java.lang.Double>
RawEigenvalue. solve(MatrixStore<java.lang.Double> rhs, DecompositionStore<java.lang.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 MatrixStore Modifier and Type Method Description default Provider2D.Determinant<N>
MatrixDecomposition.Determinant. toDeterminantProvider(ElementsSupplier<N> original, java.util.function.Supplier<MatrixStore<N>> alternativeOriginalSupplier)
default Provider2D.Inverse<java.util.Optional<MatrixStore<N>>>
MatrixDecomposition.Solver. toInverseProvider(ElementsSupplier<N> original, java.util.function.Supplier<MatrixStore<N>> alternativeOriginalSupplier)
default Provider2D.Solution<java.util.Optional<MatrixStore<N>>>
MatrixDecomposition.Solver. toSolutionProvider(ElementsSupplier<N> body, java.util.function.Supplier<MatrixStore<N>> alternativeBodySupplier, Access2D<?> rhs)
-
Uses of MatrixStore in org.ojalgo.matrix.store
Subinterfaces of MatrixStore in org.ojalgo.matrix.store Modifier and Type Interface Description interface
PhysicalStore<N extends java.lang.Comparable<N>>
PhysicalStore:s, as opposed to MatrixStore:s, are mutable.Classes in org.ojalgo.matrix.store that implement MatrixStore Modifier and Type Class Description (package private) class
AboveBelowStore<N extends java.lang.Comparable<N>>
A merger of two MatrixStore instances by placing one store below the other.(package private) class
AbstractStore<N extends java.lang.Comparable<N>>
(package private) class
ColumnsStore<N extends java.lang.Comparable<N>>
A selection (re-ordering) of columns.class
ColumnsSupplier<N extends java.lang.Comparable<N>>
Sparse columns – columns can be added and removed.(package private) class
ComposingStore<N extends java.lang.Comparable<N>>
(package private) class
ConjugatedStore<N extends java.lang.Comparable<N>>
ConjugatedStoreclass
DiagonalStore<N extends java.lang.Comparable<N>,D extends Access1D<?>>
(package private) class
FactoryStore<N extends java.lang.Comparable<N>>
class
GenericStore<N extends Scalar<N>>
A generic implementation of PhysicalStore.(package private) class
IdentityStore<N extends java.lang.Comparable<N>>
IdentityStore(package private) class
LeftRightStore<N extends java.lang.Comparable<N>>
A merger of two MatrixStore instances by placing one store to the right of the other.(package private) class
LimitStore<N extends java.lang.Comparable<N>>
(package private) class
LogicalStore<N extends java.lang.Comparable<N>>
Logical stores are (intended to be) immutable.(package private) class
LowerHessenbergStore<N extends java.lang.Comparable<N>>
A Hessenberg matrix is one that is "almost" triangular.(package private) class
LowerSymmetricStore<N extends java.lang.Comparable<N>>
(package private) class
LowerTriangularStore<N extends java.lang.Comparable<N>>
(package private) class
OffsetStore<N extends java.lang.Comparable<N>>
class
R032Store
A float implementation of PhysicalStore.class
R064Store
A double implementation of PhysicalStore.class
RawStore
Uses double[][] internally.(package private) class
RepeatedColumnsStore<N extends java.lang.Comparable<N>>
(package private) class
RepeatedRowsStore<N extends java.lang.Comparable<N>>
(package private) class
RowsStore<N extends java.lang.Comparable<N>>
A selection (re-ordering) of rows.class
RowsSupplier<N extends java.lang.Comparable<N>>
Sparse rows – rows can be added and removed.(package private) class
SelectingStore<N extends java.lang.Comparable<N>>
Selects (rearranges) existing rows and/or columns.(package private) class
ShadingStore<N extends java.lang.Comparable<N>>
Does not change the matrix size/shape, but applies some structure to the elements.(package private) class
SingleStore<N extends java.lang.Comparable<N>>
class
SparseStore<N extends java.lang.Comparable<N>>
A sparse matrix (this implementation) is not thread safe.(package private) class
SuperimposedStore<N extends java.lang.Comparable<N>>
SuperimposedStore(package private) class
TransjugatedStore<N extends java.lang.Comparable<N>>
(package private) class
TransposedStore<N extends java.lang.Comparable<N>>
(package private) class
UnaryOperatoStore<N extends java.lang.Comparable<N>>
(package private) class
UpperHessenbergStore<N extends java.lang.Comparable<N>>
A Hessenberg matrix is one that is "almost" triangular.(package private) class
UpperSymmetricStore<N extends java.lang.Comparable<N>>
(package private) class
UpperTriangularStore<N extends java.lang.Comparable<N>>
(package private) class
WrapperStore<N extends java.lang.Comparable<N>>
(package private) class
ZeroStore<N extends java.lang.Comparable<N>>
ZeroStoreFields in org.ojalgo.matrix.store declared as MatrixStore Modifier and Type Field Description private MatrixStore<N>
LogicalStore. myBase
private MatrixStore<N>
MatrixPipeline.ColumnsReducer. myBase
private MatrixStore<N>
MatrixPipeline.RowsReducer. myBase
private MatrixStore<N>
AboveBelowStore. myBelow
private MatrixStore<N>
SuperimposedStore. myDiff
private MatrixStore<N>
LeftRightStore. myRight
private MatrixStore<N>
MatrixPipeline.Multiplication. myRight
Methods in org.ojalgo.matrix.store that return MatrixStore Modifier and Type Method Description default MatrixStore<N>
MatrixStore. above(long numberOfRows)
default MatrixStore<N>
MatrixStore. above(Access2D<N> matrix)
default MatrixStore<N>
MatrixStore. above(Access2D<N>... matrices)
default MatrixStore<N>
MatrixStore. add(double scalarAddend)
default MatrixStore<N>
MatrixStore. add(N scalarAddend)
default MatrixStore<N>
MatrixStore. add(MatrixStore<N> addend)
MatrixStore<N>
ZeroStore. add(MatrixStore<N> addend)
(package private) MatrixStore<N>
LogicalStore. base()
default MatrixStore<N>
MatrixStore. below(long numberOfRows)
default MatrixStore<N>
MatrixStore. below(Access2D<N> matrix)
default MatrixStore<N>
MatrixStore. below(Access2D<N>... matrices)
default MatrixStore<N>
MatrixStore. bidiagonal(boolean upper)
(package private) static <N extends java.lang.Comparable<N>>
MatrixStore<N>AbstractStore. buildColumn(PhysicalStore.Factory<N,?> factory, long rowsCount, N... columnElements)
(package private) static <N extends java.lang.Comparable<N>>
MatrixStore<N>AbstractStore. buildColumn(PhysicalStore.Factory<N,?> factory, long rowsCount, Access2D<N> columnStore)
(package private) static <N extends java.lang.Comparable<N>>
MatrixStore<N>AbstractStore. buildColumn(PhysicalStore.Factory<N,?> factory, long rowsCount, Access2D<N>... columnStores)
(package private) static <N extends java.lang.Comparable<N>>
MatrixStore<N>AbstractStore. buildRow(PhysicalStore.Factory<N,?> factory, long colsCount, N... rowElements)
(package private) static <N extends java.lang.Comparable<N>>
MatrixStore<N>AbstractStore. buildRow(PhysicalStore.Factory<N,?> factory, long colsCount, Access2D<N> rowStore)
(package private) static <N extends java.lang.Comparable<N>>
MatrixStore<N>AbstractStore. buildRow(PhysicalStore.Factory<N,?> factory, long colsCount, Access2D<N>... rowStores)
(package private) static <N extends java.lang.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)
MatrixStore<N>
ColumnsSupplier. columns(int... columns)
default MatrixStore<N>
MatrixStore. columns(int... columns)
A selection (re-ordering) of columns.default MatrixStore<N>
MatrixStore. columns(long... columns)
MatrixStore<N>
ConjugatedStore. conjugate()
MatrixStore<N>
GenericStore. conjugate()
MatrixStore<N>
IdentityStore. conjugate()
default MatrixStore<N>
MatrixStore. conjugate()
Returns the conjugate transpose of this matrix.MatrixStore<java.lang.Double>
R032Store. conjugate()
MatrixStore<java.lang.Double>
R064Store. conjugate()
MatrixStore<java.lang.Double>
RawStore. conjugate()
MatrixStore<N>
SingleStore. conjugate()
MatrixStore<N>
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>
MatrixStore. divide(N scalarDivisor)
MatrixStore<N>
GenericStore. get()
default MatrixStore<N>
MatrixStore. get()
Deprecated.v50 No need asMatrixStore
now implementsLogical
and this method simply return "this".MatrixStore<java.lang.Double>
R064Store. get()
MatrixStore<java.lang.Double>
RawStore. get()
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>
MatrixStore. left(Access2D<N> matrix)
default MatrixStore<N>
MatrixStore. left(Access2D<N>... matrices)
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 implementsLogical
.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)
MatrixStore<N>
AboveBelowStore. multiply(double scalar)
MatrixStore<N>
AboveBelowStore. multiply(N scalar)
MatrixStore<N>
AboveBelowStore. multiply(MatrixStore<N> right)
MatrixStore<N>
ConjugatedStore. multiply(MatrixStore<N> right)
MatrixStore<N>
GenericStore. multiply(MatrixStore<N> right)
MatrixStore<N>
IdentityStore. multiply(double scalar)
MatrixStore<N>
IdentityStore. multiply(N scalar)
MatrixStore<N>
IdentityStore. multiply(MatrixStore<N> right)
MatrixStore<N>
LeftRightStore. multiply(double scalar)
MatrixStore<N>
LeftRightStore. multiply(N scalar)
MatrixStore<N>
LeftRightStore. multiply(MatrixStore<N> right)
default MatrixStore<N>
MatrixStore. multiply(double scalarMultiplicand)
default MatrixStore<N>
MatrixStore. multiply(N scalarMultiplicand)
default MatrixStore<N>
MatrixStore. multiply(MatrixStore<N> right)
MatrixStore<java.lang.Double>
R032Store. multiply(MatrixStore<java.lang.Double> right)
MatrixStore<java.lang.Double>
R064Store. multiply(MatrixStore<java.lang.Double> right)
MatrixStore<N>
SingleStore. multiply(double scalar)
MatrixStore<N>
SingleStore. multiply(N scalar)
MatrixStore<N>
SingleStore. multiply(MatrixStore<N> right)
MatrixStore<N>
SparseStore. multiply(double scalar)
MatrixStore<N>
SparseStore. multiply(N scalar)
MatrixStore<N>
SparseStore. multiply(MatrixStore<N> right)
MatrixStore<N>
SuperimposedStore. multiply(double scalar)
MatrixStore<N>
SuperimposedStore. multiply(N scalar)
MatrixStore<N>
SuperimposedStore. multiply(MatrixStore<N> right)
MatrixStore<N>
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.MatrixStore<N>
LeftRightStore. premultiply(Access1D<N> left)
default MatrixStore<N>
MatrixStore. repeat(int rowsRepetitions, int columnsRepetitions)
default MatrixStore<N>
MatrixStore. right(long numberOfColumns)
default MatrixStore<N>
MatrixStore. right(Access2D<N> matrix)
default MatrixStore<N>
MatrixStore. right(Access2D<N>... matrices)
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)
MatrixStore<N>
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>
MatrixStore. subtract(N scalarSubtrahend)
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)
MatrixStore<N>
GenericStore. transpose()
MatrixStore<N>
IdentityStore. transpose()
default MatrixStore<N>
MatrixStore. transpose()
MatrixStore<java.lang.Double>
RawStore. transpose()
MatrixStore<N>
SingleStore. transpose()
MatrixStore<N>
TransposedStore. transpose()
MatrixStore<N>
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 MatrixStore Modifier and Type Method Description protected java.util.concurrent.Future<MatrixStore<N>>
LogicalStore. executeMultiply(double scalar)
protected java.util.concurrent.Future<MatrixStore<N>>
LogicalStore. executeMultiply(N scalar)
protected java.util.concurrent.Future<MatrixStore<N>>
LogicalStore. executeMultiply(MatrixStore<N> right)
Methods in org.ojalgo.matrix.store with parameters of type MatrixStore Modifier and Type Method Description default MatrixStore<N>
MatrixStore. add(MatrixStore<N> addend)
MatrixStore<N>
ZeroStore. add(MatrixStore<N> addend)
default boolean
MatrixStore. equals(MatrixStore<N> other, NumberContext context)
protected java.util.concurrent.Future<MatrixStore<N>>
LogicalStore. executeMultiply(MatrixStore<N> right)
MatrixStore<N>
AboveBelowStore. multiply(MatrixStore<N> right)
MatrixStore<N>
ConjugatedStore. multiply(MatrixStore<N> right)
MatrixStore<N>
GenericStore. multiply(MatrixStore<N> right)
MatrixStore<N>
IdentityStore. multiply(MatrixStore<N> right)
MatrixStore<N>
LeftRightStore. multiply(MatrixStore<N> right)
default MatrixStore<N>
MatrixStore. multiply(MatrixStore<N> right)
MatrixStore<java.lang.Double>
R032Store. multiply(MatrixStore<java.lang.Double> right)
MatrixStore<java.lang.Double>
R064Store. multiply(MatrixStore<java.lang.Double> right)
RawStore
RawStore. multiply(MatrixStore<java.lang.Double> right)
MatrixStore<N>
SingleStore. multiply(MatrixStore<N> right)
MatrixStore<N>
SparseStore. multiply(MatrixStore<N> right)
MatrixStore<N>
SuperimposedStore. multiply(MatrixStore<N> right)
MatrixStore<N>
TransposedStore. multiply(MatrixStore<N> right)
ZeroStore<N>
ZeroStore. multiply(MatrixStore<N> right)
default MatrixStore<N>
MatrixStore. subtract(MatrixStore<N> subtrahend)
Constructors in org.ojalgo.matrix.store with parameters of type MatrixStore Constructor Description AboveBelowStore(MatrixStore<N> base, MatrixStore<N> below)
ColumnsReducer(MatrixStore<N> base, Aggregator aggregator)
ColumnsStore(MatrixStore<N> base, int[] columns)
ComposingStore(MatrixStore<N> base, int rowsCount, int columnsCount)
ComposingStore(MatrixStore<N> base, long rowsCount, long columnsCount)
ConjugatedStore(MatrixStore<N> base)
LeftRightStore(MatrixStore<N> base, MatrixStore<N> right)
LimitStore(int rowsCount, int columnsCount, MatrixStore<N> base)
LimitStore(long rowsCount, long columnsCount, MatrixStore<N> base)
LogicalStore(MatrixStore<N> base, int rowsCount, int columnsCount)
LogicalStore(MatrixStore<N> base, long rowsCount, long columnsCount)
LowerHessenbergStore(MatrixStore<N> base)
LowerSymmetricStore(MatrixStore<N> base, boolean hermitian)
LowerTriangularStore(MatrixStore<N> base, boolean unitDiagonal)
Multiplication(Access1D<N> left, MatrixStore<N> right)
OffsetStore(MatrixStore<N> base, int rowOffset, int columnOffset)
OffsetStore(MatrixStore<N> base, long rowOffset, long columnOffset)
RepeatedColumnsStore(MatrixStore<N> base, int repetitions)
RepeatedRowsStore(MatrixStore<N> base, int repetitions)
RowsReducer(MatrixStore<N> base, Aggregator aggregator)
RowsStore(MatrixStore<N> base, int... rows)
SelectingStore(MatrixStore<N> base, int rowsCount, int columnsCount)
SelectingStore(MatrixStore<N> base, long rowsCount, long columnsCount)
ShadingStore(MatrixStore<N> base)
SuperimposedStore(MatrixStore<N> base, long row, long col, MatrixStore<N> diff)
SuperimposedStore(MatrixStore<N> base, MatrixStore<N> diff)
TransjugatedStore(MatrixStore<N> base)
TransjugatedStore(MatrixStore<N> base, int rows, int columns)
TransposedStore(MatrixStore<N> base)
UnaryOperatoStore(MatrixStore<N> base, UnaryFunction<N> operator)
UpperHessenbergStore(MatrixStore<N> base)
UpperSymmetricStore(MatrixStore<N> base, boolean hermitian)
UpperTriangularStore(MatrixStore<N> base, boolean unitDiagonal)
-
Uses of MatrixStore in org.ojalgo.matrix.task
Methods in org.ojalgo.matrix.task that return MatrixStore Modifier and Type Method Description MatrixStore<java.lang.Double>
AbstractInverter. invert(Access2D<?> original)
MatrixStore<N>
InverterTask.Factory. invert(Access2D<?> original)
default MatrixStore<N>
InverterTask. invert(Access2D<?> original)
The output must be a "right inverse" and a "generalised inverse".MatrixStore<N>
InverterTask. invert(Access2D<?> original, PhysicalStore<N> preallocated)
Exactly how (if at all) a specific implementation makes use ofpreallocated
is not specified by this interface.MatrixStore<N>
SolverTask.Factory. solve(Access2D<?> body, Access2D<?> rhs)
[A][X]=[B] or [body][return]=[rhs]default MatrixStore<N>
SolverTask. solve(Access2D<?> body, Access2D<?> rhs)
[A][X]=[B] or [body][return]=[rhs]MatrixStore<N>
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 MatrixStore Modifier and Type Method Description default Provider2D.Inverse<java.util.Optional<MatrixStore<N>>>
InverterTask. toInverseProvider(ElementsSupplier<N> original, java.util.function.Supplier<MatrixStore<N>> alternativeOriginalSupplier)
default Provider2D.Solution<java.util.Optional<MatrixStore<N>>>
SolverTask. toSolutionProvider(ElementsSupplier<N> body, java.util.function.Supplier<MatrixStore<N>> alternativeBodySupplier, Access2D<?> rhs)
Methods in org.ojalgo.matrix.task with parameters of type MatrixStore Modifier and Type Method Description DeterminantTask<N>
DeterminantTask.Factory. make(MatrixStore<N> template)
InverterTask<N>
InverterTask.Factory. make(MatrixStore<N> template)
SolverTask<N>
SolverTask.Factory. make(MatrixStore<N> templateBody, MatrixStore<N> templateRHS)
Method parameters in org.ojalgo.matrix.task with type arguments of type MatrixStore Modifier and Type Method Description default Provider2D.Determinant<N>
DeterminantTask. toDeterminantProvider(ElementsSupplier<N> original, java.util.function.Supplier<MatrixStore<N>> alternativeOriginalSupplier)
default Provider2D.Inverse<java.util.Optional<MatrixStore<N>>>
InverterTask. toInverseProvider(ElementsSupplier<N> original, java.util.function.Supplier<MatrixStore<N>> alternativeOriginalSupplier)
default Provider2D.Solution<java.util.Optional<MatrixStore<N>>>
SolverTask. toSolutionProvider(ElementsSupplier<N> body, java.util.function.Supplier<MatrixStore<N>> alternativeBodySupplier, Access2D<?> rhs)
-
Uses of MatrixStore in org.ojalgo.matrix.task.iterative
Methods in org.ojalgo.matrix.task.iterative that return MatrixStore Modifier and Type Method Description MatrixStore<java.lang.Double>
ConjugateGradientSolver. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<java.lang.Double> preallocated)
MatrixStore<java.lang.Double>
GaussSeidelSolver. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<java.lang.Double> current)
MatrixStore<java.lang.Double>
JacobiSolver. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<java.lang.Double> current)
MatrixStore<java.lang.Double>
MutableSolver. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<java.lang.Double> current)
MatrixStore<java.lang.Double>
ParallelGaussSeidelSolver. solve(Access2D<?> body, Access2D<?> rhs, PhysicalStore<java.lang.Double> current)
Methods in org.ojalgo.matrix.task.iterative that return types with arguments of type MatrixStore Modifier and Type Method Description java.util.Optional<MatrixStore<java.lang.Double>>
IterativeSolverTask. solve(MatrixStore<java.lang.Double> body, MatrixStore<java.lang.Double> rhs)
Methods in org.ojalgo.matrix.task.iterative with parameters of type MatrixStore Modifier and Type Method Description java.util.Optional<MatrixStore<java.lang.Double>>
IterativeSolverTask. solve(MatrixStore<java.lang.Double> body, MatrixStore<java.lang.Double> rhs)
-
Uses of MatrixStore in org.ojalgo.matrix.transformation
Fields in org.ojalgo.matrix.transformation declared as MatrixStore Modifier and Type Field Description private MatrixStore<N>
HouseholderColumn. myStore
private MatrixStore<N>
HouseholderRow. myStore
Methods in org.ojalgo.matrix.transformation with parameters of type MatrixStore Modifier and Type Method Description static <N extends java.lang.Comparable<N>>
HouseholderReference<N>HouseholderReference. make(MatrixStore<N> matrix, boolean column)
static <N extends java.lang.Comparable<N>>
HouseholderReference<N>HouseholderReference. makeColumn(MatrixStore<N> matrix)
static <N extends java.lang.Comparable<N>>
HouseholderReference<N>HouseholderReference. makeRow(MatrixStore<N> matrix)
Constructors in org.ojalgo.matrix.transformation with parameters of type MatrixStore Constructor Description HouseholderColumn(MatrixStore<N> store)
HouseholderRow(MatrixStore<N> store)
-
Uses of MatrixStore in org.ojalgo.optimisation
Fields in org.ojalgo.optimisation declared as MatrixStore Modifier and Type Field Description private MatrixStore<java.lang.Double>
GenericSolver.Builder. myBE
private MatrixStore<java.lang.Double>
GenericSolver.Builder. myBI
Methods in org.ojalgo.optimisation that return MatrixStore Modifier and Type Method Description private static MatrixStore<java.lang.Double>
GenericSolver.Builder. add(RowsSupplier<java.lang.Double> baseA, MatrixStore<java.lang.Double> baseB, Access2D<?> addA, Access1D<?> addB)
MatrixStore<java.lang.Double>
Expression. getAdjustedGradient(Access1D<?> point)
MatrixStore<java.lang.Double>
Expression. getAdjustedHessian()
protected MatrixStore<java.lang.Double>
GenericSolver.Builder. getAE()
Equality constraints body: [AE][X] == [BE]protected MatrixStore<java.lang.Double>
GenericSolver.Builder. getAI()
Inequality constraints body: [AI][X] <= [BI]protected MatrixStore<java.lang.Double>
GenericSolver.Builder. getBE()
Equality constraints RHS: [AE][X] == [BE]protected MatrixStore<java.lang.Double>
GenericSolver.Builder. getBI()
Inequality constraints RHS: [AI][X] <= [BI]protected MatrixStore<java.lang.Double>
GenericSolver.Builder. getC()
Methods in org.ojalgo.optimisation with parameters of type MatrixStore Modifier and Type Method Description private static MatrixStore<java.lang.Double>
GenericSolver.Builder. add(RowsSupplier<java.lang.Double> baseA, MatrixStore<java.lang.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 void
GenericSolver.Builder. append(java.lang.StringBuilder builder, java.lang.String label, MatrixStore<java.lang.Double> matrix)
-
Uses of MatrixStore in org.ojalgo.optimisation.convex
Classes in org.ojalgo.optimisation.convex that implement MatrixStore Modifier and Type Class Description (package private) class
IterativeASS.SchurComplementSolver
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 MatrixStore Modifier and Type Field Description private MatrixStore<java.lang.Double>
ActiveSetSolver. myInvQC
Methods in org.ojalgo.optimisation.convex that return MatrixStore Modifier and Type Method Description protected MatrixStore<java.lang.Double>
ActiveSetSolver. extractSolution()
protected MatrixStore<java.lang.Double>
BasePrimitiveSolver. extractSolution()
MatrixStore<N>
ConvexData. getBE()
Equality constraints RHS: [AE][X] == [BE](package private) MatrixStore<N>
ConvexData. getBI()
Inequality constraints RHS: [AI][X] <= [BI]MatrixStore<N>
ConvexObjectiveFunction. getGradient(Access1D<N> point)
MatrixStore<N>
ConvexObjectiveFunction. getHessian(Access1D<N> point)
(package private) MatrixStore<java.lang.Double>
ActiveSetSolver. getInvQC()
(package private) MatrixStore<java.lang.Double>
ActiveSetSolver. getIterationA()
(package private) abstract MatrixStore<java.lang.Double>
ConstrainedSolver. getIterationA()
(package private) MatrixStore<java.lang.Double>
QPESolver. getIterationA()
(package private) MatrixStore<java.lang.Double>
ActiveSetSolver. getIterationB()
(package private) abstract MatrixStore<java.lang.Double>
ConstrainedSolver. getIterationB()
(package private) MatrixStore<java.lang.Double>
QPESolver. getIterationB()
(package private) MatrixStore<java.lang.Double>
ActiveSetSolver. getIterationC()
(package private) abstract MatrixStore<java.lang.Double>
ConstrainedSolver. getIterationC()
(package private) MatrixStore<java.lang.Double>
QPESolver. getIterationC()
protected MatrixStore<java.lang.Double>
UnconstrainedSolver. getIterationKKT()
(package private) MatrixStore<java.lang.Double>
ConstrainedSolver. getIterationL(int[] included)
protected MatrixStore<java.lang.Double>
UnconstrainedSolver. getIterationRHS()
MatrixStore<N>
ConvexObjectiveFunction. getLinearFactors(boolean negated)
protected MatrixStore<java.lang.Double>
BasePrimitiveSolver. getMatrixAE()
protected MatrixStore<java.lang.Double>
BasePrimitiveSolver. getMatrixAI()
protected MatrixStore<java.lang.Double>
BasePrimitiveSolver. getMatrixBE()
protected MatrixStore<java.lang.Double>
BasePrimitiveSolver. getMatrixBI()
protected MatrixStore<java.lang.Double>
BasePrimitiveSolver. getMatrixBI(int[] selector)
protected MatrixStore<java.lang.Double>
BasePrimitiveSolver. getMatrixC()
(package private) MatrixStore<java.lang.Double>
ActiveSetSolver. getSlackI(int[] rows)
protected MatrixStore<java.lang.Double>
BasePrimitiveSolver. getSolutionGeneral(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs)
protected MatrixStore<java.lang.Double>
BasePrimitiveSolver. getSolutionGeneral(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs, PhysicalStore<java.lang.Double> preallocated)
protected MatrixStore<java.lang.Double>
BasePrimitiveSolver. getSolutionQ(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs)
protected MatrixStore<java.lang.Double>
BasePrimitiveSolver. getSolutionQ(Access2D.Collectable<java.lang.Double,? super PhysicalStore<java.lang.Double>> rhs, PhysicalStore<java.lang.Double> preallocated)
Constructors in org.ojalgo.optimisation.convex with parameters of type MatrixStore Constructor Description Builder(MatrixStore<java.lang.Double>[] matrices)
-
Uses of MatrixStore in org.ojalgo.optimisation.integer
Methods in org.ojalgo.optimisation.integer that return MatrixStore Modifier and Type Method Description protected MatrixStore<java.lang.Double>
IntegerSolver. extractSolution()
-
Uses of MatrixStore in org.ojalgo.optimisation.linear
Fields in org.ojalgo.optimisation.linear declared as MatrixStore Modifier and Type Field Description private MatrixStore<java.lang.Double>
RevisedStore. myBasis
Methods in org.ojalgo.optimisation.linear with parameters of type MatrixStore Modifier and Type Method Description private void
RevisedStore. doExclTranspMult(MatrixStore<java.lang.Double> lambda, PhysicalStore<java.lang.Double> results)
LinearSolver.Builder
LinearSolver.Builder. objective(MatrixStore<java.lang.Double> mtrxC)
(package private) void
ProductFormInverse. reset(MatrixStore<java.lang.Double> basis)
Update the product form inverse to reflect a replaced column.(package private) static LinearFunction<java.lang.Double>
LinearSolver. toObjectiveFunction(MatrixStore<java.lang.Double> mtrxC)
(package private) void
ProductFormInverse. update(MatrixStore<java.lang.Double> basis, int index, SparseArray<java.lang.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 MatrixStore Modifier and Type Field Description private MatrixStore<java.lang.Double>
Random1D. myCholeskiedCorrelations
-
Uses of MatrixStore in org.ojalgo.random.process
Methods in org.ojalgo.random.process that return MatrixStore Modifier and Type Method Description (package private) MatrixStore<java.lang.Double>
GaussianField. getC11(K[] args)
(package private) MatrixStore<java.lang.Double>
GaussianField. getC12(K[] args)
(package private) MatrixStore<java.lang.Double>
GaussianField. getC21(K[] args)
(package private) MatrixStore<java.lang.Double>
GaussianProcess. getCovariances()
(package private) MatrixStore<java.lang.Double>
GaussianField. getM1(K[] args)
(package private) MatrixStore<java.lang.Double>
GaussianField. getM2()
(package private) MatrixStore<java.lang.Double>
GaussianField. getM2differenses()
(package private) MatrixStore<java.lang.Double>
GaussianField. getRegressionCoefficients(K[] args)
-
Uses of MatrixStore in org.ojalgo.scalar
Methods in org.ojalgo.scalar that return MatrixStore Modifier and Type Method Description MatrixStore<ComplexNumber>
Quaternion. toComplexMatrix()
MatrixStore<java.lang.Double>
ComplexNumber. toMultiplicationMatrix()
MatrixStore<java.lang.Double>
Quaternion. toMultiplicationMatrix()
MatrixStore<java.lang.Double>
ComplexNumber. toMultiplicationVector()
MatrixStore<java.lang.Double>
Quaternion. toMultiplicationVector()
MatrixStore<java.lang.Double>
ComplexNumber. toRotationMatrix()
MatrixStore<java.lang.Double>
Quaternion. toRotationMatrix()
(package private) MatrixStore<java.lang.Double>
Quaternion. toRotationMatrixVersor()
-
Uses of MatrixStore in org.ojalgo.series.primitive
Methods in org.ojalgo.series.primitive that return MatrixStore Modifier and Type Method Description MatrixStore<java.lang.Double>
CoordinatedSet. getSamples()
MatrixStore<java.lang.Double>
CoordinatedSet. getSamples(java.util.function.UnaryOperator<PrimitiveSeries> operator)
-