空间数据结构和算法 (scipy.spatial
)#
scipy.spatial
可以通过利用 Qhull 库来计算一组点的三角剖分、Voronoi 图和凸包。
此外,它还包含用于最近邻点查询的 KDTree
实现,以及用于各种度量中距离计算的实用程序。
Delaunay 三角剖分#
Delaunay 三角剖分是将一组点细分为一组不重叠的三角形,使得没有点位于任何三角形的外接圆内。实际上,这种三角剖分倾向于避免小角度的三角形。
Delaunay 三角剖分可以使用 scipy.spatial
按如下方式计算
>>> from scipy.spatial import Delaunay
>>> import numpy as np
>>> points = np.array([[0, 0], [0, 1.1], [1, 0], [1, 1]])
>>> tri = Delaunay(points)
我们可以将其可视化
>>> import matplotlib.pyplot as plt
>>> plt.triplot(points[:,0], points[:,1], tri.simplices)
>>> plt.plot(points[:,0], points[:,1], 'o')
并添加一些进一步的装饰
>>> for j, p in enumerate(points):
... plt.text(p[0]-0.03, p[1]+0.03, j, ha='right') # label the points
>>> for j, s in enumerate(tri.simplices):
... p = points[s].mean(axis=0)
... plt.text(p[0], p[1], '#%d' % j, ha='center') # label triangles
>>> plt.xlim(-0.5, 1.5); plt.ylim(-0.5, 1.5)
>>> plt.show()
三角剖分的结构以以下方式编码:simplices
属性包含 points
数组中构成三角形的点的索引。 例如
>>> i = 1
>>> tri.simplices[i,:]
array([3, 1, 0], dtype=int32)
>>> points[tri.simplices[i,:]]
array([[ 1. , 1. ],
[ 0. , 1.1],
[ 0. , 0. ]])
此外,还可以找到相邻的三角形
>>> tri.neighbors[i]
array([-1, 0, -1], dtype=int32)
这告诉我们,这个三角形有三角形 #0 作为邻居,但没有其他邻居。此外,它告诉我们,邻居 0 与三角形的顶点 1 相反
>>> points[tri.simplices[i, 1]]
array([ 0. , 1.1])
事实上,从图中我们可以看到情况确实如此。
对于更高维度的点集,Qhull 还可以执行对单纯形的细分(例如,在 3D 中细分为四面体)。
共面点#
需要注意的是,由于形成三角剖分中的数值精度问题,并非所有点都必然作为三角剖分的顶点出现。考虑上述具有重复点的情况
>>> points = np.array([[0, 0], [0, 1], [1, 0], [1, 1], [1, 1]])
>>> tri = Delaunay(points)
>>> np.unique(tri.simplices.ravel())
array([0, 1, 2, 3], dtype=int32)
请注意,重复的点 #4 并未作为三角剖分的顶点出现。这发生的情况被记录下来
>>> tri.coplanar
array([[4, 0, 3]], dtype=int32)
这意味着点 4 位于三角形 0 和顶点 3 附近,但未包含在三角剖分中。
请注意,这种退化不仅可能由于重复的点而发生,而且也可能由于更复杂的几何原因而发生,即使在乍看起来表现良好的点集中也是如此。
但是,Qhull 有一个 “QJ” 选项,该选项指示它随机扰动输入数据,直到退化得到解决
>>> tri = Delaunay(points, qhull_options="QJ Pp")
>>> points[tri.simplices]
array([[[1, 0],
[1, 1],
[0, 0]],
[[1, 1],
[1, 1],
[1, 0]],
[[1, 1],
[0, 1],
[0, 0]],
[[0, 1],
[1, 1],
[1, 1]]])
出现了两个新的三角形。但是,我们看到它们是退化的并且面积为零。
凸包#
凸包是包含给定点集中所有点的最小凸对象。
这些可以通过 scipy.spatial
中的 Qhull 包装器进行计算,如下所示
>>> from scipy.spatial import ConvexHull
>>> rng = np.random.default_rng()
>>> points = rng.random((30, 2)) # 30 random points in 2-D
>>> hull = ConvexHull(points)
凸包表示为一组 N 个 1D 单纯形,在 2D 中表示线段。 存储方案与上面讨论的 Delaunay 三角剖分中的单纯形完全相同。
我们可以说明以上结果
>>> import matplotlib.pyplot as plt
>>> plt.plot(points[:,0], points[:,1], 'o')
>>> for simplex in hull.simplices:
... plt.plot(points[simplex,0], points[simplex,1], 'k-')
>>> plt.show()
使用 scipy.spatial.convex_hull_plot_2d
也可以实现同样的效果。
Voronoi 图#
Voronoi 图是将空间细分为给定点集最近的邻域。
有两种方法可以使用 scipy.spatial
来处理此对象。首先,可以使用 KDTree
来回答“哪个点最接近这个点”的问题,并以这种方式定义区域
>>> from scipy.spatial import KDTree
>>> points = np.array([[0, 0], [0, 1], [0, 2], [1, 0], [1, 1], [1, 2],
... [2, 0], [2, 1], [2, 2]])
>>> tree = KDTree(points)
>>> tree.query([0.1, 0.1])
(0.14142135623730953, 0)
因此,点 (0.1, 0.1)
属于区域 0
。 以颜色表示
>>> x = np.linspace(-0.5, 2.5, 31)
>>> y = np.linspace(-0.5, 2.5, 33)
>>> xx, yy = np.meshgrid(x, y)
>>> xy = np.c_[xx.ravel(), yy.ravel()]
>>> import matplotlib.pyplot as plt
>>> dx_half, dy_half = np.diff(x[:2])[0] / 2., np.diff(y[:2])[0] / 2.
>>> x_edges = np.concatenate((x - dx_half, [x[-1] + dx_half]))
>>> y_edges = np.concatenate((y - dy_half, [y[-1] + dy_half]))
>>> plt.pcolormesh(x_edges, y_edges, tree.query(xy)[1].reshape(33, 31), shading='flat')
>>> plt.plot(points[:,0], points[:,1], 'ko')
>>> plt.show()
但是,这并没有给出作为几何对象的 Voronoi 图。
再次可以通过 scipy.spatial
中的 Qhull 包装器获得线和点的表示
>>> from scipy.spatial import Voronoi
>>> vor = Voronoi(points)
>>> vor.vertices
array([[0.5, 0.5],
[0.5, 1.5],
[1.5, 0.5],
[1.5, 1.5]])
Voronoi 顶点表示构成 Voronoi 区域多边形边缘的点集。 在这种情况下,有 9 个不同的区域
>>> vor.regions
[[], [-1, 0], [-1, 1], [1, -1, 0], [3, -1, 2], [-1, 3], [-1, 2], [0, 1, 3, 2], [2, -1, 0], [3, -1, 1]]
负值 -1
再次表示无穷远处的点。 事实上,只有其中一个区域 [0, 1, 3, 2]
是有界的。 请注意,由于与上面 Delaunay 三角剖分中类似的数值精度问题,Voronoi 区域可能少于输入点。
分隔区域的脊线(2D 中的线)被描述为与凸包部分类似的单纯形集合
>>> vor.ridge_vertices
[[-1, 0], [-1, 0], [-1, 1], [-1, 1], [0, 1], [-1, 3], [-1, 2], [2, 3], [-1, 3], [-1, 2], [1, 3], [0, 2]]
这些数字表示构成线段的 Voronoi 顶点的索引。-1
再次表示无穷远处的点 — 12 条线中只有 4 条是有界的线段,而其他线段延伸到无穷远。
Voronoi 脊线垂直于输入点之间绘制的线。 还记录了每条脊线对应于哪两个点
>>> vor.ridge_points
array([[0, 3],
[0, 1],
[2, 5],
[2, 1],
[1, 4],
[7, 8],
[7, 6],
[7, 4],
[8, 5],
[6, 3],
[4, 5],
[4, 3]], dtype=int32)
这些信息加在一起,足以构建完整的图表。
我们可以按如下方式绘制它。首先,绘制点和 Voronoi 顶点
>>> plt.plot(points[:, 0], points[:, 1], 'o')
>>> plt.plot(vor.vertices[:, 0], vor.vertices[:, 1], '*')
>>> plt.xlim(-1, 3); plt.ylim(-1, 3)
绘制有限线段的操作与凸包类似,但现在我们必须注意无限边缘
>>> for simplex in vor.ridge_vertices:
... simplex = np.asarray(simplex)
... if np.all(simplex >= 0):
... plt.plot(vor.vertices[simplex, 0], vor.vertices[simplex, 1], 'k-')
延伸到无穷远的脊线需要更多一些注意
>>> center = points.mean(axis=0)
>>> for pointidx, simplex in zip(vor.ridge_points, vor.ridge_vertices):
... simplex = np.asarray(simplex)
... if np.any(simplex < 0):
... i = simplex[simplex >= 0][0] # finite end Voronoi vertex
... t = points[pointidx[1]] - points[pointidx[0]] # tangent
... t = t / np.linalg.norm(t)
... n = np.array([-t[1], t[0]]) # normal
... midpoint = points[pointidx].mean(axis=0)
... far_point = vor.vertices[i] + np.sign(np.dot(midpoint - center, n)) * n * 100
... plt.plot([vor.vertices[i,0], far_point[0]],
... [vor.vertices[i,1], far_point[1]], 'k--')
>>> plt.show()
也可以使用 scipy.spatial.voronoi_plot_2d
创建此图。
Voronoi 图可以用来创作有趣的生成艺术。 尝试使用此 mandala
函数的设置来创建你自己的作品!
>>> import numpy as np
>>> from scipy import spatial
>>> import matplotlib.pyplot as plt
>>> def mandala(n_iter, n_points, radius):
... """Creates a mandala figure using Voronoi tessellations.
...
... Parameters
... ----------
... n_iter : int
... Number of iterations, i.e. how many times the equidistant points will
... be generated.
... n_points : int
... Number of points to draw per iteration.
... radius : scalar
... The radial expansion factor.
...
... Returns
... -------
... fig : matplotlib.Figure instance
...
... Notes
... -----
... This code is adapted from the work of Audrey Roy Greenfeld [1]_ and Carlos
... Focil-Espinosa [2]_, who created beautiful mandalas with Python code. That
... code in turn was based on Antonio Sánchez Chinchón's R code [3]_.
...
... References
... ----------
... .. [1] https://www.codemakesmehappy.com/2019/09/voronoi-mandalas.html
...
... .. [2] https://github.com/CarlosFocil/mandalapy
...
... .. [3] https://github.com/aschinchon/mandalas
...
... """
... fig = plt.figure(figsize=(10, 10))
... ax = fig.add_subplot(111)
... ax.set_axis_off()
... ax.set_aspect('equal', adjustable='box')
...
... angles = np.linspace(0, 2*np.pi * (1 - 1/n_points), num=n_points) + np.pi/2
... # Starting from a single center point, add points iteratively
... xy = np.array([[0, 0]])
... for k in range(n_iter):
... t1 = np.array([])
... t2 = np.array([])
... # Add `n_points` new points around each existing point in this iteration
... for i in range(xy.shape[0]):
... t1 = np.append(t1, xy[i, 0] + radius**k * np.cos(angles))
... t2 = np.append(t2, xy[i, 1] + radius**k * np.sin(angles))
...
... xy = np.column_stack((t1, t2))
...
... # Create the Mandala figure via a Voronoi plot
... spatial.voronoi_plot_2d(spatial.Voronoi(xy), ax=ax)
...
... return fig
>>> # Modify the following parameters in order to get different figures
>>> n_iter = 3
>>> n_points = 6
>>> radius = 4
>>> fig = mandala(n_iter, n_points, radius)
>>> plt.show()