我有一个由一组Poly3DCollection定义的3D图。集合的每个多边形都包含一个3D单纯形列表(单形= 4点),如下所示。
[[[21096.4, 15902.1, 74.3],
[21098.5, 15904.3, 54.7],
[21114.2, 15910.1, 63.0],
[21096.4, 15902.1, 74.3]],
...
[[21096.4, 15902.1, 74.3],
[21114.8, 15909.9, 91.3],
[21114.2, 15910.1, 63.0],
[21096.4, 15902.1, 74.3]]]
我想确定在2D投影时将其绘制在屏幕上以突出显示该3D网格的轮廓。 理想情况下,它会给我类似的东西
有什么方法可以实现这一目标?
要实现它,我正在考虑类似
但是我找不到从matplotlib Axes3D对象公开的界面中实现轮廓检测的任何方法。
只要我能绘制2D等高线,对我来说,直接在原始3D数据集和投影上确定还是从matplotlib Axes3D对象确定就无所谓了。
答案 0 :(得分:1)
事实证明,这比我最初预期的要复杂得多。我解决的方法是先将对象旋转到正面视图(以Axes3D
elev
和azim
角度),将其投影到yz平面上,计算2D轮廓,重新添加第三个尺寸,然后将现在的3D轮廓旋转回到当前视图。
旋转部分可以通过简单的矩阵运算来完成,只需要注意x,y和z轴可能会拉伸,并且在旋转之前不需要拉伸。
投影部分有些棘手,因为我不知道找到如此大量点的外部点的任何聪明方法。因此,我通过分别计算每个单纯形的投影,计算它们的2D凸包(使用scipy
,将它们转换为shapely
多边形,最后计算所有这些多边形的并集来解决它。然后,我又添加了丢失的x坐标,并将整个对象旋转回到当前视图中。
默认情况下,Axes3D
个对象使用透视图,导致该对象的实际轮廓与计算的投影不完全对齐。可以通过使用正交视图(用ax.set_proj_type('ortho')
设置)来避免这种情况。
最后,旋转图像后,轮廓/投影需要更新。因此,我将整个功能添加到this example之后的事件队列中。
请询问是否还有其他问题。
from mpl_toolkits.mplot3d import Axes3D
from mpl_toolkits.mplot3d.art3d import Poly3DCollection, Line3DCollection
from matplotlib import pyplot as plt
import numpy as np
from shapely.geometry import Polygon
from scipy.spatial import ConvexHull
from scipy.spatial import Delaunay
##the figure
fig, ax = plt.subplots(subplot_kw=dict(projection='3d'))
##generating some random points:
points = np.random.rand(50,3)
xmin,xmax = 0,100
ymin,ymax = -10,10
zmin,zmax = -20,20
points[:,1] = (points[:,1]*(ymax-ymin)+ymin) * np.sin(points[:,0]*np.pi)
points[:,2] = (points[:,2]*(zmax-zmin)+zmin) * np.sin(points[:,0]*np.pi)
points[:,0] *= 100
##group them into simlices
tri = Delaunay(points)
simplex_coords = np.array([tri.points[simplex] for simplex in tri.simplices])
##plotting the points
ax.scatter(points[:,0], points[:,1], points[:,2])
##visualizing simplices
line_coords = np.array(
[[c[i],c[j]] for c in simplex_coords for i in range(len(c)) for j in range(i+1,len(c))]
)
simplex_lines = Line3DCollection(line_coords, colors='k', linewidths=1, zorder=10)
ax.add_collection3d(simplex_lines)
##adjusting plot
ax.set_xlim([xmin,xmax])
ax.set_xlabel('x')
ax.set_ylim([2*ymin,2*ymax])
ax.set_ylabel('y')
ax.set_zlim([2*zmin,2*zmax])
ax.set_zlabel('z')
def compute_2D_outline():
"""
Compute the outline of the 2D projection of the 3D mesh and display it as
a Poly3DCollection or a Line3DCollection.
"""
global collection
global lines
global elev
global azim
##remove the previous projection (if it has been already created)
try:
collection.remove()
lines.remove()
except NameError as e:
pass
##storing current axes orientation
elev = ax.elev
azim = ax.azim
##convert angles
theta = -ax.elev*np.pi/180
phi = -ax.azim*np.pi/180
#the extend of each of the axes:
diff = lambda t: t[1]-t[0]
lx = diff(ax.get_xlim())
ly = diff(ax.get_ylim())
lz = diff(ax.get_zlim())
##to compute the projection, we 'unstretch' the axes and rotate them
##into the (elev=0, azmi=0) orientation
stretch = np.diag([1/lx,1/ly,1/lz])
rot_theta = np.array([
[np.cos(theta), 0, -np.sin(theta)],
[0, 1, 0],
[np.sin(theta), 0, np.cos(theta)],
])
rot_phi = np.array([
[np.cos(phi), -np.sin(phi), 0],
[np.sin(phi), np.cos(phi), 0],
[0,0,1],
])
rot_tot = np.dot(rot_theta,np.dot(rot_phi,stretch))
##after computing the outline, we will have to reverse this operation:
bstretch = np.diag([lx,ly,lz])
brot_theta = np.array([
[ np.cos(theta), 0, np.sin(theta)],
[0, 1, 0],
[-np.sin(theta), 0, np.cos(theta)],
])
brot_phi = np.array([
[ np.cos(phi), np.sin(phi), 0],
[-np.sin(phi), np.cos(phi), 0],
[0,0,1],
])
brot_tot = np.dot(np.dot(bstretch,brot_phi),brot_theta)
##To get the exact outline, we will have to compute the projection of each simplex
##separately and compute the convex hull of the projection. We then use shapely to
##compute the unity of all these convex hulls to get the projection (or shadow).
poly = None
for simplex in simplex_coords:
simplex2D = np.dot(rot_tot,simplex.T)[1:].T
hull = simplex2D[ConvexHull(simplex2D).vertices]
if poly is None:
poly = Polygon(hull)
else:
poly = poly.union(Polygon(hull))
##the 2D points of the final projection have to be made 3D and transformed back
##into the correct axes rotation
outer_points2D = np.array(poly.exterior.coords.xy)
outer_points3D = np.concatenate([[np.zeros(outer_points2D.shape[1])],outer_points2D])
outer_points3D_orig = np.dot(brot_tot, outer_points3D)
##adding the polygons
collection = Poly3DCollection(
[outer_points3D_orig.T], alpha=0.25, facecolor='b', zorder=-1
)
ax.add_collection3d(collection)
##adding the lines
lines = Line3DCollection(
[outer_points3D_orig.T], alpha=0.5, colors='r', linewidths=5, zorder=5
)
ax.add_collection3d(lines)
def on_move(event):
"""
For tracking rotations of the Axes3D object
"""
if event.inaxes == ax and (elev != ax.elev or azim != ax.azim):
compute_2D_outline()
fig.canvas.draw_idle()
##initial outline:
compute_2D_outline()
##the entire thing will only work correctly with an orthogonal view
ax.set_proj_type('ortho')
##saving ax.azim and ax.elev for on_move function
azim = ax.azim
elev = ax.elev
##adding on_move to the event queue
c1 = fig.canvas.mpl_connect('motion_notify_event', on_move)
plt.show()
最终结果(带有一些生成的随机数据)如下所示: