本文简要介绍 python 语言中 scipy.sparse.linalg.LaplacianNd
的用法。
用法:
class scipy.sparse.linalg.LaplacianNd(*args, **kwargs)#
N
维度中的网格拉普拉斯及其特征值/特征向量。在均匀矩形网格上构造拉普拉斯算子N维数并输出其特征值和特征向量。拉普拉斯算子
L
是平方、负定、实对称数组,具有带符号整数条目,否则为零。- grid_shape: 元组
长度为
N
(对应于拉帕算子的维度)的整数元组,其中每个条目给出该维度的大小。拉普拉斯矩阵是大小为np.prod(grid_shape)
的平方。- boundary_conditions: {‘neumann’, ‘dirichlet’, ‘periodic’},可选
网格边界上的边界条件类型。有效值为
'dirichlet'
或'neumann'``(default) or ``'periodic'
。- dtype: 类型
数组的数值类型。默认为
np.int8
。
参数 ::
注意:
与 1-、2-和 3-D 拉普拉斯算子的 MATLAB/Octave 实现 [1] 相比,此代码允许任意 N-D 情况和 matrix-free 可调用选项,但目前仅限于纯 Dirichlet、Neumann 或仅周期性边界条件。
矩形网格图 (
scipy.sparse.csgraph.laplacian
) 的拉普拉斯矩阵对应于具有诺伊曼条件的负拉普拉斯矩阵,即boundary_conditions = 'neumann'
。离散拉普拉斯算子的所有特征值和特征向量
N
形状的维规则网格grid_shape与网格步长h=1
是分析已知的[2]。参考:
[2]“二阶导数的特征值和特征向量”,维基百科https://en.wikipedia.org/wiki/Eigenvalues_and_eigenvectors_of_the_second_derivative
例子:
>>> import numpy as np >>> from scipy.sparse.linalg import LaplacianNd >>> from scipy.sparse import diags, csgraph >>> from scipy.linalg import eigvalsh
下面演示的具有
n=6
网格点的规则网格上的纯诺依曼边界条件的一维拉普拉斯正好是具有n
顶点的无向线性图的负图拉普拉斯,使用著名的稀疏邻接矩阵G
表示tri-diagonal矩阵:>>> n = 6 >>> G = diags(np.ones(n - 1), 1, format='csr') >>> Lf = csgraph.laplacian(G, symmetrized=True, form='function') >>> grid_shape = (n, ) >>> lap = LaplacianNd(grid_shape, boundary_conditions='neumann') >>> np.array_equal(lap.matmat(np.eye(n)), -Lf(np.eye(n))) True
由于拉普拉斯算子的所有矩阵项都是整数,因此
'int8'
是用于存储矩阵表示的默认数据类型。>>> lap.tosparse() <6x6 sparse matrix of type '<class 'numpy.int8'>' with 16 stored elements (3 diagonals) in DIAgonal format> >>> lap.toarray() array([[-1, 1, 0, 0, 0, 0], [ 1, -2, 1, 0, 0, 0], [ 0, 1, -2, 1, 0, 0], [ 0, 0, 1, -2, 1, 0], [ 0, 0, 0, 1, -2, 1], [ 0, 0, 0, 0, 1, -1]], dtype=int8) >>> np.array_equal(lap.matmat(np.eye(n)), lap.toarray()) True >>> np.array_equal(lap.tosparse().toarray(), lap.toarray()) True
可以计算任意数量的极端特征值和/或特征向量。
>>> lap = LaplacianNd(grid_shape, boundary_conditions='periodic') >>> lap.eigenvalues() array([-4., -3., -3., -1., -1., 0.]) >>> lap.eigenvalues()[-2:] array([-1., 0.]) >>> lap.eigenvalues(2) array([-1., 0.]) >>> lap.eigenvectors(1) array([[0.40824829], [0.40824829], [0.40824829], [0.40824829], [0.40824829], [0.40824829]]) >>> lap.eigenvectors(2) array([[ 0.5 , 0.40824829], [ 0. , 0.40824829], [-0.5 , 0.40824829], [-0.5 , 0.40824829], [ 0. , 0.40824829], [ 0.5 , 0.40824829]]) >>> lap.eigenvectors() array([[ 0.40824829, 0.28867513, 0.28867513, 0.5 , 0.5 , 0.40824829], [-0.40824829, -0.57735027, -0.57735027, 0. , 0. , 0.40824829], [ 0.40824829, 0.28867513, 0.28867513, -0.5 , -0.5 , 0.40824829], [-0.40824829, 0.28867513, 0.28867513, -0.5 , -0.5 , 0.40824829], [ 0.40824829, -0.57735027, -0.57735027, 0. , 0. , 0.40824829], [-0.40824829, 0.28867513, 0.28867513, 0.5 , 0.5 , 0.40824829]])
二维拉普拉斯算子在规则网格上进行说明,每个维度都有
grid_shape = (2, 3)
点。>>> grid_shape = (2, 3) >>> n = np.prod(grid_shape)
网格点计数如下:
>>> np.arange(n).reshape(grid_shape + (-1,)) array([[[0], [1], [2]], [[3], [4], [5]]])
分别示出了边界条件
'dirichlet'
、'periodic'
和'neumann'
;与'dirichlet'
>>> lap = LaplacianNd(grid_shape, boundary_conditions='dirichlet') >>> lap.tosparse() <6x6 sparse array of type '<class 'numpy.int8'>' with 20 stored elements in Compressed Sparse Row format> >>> lap.toarray() array([[-4, 1, 0, 1, 0, 0], [ 1, -4, 1, 0, 1, 0], [ 0, 1, -4, 0, 0, 1], [ 1, 0, 0, -4, 1, 0], [ 0, 1, 0, 1, -4, 1], [ 0, 0, 1, 0, 1, -4]], dtype=int8) >>> np.array_equal(lap.matmat(np.eye(n)), lap.toarray()) True >>> np.array_equal(lap.tosparse().toarray(), lap.toarray()) True >>> lap.eigenvalues() array([-6.41421356, -5. , -4.41421356, -3.58578644, -3. , -1.58578644]) >>> eigvals = eigvalsh(lap.toarray().astype(np.float64)) >>> np.allclose(lap.eigenvalues(), eigvals) True >>> np.allclose(lap.toarray() @ lap.eigenvectors(), ... lap.eigenvectors() @ np.diag(lap.eigenvalues())) True
与
'periodic'
>>> lap = LaplacianNd(grid_shape, boundary_conditions='periodic') >>> lap.tosparse() <6x6 sparse array of type '<class 'numpy.int8'>' with 24 stored elements in Compressed Sparse Row format> >>> lap.toarray() array([[-4, 1, 1, 2, 0, 0], [ 1, -4, 1, 0, 2, 0], [ 1, 1, -4, 0, 0, 2], [ 2, 0, 0, -4, 1, 1], [ 0, 2, 0, 1, -4, 1], [ 0, 0, 2, 1, 1, -4]], dtype=int8) >>> np.array_equal(lap.matmat(np.eye(n)), lap.toarray()) True >>> np.array_equal(lap.tosparse().toarray(), lap.toarray()) True >>> lap.eigenvalues() array([-7., -7., -4., -3., -3., 0.]) >>> eigvals = eigvalsh(lap.toarray().astype(np.float64)) >>> np.allclose(lap.eigenvalues(), eigvals) True >>> np.allclose(lap.toarray() @ lap.eigenvectors(), ... lap.eigenvectors() @ np.diag(lap.eigenvalues())) True
并使用
'neumann'
>>> lap = LaplacianNd(grid_shape, boundary_conditions='neumann') >>> lap.tosparse() <6x6 sparse array of type '<class 'numpy.int8'>' with 20 stored elements in Compressed Sparse Row format> >>> lap.toarray() array([[-2, 1, 0, 1, 0, 0], [ 1, -3, 1, 0, 1, 0], [ 0, 1, -2, 0, 0, 1], [ 1, 0, 0, -2, 1, 0], [ 0, 1, 0, 1, -3, 1], [ 0, 0, 1, 0, 1, -2]]) >>> np.array_equal(lap.matmat(np.eye(n)), lap.toarray()) True >>> np.array_equal(lap.tosparse().toarray(), lap.toarray()) True >>> lap.eigenvalues() array([-5., -3., -3., -2., -1., 0.]) >>> eigvals = eigvalsh(lap.toarray().astype(np.float64)) >>> np.allclose(lap.eigenvalues(), eigvals) True >>> np.allclose(lap.toarray() @ lap.eigenvectors(), ... lap.eigenvectors() @ np.diag(lap.eigenvalues())) True
相关用法
- Python SciPy linalg.LinAlgError用法及代码示例
- Python SciPy linalg.LinearOperator用法及代码示例
- Python SciPy linalg.eigvalsh_tridiagonal用法及代码示例
- Python SciPy linalg.cdf2rdf用法及代码示例
- Python SciPy linalg.solve_circulant用法及代码示例
- Python SciPy linalg.polar用法及代码示例
- Python SciPy linalg.clarkson_woodruff_transform用法及代码示例
- 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用法及代码示例
- Python SciPy linalg.factorized用法及代码示例
- Python SciPy linalg.lu_factor用法及代码示例
- Python SciPy linalg.SuperLU用法及代码示例
- Python SciPy linalg.lsqr用法及代码示例
- Python SciPy linalg.cho_factor用法及代码示例
- Python SciPy linalg.fractional_matrix_power用法及代码示例
- Python SciPy linalg.eig_banded用法及代码示例
- Python SciPy linalg.tanhm用法及代码示例
- Python SciPy linalg.orthogonal_procrustes用法及代码示例
- Python SciPy linalg.use_solver用法及代码示例
- Python SciPy linalg.qr_multiply用法及代码示例
注:本文由纯净天空筛选整理自scipy.org大神的英文原创作品 scipy.sparse.linalg.LaplacianNd。非经特殊声明,原始代码版权归原作者所有,本译文未经允许或授权,请勿转载或复制。