This trait is commonly used for breeze.linalg.
A compressed sparse column matrix, as used in Matlab and CSparse, etc.
This is an auto-generated trait providing operators for CSCMatrix
This is an auto-generated trait providing operators for CSCMatrix
This is an auto-generated trait providing operators for CSCMatrix
A map-like tensor that acts like a collection of key-value pairs where the set of values may grow arbitrarily.
A map-like tensor that acts like a collection of key-value pairs where the set of values may grow arbitrarily.
A DenseMatrix is a matrix with all elements found in an array.
This is an auto-generated trait providing multiplication for DenseMatrix
This is an auto-generated trait providing multiplication for DenseMatrix
This is an auto-generated trait providing multiplication for DenseMatrix
This is an auto-generated trait providing operators for DenseMatrix.
This is an auto-generated trait providing operators for DenseMatrix.
This is an auto-generated trait providing operators for DenseMatrix.
This is an auto-generated trait providing operators for DenseMatrix.
This is an auto-generated trait providing operators for DenseMatrix.
This is an auto-generated trait providing operators for DenseMatrix.
A DenseVector is the "obvious" implementation of a Vector, with one twist.
This is an auto-generated trait providing operators for DenseVector.
This is an auto-generated trait providing operators for DenseVector.
This is an auto-generated trait providing operators for DenseVector.
This is an auto-generated trait providing operators for DenseVector.
This is an auto-generated trait providing operators for DenseVector and HashVector
This is an auto-generated trait providing operators for DenseVector and HashVector
This is an auto-generated trait providing operators for DenseVector and HashVector
This is an auto-generated trait providing operators for DenseVector.
This is an auto-generated trait providing operators for DenseVector.
This is an auto-generated trait providing operators for DenseVector and SparseVector
This is an auto-generated trait providing operators for DenseVector and SparseVector
This is an auto-generated trait providing operators for DenseVector and SparseVector
A HashVector is a sparse vector backed by an OpenAddressHashArray
This is an auto-generated trait providing operators for HashVector.
This is an auto-generated trait providing operators for HashVector.
This is an auto-generated trait providing operators for HashVector.
Basic linear algebraic operations.
This is an auto-generated trait providing multiplication for Matrix
This is an auto-generated trait providing multiplication for Matrix
This is an auto-generated trait providing multiplication for Matrix
Thrown when trying to solve using a singular matrix.
This decorator automatically caches the norm and sums of a vector and invalidates the cache whenever the vector is updated.
Exception thrown if a routine has not converged.
In some sense, this is the real root of the linalg hierarchy.
We occasionally need a Tensor that doesn't extend NumericOps directly.
A SliceVector is a vector that is a view of another underlying tensor.
A Binary-search backed vector.
This is an auto-generated trait providing operators for SparseVector
This is an auto-generated trait providing operators for SparseVector
This is an auto-generated trait providing operators for SparseVector
A Tensor defines a map from an index set to a set of values.
A Vector represents the mathematical concept of a vector in math.
A VectorBuilder is basically unsorted Sparse Vector.
Trait that can mixed to companion objects to enable utility methods for creating vectors.
Trait for operators and such used in vectors.
This is an auto-generated trait providing operators for Vector.
This is an auto-generated trait providing operators for Vector.
This is an auto-generated trait providing operators for Vector.
Trait used for methods that can return a view or a copy.
Computes the LU factorization of the given real M-by-N matrix X such that X = P * L * U where P is a permutation matrix (row exchanges).
Computes the LU factorization of the given real M-by-N matrix X such that X = P * L * U where P is a permutation matrix (row exchanges).
Upon completion, a tuple consisting of a matrix A and an integer array P.
The upper triangular portion of A resembles U whereas the lower triangular portion of A resembles L up to but not including the diagonal elements of L which are all equal to 1.
For 0 <= i < M, each element P(i) denotes whether row i of the matrix X was exchanged with row P(i-1) during computation (the offset is caused by the internal call to LAPACK).
Import this to provide access to a DenseMatrix[Double] as a MutableInnerProductSpace, so it can be used in optimization.
Computes y += x * a, possibly doing less work than actually doing that operation
Attempts to load the NativeBlas libraries.
Attempts to load the NativeBlas libraries. Returns false if we can't.
Computes the cholesky decomposition A of the given real symmetric positive definite matrix X such that X = A A.
Computes the cholesky decomposition A of the given real symmetric positive definite matrix X such that X = A A.t.
XXX: For higher dimensionalities, the return value really should be a sparse matrix due to its inherent lower triangular nature.
Copy a T.
Copy a T. Most tensor objects have a CanCopy implicit, which is what this farms out to.
Vector cross product of 3D vectors a and b.
Vector cross product of 3D vectors a and b.
Computes the determinant of the given real matrix.
Computes the determinant of the given real matrix.
Creates a Diagonal dense matrix from this vector.
Creates a Diagonal dense matrix from this vector.
TODO make a real diagonal matrix class
returns a vector along the diagonal of v.
returns a vector along the diagonal of v. Requires a square matrix?
the matrix
Eigenvalue decomposition (right eigenvectors)
Eigenvalue decomposition (right eigenvectors)
This function returns the real and imaginary parts of the eigenvalues, and the corresponding eigenvectors. For most (?) interesting matrices, the imaginary part of all eigenvalues will be zero (and the corresponding eigenvectors will be real). Any complex eigenvalues will appear in complex-conjugate pairs, and the real and imaginary components of the eigenvector for each pair will be in the corresponding columns of the eigenvector matrix. Take the complex conjugate to find the second eigenvector.
Based on EVD.java from MTJ 0.9.12
Computes all eigenvalues (and optionally right eigenvectors) of the given real symmetric matrix X.
Computes all eigenvalues (and optionally right eigenvectors) of the given real symmetric matrix X.
Computes the inverse of a given real matrix.
Computes the inverse of a given real matrix.
Returns the Kronecker product of the two matrices a and b, usually denoted a ⊗ b.
Returns the Kronecker product of the two matrices a and b, usually denoted a ⊗ b.
Generates a vector of linearly spaced values between a and b (inclusive).
Generates a vector of linearly spaced values between a and b (inclusive). The returned vector will have length elements, defaulting to 100.
logs and then logNormalizes the argument along axis such that each softmax is 0.
logs and then logNormalizes the argument along axis such that each softmax is 0.0. Returns value if value's softmax is -infinity
logs and then logNormalizes the argument such that the softmax is 0.
logs and then logNormalizes the argument such that the softmax is 0.0. Returns value if value's softmax is -infinity
logs and then logNormalizes the argument along axis such that each softmax is 0.
logs and then logNormalizes the argument along axis such that each softmax is 0.0. Returns value if value's softmax is -infinity
logNormalizes the argument such that the softmax is 0.
logNormalizes the argument such that the softmax is 0.0. Returns value if value's softmax is -infinity
The lower triangular portion of the given real quadratic matrix X.
The lower triangular portion of the given real quadratic matrix X. Note that no check will be performed regarding the symmetry of X.
Computes the max, aka the infinity norm.
A breeze.generic.URFunc for computing the mean of objects
A breeze.generic.URFunc for computing the mean and variance of objects.
A breeze.generic.URFunc for computing the mean and variance of objects. This uses an efficient, numerically stable, one pass algorithm for computing both the mean and the variance.
Computes the minimum.
Computes the norm of an object.
Computes the norm of an object. Many tensor objects have a CanNorm implicit, which is what this calls.
Normalizes the argument along each axis such that each row along the axis has norm 1.
Normalizes the argument along each axis such that each row along the axis has norm 1.0 (with respect to the argument n). Each column is unchanged if it's norm is 0
Normalizes the argument such that its norm is 1.
Normalizes the argument such that its norm is 1.0 (with respect to the argument n). Returns value if value's norm is 0.
Computes the Moore-Penrose pseudo inverse of the given real matrix X.
Computes the Moore-Penrose pseudo inverse of the given real matrix X.
Computes the Moore-Penrose pseudo inverse of the given real matrix X.
Computes the Moore-Penrose pseudo inverse of the given real matrix X.
Raises m to the exp'th power via eigenvalue decomposition.
Raises m to the exp'th power via eigenvalue decomposition. Currently requires that m's eigenvalues are real.
QR Factorization
QR Factorization
m x n matrix
(optional) if true, don't reconstruct orthogonal matrix Q (instead returns (null,R))
(Q,R) Q: m x m R: m x n
QR Factorization with pivoting
QR Factorization with pivoting
input: A m x n matrix output: (Q,R,P,pvt) where AP = QR Q: m x m R: m x n P: n x n : permutation matrix (P(pvt(i),i) = 1) pvt : pivot indices
Computes the rank of a DenseMatrix[Double].
Computes the rank of a DenseMatrix[Double].
The rank of the matrix is computed using the SVD method. The singular values of the SVD which are greater than a specified tolerance are counted.
matrix for which to compute the rank
optional tolerance for singular values. If not supplied, the default tolerance is: max(m.cols, m.rows) * eps * sigma_max, where eps is the machine epsilon and sigma_max is the largest singular value of m.
the rank of the matrix (number of singular values)
Returns the rank of each element in the given vector, adjusting for ties.
Returns the rank of each element in the given vector, adjusting for ties.
Computes the softmax (a.
Computes the softmax (a.k.a. logSum) of an object. Softmax is defined as \log \sum_i \exp(x(i)), but implemented in a more numerically stable way. Softmax is so-called because it is a differentiable function that tends to look quite a lot like max. Consider log(exp(30) + exp(10)). That's basically 30. We use softmax a lot in machine learning.
Cmoputes the standard deviation by calling variance and then sqrt'ing
Computes the SVD of a m by n matrix Returns an m*m matrix U, a vector of singular values, and a n*n matrix V'
Computes the SVD of a m by n matrix Returns an m*m matrix U, a vector of singular values, and a n*n matrix V'
The upper triangular portion of the given real quadratic matrix X.
The upper triangular portion of the given real quadratic matrix X. Note that no check will be performed regarding the symmetry of X.
Returns true if we can use native libraries.
Returns true if we can use native libraries. You can disable it by writing breeze.linalg.useNativeLibraries to false
Disables or attempts to enable native libraries.
Disables or attempts to enable native libraries. Will throw a RuntimeException if you try to set the value to true and we can't load the libraries.
A breeze.generic.URFunc for computing the variance of objects.
A breeze.generic.URFunc for computing the variance of objects. The method just calls meanAndVariance and returns the second result.
This package contains everything relating to Vectors, Matrices, Tensors, etc.
If you're doing basic work, you probably want breeze.linalg.DenseVector and breeze.linalg.DenseMatrix, which support most operations. We also have breeze.linalg.SparseVectors and (basic!) support for a sparse matrix (breeze.linalg.CSCMatrix).
This package object contains Matlab-esque functions for interacting with tensors and matrices.