scipy.linalg.
svd#
- scipy.linalg.svd(a, full_matrices=True, compute_uv=True, overwrite_a=False, check_finite=True, lapack_driver='gesdd')[源代码][源代码]#
奇异值分解。
将矩阵 a 分解为两个酉矩阵
U
和Vh
,以及一个奇异值的一维数组s``(实数,非负),使得 ``a == U @ S @ Vh
,其中S
是一个适当形状的零矩阵,其主对角线为s
。- 参数:
- a(M, N) array_like
要分解的矩阵。
- full_matricesbool, 可选
如果为 True(默认),U 和 Vh 的形状为
(M, M)
,(N, N)
。如果为 False,形状为(M, K)
和(K, N)
,其中K = min(M, N)
。- compute_uvbool, 可选
是否在计算
s
的同时也计算U
和Vh
。默认值为 True。- overwrite_abool, 可选
是否覆盖 a;可能会提高性能。默认值为 False。
- check_finitebool, 可选
是否检查输入矩阵是否仅包含有限数值。禁用可能会提高性能,但如果输入包含无穷大或NaN,可能会导致问题(崩溃、非终止)。
- lapack_driver{‘gesdd’, ‘gesvd’}, 可选
是否使用更高效的分割-征服方法(
'gesdd'
)或一般矩形方法('gesvd'
)来计算SVD。MATLAB和Octave使用``’gesvd’方法。默认是
’gesdd’``。Added in version 0.18.
- 返回:
- Undarray
具有左奇异向量作为列的酉矩阵。形状为
(M, M)
或(M, K)
,取决于 full_matrices。- sndarray
奇异值,按非递增顺序排序。形状为 (K,),其中
K = min(M, N)
。- Vhndarray
具有右奇异向量作为行的酉矩阵。形状为
(N, N)
或(K, N)
取决于 full_matrices。- 对于
compute_uv=False
,仅返回s
。
- Raises:
- LinAlgError
如果SVD计算不收敛。
示例
>>> import numpy as np >>> from scipy import linalg >>> rng = np.random.default_rng() >>> m, n = 9, 6 >>> a = rng.standard_normal((m, n)) + 1.j*rng.standard_normal((m, n)) >>> U, s, Vh = linalg.svd(a) >>> U.shape, s.shape, Vh.shape ((9, 9), (6,), (6, 6))
从分解中重建原始矩阵:
>>> sigma = np.zeros((m, n)) >>> for i in range(min(m, n)): ... sigma[i, i] = s[i] >>> a1 = np.dot(U, np.dot(sigma, Vh)) >>> np.allclose(a, a1) True
或者,使用
full_matrices=False``(注意此时 ``U
的形状是(m, n)
而不是(m, m)
):>>> U, s, Vh = linalg.svd(a, full_matrices=False) >>> U.shape, s.shape, Vh.shape ((9, 6), (6,), (6, 6)) >>> S = np.diag(s) >>> np.allclose(a, np.dot(U, np.dot(S, Vh))) True
>>> s2 = linalg.svd(a, compute_uv=False) >>> np.allclose(s, s2) True