本文简要介绍 python 语言中 scipy.interpolate.BSpline.integrate
的用法。
用法:
BSpline.integrate(a, b, extrapolate=None)#
计算样条的定积分。
- a: 浮点数
积分的下限。
- b: 浮点数
积分上限。
- extrapolate: bool 或 ‘periodic’,可选
是否外推超出基本区间,
t[k] .. t[-k-1]
,或将样条曲线设为基本区间之外的零。如果‘periodic’,使用周期性外推。如果无(默认),使用self.extrapolate.
- I: array_like
样条在区间
[a, b]
上的定积分。
参数 ::
返回 ::
例子:
在基本区间
x if x < 1 else 2 - x
并将其积分 上构造线性样条>>> from scipy.interpolate import BSpline >>> b = BSpline.basis_element([0, 1, 2]) >>> b.integrate(0, 1) array(0.5)
如果积分限制在基本区间之外,则结果由外推参数控制
>>> b.integrate(-1, 1) array(0.0) >>> b.integrate(-1, 1, extrapolate=False) array(0.5)
>>> import matplotlib.pyplot as plt >>> fig, ax = plt.subplots() >>> ax.grid(True) >>> ax.axvline(0, c='r', lw=5, alpha=0.5) # base interval >>> ax.axvline(2, c='r', lw=5, alpha=0.5) >>> xx = [-1, 1, 2] >>> ax.plot(xx, b(xx)) >>> plt.show()
相关用法
- Python SciPy BSpline.basis_element用法及代码示例
- Python SciPy BSpline.design_matrix用法及代码示例
- Python SciPy BivariateSpline.ev用法及代码示例
- Python SciPy BPoly.from_derivatives用法及代码示例
- Python SciPy Bounds.residual用法及代码示例
- Python SciPy BivariateSpline.__call__用法及代码示例
- Python SciPy BinomTestResult.proportion_ci用法及代码示例
- Python SciPy BarycentricInterpolator.derivatives用法及代码示例
- 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用法及代码示例
- Python SciPy fft.idctn用法及代码示例
- Python SciPy linalg.LaplacianNd用法及代码示例
注:本文由纯净天空筛选整理自scipy.org大神的英文原创作品 scipy.interpolate.BSpline.integrate。非经特殊声明,原始代码版权归原作者所有,本译文未经允许或授权,请勿转载或复制。