Uses of Interface
org.ojalgo.structure.Access2D
Packages that use Access2D
Package
Description
Everythinng in this package should be considered library-private – it should only be used by other parts of
ojAlgo! Code in this package is often refactored (api-breaking) without even a notice in the changelog.
Classes in this package relate to modelling of financial investment portfolios, and Modern Portfolio
Theory.
This package loosely corresponds to (extends) the packages: java.io.*, java.nio.*, java.net.* and sun.net.*
-
Uses of Access2D in org.ojalgo
Methods in org.ojalgo with parameters of type Access2DModifier and TypeMethodDescriptionstatic void
ProgrammingError.throwIfMultiplicationNotPossible
(Access2D<?> left, Access2D<?> right) static void
ProgrammingError.throwIfNotEqualColumnDimensions
(Access2D<?> mtrx1, Access2D<?> mtrx2) static void
ProgrammingError.throwIfNotEqualDimensions
(Access2D<?> mtrx1, Access2D<?> mtrx2) -
Uses of Access2D in org.ojalgo.array
Classes in org.ojalgo.array that implement Access2DMethods in org.ojalgo.array with parameters of type Access2D -
Uses of Access2D in org.ojalgo.array.operation
Methods in org.ojalgo.array.operation with parameters of type Access2DModifier and TypeMethodDescriptionstatic void
static void
FillMatchingSingle.conjugate
(double[] data, int structure, int firstColumn, int limitColumn, Access2D<?> source) static void
FillMatchingSingle.conjugate
(BigDecimal[] data, int structure, int firstColumn, int limitColumn, Access2D<?> source) static <N extends Scalar<N>>
voidFillMatchingSingle.conjugate
(N[] data, int structure, int firstColumn, int limitColumn, Access2D<?> source, Scalar.Factory<N> scalar) static void
FillMatchingSingle.copy
(double[] data, int structure, int firstColumn, int limitColumn, Access2D<? extends Comparable<?>> source) static void
FillMatchingSingle.copy
(float[] data, int structure, int firstColumn, int limitColumn, Access2D<? extends Comparable<?>> source) static void
FillMatchingSingle.copy
(BigDecimal[] data, int structure, int firstColumn, int limitColumn, Access2D<? extends Comparable<?>> source) static <N extends Scalar<N>>
voidFillMatchingSingle.copy
(N[] data, int structure, int firstColumn, int limitColumn, Access2D<?> source, Scalar.Factory<N> scalar) (package private) static <N extends Comparable<N>,
T extends Mutate2D>
TFillCompatible.expand
(Factory2D<T> factory, Access2D<N> left, BinaryFunction<N> operator, Access2D<N> right) static void
FillCompatible.invoke
(double[][] target, Access2D<?> left, BinaryFunction<?> operator, Access2D<?> right) static void
FillCompatible.invoke
(double[] target, int structure, Access2D<?> left, BinaryFunction<?> operator, Access2D<?> right) static void
FillCompatible.invoke
(float[] target, int structure, Access2D<?> left, BinaryFunction<?> operator, Access2D<?> right) static <N extends Comparable<N>>
voidFillCompatible.invoke
(Mutate2D target, Access2D<N> left, BinaryFunction<N> operator, Access2D<N> right) static void
SubstituteBackwards.invoke
(double[][] data, Access2D<?> body, boolean unitDiagonal, boolean conjugated, boolean hermitian) static void
SubstituteBackwards.invoke
(double[] data, int structure, int first, int limit, Access2D<?> body, boolean unitDiagonal, boolean conjugated, boolean hermitian) static void
SubstituteBackwards.invoke
(float[] data, int structure, int first, int limit, Access2D<?> body, boolean unitDiagonal, boolean conjugated, boolean hermitian) static <N extends Scalar<N>>
voidSubstituteBackwards.invoke
(N[] data, int structure, int first, int limit, Access2D<N> body, boolean unitDiagonal, boolean conjugated, boolean hermitian, Scalar.Factory<N> scalar) static void
SubstituteForwards.invoke
(double[][] data, Access2D<?> body, boolean unitDiagonal, boolean conjugated, boolean identity) static void
SubstituteForwards.invoke
(double[] data, int structure, int first, int limit, Access2D<?> body, boolean unitDiagonal, boolean conjugated, boolean identity) static void
SubstituteForwards.invoke
(float[] data, int structure, int first, int limit, Access2D<?> body, boolean unitDiagonal, boolean conjugated, boolean identity) static <N extends Scalar<N>>
voidSubstituteForwards.invoke
(N[] data, int structure, int first, int limit, Access2D<N> body, boolean unitDiagonal, boolean conjugated, boolean identity, Scalar.Factory<N> scalar) static void
static void
FillMatchingSingle.transpose
(double[] data, int structure, int firstColumn, int limitColumn, Access2D<?> source) static void
FillMatchingSingle.transpose
(float[] data, int structure, int firstColumn, int limitColumn, Access2D<?> source) static void
FillMatchingSingle.transpose
(BigDecimal[] data, int structure, int firstColumn, int limitColumn, Access2D<?> source) static <N extends Scalar<N>>
voidFillMatchingSingle.transpose
(N[] data, int structure, int firstColumn, int limitColumn, Access2D<?> source, Scalar.Factory<N> scalar) -
Uses of Access2D in org.ojalgo.data
Classes in org.ojalgo.data that implement Access2DMethods in org.ojalgo.data with type parameters of type Access2DModifier and TypeMethodDescriptionstatic <D extends Access2D<?> & Access2D.Sliceable<?>,
M extends Mutate2D>
MDataProcessors.covariances
(Factory2D<M> factory, D data) Variables in columns and matching samples in rows. -
Uses of Access2D in org.ojalgo.data.domain.finance
Methods in org.ojalgo.data.domain.finance with parameters of type Access2DModifier and TypeMethodDescriptionstatic MatrixR064
FinanceUtils.toCorrelations
(Access2D<?> covariances) static MatrixR064
FinanceUtils.toCorrelations
(Access2D<?> covariances, boolean clean) Will extract the correlation coefficients from the input covariance matrix.static MatrixR064
FinanceUtils.toCovariances
(Access1D<?> volatilities, Access2D<?> correlations) Vill constract a covariance matrix from the standard deviations (volatilities) and correlation coefficient,static MatrixR064
FinanceUtils.toVolatilities
(Access2D<?> covariances) static MatrixR064
FinanceUtils.toVolatilities
(Access2D<?> covariances, boolean clean) Will extract the standard deviations (volatilities) from the input covariance matrix. -
Uses of Access2D in org.ojalgo.data.domain.finance.portfolio
Constructors in org.ojalgo.data.domain.finance.portfolio with parameters of type Access2DModifierConstructorDescriptionMarketEquilibrium
(String[] assetNamesOrKeys, Access2D<?> covarianceMatrix) MarketEquilibrium
(String[] assetNamesOrKeys, Access2D<?> covarianceMatrix, Comparable<?> riskAversionFactor) MarketEquilibrium
(Access2D<?> covarianceMatrix) MarketEquilibrium
(Access2D<?> covarianceMatrix, Comparable<?> riskAversionFactor) PortfolioContext
(Access1D<?> assetReturns, Access1D<?> assetVolatilities, Access2D<?> correlations) PortfolioContext
(Access1D<?> assetReturns, Access2D<?> covariances) SimplePortfolio
(Access2D<?> correlationsMatrix, List<SimpleAsset> someAssets) -
Uses of Access2D in org.ojalgo.data.domain.finance.portfolio.simulator
Constructors in org.ojalgo.data.domain.finance.portfolio.simulator with parameters of type Access2DModifierConstructorDescriptionPortfolioSimulator
(Access2D<?> correlations, List<GeometricBrownianMotion> assetProcesses) -
Uses of Access2D in org.ojalgo.data.image
Classes in org.ojalgo.data.image that implement Access2DModifier and TypeClassDescriptionclass
Treats an image as a matrix.(package private) static final class
Methods in org.ojalgo.data.image with parameters of type Access2DModifier and TypeMethodDescriptionstatic ImageData
void
ImageData.fillMatching
(Access2D<?> values) static ImageData
ImageData.ofPowerSpectrum
(Access2D<ComplexNumber> transformed) Converts a matrix of complex numbers to an image of its power spectrum (log10 of the squared norms). -
Uses of Access2D in org.ojalgo.function.multiary
Fields in org.ojalgo.function.multiary declared as Access2DModifier and TypeFieldDescriptionprivate Access2D
<?> PureQuadraticFunction.Factory.myCoefficients
Methods in org.ojalgo.function.multiary with parameters of type Access2DModifier and TypeMethodDescriptionPureQuadraticFunction.Factory.coefficients
(Access2D<?> coefficients) -
Uses of Access2D in org.ojalgo.matrix
Subinterfaces of Access2D in org.ojalgo.matrixModifier and TypeInterfaceDescriptioninterface
Matrix2D<N extends Comparable<N>,
M extends Matrix2D<N, M>> Definition of what's common toBasicMatrix
andMatrixStore
.Classes in org.ojalgo.matrix that implement Access2DModifier and TypeClassDescriptionclass
BasicMatrix<N extends Comparable<N>,
M extends BasicMatrix<N, M>> A base class for, easy to use, immutable (thread safe) matrices with a rich feature set.(package private) class
DenseMutator2D<N extends Comparable<N>,
M extends BasicMatrix<N, M>> final class
A matrix (linear algebra) with ComplexNumberSet.C
elements, implemented using dual 64-bit double values.static final class
final class
A matrix (linear algebra) with QuaternionNumberSet.H
elements, implemented using four 64-bit double values.static final class
final class
A matrix (linear algebra) with RationalNumberSet.Q
elements, implemented using dual 64-bit long values.static final class
final class
A matrix (linear algebra) with RealNumberSet.R
elements, approximated by 32-bit float.static final class
final class
A matrix (linear algebra) with RealNumberSet.R
elements, approximated by 64-bit double.static final class
final class
A matrix (linear algebra) with RealNumberSet.R
elements, approximated by 128-bit floating-point values (implemented using dual 64-bit double).static final class
Methods in org.ojalgo.matrix with parameters of type Access2DModifier and TypeMethodDescriptionvoid
BasicMatrix.diagonally
(Access2D<N>... diagonally) default boolean
Matrix2D.equals
(Access2D<?> another, NumberContext accuracy) private Provider2D.Solution
<Optional<MatrixStore<N>>> BasicMatrix.getSolutionProvider
(boolean safe, Access2D<?> rhs) MatrixFactory.makeWrapper
(Access2D<?> elements) void
DenseMutator2D.modifyCompatible
(BinaryFunction<N> operator, Access2D<N> right) void
DenseMutator2D.modifyCompatible
(Access2D<N> left, BinaryFunction<N> operator) BasicMatrix.onCompatible
(BinaryFunction<N> operator, Access2D<N> right) BasicMatrix.onCompatible
(Access2D<N> left, BinaryFunction<N> operator) BasicMatrix.onMatching
(BinaryFunction<N> operator, Access2D<N> right) BasicMatrix.onMatching
(Access2D<N> left, BinaryFunction<N> operator) This method solves a system of linear equations: [this][X]=[rhs].BasicMatrix.superimpose
(long row, long col, Access2D<N> matrix) -
Uses of Access2D in org.ojalgo.matrix.decomposition
Subinterfaces of Access2D 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.Methods in org.ojalgo.matrix.decomposition with parameters of type Access2DModifier and TypeMethodDescriptionCholeskyDecomposition.calculateDeterminant
(Access2D<?> matrix) EigenvalueDecomposition.calculateDeterminant
(Access2D<?> matrix) LDLDecomposition.calculateDeterminant
(Access2D<?> matrix) LUDecomposition.calculateDeterminant
(Access2D<?> matrix) QRDecomposition.calculateDeterminant
(Access2D<?> matrix) RawCholesky.calculateDeterminant
(Access2D<?> matrix) RawEigenvalue.calculateDeterminant
(Access2D<?> matrix) RawLU.calculateDeterminant
(Access2D<?> matrix) RawQR.calculateDeterminant
(Access2D<?> matrix) protected final DecompositionStore
<N> private boolean
RawCholesky.doDecompose
(double[][] data, Access2D<?> input) 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) 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) default Optional
<MatrixStore<N>> QRDecomposition.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<N> preallocated) RawCholesky.solve
(Access2D<?> body, Access2D<?> rhs, PhysicalStore<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) default Provider2D.Solution
<Optional<MatrixStore<N>>> MatrixDecomposition.Solver.toSolutionProvider
(ElementsSupplier<N> body, Supplier<MatrixStore<N>> alternativeBodySupplier, Access2D<?> rhs) protected final MatrixStore
<N> protected Access2D.Collectable
<Double, ? super PhysicalStore<Double>> -
Uses of Access2D in org.ojalgo.matrix.store
Subinterfaces of Access2D in org.ojalgo.matrix.storeModifier and TypeInterfaceDescriptioninterface
MatrixStore<N extends Comparable<N>>
A MatrixStore is a two dimensional store of numbers/scalars.interface
PhysicalStore<N extends Comparable<N>>
PhysicalStore:s, as opposed to MatrixStore:s, are mutable.interface
TransformableRegion<N extends Comparable<N>>
A transformable 2D (sub)region.Classes in org.ojalgo.matrix.store that implement Access2DModifier 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) class
Subregion2D<N extends Comparable<N>>
(package private) static final class
Subregion2D.ColumnsRegion<N extends Comparable<N>>
(package private) static final class
Subregion2D.LimitRegion<N extends Comparable<N>>
(package private) static final class
Subregion2D.OffsetRegion<N extends Comparable<N>>
(package private) static final class
Subregion2D.RowsRegion<N extends Comparable<N>>
(package private) static final class
Subregion2D.SynchronizedRegion<N extends Comparable<N>>
(package private) static final class
Subregion2D.TransposedRegion<N extends Comparable<N>>
(package private) static final class
Subregion2D.WrapperRegion<N extends Comparable<N>>
(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 Access2DModifier and TypeFieldDescriptionMatrixPipeline.BinaryOperatorLeft.myLeft
MatrixPipeline.BinaryOperatorRight.myRight
Methods in org.ojalgo.matrix.store that return Access2DModifier and TypeMethodDescriptionSubregion2D.SynchronizedRegion.columns
(int... columns) Subregion2D.SynchronizedRegion.columns
(long... columns) Subregion2D.SynchronizedRegion.rows
(int... rows) Subregion2D.SynchronizedRegion.rows
(long... rows) Subregion2D.SynchronizedRegion.select
(int[] rows, int[] columns) Subregion2D.SynchronizedRegion.select
(long[] rows, long[] columns) Methods in org.ojalgo.matrix.store that return types with arguments of type Access2DModifier and TypeMethodDescriptionMethods in org.ojalgo.matrix.store with parameters of type Access2DModifier and TypeMethodDescriptiondefault MatrixStore
<N> default MatrixStore
<N> void
void
void
void
void
default MatrixStore
<N> default MatrixStore
<N> (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, 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) final I
default MatrixStore
<N> MatrixStore.diagonally
(Access2D<N>... diagonally) void
R032Store.fillCompatible
(Access2D<Double> left, BinaryFunction<Double> operator, Access2D<Double> right) void
R064Store.fillCompatible
(Access2D<Double> left, BinaryFunction<Double> operator, Access2D<Double> right) void
RawStore.fillCompatible
(Access2D<Double> left, BinaryFunction<Double> operator, Access2D<Double> right) void
Subregion2D.SynchronizedRegion.fillCompatible
(Access2D<N> left, BinaryFunction<N> operator, Access2D<N> right) static R064Store
R064Store.getComplexArgument
(Access2D<ComplexNumber> arg) Extracts the argument of the ComplexNumber elements to a new primitive double valued matrix.static R064Store
R064Store.getComplexImaginary
(Access2D<ComplexNumber> arg) Extracts the imaginary part of the ComplexNumber elements to a new primitive double valued matrix.static R064Store
R064Store.getComplexModulus
(Access2D<ComplexNumber> arg) Extracts the modulus of the ComplexNumber elements to a new primitive double valued matrix.static R064Store
R064Store.getComplexReal
(Access2D<ComplexNumber> arg) Extracts the real part of the ComplexNumber elements to a new primitive double valued matrix.default MatrixStore
<N> default MatrixStore
<N> default MatrixStore
<N> PhysicalStore.Factory.makeWrapper
(Access2D<?> access) void
Subregion2D.SynchronizedRegion.modifyCompatible
(BinaryFunction<N> operator, Access2D<N> right) void
Subregion2D.SynchronizedRegion.modifyCompatible
(Access2D<N> left, BinaryFunction<N> operator) default ElementsSupplier
<N> ElementsSupplier.onMatching
(BinaryFunction<N> operator, Access2D<N> right) default ElementsSupplier
<N> ElementsSupplier.onMatching
(Access2D<N> left, BinaryFunction<N> operator) default MatrixStore
<N> default MatrixStore
<N> void
GenericStore.substituteBackwards
(Access2D<N> body, boolean unitDiagonal, boolean conjugated, boolean hermitian) void
PhysicalStore.substituteBackwards
(Access2D<N> body, boolean unitDiagonal, boolean conjugated, boolean hermitian) Will solve the equation system [A][X]=[B] where: [body][this]=[this] is [A][X]=[B] ("this" is the right hand side, and it will be overwritten with the solution). [A] is upper/right triangularvoid
R032Store.substituteBackwards
(Access2D<Double> body, boolean unitDiagonal, boolean conjugated, boolean hermitian) void
R064Store.substituteBackwards
(Access2D<Double> body, boolean unitDiagonal, boolean conjugated, boolean hermitian) void
RawStore.substituteBackwards
(Access2D<Double> body, boolean unitDiagonal, boolean conjugated, boolean hermitian) void
GenericStore.substituteForwards
(Access2D<N> body, boolean unitDiagonal, boolean conjugated, boolean identity) void
PhysicalStore.substituteForwards
(Access2D<N> body, boolean unitDiagonal, boolean conjugated, boolean identity) Will solve the equation system [A][X]=[B] where: [body][this]=[this] is [A][X]=[B] ("this" is the right hand side, and it will be overwritten with the solution). [A] is lower/left triangularvoid
R032Store.substituteForwards
(Access2D<Double> body, boolean unitDiagonal, boolean conjugated, boolean identity) void
R064Store.substituteForwards
(Access2D<Double> body, boolean unitDiagonal, boolean conjugated, boolean identity) void
RawStore.substituteForwards
(Access2D<Double> body, boolean unitDiagonal, boolean conjugated, boolean identity) default MatrixStore
<N> MatrixStore.superimpose
(long row, long col, Access2D<N> matrix) default MatrixStore
<N> MatrixStore.superimpose
(Access2D<N> matrix) Method parameters in org.ojalgo.matrix.store with type arguments of type Access2DModifier and TypeMethodDescriptionConstructors in org.ojalgo.matrix.store with parameters of type Access2DModifierConstructorDescription(package private)
BinaryOperatorLeft
(Access2D<N> left, BinaryFunction<N> operator, ElementsSupplier<N> right) (package private)
BinaryOperatorRight
(ElementsSupplier<N> left, BinaryFunction<N> operator, Access2D<N> right) (package private)
WrapperStore
(PhysicalStore.Factory<N, ?> factory, Access2D<?> access2D) -
Uses of Access2D in org.ojalgo.matrix.task
Methods in org.ojalgo.matrix.task with parameters of type Access2DModifier and TypeMethodDescriptionDeterminantTask.calculateDeterminant
(Access2D<?> matrix) (package private) static void
AbstractInverter.full1X1
(Access2D<?> source, PhysicalStore<?> destination) (package private) static void
AbstractSolver.full1X1
(Access2D<?> body, Access1D<?> rhs, PhysicalStore<?> solution) (package private) static void
AbstractInverter.full2X2
(Access2D<?> source, PhysicalStore<?> destination) (package private) static void
AbstractSolver.full2X2
(Access2D<?> body, Access1D<?> rhs, PhysicalStore<?> solution) (package private) static void
AbstractInverter.full3X3
(Access2D<?> source, PhysicalStore<?> destination) (package private) static void
AbstractSolver.full3X3
(Access2D<?> body, Access1D<?> rhs, PhysicalStore<?> solution) (package private) static void
AbstractInverter.full4X4
(Access2D<?> source, PhysicalStore<?> destination) (package private) static void
AbstractSolver.full4X4
(Access2D<?> body, Access1D<?> rhs, PhysicalStore<?> solution) (package private) static void
AbstractInverter.full5X5
(Access2D<?> source, PhysicalStore<?> destination) (package private) static void
AbstractSolver.full5X5
(Access2D<?> body, Access1D<?> rhs, PhysicalStore<?> solution) final 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.(package private) static void
AbstractSolver.leastSquares
(Access2D<?> body, Access1D<?> rhs, PhysicalStore<?> solution) [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.(package private) static void
AbstractInverter.symmetric2X2
(Access2D<?> source, PhysicalStore<?> destination) (package private) static void
AbstractSolver.symmetric2X2
(Access2D<?> body, Access1D<?> rhs, PhysicalStore<?> solution) (package private) static void
AbstractInverter.symmetric3X3
(Access2D<?> source, PhysicalStore<?> destination) (package private) static void
AbstractSolver.symmetric3X3
(Access2D<?> body, Access1D<?> rhs, PhysicalStore<?> solution) (package private) static void
AbstractInverter.symmetric4X4
(Access2D<?> source, PhysicalStore<?> destination) (package private) static void
AbstractSolver.symmetric4X4
(Access2D<?> body, Access1D<?> rhs, PhysicalStore<?> solution) (package private) static void
AbstractInverter.symmetric5X5
(Access2D<?> source, PhysicalStore<?> destination) (package private) static void
AbstractSolver.symmetric5X5
(Access2D<?> body, Access1D<?> rhs, PhysicalStore<?> solution) default Provider2D.Solution
<Optional<MatrixStore<N>>> SolverTask.toSolutionProvider
(ElementsSupplier<N> body, Supplier<MatrixStore<N>> alternativeBodySupplier, Access2D<?> rhs) -
Uses of Access2D in org.ojalgo.matrix.task.iterative
Methods in org.ojalgo.matrix.task.iterative with parameters of type Access2DModifier 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) IterativeSolverTask.toListOfRows
(Access2D<?> body, Access2D<?> rhs) -
Uses of Access2D in org.ojalgo.netio
Methods in org.ojalgo.netio with parameters of type Access2DModifier and TypeMethodDescriptionstatic void
BasicLogger.debugMatrix
(String message, Access2D<?> matrix) static void
BasicLogger.debugMatrix
(String message, Access2D<?> matrix, NumberContext context) static void
BasicLogger.errorMatrix
(String message, Access2D<?> matrix) static void
BasicLogger.errorMatrix
(String message, Access2D<?> matrix, NumberContext context) static void
IDX.print
(Access2D<?> image, BasicLogger printer) static void
IDX.print
(Access2D<?> image, BasicLogger printer, boolean transpose) static void
IDX.print
(Access2D<?> image, BasicLogger printer, boolean transpose, double maxExpectedValue) (package private) static void
BasicLogger.NotNull.printmtrx
(BasicLogger appender, String message, Access2D<?> matrix, NumberContext context) default void
default void
BasicLogger.printmtrx
(String message, Access2D<?> matrix, NumberContext context) (package private) static void
BasicLogger.PrivateDetails.printmtrx
(BasicLogger appender, String message, Access2D<?> matrix, NumberContext context) private static void
BasicLogger.PrivateDetails.printmtrx
(BasicLogger appender, Access2D<?> matrix, NumberContext context, boolean plain) -
Uses of Access2D in org.ojalgo.optimisation
Methods in org.ojalgo.optimisation with parameters of type Access2DModifier and TypeMethodDescriptionprivate static MatrixStore
<Double> GenericSolver.Builder.add
(RowsSupplier<Double> baseA, MatrixStore<Double> baseB, Access2D<?> addA, Access1D<?> addB) protected B
GenericSolver.Builder.equalities
(Access2D<?> mtrxAE, Access1D<?> mtrxBE) protected B
GenericSolver.Builder.inequalities
(Access2D<?> mtrxAI, Access1D<?> mtrxBI) protected final void
(package private) void
GenericSolver.Builder.setEqualities
(Access2D<?> mtrxAE, Access1D<?> mtrxBE) (package private) void
GenericSolver.Builder.setInequalities
(Access2D<?> mtrxAI, Access1D<?> mtrxBI) void
Expression.setQuadraticFactors
(List<Variable> variables, Access2D<?> factors) -
Uses of Access2D in org.ojalgo.optimisation.convex
Classes in org.ojalgo.optimisation.convex that implement Access2DModifier and TypeClassDescription(package private) final class
The equation system body is the (negated) Schur complement (of the Q-matrix in the full KKT-system).Methods in org.ojalgo.optimisation.convex with parameters of type Access2DModifier and TypeMethodDescriptionConvexSolver.Builder.equalities
(Access2D<?> mtrxAE, Access1D<?> mtrxBE) ConvexSolver.Builder.inequalities
(Access2D<?> mtrxAI, Access1D<?> mtrxBI) static ConvexSolver.Builder
ConvexSolver.newBuilder
(Access2D<?> quadratic) Set the quadratic part of the objective function -
Uses of Access2D in org.ojalgo.optimisation.linear
Classes in org.ojalgo.optimisation.linear that implement Access2DModifier and TypeClassDescription(package private) final class
(package private) class
(package private) final class
Methods in org.ojalgo.optimisation.linear with parameters of type Access2DModifier and TypeMethodDescriptionLinearSolver.Builder.equalities
(Access2D<?> mtrxAE, Access1D<?> mtrxBE) LinearSolver.Builder.inequalities
(Access2D<?> mtrxAI, Access1D<?> mtrxBI) -
Uses of Access2D in org.ojalgo.random
Methods in org.ojalgo.random that return Access2DModifier and TypeMethodDescription(package private) static Access2D
<?> Normal1D.correlations
(Access2D<?> covariances) Methods in org.ojalgo.random with parameters of type Access2DModifier and TypeMethodDescription(package private) static Access2D
<?> Normal1D.correlations
(Access2D<?> covariances) Constructors in org.ojalgo.random with parameters of type Access2D -
Uses of Access2D in org.ojalgo.random.process
Methods in org.ojalgo.random.process with parameters of type Access2DModifier and TypeMethodDescriptionstatic <P extends Process1D.ComponentProcess<?>>
Process1D<P> Correlated processesstatic <P extends Process1D.ComponentProcess<?>>
Process1D<P> Correlated processes -
Uses of Access2D in org.ojalgo.scalar
Classes in org.ojalgo.scalar that implement Access2DModifier and TypeClassDescriptionfinal class
ComplexNumber is an immutable complex number class.final class
-
Uses of Access2D in org.ojalgo.series.primitive
Methods in org.ojalgo.series.primitive with type parameters of type Access2DModifier and TypeMethodDescription<M extends Access2D<?>>
MSeriesSet.getData
(Factory2D.TwoStep<M, ?> factory) Return aStructure2D
with variables in columns and matching samples in rows. -
Uses of Access2D in org.ojalgo.structure
Subinterfaces of Access2D in org.ojalgo.structureModifier and TypeInterfaceDescriptionstatic interface
Mutate2D.ModifiableReceiver<N extends Comparable<N>>
Apart from extendingMutate2D.Receiver
this interface extendsMutate2D.Modifiable
andMutate2D.Exchangeable
which both imply access to existing elements as well asAccess2D
that dictates explicit access.Classes in org.ojalgo.structure that implement Access2DModifier and TypeClassDescriptionstatic final class
Access2D.SelectionView<N extends Comparable<N>>
static final class
AccessAnyD.MatrixView<N extends Comparable<N>>
class
(package private) static final class
(package private) static final class
Fields in org.ojalgo.structure declared as Access2DModifier and TypeFieldDescriptionAccess2D.ColumnView.myDelegate2D
Access2D.RowView.myDelegate2D
Access2D.SelectionView.myFullData
Keyed2D.myStructure
Methods in org.ojalgo.structure that return Access2DModifier and TypeMethodDescriptionAccess2D.asPrimitive2D
(Access2D<?> access) Deprecated.Access2D.columns
(int... columns) Access2D.columns
(long... columns) Access2D.rows
(int... rows) Access2D.rows
(long... rows) Access2D.select
(int[] rows, int[] columns) Access2D.select
(long[] rows, long[] columns) Creates a view of the underlying data structure of only the selected elements.Access2D.wrap
(double[][] target) static <N extends Comparable<N>>
Access2D<N> Access2D.wrap
(N[][] target) Methods in org.ojalgo.structure with parameters of type Access2DModifier and TypeMethodDescriptiondefault void
Access2D.asPrimitive2D
(Access2D<?> access) Deprecated.v54 UsePrimitive2D.wrap(Structure2D)
insteaddefault I
static boolean
Access2D.equals
(Access2D<?> accessA, Access2D<?> accessB, NumberContext accuracy) default void
Mutate2D.Fillable.fillCompatible
(Access2D<N> left, BinaryFunction<N> operator, Access2D<N> right) 'this' needs to be of a size compatible with the 'left' and 'right' matrices.default void
Mutate2D.ModifiableReceiver.modifyCompatible
(BinaryFunction<N> operator, Access2D<N> right) default void
Mutate2D.ModifiableReceiver.modifyCompatible
(Access2D<N> left, BinaryFunction<N> operator) The "compatible" part of the method name references MATLAB's terminology "Compatible Array Sizes".default P
Operate2D.onCompatible
(BinaryFunction<N> operator, Access2D<N> right) default P
Operate2D.onCompatible
(Access2D<N> left, BinaryFunction<N> operator) Operate2D.onMatching
(BinaryFunction<N> operator, Access2D<N> right) Operate2D.onMatching
(Access2D<N> left, BinaryFunction<N> operator) static String
Constructors in org.ojalgo.structure with parameters of type Access2DModifierConstructorDescriptionprotected
ColumnView
(Access2D<N> access) (package private)
ColumnView
(Access2D<N> access, long column) private
ColumnView
(Access2D<N> access, long column, long lastColumn) (package private)
protected
(package private)
private
(package private)
SelectionView
(Access2D<N> fullData, long[] rows, long[] columns) -
Uses of Access2D in org.ojalgo.tensor
Classes in org.ojalgo.tensor that implement Access2DMethods in org.ojalgo.tensor with parameters of type Access2DModifier and TypeMethodDescriptionWill create a block diagonal tensor using the input matrices as blocks in the supplied order.The Kronecker matrix product / matrix tensor product
Primitive2D.wrap(Structure2D)
instead