scipy.interpolate.

CubicSpline#

class scipy.interpolate.CubicSpline(x, y, axis=0, bc_type='not-a-knot', extrapolate=None)[source]#

三次样条数据插值器。

用分段三次多项式插值数据,该多项式是二次连续可微的 [1]。结果表示为一个 PPoly 实例,其断点与给定数据匹配。

参数:
xarray_like, shape (n,)

包含自变量值的1维数组。值必须是实数、有限且严格递增。

yarray_like

包含因变量值的数组。它可以具有任意数量的维度,但沿 axis(见下文)的长度必须与 x 的长度匹配。值必须是有限的。

axisint, 可选

假定 y 沿其变化的轴。这意味着对于 x[i],对应的值为 np.take(y, i, axis=axis)。默认为 0。

bc_type字符串或 2 元组,可选

边界条件类型。需要由边界条件给出的两个附加方程来确定每段上所有多项式的系数 [2]

如果 bc_type 是一个字符串,则指定的条件将应用于样条的两端。可用的条件是

  • ‘not-a-knot’(默认):曲线末端的第一个和第二个段是相同的多项式。当边界条件没有信息时,这是一个很好的默认值。

  • ‘periodic’:插值函数被假定为周期性的,周期为 x[-1] - x[0]。第一个和最后一个 y 值必须相同:y[0] == y[-1]。此边界条件将导致 y'[0] == y'[-1]y''[0] == y''[-1]

  • ‘clamped’:曲线末端的第一个导数为零。假设一个 1D ybc_type=((1, 0.0), (1, 0.0)) 是相同的条件。

  • ‘natural’:曲线末端的第二个导数为零。假设一个 1D ybc_type=((2, 0.0), (2, 0.0)) 是相同的条件。

如果 bc_type 是一个 2 元组,则第一个和第二个值将分别应用于曲线起点和终点。元组值可以是前面提到的字符串之一(除了‘periodic’),或者是一个元组 (order, deriv_values),允许在曲线末端指定任意导数

  • order:导数阶数,1 或 2。

  • deriv_value:包含导数值的类似数组,形状必须与 y 相同,但不包括 axis 维度。例如,如果 y 是 1 维的,则 deriv_value 必须是一个标量。如果 y 是 3 维的,形状为 (n0, n1, n2) 且 axis=2,则 deriv_value 必须是 2 维的,形状为 (n0, n1)。

extrapolate{bool, ‘periodic’, None}, 可选

如果为布尔值,则确定是根据第一个和最后一个区间外推到超出范围的点,还是返回 NaN。如果为‘periodic’,则使用周期性外推。如果为 None(默认),则对于 bc_type='periodic'extrapolate 设置为‘periodic’,否则设置为 True。

另请参阅

Akima1DInterpolator

Akima 1D 插值器。

PchipInterpolator

PCHIP 1D 单调三次插值器。

PPoly

分段多项式,以系数和断点表示。

备注

参数 bc_typeextrapolate 独立工作,即前者仅控制样条的构造,后者仅控制评估。

当边界条件为 ‘not-a-knot’ 且 n = 2 时,它将被替换为第一个导数等于线性插值斜率的条件。当两个边界条件都为 ‘not-a-knot’ 且 n = 3 时,将寻求穿过给定点的抛物线作为解。

当对两端应用 ‘not-a-knot’ 边界条件时,生成的样条将与 splreps=0)和 InterpolatedUnivariateSpline 返回的相同,但这两个方法使用 B 样条基表示。

版本 0.18.0 中添加。

参考文献

[1]

三次样条插值 在维基教科书上。

[2]

Carl de Boor,“样条的实用指南”,Springer-Verlag,1978 年。

示例

在本例中,三次样条用于插值一个采样的正弦波。您可以看到样条的连续性属性对于一阶和二阶导数都成立,而对于三阶导数仅违反。

>>> import numpy as np
>>> from scipy.interpolate import CubicSpline
>>> import matplotlib.pyplot as plt
>>> x = np.arange(10)
>>> y = np.sin(x)
>>> cs = CubicSpline(x, y)
>>> xs = np.arange(-0.5, 9.6, 0.1)
>>> fig, ax = plt.subplots(figsize=(6.5, 4))
>>> ax.plot(x, y, 'o', label='data')
>>> ax.plot(xs, np.sin(xs), label='true')
>>> ax.plot(xs, cs(xs), label="S")
>>> ax.plot(xs, cs(xs, 1), label="S'")
>>> ax.plot(xs, cs(xs, 2), label="S''")
>>> ax.plot(xs, cs(xs, 3), label="S'''")
>>> ax.set_xlim(-0.5, 9.5)
>>> ax.legend(loc='lower left', ncol=2)
>>> plt.show()
../../_images/scipy-interpolate-CubicSpline-1_00_00.png

在第二个示例中,使用样条插值单位圆。使用了周期性边界条件。您可以看到,在周期性点 (1, 0) 处,一阶导数值 ds/dx=0,ds/dy=1 被正确计算。请注意,圆无法用三次样条精确表示。要提高精度,需要更多断点。

>>> theta = 2 * np.pi * np.linspace(0, 1, 5)
>>> y = np.c_[np.cos(theta), np.sin(theta)]
>>> cs = CubicSpline(theta, y, bc_type='periodic')
>>> print("ds/dx={:.1f} ds/dy={:.1f}".format(cs(0, 1)[0], cs(0, 1)[1]))
ds/dx=0.0 ds/dy=1.0
>>> xs = 2 * np.pi * np.linspace(0, 1, 100)
>>> fig, ax = plt.subplots(figsize=(6.5, 4))
>>> ax.plot(y[:, 0], y[:, 1], 'o', label='data')
>>> ax.plot(np.cos(xs), np.sin(xs), label='true')
>>> ax.plot(cs(xs)[:, 0], cs(xs)[:, 1], label='spline')
>>> ax.axes.set_aspect('equal')
>>> ax.legend(loc='center')
>>> plt.show()
../../_images/scipy-interpolate-CubicSpline-1_01_00.png

第三个示例是多项式 y = x**3 在区间 0 <= x<= 1 上的插值。三次样条可以精确地表示此函数。为了实现这一点,我们需要在区间的端点指定值和一阶导数。请注意,y’ = 3 * x**2,因此 y’(0) = 0 且 y’(1) = 3。

>>> cs = CubicSpline([0, 1], [0, 1], bc_type=((1, 0), (1, 3)))
>>> x = np.linspace(0, 1)
>>> np.allclose(x**3, cs(x))
True
属性:
xndarray, shape (n,)

断点。与传递给构造函数的 x 相同。

cndarray, shape (4, n-1, …)

每段上多项式的系数。尾部维度与 y 的维度匹配,不包括 axis。例如,如果 y 是 1 维的,则 c[k, i] 是在 x[i]x[i+1] 之间的段上 (x-x[i])**(3-k) 的系数。

axisint

插值轴。与传递给构造函数的 axis 相同。

方法

__call__(x[, nu, extrapolate])

评估分段多项式或其导数。

derivative([nu])

构造一个新的表示导数的分段多项式。

antiderivative([nu])

构造一个新的表示反导数的分段多项式。

integrate(a, b[, extrapolate])

计算分段多项式上的定积分。

roots([discontinuity, extrapolate])

找到分段多项式的实根。