scipy.sparse.linalg.
spilu#
- scipy.sparse.linalg.spilu(A, drop_tol=None, fill_factor=None, drop_rule=None, permc_spec=None, diag_pivot_thresh=None, relax=None, panel_size=None, options=None)[source]#
计算稀疏方阵的非完全 LU 分解。
结果对象是 A 逆的近似值。
- 参数:
- A(N, N) array_like
要分解的稀疏矩阵。以 CSC 格式提供时效率最高。其他格式将在分解前转换为 CSC。
- drop_tolfloat, 可选
非完全 LU 分解的舍弃容差 (0 <= tol <= 1)。(默认值:1e-4)
- fill_factorfloat, 可选
指定 ILU 的填充率上限 (>= 1.0)。(默认值:10)
- drop_rulestr, 可选
要使用的舍弃规则的逗号分隔字符串。可用规则:
basic
,prows
,column
,area
,secondary
,dynamic
,interp
. (默认值:basic,area
)有关详细信息,请参阅 SuperLU 文档。
- 其他选项
与
splu
相同
- 返回值:
- invA_approxscipy.sparse.linalg.SuperLU
对象,它具有
solve
方法。
另请参阅
splu
完全 LU 分解
备注
为了获得更接近逆的近似值,您可能需要增加 fill_factor 并且降低 drop_tol。
此函数使用 SuperLU 库。
示例
>>> import numpy as np >>> from scipy.sparse import csc_matrix >>> from scipy.sparse.linalg import spilu >>> A = csc_matrix([[1., 0., 0.], [5., 0., 2.], [0., -1., 0.]], dtype=float) >>> B = spilu(A) >>> x = np.array([1., 2., 3.], dtype=float) >>> B.solve(x) array([ 1. , -3. , -1.5]) >>> A.dot(B.solve(x)) array([ 1., 2., 3.]) >>> B.solve(A.dot(x)) array([ 1., 2., 3.])