lsmr#
- scipy.sparse.linalg.lsmr(A, b, damp=0.0, atol=1e-06, btol=1e-06, conlim=100000000.0, maxiter=None, show=False, x0=None)[源代码][源代码]#
用于最小二乘问题的迭代求解器。
lsmr 解决线性方程组
Ax = b
。如果系统不一致,它解决最小二乘问题min ||b - Ax||_2
。A
是一个 m×n 的矩形矩阵,所有情况都允许:m = n,m > n,或 m < n。b
是一个长度为 m 的向量。矩阵 A 可以是密集的或稀疏的(通常是稀疏的)。- 参数:
- A{稀疏矩阵, ndarray, 线性算子}
线性系统中的矩阵 A。或者,
A
可以是一个线性算子,它可以使用例如scipy.sparse.linalg.LinearOperator
生成Ax
和A^H x
。- barray_like, 形状 (m,)
线性系统中的向量
b
。- 阻尼浮动
正则化最小二乘法的阻尼因子。
lsmr
解决正则化最小二乘问题:min ||(b) - ( A )x|| ||(0) (damp*I) ||_2
其中 damp 是一个标量。如果 damp 为 None 或 0,则系统在无正则化的情况下求解。默认值为 0。
- atol, btolfloat, 可选
停止容差。
lsmr
会继续迭代,直到某个后向误差估计小于依赖于 atol 和 btol 的某个量。设r = b - Ax
为当前近似解x
的残差向量。如果Ax = b
看起来是一致的,lsmr
在norm(r) <= atol * norm(A) * norm(x) + btol * norm(b)
时终止。否则,lsmr
在norm(A^H r) <= atol * norm(A) * norm(r)
时终止。如果两个容差都是 1.0e-6(默认值),最终的norm(r)
应该精确到大约 6 位数字。(最终的x
通常会有较少的正确数字,取决于cond(A)
和 LAMBDA 的大小。)如果 atol 或 btol 为 None,将使用默认值 1.0e-6。理想情况下,它们应该是A
和b
条目中相对误差的估计值。例如,如果A
的条目有 7 位正确数字,设置atol = 1e-7
。这防止算法在输入数据的不确定性之外做不必要的工作。- conlimfloat, 可选
lsmr
在估计的cond(A)
超过 conlim 时终止。对于兼容系统Ax = b
,conlim 可以大到 1.0e+12(例如)。对于最小二乘问题,conlim 应小于 1.0e+8。如果 conlim 为 None,默认值为 1e+8。通过设置atol = btol = conlim = 0
可以获得最大精度,但迭代次数可能会过多。默认值为 1e8。- maxiterint, 可选
lsmr
在迭代次数达到 maxiter 时终止。默认值为maxiter = min(m, n)
。对于病态系统,可能需要更大的 maxiter 值。默认值为 False。- 显示bool, 可选
如果
show=True
,则打印迭代日志。默认为 False。- x0类似数组,形状 (n,),可选
x
的初始猜测,如果为 None 则使用零。默认为 None。Added in version 1.0.0.
- 返回:
- x浮点数 ndarray
返回最小二乘解。
- istop整数
istop 给出停止的原因:
istop = 0 means x=0 is a solution. If x0 was given, then x=x0 is a solution. = 1 means x is an approximate solution to A@x = B, according to atol and btol. = 2 means x approximately solves the least-squares problem according to atol. = 3 means COND(A) seems to be greater than CONLIM. = 4 is the same as 1 with atol = btol = eps (machine precision) = 5 is the same as 2 with atol = eps. = 6 is the same as 3 with CONLIM = 1/eps. = 7 means ITN reached maxiter before the other stopping conditions were satisfied.
- itn整数
使用的迭代次数。
- normr浮动
norm(b-Ax)
- normar浮动
norm(A^H (b - Ax))
- norma浮动
norm(A)
- conda浮动
A 的条件数。
- normx浮动
norm(x)
注释
Added in version 0.11.0.
参考文献
[1]D. C.-L. Fong and M. A. Saunders, “LSMR: An iterative algorithm for sparse least-squares problems”, SIAM J. Sci. Comput., vol. 33, pp. 2950-2971, 2011. arXiv:1006.0758
[2]示例
>>> import numpy as np >>> from scipy.sparse import csc_matrix >>> from scipy.sparse.linalg import lsmr >>> A = csc_matrix([[1., 0.], [1., 1.], [0., 1.]], dtype=float)
第一个例子有一个平凡的解
[0, 0]
>>> b = np.array([0., 0., 0.], dtype=float) >>> x, istop, itn, normr = lsmr(A, b)[:4] >>> istop 0 >>> x array([0., 0.])
返回的停止代码 istop=0 表示找到了一个零向量作为解。返回的解 x 确实包含
[0., 0.]
。下一个示例有一个非平凡解:>>> b = np.array([1., 0., -1.], dtype=float) >>> x, istop, itn, normr = lsmr(A, b)[:4] >>> istop 1 >>> x array([ 1., -1.]) >>> itn 1 >>> normr 4.440892098500627e-16
如 istop=1 所示,
lsmr
找到了一个符合容差限制的解。给出的解[1., -1.]
显然解决了方程。剩余的返回值包括关于迭代次数(itn=1)和已解方程左右两侧剩余差异的信息。最后一个例子展示了在方程无解情况下的行为:>>> b = np.array([1., 0.01, -1.], dtype=float) >>> x, istop, itn, normr = lsmr(A, b)[:4] >>> istop 2 >>> x array([ 1.00333333, -0.99666667]) >>> A.dot(x)-b array([ 0.00333333, -0.00333333, 0.00333333]) >>> normr 0.005773502691896255
istop 表示系统不一致,因此 x 更接近于相应最小二乘问题的近似解。normr 包含了找到的最小距离。