Uses of Class
org.jblas.FloatMatrix
Packages that use FloatMatrix
Package
Description
Main linear algebra package.
Support classes for jBLAS.
-
Uses of FloatMatrix in org.jblas
Fields in org.jblas declared as FloatMatrixMethods in org.jblas that return FloatMatrixModifier and TypeMethodDescriptionstatic FloatMatrix
MatrixFunctions.abs
(FloatMatrix x) Returns a copy of this matrix where all elements are set to their absolute values.static FloatMatrix
MatrixFunctions.absi
(FloatMatrix x) Sets all elements in this matrix to their absolute values.static FloatMatrix
MatrixFunctions.acos
(FloatMatrix x) Returns a copy of this matrix where the trigonometric acos function is applied element wise.static FloatMatrix
MatrixFunctions.acosi
(FloatMatrix x) Applies the trigonometric arccosine function element wise on this matrix.FloatMatrix.add
(float v) Add a scalar.FloatMatrix.add
(FloatMatrix other) Add a matrix.FloatMatrix.addColumnVector
(FloatMatrix x) Add a vector to all columns of the matrix.FloatMatrix.addi
(float v) Add a scalar (in place).FloatMatrix.addi
(float v, FloatMatrix result) Add a scalar to a matrix (in-place).FloatMatrix.addi
(FloatMatrix other) Add a matrix (in place).FloatMatrix.addi
(FloatMatrix other, FloatMatrix result) Add two matrices (in-place).FloatMatrix.addiColumnVector
(FloatMatrix x) Add a vector to all columns of the matrix (in-place).FloatMatrix.addiRowVector
(FloatMatrix x) Add a row vector to all rows of the matrix (in place).FloatMatrix.addRowVector
(FloatMatrix x) Add a row to all rows of the matrix.FloatMatrix.and
(float value) Compute elementwise logical and against a scalar.FloatMatrix.and
(FloatMatrix other) Compute elementwise logical and.FloatMatrix.andi
(float value) Compute elementwise logical and against a scalar (in-place).FloatMatrix.andi
(float value, FloatMatrix result) Compute elementwise logical and against a scalar (in-place).FloatMatrix.andi
(FloatMatrix other) Compute elementwise logical and (in-place).FloatMatrix.andi
(FloatMatrix other, FloatMatrix result) Compute elementwise logical and (in-place).static FloatMatrix
MatrixFunctions.asin
(FloatMatrix x) static FloatMatrix
MatrixFunctions.asini
(FloatMatrix x) Applies the trigonometric arcsine function element wise on this matrix.static FloatMatrix
MatrixFunctions.atan
(FloatMatrix x) static FloatMatrix
MatrixFunctions.atani
(FloatMatrix x) Applies the trigonometric arctangend function element wise on this matrix.static FloatMatrix
SimpleBlas.axpy
(float da, FloatMatrix dx, FloatMatrix dy) Compute y <- alpha * x + y (elementwise addition)static FloatMatrix
MatrixFunctions.cbrt
(FloatMatrix x) static FloatMatrix
MatrixFunctions.cbrti
(FloatMatrix x) Applies the cube root function element wise on this matrix.static FloatMatrix
MatrixFunctions.ceil
(FloatMatrix x) static FloatMatrix
MatrixFunctions.ceili
(FloatMatrix x) Element-wise round up by applying the ceil function on each element.static FloatMatrix
Geometry.center
(FloatMatrix x) Center a vector (subtract mean from all elements (in-place).static FloatMatrix
Geometry.centerColumns
(FloatMatrix x) Center the columns of a matrix (in-place).static FloatMatrix
Geometry.centerRows
(FloatMatrix x) Center the rows of a matrix (in-place).static FloatMatrix
Decompose.cholesky
(FloatMatrix A) if (info ) Compute Cholesky decomposition of AFloatMatrix.columnMaxs()
Return column-wise maximums.FloatMatrix.columnMeans()
Return a vector containing the means of all columns.FloatMatrix.columnMins()
Return column-wise minimums.FloatMatrix.columnSums()
Return a vector containing the sums of the columns (having number of columns many entries)static FloatMatrix
FloatMatrix.concatHorizontally
(FloatMatrix A, FloatMatrix B) Concatenates two matrices horizontally.static FloatMatrix
FloatMatrix.concatVertically
(FloatMatrix A, FloatMatrix B) Concatenates two matrices vertically.ConvertsToFloatMatrix.convertToFloatMatrix()
FloatMatrix.ColumnsAsListView.convertToFloatMatrix()
FloatMatrix.ElementsAsListView.convertToFloatMatrix()
FloatMatrix.RowsAsListView.convertToFloatMatrix()
FloatMatrix.copy
(FloatMatrix a) Copy FloatMatrix a to this.static FloatMatrix
SimpleBlas.copy
(FloatMatrix x, FloatMatrix y) Compute y <- x (copy a matrix)static FloatMatrix
MatrixFunctions.cos
(FloatMatrix x) static FloatMatrix
MatrixFunctions.cosh
(FloatMatrix x) static FloatMatrix
MatrixFunctions.coshi
(FloatMatrix x) Applies the hyperbolic cosine function element-wise on this matrix.static FloatMatrix
MatrixFunctions.cosi
(FloatMatrix x) Applies the cosine function element-wise on this matrix.FloatMatrix.cumulativeSum()
Computes the cumulative sum, that is, the sum of all elements of the matrix up to a given index in linear addressing.FloatMatrix.cumulativeSumi()
Computes the cumulative sum, that is, the sum of all elements of the matrix up to a given index in linear addressing (in-place).FloatMatrix.diag()
Returns the diagonal of the matrix.static FloatMatrix
FloatMatrix.diag
(FloatMatrix x) Creates a new matrix where the values of the given vector are the diagonal values of the matrix.static FloatMatrix
FloatMatrix.diag
(FloatMatrix x, int rows, int columns) Construct a matrix of arbitrary shape and set the diagonal according to a passed vector.FloatMatrix.div
(float v) Elementwise divide by a scalar.FloatMatrix.div
(FloatMatrix other) Elementwise divide by a matrix.FloatMatrix.divColumnVector
(FloatMatrix x) FloatMatrix.divi
(float v) Elementwise divide by a scalar (in place).FloatMatrix.divi
(float a, FloatMatrix result) Elementwise division with a scalar (in-place).FloatMatrix.divi
(FloatMatrix other) Elementwise divide by a matrix (in place).FloatMatrix.divi
(FloatMatrix other, FloatMatrix result) Elementwise division (in-place).FloatMatrix.diviColumnVector
(FloatMatrix x) FloatMatrix.diviRowVector
(FloatMatrix x) FloatMatrix.divRowVector
(FloatMatrix x) static FloatMatrix
MatrixFunctions.doubleToFloat
(DoubleMatrix dm) FloatMatrix.dup()
Returns a duplicate of this matrix.FloatMatrix.eq
(float value) test for equality against a scalar.FloatMatrix.eq
(FloatMatrix other) Test for equality.FloatMatrix.eqi
(float value) Test for equality against a scalar (in-place).FloatMatrix.eqi
(float value, FloatMatrix result) Test for equality against a scalar (in-place).FloatMatrix.eqi
(FloatMatrix other) Test for equality (in-place).FloatMatrix.eqi
(FloatMatrix other, FloatMatrix result) Test for equality (in-place).static FloatMatrix
MatrixFunctions.exp
(FloatMatrix x) static FloatMatrix
MatrixFunctions.expi
(FloatMatrix x) Applies the exponential function element-wise on this matrix.static FloatMatrix
MatrixFunctions.expm
(FloatMatrix A) Calculate matrix exponential of a square matrix.static FloatMatrix
FloatMatrix.eye
(int n) Construct a new n-by-n identity matrix.FloatMatrix.fill
(float value) Set all elements to a value.static FloatMatrix
MatrixFunctions.floor
(FloatMatrix x) static FloatMatrix
MatrixFunctions.floori
(FloatMatrix x) Element-wise round down by applying the floor function on each element.static FloatMatrix[]
Singular.fullSVD
(FloatMatrix A) Compute a singular-value decomposition of A.FloatMatrix.ge
(float value) test for "greater than or equal" against a scalar.FloatMatrix.ge
(FloatMatrix other) Test for "greater than or equal".FloatMatrix.gei
(float value) Test for "greater than or equal" against a scalar (in-place).FloatMatrix.gei
(float value, FloatMatrix result) Test for "greater than or equal" against a scalar (in-place).FloatMatrix.gei
(FloatMatrix other) Test for "greater than or equal" (in-place).FloatMatrix.gei
(FloatMatrix other, FloatMatrix result) Test for "greater than or equal" (in-place).static FloatMatrix
SimpleBlas.gemm
(float alpha, FloatMatrix a, FloatMatrix b, float beta, FloatMatrix c) Compute c <- a*b + beta * c (general matrix matrix multiplication)static FloatMatrix
SimpleBlas.gemv
(float alpha, FloatMatrix a, FloatMatrix x, float beta, FloatMatrix y) Compute y <- alpha*op(a)*x + beta * y (general matrix vector multiplication)static FloatMatrix
SimpleBlas.ger
(float alpha, FloatMatrix x, FloatMatrix y, FloatMatrix a) Compute A <- alpha * x * y^T + A (general rank-1 update)static FloatMatrix
SimpleBlas.gesv
(FloatMatrix a, int[] ipiv, FloatMatrix b) LAPACKFloatMatrix.ColumnsAsListView.get
(int index) FloatMatrix.get
(int[] indices) Get all elements specified by the linear indices.FloatMatrix.get
(int[] indices, int c) Get all elements for a given column and the specified rows.FloatMatrix.get
(int[] rindices, int[] cindices) Get all elements from the specified rows and columns.FloatMatrix.get
(int r, int[] indices) Get all elements for a given row and the specified columns.FloatMatrix.get
(int r, FloatMatrix indices) Get elements from a row and columns as specified by the non-zero entries of a matrix.FloatMatrix.get
(FloatMatrix indices) Get elements specified by the non-zero entries of the passed matrix.FloatMatrix.get
(FloatMatrix indices, int c) Get elements from a column and rows as specified by the non-zero entries of a matrix.FloatMatrix.get
(FloatMatrix rindices, FloatMatrix cindices) Get elements from columns and rows as specified by the non-zero entries of the passed matrices.Get elements from specified rows and columns.FloatMatrix.RowsAsListView.get
(int index) FloatMatrix.getColumn
(int c) Get a copy of a column.FloatMatrix.getColumn
(int c, FloatMatrix result) Copy a column to the given vector.FloatMatrix.getColumnRange
(int r, int a, int b) Get elements from a row and columns a to b.FloatMatrix.getColumns
(int[] cindices) Get whole columns from the passed indices.FloatMatrix.getColumns
(FloatMatrix cindices) Get whole columns as specified by the non-zero entries of a matrix.FloatMatrix.getColumns
(Range indices) FloatMatrix.getColumns
(Range indices, FloatMatrix result) Get whole columns as specified by Range.FloatMatrix.getRange
(int a, int b) Return all elements with linear index a, a + 1, ..., b - 1.FloatMatrix.getRange
(int ra, int rb, int ca, int cb) Get elements from rows ra to rb and columns ca to cb.ComplexFloatMatrix.getReal()
FloatMatrix.getRow
(int r) Get a copy of a row.FloatMatrix.getRow
(int r, FloatMatrix result) Copy a row to a given vector.FloatMatrix.getRowRange
(int a, int b, int c) Get elements from a column and rows a to b.FloatMatrix.getRows
(int[] rindices) Get whole rows from the passed indices.FloatMatrix.getRows
(FloatMatrix rindices) Get whole rows as specified by the non-zero entries of a matrix.FloatMatrix.getRows
(Range indices, FloatMatrix result) FloatMatrix.gt
(float value) test for "greater than" against a scalar.FloatMatrix.gt
(FloatMatrix other) Test for "greater than".FloatMatrix.gti
(float value) Test for "greater than" against a scalar (in-place).FloatMatrix.gti
(float value, FloatMatrix result) Test for "greater than" against a scalar (in-place).FloatMatrix.gti
(FloatMatrix other) Test for "greater than" (in-place).FloatMatrix.gti
(FloatMatrix other, FloatMatrix result) Test for "greater than" (in-place).ComplexFloatMatrix.imag()
Get imaginary part of the matrix.FloatMatrix.isInfinite()
FloatMatrix.isInfinitei()
FloatMatrix.isNaN()
FloatMatrix.isNaNi()
FloatMatrix.le
(float value) test for "less than or equal" against a scalar.FloatMatrix.le
(FloatMatrix other) Test for "less than or equal".FloatMatrix.lei
(float value) Test for "less than or equal" against a scalar (in-place).FloatMatrix.lei
(float value, FloatMatrix result) Test for "less than or equal" against a scalar (in-place).FloatMatrix.lei
(FloatMatrix other) Test for "less than or equal" (in-place).FloatMatrix.lei
(FloatMatrix other, FloatMatrix result) Test for "less than or equal" (in-place).static FloatMatrix
FloatMatrix.linspace
(int lower, int upper, int size) Construct a column vector whose entries are linearly spaced points from lower to upper with size many steps.static FloatMatrix
FloatMatrix.loadAsciiFile
(String filename) static FloatMatrix
FloatMatrix.loadCSVFile
(String filename) static FloatMatrix
MatrixFunctions.log
(FloatMatrix x) static FloatMatrix
MatrixFunctions.log10
(FloatMatrix x) static FloatMatrix
MatrixFunctions.log10i
(FloatMatrix x) Applies the logarithm with basis to 10 element-wise on this matrix.static FloatMatrix
MatrixFunctions.logi
(FloatMatrix x) Applies the natural logarithm function element-wise on this matrix.static FloatMatrix
FloatMatrix.logspace
(float lower, float upper, int size) Construct a column vector whose entries are logarithmically spaced points from 10^lower to 10^upper using the specified number of stepsFloatMatrix.lt
(float value) test for "less than" against a scalar.FloatMatrix.lt
(FloatMatrix other) Test for "less than".FloatMatrix.lti
(float value) Test for "less than" against a scalar (in-place).FloatMatrix.lti
(float value, FloatMatrix result) Test for "less than" against a scalar (in-place).FloatMatrix.lti
(FloatMatrix other) Test for "less than" (in-place).FloatMatrix.lti
(FloatMatrix other, FloatMatrix result) Test for "less than" (in-place).FloatMatrix.max
(float v) FloatMatrix.max
(FloatMatrix other) Computes the maximum between two matrices.FloatMatrix.maxi
(float v) FloatMatrix.maxi
(float v, FloatMatrix result) FloatMatrix.maxi
(FloatMatrix other) Computes the maximum between two matrices.FloatMatrix.maxi
(FloatMatrix other, FloatMatrix result) Computes the maximum between two matrices.FloatMatrix.min
(float v) FloatMatrix.min
(FloatMatrix other) Computes the minimum between two matrices.FloatMatrix.mini
(float v) FloatMatrix.mini
(float v, FloatMatrix result) FloatMatrix.mini
(FloatMatrix other) Computes the minimum between two matrices.FloatMatrix.mini
(FloatMatrix other, FloatMatrix result) Computes the minimum between two matrices.FloatMatrix.mmul
(float v) Matrix-multiply by a scalar.FloatMatrix.mmul
(FloatMatrix other) Matrix-multiply by a matrix.FloatMatrix.mmuli
(float v) Matrix-multiply by a scalar (in place).FloatMatrix.mmuli
(float v, FloatMatrix result) Matrix-matrix multiplication with a scalar (for symmetry, does the same asmuli(scalar)
(in-place).FloatMatrix.mmuli
(FloatMatrix other) Matrix-multiply by a matrix (in place).FloatMatrix.mmuli
(FloatMatrix other, FloatMatrix result) Matrix-matrix multiplication (in-place).FloatMatrix.mul
(float v) Elementwise multiply by a scalar.FloatMatrix.mul
(FloatMatrix other) Elementwise multiply by a matrix.FloatMatrix.mulColumn
(int c, float scale) Multiply a column by a scalar.FloatMatrix.mulColumnVector
(FloatMatrix x) Multiply all columns with a column vector.FloatMatrix.muli
(float v) Elementwise multiply by a scalar (in place).FloatMatrix.muli
(float v, FloatMatrix result) Elementwise multiplication with a scalar (in-place).FloatMatrix.muli
(FloatMatrix other) Elementwise multiply by a matrix (in place).FloatMatrix.muli
(FloatMatrix other, FloatMatrix result) Elementwise multiplication (in-place).FloatMatrix.muliColumnVector
(FloatMatrix x) Multiply all columns with a column vector (in-place).FloatMatrix.muliRowVector
(FloatMatrix x) Multiply all rows with a row vector (in-place).FloatMatrix.mulRow
(int r, float scale) Multiply a row by a scalar.FloatMatrix.mulRowVector
(FloatMatrix x) Multiply all rows with a row vector.FloatMatrix.ne
(float value) test for inequality against a scalar.FloatMatrix.ne
(FloatMatrix other) Test for inequality.FloatMatrix.neg()
Negate each element.FloatMatrix.negi()
Negate each element (in-place).FloatMatrix.nei
(float value) Test for inequality against a scalar (in-place).FloatMatrix.nei
(float value, FloatMatrix result) Test for inequality against a scalar (in-place).FloatMatrix.nei
(FloatMatrix other) Test for inequality (in-place).FloatMatrix.nei
(FloatMatrix other, FloatMatrix result) Test for inequality (in-place).static FloatMatrix
Geometry.normalize
(FloatMatrix x) Normalize a vector (scale such that its Euclidean norm is 1) (in-place).static FloatMatrix
Geometry.normalizeColumns
(FloatMatrix x) Normalize the columns of a matrix (in-place).static FloatMatrix
Geometry.normalizeRows
(FloatMatrix x) Normalize the rows of a matrix (in-place).FloatMatrix.not()
Maps zero to 1.0f and all non-zero values to 0.0f.FloatMatrix.noti()
Maps zero to 1.0f and all non-zero values to 0.0f (in-place).static FloatMatrix
FloatMatrix.ones
(int length) Creates a column vector with all elements equal to 1.static FloatMatrix
FloatMatrix.ones
(int rows, int columns) Creates a new matrix in which all values are equal 1.FloatMatrix.or
(float value) Compute elementwise logical or against a scalar.FloatMatrix.or
(FloatMatrix other) Compute elementwise logical or.FloatMatrix.ori
(float value) Compute elementwise logical or against a scalar (in-place).FloatMatrix.ori
(float value, FloatMatrix result) Compute elementwise logical or against a scalar (in-place).FloatMatrix.ori
(FloatMatrix other) Compute elementwise logical or (in-place).FloatMatrix.ori
(FloatMatrix other, FloatMatrix result) Compute elementwise logical or (in-place).static FloatMatrix
Geometry.pairwiseSquaredDistances
(FloatMatrix X, FloatMatrix Y) Compute the pairwise squared distances between all columns of the two matrices.static FloatMatrix
Solve.pinv
(FloatMatrix A) Computes the pseudo-inverse.static FloatMatrix
MatrixFunctions.pow
(float b, FloatMatrix x) static FloatMatrix
MatrixFunctions.pow
(FloatMatrix x, float e) static FloatMatrix
MatrixFunctions.pow
(FloatMatrix x, FloatMatrix e) static FloatMatrix
MatrixFunctions.powi
(float base, FloatMatrix x) static FloatMatrix
MatrixFunctions.powi
(FloatMatrix x, float d) Element-wise power function.static FloatMatrix
MatrixFunctions.powi
(FloatMatrix x, FloatMatrix e) FloatMatrix.put
(int[] indices, float v) Put a single value into the specified indices (linear adressing).FloatMatrix.put
(int[] rindices, int[] cindices, float v) Put a single value into the specified rows and columns.FloatMatrix.put
(int[] rindices, int[] cindices, FloatMatrix x) Put a sub-matrix as specified by the indices.FloatMatrix.put
(int[] indices, int c, float v) Put a single value into the specified rows of a column.FloatMatrix.put
(int[] indices, int c, FloatMatrix x) Set multiple elements in a row.FloatMatrix.put
(int[] indices, FloatMatrix x) Set elements in linear ordering in the specified indices.FloatMatrix.put
(int i, float v) Set a matrix element (linear indexing).FloatMatrix.put
(int r, int[] indices, float v) Put a single value into a row and the specified columns.FloatMatrix.put
(int r, int[] indices, FloatMatrix x) Set multiple elements in a row.FloatMatrix.put
(int rowIndex, int columnIndex, float value) Set matrix elementFloatMatrix.put
(int r, FloatMatrix indices, float v) Put a single value into the specified columns (non-zero entries of indices) of a row.FloatMatrix.put
(int r, FloatMatrix indices, FloatMatrix v) Put a sub-vector into the specified columns (non-zero entries of indices) of a row.FloatMatrix.put
(FloatMatrix indices, float v) Put a single value into the elements specified by the non-zero entries of indices (linear adressing).FloatMatrix.put
(FloatMatrix indices, int c, float v) Put a single value into the specified rows (non-zero entries of indices) of a column.FloatMatrix.put
(FloatMatrix indices, int c, FloatMatrix v) Put a sub-vector into the specified rows (non-zero entries of indices) of a column.FloatMatrix.put
(FloatMatrix indices, FloatMatrix v) Put a sub-matrix into the indices specified by the non-zero entries of indices (linear adressing).FloatMatrix.put
(FloatMatrix rindices, FloatMatrix cindices, float v) Put a single value in the specified rows and columns (non-zero entries of rindices and cindices.FloatMatrix.put
(FloatMatrix rindices, FloatMatrix cindices, FloatMatrix v) Put a sub-matrix into the specified rows and columns (non-zero entries of rindices and cindices.FloatMatrix.put
(Range rs, Range cs, FloatMatrix x) Put a matrix into specified indices.static FloatMatrix
FloatMatrix.rand
(int len) Creates a column vector with random values uniformly in 0..1.static FloatMatrix
FloatMatrix.rand
(int rows, int columns) Create matrix with random values uniformly in 0..1.static FloatMatrix
FloatMatrix.randn
(int len) Create column vector with normally distributed random values.static FloatMatrix
FloatMatrix.randn
(int rows, int columns) Create matrix with normally distributed random values.FloatMatrix.rankOneUpdate
(float alpha, FloatMatrix x) Computes a rank-1-update A = A + alpha * x * x'.FloatMatrix.rankOneUpdate
(float alpha, FloatMatrix x, FloatMatrix y) Computes a rank-1-update A = A + alpha * x * y'.FloatMatrix.rankOneUpdate
(FloatMatrix x) Computes a rank-1-update A = A + x * x'.FloatMatrix.rankOneUpdate
(FloatMatrix x, FloatMatrix y) Computes a rank-1-update A = A + x * y'.FloatMatrix.rdiv
(float v) (right-)elementwise divide by a scalar.FloatMatrix.rdiv
(FloatMatrix other) (right-)elementwise divide by a matrix.FloatMatrix.rdivi
(float v) (right-)elementwise divide by a scalar (in place).FloatMatrix.rdivi
(float a, FloatMatrix result) (Elementwise) division with a scalar, with operands switched.FloatMatrix.rdivi
(FloatMatrix other) (right-)elementwise divide by a matrix (in place).FloatMatrix.rdivi
(FloatMatrix other, FloatMatrix result) Elementwise division, with operands switched.ComplexFloatMatrix.real()
Get real part of the matrix.FloatMatrix.repmat
(int rowMult, int columnMult) Generate a new matrix which has the given number of replications of this.FloatMatrix.reshape
(int newRows, int newColumns) Reshape the matrix.FloatMatrix.rowMaxs()
Return row-wise maximums.FloatMatrix.rowMeans()
Return a vector containing the means of the rows.FloatMatrix.rowMins()
Return row-wise minimums.FloatMatrix.rowSums()
Return a vector containing the sum of the rows.FloatMatrix.rsub
(float v) (right-)subtract a scalar.FloatMatrix.rsub
(FloatMatrix other) (right-)subtract a matrix.FloatMatrix.rsubi
(float v) (right-)subtract a scalar (in place).FloatMatrix.rsubi
(float a, FloatMatrix result) Subtract a matrix from a scalar (in-place).FloatMatrix.rsubi
(FloatMatrix other) (right-)subtract a matrix (in place).FloatMatrix.rsubi
(FloatMatrix other, FloatMatrix result) Subtract two matrices, but subtract first from second matrix, that is, compute result = other - this (in-place).static FloatMatrix
SimpleBlas.scal
(float alpha, FloatMatrix x) Compute x <- alpha * x (scale a matrix)static FloatMatrix
FloatMatrix.scalar
(float s) Create a 1-by-1 matrix.FloatMatrix.select
(FloatMatrix where) FloatMatrix.selecti
(FloatMatrix where) static FloatMatrix
MatrixFunctions.signum
(FloatMatrix x) static FloatMatrix
MatrixFunctions.signumi
(FloatMatrix x) static FloatMatrix
MatrixFunctions.sin
(FloatMatrix x) static FloatMatrix
MatrixFunctions.sinh
(FloatMatrix x) static FloatMatrix
MatrixFunctions.sinhi
(FloatMatrix x) static FloatMatrix
MatrixFunctions.sini
(FloatMatrix x) static FloatMatrix
Solve.solve
(FloatMatrix A, FloatMatrix B) Solves the linear equation A*X = B.static FloatMatrix
Solve.solveLeastSquares
(FloatMatrix A, FloatMatrix B) Computes the Least Squares solution for over or underdetermined linear equations A*X = B In the overdetermined case, when m > n, that is, there are more equations than variables, it computes the least squares solution of X -> ||A*X - B ||_2.static FloatMatrix
Solve.solvePositive
(FloatMatrix A, FloatMatrix B) Solves the linear equation A*X = B for symmetric and positive definite A.static FloatMatrix
Solve.solveSymmetric
(FloatMatrix A, FloatMatrix B) Solves the linear equation A*X = B for symmetric A.FloatMatrix.sort()
Return a new matrix with all elements sorted.FloatMatrix.sortColumns()
Sort columns.FloatMatrix.sortColumnsi()
Sort columns (in-place).FloatMatrix.sorti()
Sort elements in-place.FloatMatrix.sortRows()
Sort rows.FloatMatrix.sortRowsi()
Sort rows (in-place).static FloatMatrix[]
Singular.sparseSVD
(FloatMatrix A) Compute a singular-value decomposition of A (sparse variant).static FloatMatrix
MatrixFunctions.sqrt
(FloatMatrix x) static FloatMatrix
MatrixFunctions.sqrti
(FloatMatrix x) FloatMatrix.sub
(float v) Subtract a scalar.FloatMatrix.sub
(FloatMatrix other) Subtract a matrix.FloatMatrix.subColumnVector
(FloatMatrix x) Subtract a vector from all columns of the matrix.FloatMatrix.subi
(float v) Subtract a scalar (in place).FloatMatrix.subi
(float v, FloatMatrix result) Subtract a scalar from a matrix (in-place).FloatMatrix.subi
(FloatMatrix other) Subtract a matrix (in place).FloatMatrix.subi
(FloatMatrix other, FloatMatrix result) Subtract two matrices (in-place).FloatMatrix.subiColumnVector
(FloatMatrix x) Subtract a column vector from all columns of the matrix (in-place).FloatMatrix.subiRowVector
(FloatMatrix x) Subtract a row vector from all rows of the matrix (in-place).FloatMatrix.subRowVector
(FloatMatrix x) Subtract a row vector from all rows of the matrix.static FloatMatrix
Singular.SVDValues
(ComplexFloatMatrix A) Compute the singular values of a complex matrix.static FloatMatrix
Singular.SVDValues
(FloatMatrix A) Compute the singular values of a matrix.static FloatMatrix
SimpleBlas.swap
(FloatMatrix x, FloatMatrix y) Compute x <-> y (swap two matrices)FloatMatrix.swapColumns
(int i, int j) Swap two columns of a matrix.FloatMatrix.swapRows
(int i, int j) Swap two rows of a matrix.static FloatMatrix
Eigen.symmetricEigenvalues
(FloatMatrix A) Compute the eigenvalues for a symmetric matrix.static FloatMatrix[]
Eigen.symmetricEigenvectors
(FloatMatrix A) Computes the eigenvalues and eigenvectors for a symmetric matrix.static FloatMatrix
Eigen.symmetricGeneralizedEigenvalues
(FloatMatrix A, FloatMatrix B) Compute generalized eigenvalues of the problem A x = L B x.static FloatMatrix
Eigen.symmetricGeneralizedEigenvalues
(FloatMatrix A, FloatMatrix B, float vl, float vu) Computes selected eigenvalues of the real generalized symmetric-definite eigenproblem of the form A x = L B x or, equivalently, (A - L B)x = 0.static FloatMatrix
Eigen.symmetricGeneralizedEigenvalues
(FloatMatrix A, FloatMatrix B, int il, int iu) Computes selected eigenvalues of the real generalized symmetric-definite eigenproblem of the form A x = L B x or, equivalently, (A - L B)x = 0.static FloatMatrix[]
Eigen.symmetricGeneralizedEigenvectors
(FloatMatrix A, FloatMatrix B) Solve a general problem A x = L B x.static FloatMatrix[]
Eigen.symmetricGeneralizedEigenvectors
(FloatMatrix A, FloatMatrix B, float vl, float vu) Computes selected eigenvalues and their corresponding eigenvectors of the real generalized symmetric-definite eigenproblem of the form A x = L B x or, equivalently, (A - L B)x = 0.static FloatMatrix[]
Eigen.symmetricGeneralizedEigenvectors
(FloatMatrix A, FloatMatrix B, int il, int iu) Computes selected eigenvalues and their corresponding eigenvectors of the real generalized symmetric-definite eigenproblem of the form A x = L B x or, equivalently, (A - L B)x = 0.static FloatMatrix
SimpleBlas.sysv
(char uplo, FloatMatrix a, int[] ipiv, FloatMatrix b) static FloatMatrix
MatrixFunctions.tan
(FloatMatrix x) static FloatMatrix
MatrixFunctions.tanh
(FloatMatrix x) static FloatMatrix
MatrixFunctions.tanhi
(FloatMatrix x) static FloatMatrix
MatrixFunctions.tani
(FloatMatrix x) DoubleMatrix.toFloat()
FloatMatrix.toFloat()
FloatMatrix.transpose()
Return transposed copy of this matrix.FloatMatrix.truth()
Maps zero to 0.0f and all non-zero values to 1.0f.FloatMatrix.truthi()
Maps zero to 0.0f and all non-zero values to 1.0f (in-place).static FloatMatrix
Construct FloatMatrix from ASCII representation.FloatMatrix.xor
(float value) Compute elementwise logical xor against a scalar.FloatMatrix.xor
(FloatMatrix other) Compute elementwise logical xor.FloatMatrix.xori
(float value) Compute elementwise logical xor against a scalar (in-place).FloatMatrix.xori
(float value, FloatMatrix result) Compute elementwise logical xor against a scalar (in-place).FloatMatrix.xori
(FloatMatrix other) Compute elementwise logical xor (in-place).FloatMatrix.xori
(FloatMatrix other, FloatMatrix result) Compute elementwise logical xor (in-place).static FloatMatrix
FloatMatrix.zeros
(int length) Creates a column vector of given length.static FloatMatrix
FloatMatrix.zeros
(int rows, int columns) Creates a new matrix in which all values are equal 0.Methods in org.jblas that return types with arguments of type FloatMatrixModifier and TypeMethodDescriptionFloatMatrix.columnsAsList()
static Decompose.LUDecomposition
<FloatMatrix> Decompose.lu
(FloatMatrix A) Compute LU Decomposition of a general matrix.static Decompose.QRDecomposition
<FloatMatrix> Decompose.qr
(FloatMatrix A) QR decomposition.FloatMatrix.rowsAsList()
Methods in org.jblas with parameters of type FloatMatrixModifier and TypeMethodDescriptionstatic FloatMatrix
MatrixFunctions.abs
(FloatMatrix x) Returns a copy of this matrix where all elements are set to their absolute values.static FloatMatrix
MatrixFunctions.absi
(FloatMatrix x) Sets all elements in this matrix to their absolute values.static FloatMatrix
MatrixFunctions.acos
(FloatMatrix x) Returns a copy of this matrix where the trigonometric acos function is applied element wise.static FloatMatrix
MatrixFunctions.acosi
(FloatMatrix x) Applies the trigonometric arccosine function element wise on this matrix.FloatMatrix.add
(FloatMatrix other) Add a matrix.FloatMatrix.addColumnVector
(FloatMatrix x) Add a vector to all columns of the matrix.FloatMatrix.addi
(float v, FloatMatrix result) Add a scalar to a matrix (in-place).FloatMatrix.addi
(FloatMatrix other) Add a matrix (in place).FloatMatrix.addi
(FloatMatrix other, FloatMatrix result) Add two matrices (in-place).FloatMatrix.addiColumnVector
(FloatMatrix x) Add a vector to all columns of the matrix (in-place).FloatMatrix.addiRowVector
(FloatMatrix x) Add a row vector to all rows of the matrix (in place).FloatMatrix.addRowVector
(FloatMatrix x) Add a row to all rows of the matrix.FloatMatrix.and
(FloatMatrix other) Compute elementwise logical and.FloatMatrix.andi
(float value, FloatMatrix result) Compute elementwise logical and against a scalar (in-place).FloatMatrix.andi
(FloatMatrix other) Compute elementwise logical and (in-place).FloatMatrix.andi
(FloatMatrix other, FloatMatrix result) Compute elementwise logical and (in-place).static FloatMatrix
MatrixFunctions.asin
(FloatMatrix x) static FloatMatrix
MatrixFunctions.asini
(FloatMatrix x) Applies the trigonometric arcsine function element wise on this matrix.void
FloatMatrix.assertMultipliesWith
(FloatMatrix a) Throws SizeException unless matrices can be multiplied with one another.void
FloatMatrix.assertSameLength
(FloatMatrix a) Throws SizeException unless matrices have the same length.void
FloatMatrix.assertSameSize
(FloatMatrix a) Throws SizeException unless two matrices have the same size.static float
SimpleBlas.asum
(FloatMatrix x) Compute || x ||_1 (1-norm, sum of absolute values)static FloatMatrix
MatrixFunctions.atan
(FloatMatrix x) static FloatMatrix
MatrixFunctions.atani
(FloatMatrix x) Applies the trigonometric arctangend function element wise on this matrix.static FloatMatrix
SimpleBlas.axpy
(float da, FloatMatrix dx, FloatMatrix dy) Compute y <- alpha * x + y (elementwise addition)static FloatMatrix
MatrixFunctions.cbrt
(FloatMatrix x) static FloatMatrix
MatrixFunctions.cbrti
(FloatMatrix x) Applies the cube root function element wise on this matrix.static FloatMatrix
MatrixFunctions.ceil
(FloatMatrix x) static FloatMatrix
MatrixFunctions.ceili
(FloatMatrix x) Element-wise round up by applying the ceil function on each element.static FloatMatrix
Geometry.center
(FloatMatrix x) Center a vector (subtract mean from all elements (in-place).static FloatMatrix
Geometry.centerColumns
(FloatMatrix x) Center the columns of a matrix (in-place).static FloatMatrix
Geometry.centerRows
(FloatMatrix x) Center the rows of a matrix (in-place).static FloatMatrix
Decompose.cholesky
(FloatMatrix A) if (info ) Compute Cholesky decomposition of Astatic FloatMatrix
FloatMatrix.concatHorizontally
(FloatMatrix A, FloatMatrix B) Concatenates two matrices horizontally.static FloatMatrix
FloatMatrix.concatVertically
(FloatMatrix A, FloatMatrix B) Concatenates two matrices vertically.FloatMatrix.copy
(FloatMatrix a) Copy FloatMatrix a to this.static FloatMatrix
SimpleBlas.copy
(FloatMatrix x, FloatMatrix y) Compute y <- x (copy a matrix)static FloatMatrix
MatrixFunctions.cos
(FloatMatrix x) static FloatMatrix
MatrixFunctions.cosh
(FloatMatrix x) static FloatMatrix
MatrixFunctions.coshi
(FloatMatrix x) Applies the hyperbolic cosine function element-wise on this matrix.static FloatMatrix
MatrixFunctions.cosi
(FloatMatrix x) Applies the cosine function element-wise on this matrix.static FloatMatrix
FloatMatrix.diag
(FloatMatrix x) Creates a new matrix where the values of the given vector are the diagonal values of the matrix.static FloatMatrix
FloatMatrix.diag
(FloatMatrix x, int rows, int columns) Construct a matrix of arbitrary shape and set the diagonal according to a passed vector.float
FloatMatrix.distance1
(FloatMatrix other) Returns the (1-norm) distance.float
FloatMatrix.distance2
(FloatMatrix other) Returns the (euclidean) distance.FloatMatrix.div
(FloatMatrix other) Elementwise divide by a matrix.FloatMatrix.divColumnVector
(FloatMatrix x) FloatMatrix.divi
(float a, FloatMatrix result) Elementwise division with a scalar (in-place).FloatMatrix.divi
(FloatMatrix other) Elementwise divide by a matrix (in place).FloatMatrix.divi
(FloatMatrix other, FloatMatrix result) Elementwise division (in-place).FloatMatrix.diviColumnVector
(FloatMatrix x) FloatMatrix.diviRowVector
(FloatMatrix x) FloatMatrix.divRowVector
(FloatMatrix x) float
FloatMatrix.dot
(FloatMatrix other) The scalar product of this with other.static float
SimpleBlas.dot
(FloatMatrix x, FloatMatrix y) Compute x^T * y (dot product)static ComplexFloatMatrix
Eigen.eigenvalues
(FloatMatrix A) Computes the eigenvalues of a general matrix.static ComplexFloatMatrix[]
Eigen.eigenvectors
(FloatMatrix A) Computes the eigenvalues and eigenvectors of a general matrix.FloatMatrix.eq
(FloatMatrix other) Test for equality.FloatMatrix.eqi
(float value, FloatMatrix result) Test for equality against a scalar (in-place).FloatMatrix.eqi
(FloatMatrix other) Test for equality (in-place).FloatMatrix.eqi
(FloatMatrix other, FloatMatrix result) Test for equality (in-place).static FloatMatrix
MatrixFunctions.exp
(FloatMatrix x) static FloatMatrix
MatrixFunctions.expi
(FloatMatrix x) Applies the exponential function element-wise on this matrix.static FloatMatrix
MatrixFunctions.expm
(FloatMatrix A) Calculate matrix exponential of a square matrix.static DoubleMatrix
MatrixFunctions.floatToDouble
(FloatMatrix fm) static FloatMatrix
MatrixFunctions.floor
(FloatMatrix x) static FloatMatrix
MatrixFunctions.floori
(FloatMatrix x) Element-wise round down by applying the floor function on each element.static FloatMatrix[]
Singular.fullSVD
(FloatMatrix A) Compute a singular-value decomposition of A.FloatMatrix.ge
(FloatMatrix other) Test for "greater than or equal".static int
SimpleBlas.geev
(char jobvl, char jobvr, FloatMatrix A, FloatMatrix WR, FloatMatrix WI, FloatMatrix VL, FloatMatrix VR) FloatMatrix.gei
(float value, FloatMatrix result) Test for "greater than or equal" against a scalar (in-place).FloatMatrix.gei
(FloatMatrix other) Test for "greater than or equal" (in-place).FloatMatrix.gei
(FloatMatrix other, FloatMatrix result) Test for "greater than or equal" (in-place).static void
SimpleBlas.gelsd
(FloatMatrix A, FloatMatrix B) Generalized Least Squares via *GELSD.static FloatMatrix
SimpleBlas.gemm
(float alpha, FloatMatrix a, FloatMatrix b, float beta, FloatMatrix c) Compute c <- a*b + beta * c (general matrix matrix multiplication)static FloatMatrix
SimpleBlas.gemv
(float alpha, FloatMatrix a, FloatMatrix x, float beta, FloatMatrix y) Compute y <- alpha*op(a)*x + beta * y (general matrix vector multiplication)static void
SimpleBlas.geqrf
(FloatMatrix A, FloatMatrix tau) static FloatMatrix
SimpleBlas.ger
(float alpha, FloatMatrix x, FloatMatrix y, FloatMatrix a) Compute A <- alpha * x * y^T + A (general rank-1 update)static FloatMatrix
SimpleBlas.gesv
(FloatMatrix a, int[] ipiv, FloatMatrix b) LAPACKFloatMatrix.get
(int r, FloatMatrix indices) Get elements from a row and columns as specified by the non-zero entries of a matrix.FloatMatrix.get
(FloatMatrix indices) Get elements specified by the non-zero entries of the passed matrix.FloatMatrix.get
(FloatMatrix indices, int c) Get elements from a column and rows as specified by the non-zero entries of a matrix.FloatMatrix.get
(FloatMatrix rindices, FloatMatrix cindices) Get elements from columns and rows as specified by the non-zero entries of the passed matrices.FloatMatrix.getColumn
(int c, FloatMatrix result) Copy a column to the given vector.FloatMatrix.getColumns
(FloatMatrix cindices) Get whole columns as specified by the non-zero entries of a matrix.FloatMatrix.getColumns
(Range indices, FloatMatrix result) Get whole columns as specified by Range.FloatMatrix.getRow
(int r, FloatMatrix result) Copy a row to a given vector.FloatMatrix.getRows
(FloatMatrix rindices) Get whole rows as specified by the non-zero entries of a matrix.FloatMatrix.getRows
(Range indices, FloatMatrix result) FloatMatrix.gt
(FloatMatrix other) Test for "greater than".FloatMatrix.gti
(float value, FloatMatrix result) Test for "greater than" against a scalar (in-place).FloatMatrix.gti
(FloatMatrix other) Test for "greater than" (in-place).FloatMatrix.gti
(FloatMatrix other, FloatMatrix result) Test for "greater than" (in-place).static int
SimpleBlas.iamax
(FloatMatrix x) Compute index of element with largest absolute value (index of absolute value maximum)FloatMatrix.le
(FloatMatrix other) Test for "less than or equal".FloatMatrix.lei
(float value, FloatMatrix result) Test for "less than or equal" against a scalar (in-place).FloatMatrix.lei
(FloatMatrix other) Test for "less than or equal" (in-place).FloatMatrix.lei
(FloatMatrix other, FloatMatrix result) Test for "less than or equal" (in-place).static FloatMatrix
MatrixFunctions.log
(FloatMatrix x) static FloatMatrix
MatrixFunctions.log10
(FloatMatrix x) static FloatMatrix
MatrixFunctions.log10i
(FloatMatrix x) Applies the logarithm with basis to 10 element-wise on this matrix.static FloatMatrix
MatrixFunctions.logi
(FloatMatrix x) Applies the natural logarithm function element-wise on this matrix.FloatMatrix.lt
(FloatMatrix other) Test for "less than".FloatMatrix.lti
(float value, FloatMatrix result) Test for "less than" against a scalar (in-place).FloatMatrix.lti
(FloatMatrix other) Test for "less than" (in-place).FloatMatrix.lti
(FloatMatrix other, FloatMatrix result) Test for "less than" (in-place).static Decompose.LUDecomposition
<FloatMatrix> Decompose.lu
(FloatMatrix A) Compute LU Decomposition of a general matrix.FloatMatrix.max
(FloatMatrix other) Computes the maximum between two matrices.FloatMatrix.maxi
(float v, FloatMatrix result) FloatMatrix.maxi
(FloatMatrix other) Computes the maximum between two matrices.FloatMatrix.maxi
(FloatMatrix other, FloatMatrix result) Computes the maximum between two matrices.FloatMatrix.min
(FloatMatrix other) Computes the minimum between two matrices.FloatMatrix.mini
(float v, FloatMatrix result) FloatMatrix.mini
(FloatMatrix other) Computes the minimum between two matrices.FloatMatrix.mini
(FloatMatrix other, FloatMatrix result) Computes the minimum between two matrices.FloatMatrix.mmul
(FloatMatrix other) Matrix-multiply by a matrix.FloatMatrix.mmuli
(float v, FloatMatrix result) Matrix-matrix multiplication with a scalar (for symmetry, does the same asmuli(scalar)
(in-place).FloatMatrix.mmuli
(FloatMatrix other) Matrix-multiply by a matrix (in place).FloatMatrix.mmuli
(FloatMatrix other, FloatMatrix result) Matrix-matrix multiplication (in-place).FloatMatrix.mul
(FloatMatrix other) Elementwise multiply by a matrix.FloatMatrix.mulColumnVector
(FloatMatrix x) Multiply all columns with a column vector.FloatMatrix.muli
(float v, FloatMatrix result) Elementwise multiplication with a scalar (in-place).FloatMatrix.muli
(FloatMatrix other) Elementwise multiply by a matrix (in place).FloatMatrix.muli
(FloatMatrix other, FloatMatrix result) Elementwise multiplication (in-place).FloatMatrix.muliColumnVector
(FloatMatrix x) Multiply all columns with a column vector (in-place).FloatMatrix.muliRowVector
(FloatMatrix x) Multiply all rows with a row vector (in-place).FloatMatrix.mulRowVector
(FloatMatrix x) Multiply all rows with a row vector.boolean
FloatMatrix.multipliesWith
(FloatMatrix a) Checks whether two matrices can be multiplied (that is, number of columns of this must equal number of rows of a.FloatMatrix.ne
(FloatMatrix other) Test for inequality.FloatMatrix.nei
(float value, FloatMatrix result) Test for inequality against a scalar (in-place).FloatMatrix.nei
(FloatMatrix other) Test for inequality (in-place).FloatMatrix.nei
(FloatMatrix other, FloatMatrix result) Test for inequality (in-place).static FloatMatrix
Geometry.normalize
(FloatMatrix x) Normalize a vector (scale such that its Euclidean norm is 1) (in-place).static FloatMatrix
Geometry.normalizeColumns
(FloatMatrix x) Normalize the columns of a matrix (in-place).static FloatMatrix
Geometry.normalizeRows
(FloatMatrix x) Normalize the rows of a matrix (in-place).static float
SimpleBlas.nrm2
(FloatMatrix x) Compute || x ||_2 (2-norm)FloatMatrix.or
(FloatMatrix other) Compute elementwise logical or.static void
SimpleBlas.orgqr
(int n, int k, FloatMatrix A, FloatMatrix tau) FloatMatrix.ori
(float value, FloatMatrix result) Compute elementwise logical or against a scalar (in-place).FloatMatrix.ori
(FloatMatrix other) Compute elementwise logical or (in-place).FloatMatrix.ori
(FloatMatrix other, FloatMatrix result) Compute elementwise logical or (in-place).static void
SimpleBlas.ormqr
(char side, char trans, FloatMatrix A, FloatMatrix tau, FloatMatrix C) static FloatMatrix
Geometry.pairwiseSquaredDistances
(FloatMatrix X, FloatMatrix Y) Compute the pairwise squared distances between all columns of the two matrices.static FloatMatrix
Solve.pinv
(FloatMatrix A) Computes the pseudo-inverse.static void
SimpleBlas.posv
(char uplo, FloatMatrix A, FloatMatrix B) static FloatMatrix
MatrixFunctions.pow
(float b, FloatMatrix x) static FloatMatrix
MatrixFunctions.pow
(FloatMatrix x, float e) static FloatMatrix
MatrixFunctions.pow
(FloatMatrix x, FloatMatrix e) static FloatMatrix
MatrixFunctions.powi
(float base, FloatMatrix x) static FloatMatrix
MatrixFunctions.powi
(FloatMatrix x, float d) Element-wise power function.static FloatMatrix
MatrixFunctions.powi
(FloatMatrix x, FloatMatrix e) float
FloatMatrix.project
(FloatMatrix other) Computes the projection coefficient of other on this.FloatMatrix.put
(int[] rindices, int[] cindices, FloatMatrix x) Put a sub-matrix as specified by the indices.FloatMatrix.put
(int[] indices, int c, FloatMatrix x) Set multiple elements in a row.FloatMatrix.put
(int[] indices, FloatMatrix x) Set elements in linear ordering in the specified indices.FloatMatrix.put
(int r, int[] indices, FloatMatrix x) Set multiple elements in a row.FloatMatrix.put
(int r, FloatMatrix indices, float v) Put a single value into the specified columns (non-zero entries of indices) of a row.FloatMatrix.put
(int r, FloatMatrix indices, FloatMatrix v) Put a sub-vector into the specified columns (non-zero entries of indices) of a row.FloatMatrix.put
(FloatMatrix indices, float v) Put a single value into the elements specified by the non-zero entries of indices (linear adressing).FloatMatrix.put
(FloatMatrix indices, int c, float v) Put a single value into the specified rows (non-zero entries of indices) of a column.FloatMatrix.put
(FloatMatrix indices, int c, FloatMatrix v) Put a sub-vector into the specified rows (non-zero entries of indices) of a column.FloatMatrix.put
(FloatMatrix indices, FloatMatrix v) Put a sub-matrix into the indices specified by the non-zero entries of indices (linear adressing).FloatMatrix.put
(FloatMatrix rindices, FloatMatrix cindices, float v) Put a single value in the specified rows and columns (non-zero entries of rindices and cindices.FloatMatrix.put
(FloatMatrix rindices, FloatMatrix cindices, FloatMatrix v) Put a sub-matrix into the specified rows and columns (non-zero entries of rindices and cindices.FloatMatrix.put
(Range rs, Range cs, FloatMatrix x) Put a matrix into specified indices.void
FloatMatrix.putColumn
(int c, FloatMatrix v) Copy a column back into the matrix.void
FloatMatrix.putRow
(int r, FloatMatrix v) Copy a row back into the matrix.static Decompose.QRDecomposition
<FloatMatrix> Decompose.qr
(FloatMatrix A) QR decomposition.FloatMatrix.rankOneUpdate
(float alpha, FloatMatrix x) Computes a rank-1-update A = A + alpha * x * x'.FloatMatrix.rankOneUpdate
(float alpha, FloatMatrix x, FloatMatrix y) Computes a rank-1-update A = A + alpha * x * y'.FloatMatrix.rankOneUpdate
(FloatMatrix x) Computes a rank-1-update A = A + x * x'.FloatMatrix.rankOneUpdate
(FloatMatrix x, FloatMatrix y) Computes a rank-1-update A = A + x * y'.FloatMatrix.rdiv
(FloatMatrix other) (right-)elementwise divide by a matrix.FloatMatrix.rdivi
(float a, FloatMatrix result) (Elementwise) division with a scalar, with operands switched.FloatMatrix.rdivi
(FloatMatrix other) (right-)elementwise divide by a matrix (in place).FloatMatrix.rdivi
(FloatMatrix other, FloatMatrix result) Elementwise division, with operands switched.FloatMatrix.rsub
(FloatMatrix other) (right-)subtract a matrix.FloatMatrix.rsubi
(float a, FloatMatrix result) Subtract a matrix from a scalar (in-place).FloatMatrix.rsubi
(FloatMatrix other) (right-)subtract a matrix (in place).FloatMatrix.rsubi
(FloatMatrix other, FloatMatrix result) Subtract two matrices, but subtract first from second matrix, that is, compute result = other - this (in-place).boolean
FloatMatrix.sameLength
(FloatMatrix a) Checks whether two matrices have the same length.boolean
FloatMatrix.sameSize
(FloatMatrix a) Checks whether two matrices have the same size.static FloatMatrix
SimpleBlas.scal
(float alpha, FloatMatrix x) Compute x <- alpha * x (scale a matrix)FloatMatrix.select
(FloatMatrix where) FloatMatrix.selecti
(FloatMatrix where) static FloatMatrix
MatrixFunctions.signum
(FloatMatrix x) static FloatMatrix
MatrixFunctions.signumi
(FloatMatrix x) static FloatMatrix
MatrixFunctions.sin
(FloatMatrix x) static FloatMatrix
MatrixFunctions.sinh
(FloatMatrix x) static FloatMatrix
MatrixFunctions.sinhi
(FloatMatrix x) static FloatMatrix
MatrixFunctions.sini
(FloatMatrix x) static FloatMatrix
Solve.solve
(FloatMatrix A, FloatMatrix B) Solves the linear equation A*X = B.static FloatMatrix
Solve.solveLeastSquares
(FloatMatrix A, FloatMatrix B) Computes the Least Squares solution for over or underdetermined linear equations A*X = B In the overdetermined case, when m > n, that is, there are more equations than variables, it computes the least squares solution of X -> ||A*X - B ||_2.static FloatMatrix
Solve.solvePositive
(FloatMatrix A, FloatMatrix B) Solves the linear equation A*X = B for symmetric and positive definite A.static FloatMatrix
Solve.solveSymmetric
(FloatMatrix A, FloatMatrix B) Solves the linear equation A*X = B for symmetric A.static FloatMatrix[]
Singular.sparseSVD
(FloatMatrix A) Compute a singular-value decomposition of A (sparse variant).static FloatMatrix
MatrixFunctions.sqrt
(FloatMatrix x) static FloatMatrix
MatrixFunctions.sqrti
(FloatMatrix x) float
FloatMatrix.squaredDistance
(FloatMatrix other) Returns the squared (Euclidean) distance.FloatMatrix.sub
(FloatMatrix other) Subtract a matrix.FloatMatrix.subColumnVector
(FloatMatrix x) Subtract a vector from all columns of the matrix.FloatMatrix.subi
(float v, FloatMatrix result) Subtract a scalar from a matrix (in-place).FloatMatrix.subi
(FloatMatrix other) Subtract a matrix (in place).FloatMatrix.subi
(FloatMatrix other, FloatMatrix result) Subtract two matrices (in-place).FloatMatrix.subiColumnVector
(FloatMatrix x) Subtract a column vector from all columns of the matrix (in-place).FloatMatrix.subiRowVector
(FloatMatrix x) Subtract a row vector from all rows of the matrix (in-place).FloatMatrix.subRowVector
(FloatMatrix x) Subtract a row vector from all rows of the matrix.static FloatMatrix
Singular.SVDValues
(FloatMatrix A) Compute the singular values of a matrix.static FloatMatrix
SimpleBlas.swap
(FloatMatrix x, FloatMatrix y) Compute x <-> y (swap two matrices)static int
SimpleBlas.syev
(char jobz, char uplo, FloatMatrix a, FloatMatrix w) static int
SimpleBlas.syevd
(char jobz, char uplo, FloatMatrix A, FloatMatrix w) static int
SimpleBlas.syevr
(char jobz, char range, char uplo, FloatMatrix a, float vl, float vu, int il, int iu, float abstol, FloatMatrix w, FloatMatrix z, int[] isuppz) static int
SimpleBlas.syevx
(char jobz, char range, char uplo, FloatMatrix a, float vl, float vu, int il, int iu, float abstol, FloatMatrix w, FloatMatrix z) static int
SimpleBlas.sygvd
(int itype, char jobz, char uplo, FloatMatrix A, FloatMatrix B, FloatMatrix W) static int
SimpleBlas.sygvx
(int itype, char jobz, char range, char uplo, FloatMatrix A, FloatMatrix B, float vl, float vu, int il, int iu, float abstol, int[] m, FloatMatrix W, FloatMatrix Z) static FloatMatrix
Eigen.symmetricEigenvalues
(FloatMatrix A) Compute the eigenvalues for a symmetric matrix.static FloatMatrix[]
Eigen.symmetricEigenvectors
(FloatMatrix A) Computes the eigenvalues and eigenvectors for a symmetric matrix.static FloatMatrix
Eigen.symmetricGeneralizedEigenvalues
(FloatMatrix A, FloatMatrix B) Compute generalized eigenvalues of the problem A x = L B x.static FloatMatrix
Eigen.symmetricGeneralizedEigenvalues
(FloatMatrix A, FloatMatrix B, float vl, float vu) Computes selected eigenvalues of the real generalized symmetric-definite eigenproblem of the form A x = L B x or, equivalently, (A - L B)x = 0.static FloatMatrix
Eigen.symmetricGeneralizedEigenvalues
(FloatMatrix A, FloatMatrix B, int il, int iu) Computes selected eigenvalues of the real generalized symmetric-definite eigenproblem of the form A x = L B x or, equivalently, (A - L B)x = 0.static FloatMatrix[]
Eigen.symmetricGeneralizedEigenvectors
(FloatMatrix A, FloatMatrix B) Solve a general problem A x = L B x.static FloatMatrix[]
Eigen.symmetricGeneralizedEigenvectors
(FloatMatrix A, FloatMatrix B, float vl, float vu) Computes selected eigenvalues and their corresponding eigenvectors of the real generalized symmetric-definite eigenproblem of the form A x = L B x or, equivalently, (A - L B)x = 0.static FloatMatrix[]
Eigen.symmetricGeneralizedEigenvectors
(FloatMatrix A, FloatMatrix B, int il, int iu) Computes selected eigenvalues and their corresponding eigenvectors of the real generalized symmetric-definite eigenproblem of the form A x = L B x or, equivalently, (A - L B)x = 0.static FloatMatrix
SimpleBlas.sysv
(char uplo, FloatMatrix a, int[] ipiv, FloatMatrix b) static FloatMatrix
MatrixFunctions.tan
(FloatMatrix x) static FloatMatrix
MatrixFunctions.tanh
(FloatMatrix x) static FloatMatrix
MatrixFunctions.tanhi
(FloatMatrix x) static FloatMatrix
MatrixFunctions.tani
(FloatMatrix x) FloatMatrix.xor
(FloatMatrix other) Compute elementwise logical xor.FloatMatrix.xori
(float value, FloatMatrix result) Compute elementwise logical xor against a scalar (in-place).FloatMatrix.xori
(FloatMatrix other) Compute elementwise logical xor (in-place).FloatMatrix.xori
(FloatMatrix other, FloatMatrix result) Compute elementwise logical xor (in-place).Constructors in org.jblas with parameters of type FloatMatrixModifierConstructorDescriptionConstruct a complex matrix from a real matrix.ComplexFloatMatrix
(FloatMatrix real, FloatMatrix imag) Construct a complex matrix from separate real and imaginary parts. -
Uses of FloatMatrix in org.jblas.util
Methods in org.jblas.util that return FloatMatrixModifier and TypeMethodDescriptionstatic FloatMatrix
Permutations.permutationFloatMatrixFromPivotIndices
(int size, int[] ipiv) Create a permutation matrix from a LAPACK-style 'ipiv' vector.