本文簡要介紹 python 語言中 scipy.sparse.linalg.cgs
的用法。
用法:
scipy.sparse.linalg.cgs(A, b, x0=None, *, tol=<object object>, maxiter=None, M=None, callback=None, atol=0.0, rtol=1e-05)#
使用共軛梯度平方迭代來求解
Ax = b
。- A: {稀疏矩陣,ndarray,LinearOperator}
線性係統的實值N-by-N 矩陣。或者,
A
可以是線性運算符,它可以使用scipy.sparse.linalg.LinearOperator
等生成Ax
。- b: ndarray
線性係統的右手邊。具有形狀 (N,) 或 (N,1)。
- x0: ndarray
開始猜測解決方案。
- rtol, atol: 浮點數,可選
收斂測試的參數。為了收斂,應滿足
norm(b - A @ x) <= max(rtol*norm(b), atol)
。默認為atol=0.
和rtol=1e-5
。- maxiter: 整數
最大迭代次數。即使沒有達到指定的容差,迭代也會在 maxiter 步後停止。
- M: {稀疏矩陣,ndarray,LinearOperator}
A 的預處理器。預處理器應該近似於 A 的逆。有效的預處理顯著提高了收斂速度,這意味著需要更少的迭代來達到給定的誤差容限。
- callback: 函數
每次迭代後調用的用戶提供的函數。它被稱為 callback(xk),其中 xk 是當前解向量。
- tol: 浮點數,可選,已棄用
- x: ndarray
融合解決方案。
- info: 整數
- 提供收斂信息:
0:成功退出>0:未達到容差收斂,迭代次數<0:參數崩潰
參數 ::
返回 ::
例子:
>>> import numpy as np >>> from scipy.sparse import csc_matrix >>> from scipy.sparse.linalg import cgs >>> R = np.array([[4, 2, 0, 1], ... [3, 0, 0, 2], ... [0, 1, 1, 1], ... [0, 2, 1, 0]]) >>> A = csc_matrix(R) >>> b = np.array([-1, -0.5, -1, 2]) >>> x, exit_code = cgs(A, b) >>> print(exit_code) # 0 indicates successful convergence 0 >>> np.allclose(A.dot(x), b) True
相關用法
- Python SciPy linalg.cg用法及代碼示例
- Python SciPy linalg.cdf2rdf用法及代碼示例
- Python SciPy linalg.clarkson_woodruff_transform用法及代碼示例
- Python SciPy linalg.cho_factor用法及代碼示例
- Python SciPy linalg.cholesky用法及代碼示例
- Python SciPy linalg.cho_solve_banded用法及代碼示例
- Python SciPy linalg.cosm用法及代碼示例
- Python SciPy linalg.cho_solve用法及代碼示例
- Python SciPy linalg.convolution_matrix用法及代碼示例
- Python SciPy linalg.circulant用法及代碼示例
- Python scipy.linalg.cossin用法及代碼示例
- Python SciPy linalg.companion用法及代碼示例
- Python SciPy linalg.cholesky_banded用法及代碼示例
- Python SciPy linalg.coshm用法及代碼示例
- Python SciPy linalg.eigvalsh_tridiagonal用法及代碼示例
- Python SciPy linalg.LaplacianNd用法及代碼示例
- Python SciPy linalg.solve_circulant用法及代碼示例
- Python SciPy linalg.polar用法及代碼示例
- Python SciPy linalg.rsf2csf用法及代碼示例
- Python SciPy linalg.hessenberg用法及代碼示例
- Python SciPy linalg.tril用法及代碼示例
- Python SciPy linalg.triu用法及代碼示例
- Python SciPy linalg.svd用法及代碼示例
- Python SciPy linalg.ishermitian用法及代碼示例
- Python SciPy linalg.invhilbert用法及代碼示例
注:本文由純淨天空篩選整理自scipy.org大神的英文原創作品 scipy.sparse.linalg.cgs。非經特殊聲明,原始代碼版權歸原作者所有,本譯文未經允許或授權,請勿轉載或複製。