Interpolation (scipy.interpolate)#
Sub-package for objects used in interpolation.
As listed below, this sub-package contains spline functions and classes, 1-D and multidimensional (univariate and multivariate) interpolation classes, Lagrange and Taylor polynomial interpolators, and wrappers for FITPACK and DFITPACK functions.
Univariate interpolation#
  | 
Interpolate a 1-D function.  | 
  | 
Interpolating polynomial for a set of points.  | 
  | 
Interpolating polynomial for a set of points.  | 
  | 
Convenience function for polynomial interpolation.  | 
  | 
Convenience function for polynomial interpolation.  | 
  | 
Convenience function for pchip interpolation.  | 
  | 
Piecewise-cubic interpolator matching values and first derivatives.  | 
  | 
PCHIP 1-D monotonic cubic interpolation.  | 
  | 
Akima interpolator  | 
  | 
Cubic spline data interpolator.  | 
  | 
Piecewise polynomial in terms of coefficients and breakpoints  | 
  | 
Piecewise polynomial in terms of coefficients and breakpoints.  | 
Multivariate interpolation#
Unstructured data:
  | 
Interpolate unstructured D-D data.  | 
  | 
Piecewise linear interpolator in N > 1 dimensions.  | 
  | 
NearestNDInterpolator(x, y).  | 
  | 
CloughTocher2DInterpolator(points, values, tol=1e-6).  | 
  | 
Radial basis function (RBF) interpolation in N dimensions.  | 
  | 
A class for radial basis function interpolation of functions from N-D scattered data to an M-D domain.  | 
  | 
Deprecated since version 1.10.0.  | 
For data on a grid:
  | 
Multidimensional interpolation on regular or rectilinear grids.  | 
  | 
Interpolator on a regular or rectilinear grid in arbitrary dimensions.  | 
  | 
Bivariate spline approximation over a rectangular mesh.  | 
See also
Tensor product polynomials:
  | 
Piecewise tensor product polynomial  | 
  | 
Tensor product spline object.  | 
1-D Splines#
  | 
Univariate spline in the B-spline basis.  | 
  | 
Compute the (coefficients of) interpolating B-spline.  | 
  | 
Compute the (coefficients of) an LSQ (Least SQuared) based fitting B-spline.  | 
  | 
Compute the (coefficients of) smoothing cubic spline function using   | 
Functional interface to FITPACK routines:
  | 
Find the B-spline representation of a 1-D curve.  | 
  | 
Find the B-spline representation of an N-D curve.  | 
  | 
Evaluate a B-spline or its derivatives.  | 
  | 
Evaluate the definite integral of a B-spline between two given points.  | 
  | 
Find the roots of a cubic B-spline.  | 
  | 
Evaluate all derivatives of a B-spline.  | 
  | 
Compute the spline representation of the derivative of a given spline  | 
  | 
Compute the spline for the antiderivative (integral) of a given spline.  | 
  | 
Insert knots into a B-spline.  | 
Object-oriented FITPACK interface:
  | 
1-D smoothing spline fit to a given set of data points.  | 
  | 
1-D interpolating spline for a given set of data points.  | 
  | 
1-D spline with explicit internal knots.  | 
2-D Splines#
For data on a grid:
  | 
Bivariate spline approximation over a rectangular mesh.  | 
  | 
Bivariate spline approximation over a rectangular mesh on a sphere.  | 
For unstructured data:
Base class for bivariate splines.  | 
|
  | 
Smooth bivariate spline approximation.  | 
  | 
Smooth bivariate spline approximation in spherical coordinates.  | 
  | 
Weighted least-squares bivariate spline approximation.  | 
  | 
Weighted least-squares bivariate spline approximation in spherical coordinates.  | 
Low-level interface to FITPACK functions:
  | 
Find a bivariate B-spline representation of a surface.  | 
  | 
Evaluate a bivariate B-spline and its derivatives.  | 
Additional tools#
  | 
Return a Lagrange interpolating polynomial.  | 
  | 
Estimate the Taylor polynomial of f at x by polynomial fitting.  | 
  | 
Return Pade approximation to a polynomial as the ratio of two polynomials.  | 
See also
scipy.ndimage.map_coordinates,
scipy.ndimage.spline_filter,
scipy.signal.resample,
scipy.signal.bspline,
scipy.signal.gauss_spline,
scipy.signal.qspline1d,
scipy.signal.cspline1d,
scipy.signal.qspline1d_eval,
scipy.signal.cspline1d_eval,
scipy.signal.qspline2d,
scipy.signal.cspline2d.
pchip is an alias of PchipInterpolator for backward compatibility
(should not be used in new code).