Sparse linear algebra (scipy.sparse.linalg)#
Abstract linear operators#
  | 
Common interface for performing matrix vector products  | 
Return A as a LinearOperator.  | 
Matrix Operations#
  | 
Compute the inverse of a sparse matrix  | 
  | 
Compute the matrix exponential using Pade approximation.  | 
  | 
Compute the action of the matrix exponential of A on B.  | 
  | 
Raise a square matrix to the integer power, power.  | 
Matrix norms#
  | 
Norm of a sparse matrix  | 
  | 
Compute a lower bound of the 1-norm of a sparse matrix.  | 
Solving linear problems#
Direct methods for linear equation systems:
  | 
Solve the sparse linear system Ax=b, where b may be a vector or a matrix.  | 
  | 
Solve the equation   | 
  | 
Return a function for solving a sparse linear system, with A pre-factorized.  | 
  | 
Select default sparse direct solver to be used.  | 
Iterative methods for linear equation systems:
  | 
Use BIConjugate Gradient iteration to solve   | 
  | 
Use BIConjugate Gradient STABilized iteration to solve   | 
  | 
Use Conjugate Gradient iteration to solve   | 
  | 
Use Conjugate Gradient Squared iteration to solve   | 
  | 
Use Generalized Minimal RESidual iteration to solve   | 
  | 
Solve a matrix equation using the LGMRES algorithm.  | 
  | 
Use MINimum RESidual iteration to solve Ax=b  | 
  | 
Use Quasi-Minimal Residual iteration to solve   | 
  | 
Solve a matrix equation using flexible GCROT(m,k) algorithm.  | 
  | 
Use Transpose-Free Quasi-Minimal Residual iteration to solve   | 
Iterative methods for least-squares problems:
  | 
Find the least-squares solution to a large, sparse, linear system of equations.  | 
  | 
Iterative solver for least-squares problems.  | 
Matrix factorizations#
Eigenvalue problems:
  | 
Find k eigenvalues and eigenvectors of the square matrix A.  | 
  | 
Find k eigenvalues and eigenvectors of the real symmetric square matrix or complex Hermitian matrix A.  | 
  | 
Locally Optimal Block Preconditioned Conjugate Gradient Method (LOBPCG).  | 
Singular values problems:
  | 
Partial singular value decomposition of a sparse matrix.  | 
The svds function supports the following solvers:
Complete or incomplete LU factorizations
  | 
Compute the LU decomposition of a sparse, square matrix.  | 
  | 
Compute an incomplete LU decomposition for a sparse, square matrix.  | 
  | 
LU factorization of a sparse matrix.  | 
Sparse arrays with structure#
  | 
The grid Laplacian in   | 
Exceptions#
  | 
ARPACK iteration did not converge  | 
  | 
ARPACK error  |