本文簡要介紹 python 語言中 scipy.interpolate.SmoothSphereBivariateSpline.ev
的用法。
用法:
SmoothSphereBivariateSpline.ev(theta, phi, dtheta=0, dphi=0)#
評估點處的樣條線
返回
(theta[i], phi[i]), i=0,...,len(theta)-1
處的插值。- theta, phi: array_like
輸入坐標。遵循標準 Numpy 廣播。軸的排序與 np.meshgrid(..., indexing=”ij”) 一致,與默認排序 np.meshgrid(..., indexing=”xy”) 不一致。
- dtheta: 整數,可選
theta-derivative的訂單
- dphi: 整數,可選
phi-derivative的訂單
參數 ::
例子:
假設我們要使用樣條線在球體上插值二元函數。該函數的值在經度和緯度網格上已知。
>>> import numpy as np >>> from scipy.interpolate import RectSphereBivariateSpline >>> def f(theta, phi): ... return np.sin(theta) * np.cos(phi)
我們評估網格上的函數。請注意,網格網格的默認索引 =”xy” 會導致插值後出現意外(轉置)結果。
>>> thetaarr = np.linspace(0, np.pi, 22)[1:-1] >>> phiarr = np.linspace(0, 2 * np.pi, 21)[:-1] >>> thetagrid, phigrid = np.meshgrid(thetaarr, phiarr, indexing="ij") >>> zdata = f(thetagrid, phigrid)
接下來,我們設置插值器並使用它來評估原始網格之外的點處的函數。
>>> rsbs = RectSphereBivariateSpline(thetaarr, phiarr, zdata) >>> thetainterp = np.linspace(thetaarr[0], thetaarr[-1], 200) >>> phiinterp = np.linspace(phiarr[0], phiarr[-1], 200) >>> zinterp = rsbs.ev(thetainterp, phiinterp)
最後,我們通過初始網格繪製對角線切片的原始數據,並沿同一切片繪製樣條近似值。
>>> import matplotlib.pyplot as plt >>> fig = plt.figure() >>> ax1 = fig.add_subplot(1, 1, 1) >>> ax1.plot(np.sin(thetaarr) * np.sin(phiarr), np.diag(zdata), "or") >>> ax1.plot(np.sin(thetainterp) * np.sin(phiinterp), zinterp, "-b") >>> plt.show()
相關用法
- Python SciPy SmoothSphereBivariateSpline.__call__用法及代碼示例
- Python SciPy SmoothBivariateSpline.__call__用法及代碼示例
- Python SciPy SmoothBivariateSpline.ev用法及代碼示例
- Python SciPy ShortTimeFFT.from_dual用法及代碼示例
- Python SciPy ShortTimeFFT.from_window用法及代碼示例
- Python SciPy SuperLU.perm_c用法及代碼示例
- Python SciPy SuperLU.solve用法及代碼示例
- Python SciPy ShortTimeFFT.istft用法及代碼示例
- Python SciPy SuperLU.perm_r用法及代碼示例
- Python SciPy ShortTimeFFT.spectrogram用法及代碼示例
- Python SciPy interpolate.make_interp_spline用法及代碼示例
- Python SciPy stats.anderson用法及代碼示例
- Python SciPy ClusterNode.pre_order用法及代碼示例
- Python SciPy stats.iqr用法及代碼示例
- Python SciPy FortranFile.read_record用法及代碼示例
- Python SciPy ndimage.correlate用法及代碼示例
- Python SciPy special.exp1用法及代碼示例
- Python SciPy special.expn用法及代碼示例
- Python SciPy signal.czt_points用法及代碼示例
- Python SciPy interpolate.krogh_interpolate用法及代碼示例
- Python SciPy ndimage.morphological_gradient用法及代碼示例
- Python SciPy distance.sokalmichener用法及代碼示例
- Python SciPy linalg.eigvalsh_tridiagonal用法及代碼示例
- Python SciPy linalg.cdf2rdf用法及代碼示例
- Python SciPy csc_array.diagonal用法及代碼示例
注:本文由純淨天空篩選整理自scipy.org大神的英文原創作品 scipy.interpolate.SmoothSphereBivariateSpline.ev。非經特殊聲明,原始代碼版權歸原作者所有,本譯文未經允許或授權,請勿轉載或複製。