本文简要介绍 python 语言中 scipy.spatial.tsearch
的用法。
用法:
scipy.spatial.tsearch(tri, xi)#
找到包含给定点的单纯形。此函数与
Delaunay.find_simplex
的作用相同。- tri: DelaunayInfo
德劳内三角剖分
- xi: 双精度 ndarray,形状 (..., ndim)
定位点
- i: int 的 ndarray,形状与xi
包含每个点的单纯形的索引。三角剖分之外的点的值为 -1。
参数 ::
返回 ::
注意:
例子:
>>> import numpy as np >>> import matplotlib.pyplot as plt >>> from scipy.spatial import Delaunay, delaunay_plot_2d, tsearch >>> rng = np.random.default_rng()
一组随机点的 Delaunay 三角剖分:
>>> pts = rng.random((20, 2)) >>> tri = Delaunay(pts) >>> _ = delaunay_plot_2d(tri)
求包含给定点集的单纯形:
>>> loc = rng.uniform(0.2, 0.8, (5, 2)) >>> s = tsearch(tri, loc) >>> plt.triplot(pts[:, 0], pts[:, 1], tri.simplices[s], 'b-', mask=s==-1) >>> plt.scatter(loc[:, 0], loc[:, 1], c='r', marker='x') >>> plt.show()
相关用法
- Python SciPy spatial.Voronoi用法及代码示例
- Python SciPy spatial.procrustes用法及代码示例
- Python SciPy spatial.SphericalVoronoi用法及代码示例
- Python SciPy spatial.minkowski_distance用法及代码示例
- Python SciPy spatial.HalfspaceIntersection用法及代码示例
- Python SciPy spatial.voronoi_plot_2d用法及代码示例
- Python SciPy spatial.minkowski_distance_p用法及代码示例
- Python SciPy spatial.geometric_slerp用法及代码示例
- Python SciPy spatial.distance_matrix用法及代码示例
- Python SciPy spatial.ConvexHull用法及代码示例
- Python SciPy spatial.convex_hull_plot_2d用法及代码示例
- Python SciPy spatial.Delaunay用法及代码示例
- Python SciPy spatial.delaunay_plot_2d用法及代码示例
- Python SciPy sparse.isspmatrix用法及代码示例
- Python SciPy sparse.save_npz用法及代码示例
- Python SciPy sparse.issparse用法及代码示例
- Python SciPy sparse.coo_matrix用法及代码示例
- Python SciPy sparse.isspmatrix_csc用法及代码示例
- Python SciPy sparse.isspmatrix_csr用法及代码示例
- Python SciPy sparse.tril用法及代码示例
- Python SciPy sparse.coo_array用法及代码示例
- Python SciPy sparse.dia_array用法及代码示例
- Python SciPy sparse.bmat用法及代码示例
- Python SciPy sparse.hstack用法及代码示例
- Python SciPy sparse.rand用法及代码示例
注:本文由纯净天空筛选整理自scipy.org大神的英文原创作品 scipy.spatial.tsearch。非经特殊声明,原始代码版权归原作者所有,本译文未经允许或授权,请勿转载或复制。