doc_content
stringlengths 1
386k
| doc_id
stringlengths 5
188
|
---|---|
numpy.polynomial.laguerre.lagadd polynomial.laguerre.lagadd(c1, c2)[source]
Add one Laguerre series to another. Returns the sum of two Laguerre series c1 + c2. The arguments are sequences of coefficients ordered from lowest order term to highest, i.e., [1,2,3] represents the series P_0 + 2*P_1 + 3*P_2. Parameters
c1, c2array_like
1-D arrays of Laguerre series coefficients ordered from low to high. Returns
outndarray
Array representing the Laguerre series of their sum. See also
lagsub, lagmulx, lagmul, lagdiv, lagpow
Notes Unlike multiplication, division, etc., the sum of two Laguerre series is a Laguerre series (without having to “reproject” the result onto the basis set) so addition, just like that of “standard” polynomials, is simply “component-wise.” Examples >>> from numpy.polynomial.laguerre import lagadd
>>> lagadd([1, 2, 3], [1, 2, 3, 4])
array([2., 4., 6., 4.]) | numpy.reference.generated.numpy.polynomial.laguerre.lagadd |
numpy.polynomial.laguerre.lagcompanion polynomial.laguerre.lagcompanion(c)[source]
Return the companion matrix of c. The usual companion matrix of the Laguerre polynomials is already symmetric when c is a basis Laguerre polynomial, so no scaling is applied. Parameters
carray_like
1-D array of Laguerre series coefficients ordered from low to high degree. Returns
matndarray
Companion matrix of dimensions (deg, deg). Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.laguerre.lagcompanion |
numpy.polynomial.laguerre.lagder polynomial.laguerre.lagder(c, m=1, scl=1, axis=0)[source]
Differentiate a Laguerre series. Returns the Laguerre series coefficients c differentiated m times along axis. At each iteration the result is multiplied by scl (the scaling factor is for use in a linear change of variable). The argument c is an array of coefficients from low to high degree along each axis, e.g., [1,2,3] represents the series 1*L_0 + 2*L_1 + 3*L_2 while [[1,2],[1,2]] represents 1*L_0(x)*L_0(y) + 1*L_1(x)*L_0(y) +
2*L_0(x)*L_1(y) + 2*L_1(x)*L_1(y) if axis=0 is x and axis=1 is y. Parameters
carray_like
Array of Laguerre series coefficients. If c is multidimensional the different axis correspond to different variables with the degree in each axis given by the corresponding index.
mint, optional
Number of derivatives taken, must be non-negative. (Default: 1)
sclscalar, optional
Each differentiation is multiplied by scl. The end result is multiplication by scl**m. This is for use in a linear change of variable. (Default: 1)
axisint, optional
Axis over which the derivative is taken. (Default: 0). New in version 1.7.0. Returns
derndarray
Laguerre series of the derivative. See also lagint
Notes In general, the result of differentiating a Laguerre series does not resemble the same operation on a power series. Thus the result of this function may be “unintuitive,” albeit correct; see Examples section below. Examples >>> from numpy.polynomial.laguerre import lagder
>>> lagder([ 1., 1., 1., -3.])
array([1., 2., 3.])
>>> lagder([ 1., 0., 0., -4., 3.], m=2)
array([1., 2., 3.]) | numpy.reference.generated.numpy.polynomial.laguerre.lagder |
numpy.polynomial.laguerre.lagdiv polynomial.laguerre.lagdiv(c1, c2)[source]
Divide one Laguerre series by another. Returns the quotient-with-remainder of two Laguerre series c1 / c2. The arguments are sequences of coefficients from lowest order “term” to highest, e.g., [1,2,3] represents the series P_0 + 2*P_1 + 3*P_2. Parameters
c1, c2array_like
1-D arrays of Laguerre series coefficients ordered from low to high. Returns
[quo, rem]ndarrays
Of Laguerre series coefficients representing the quotient and remainder. See also
lagadd, lagsub, lagmulx, lagmul, lagpow
Notes In general, the (polynomial) division of one Laguerre series by another results in quotient and remainder terms that are not in the Laguerre polynomial basis set. Thus, to express these results as a Laguerre series, it is necessary to “reproject” the results onto the Laguerre basis set, which may produce “unintuitive” (but correct) results; see Examples section below. Examples >>> from numpy.polynomial.laguerre import lagdiv
>>> lagdiv([ 8., -13., 38., -51., 36.], [0, 1, 2])
(array([1., 2., 3.]), array([0.]))
>>> lagdiv([ 9., -12., 38., -51., 36.], [0, 1, 2])
(array([1., 2., 3.]), array([1., 1.])) | numpy.reference.generated.numpy.polynomial.laguerre.lagdiv |
numpy.polynomial.laguerre.lagdomain polynomial.laguerre.lagdomain = array([0, 1])
An array object represents a multidimensional, homogeneous array of fixed-size items. An associated data-type object describes the format of each element in the array (its byte-order, how many bytes it occupies in memory, whether it is an integer, a floating point number, or something else, etc.) Arrays should be constructed using array, zeros or empty (refer to the See Also section below). The parameters given here refer to a low-level method (ndarray(…)) for instantiating an array. For more information, refer to the numpy module and examine the methods and attributes of an array. Parameters
(for the __new__ method; see Notes below)
shapetuple of ints
Shape of created array.
dtypedata-type, optional
Any object that can be interpreted as a numpy data type.
bufferobject exposing buffer interface, optional
Used to fill the array with data.
offsetint, optional
Offset of array data in buffer.
stridestuple of ints, optional
Strides of data in memory.
order{‘C’, ‘F’}, optional
Row-major (C-style) or column-major (Fortran-style) order. See also array
Construct an array. zeros
Create an array, each element of which is zero. empty
Create an array, but leave its allocated memory unchanged (i.e., it contains “garbage”). dtype
Create a data-type. numpy.typing.NDArray
An ndarray alias generic w.r.t. its dtype.type. Notes There are two modes of creating an array using __new__: If buffer is None, then only shape, dtype, and order are used. If buffer is an object exposing the buffer interface, then all keywords are interpreted. No __init__ method is needed because the array is fully initialized after the __new__ method. Examples These examples illustrate the low-level ndarray constructor. Refer to the See Also section above for easier ways of constructing an ndarray. First mode, buffer is None: >>> np.ndarray(shape=(2,2), dtype=float, order='F')
array([[0.0e+000, 0.0e+000], # random
[ nan, 2.5e-323]])
Second mode: >>> np.ndarray((2,), buffer=np.array([1,2,3]),
... offset=np.int_().itemsize,
... dtype=int) # offset = 1*itemsize, i.e. skip first element
array([2, 3])
Attributes
Tndarray
Transpose of the array.
databuffer
The array’s elements, in memory.
dtypedtype object
Describes the format of the elements in the array.
flagsdict
Dictionary containing information related to memory use, e.g., ‘C_CONTIGUOUS’, ‘OWNDATA’, ‘WRITEABLE’, etc.
flatnumpy.flatiter object
Flattened version of the array as an iterator. The iterator allows assignments, e.g., x.flat = 3 (See ndarray.flat for assignment examples; TODO).
imagndarray
Imaginary part of the array.
realndarray
Real part of the array.
sizeint
Number of elements in the array.
itemsizeint
The memory use of each array element in bytes.
nbytesint
The total number of bytes required to store the array data, i.e., itemsize * size.
ndimint
The array’s number of dimensions.
shapetuple of ints
Shape of the array.
stridestuple of ints
The step-size required to move from one element to the next in memory. For example, a contiguous (3, 4) array of type int16 in C-order has strides (8, 2). This implies that to move from element to element in memory requires jumps of 2 bytes. To move from row-to-row, one needs to jump 8 bytes at a time (2 * 4).
ctypesctypes object
Class containing properties of the array needed for interaction with ctypes.
basendarray
If the array is a view into another array, that array is its base (unless that array is also a view). The base array is where the array data is actually stored. | numpy.reference.generated.numpy.polynomial.laguerre.lagdomain |
numpy.polynomial.laguerre.lagfit polynomial.laguerre.lagfit(x, y, deg, rcond=None, full=False, w=None)[source]
Least squares fit of Laguerre series to data. Return the coefficients of a Laguerre series of degree deg that is the least squares fit to the data values y given at points x. If y is 1-D the returned coefficients will also be 1-D. If y is 2-D multiple fits are done, one for each column of y, and the resulting coefficients are stored in the corresponding columns of a 2-D return. The fitted polynomial(s) are in the form \[p(x) = c_0 + c_1 * L_1(x) + ... + c_n * L_n(x),\] where n is deg. Parameters
xarray_like, shape (M,)
x-coordinates of the M sample points (x[i], y[i]).
yarray_like, shape (M,) or (M, K)
y-coordinates of the sample points. Several data sets of sample points sharing the same x-coordinates can be fitted at once by passing in a 2D-array that contains one dataset per column.
degint or 1-D array_like
Degree(s) of the fitting polynomials. If deg is a single integer all terms up to and including the deg’th term are included in the fit. For NumPy versions >= 1.11.0 a list of integers specifying the degrees of the terms to include may be used instead.
rcondfloat, optional
Relative condition number of the fit. Singular values smaller than this relative to the largest singular value will be ignored. The default value is len(x)*eps, where eps is the relative precision of the float type, about 2e-16 in most cases.
fullbool, optional
Switch determining nature of return value. When it is False (the default) just the coefficients are returned, when True diagnostic information from the singular value decomposition is also returned.
warray_like, shape (M,), optional
Weights. If not None, the weight w[i] applies to the unsquared residual y[i] - y_hat[i] at x[i]. Ideally the weights are chosen so that the errors of the products w[i]*y[i] all have the same variance. When using inverse-variance weighting, use w[i] = 1/sigma(y[i]). The default value is None. Returns
coefndarray, shape (M,) or (M, K)
Laguerre coefficients ordered from low to high. If y was 2-D, the coefficients for the data in column k of y are in column k.
[residuals, rank, singular_values, rcond]list
These values are only returned if full == True residuals – sum of squared residuals of the least squares fit rank – the numerical rank of the scaled Vandermonde matrix singular_values – singular values of the scaled Vandermonde matrix rcond – value of rcond. For more details, see numpy.linalg.lstsq. Warns
RankWarning
The rank of the coefficient matrix in the least-squares fit is deficient. The warning is only raised if full == False. The warnings can be turned off by >>> import warnings
>>> warnings.simplefilter('ignore', np.RankWarning)
See also numpy.polynomial.polynomial.polyfit
numpy.polynomial.legendre.legfit
numpy.polynomial.chebyshev.chebfit
numpy.polynomial.hermite.hermfit
numpy.polynomial.hermite_e.hermefit
lagval
Evaluates a Laguerre series. lagvander
pseudo Vandermonde matrix of Laguerre series. lagweight
Laguerre weight function. numpy.linalg.lstsq
Computes a least-squares fit from the matrix. scipy.interpolate.UnivariateSpline
Computes spline fits. Notes The solution is the coefficients of the Laguerre series p that minimizes the sum of the weighted squared errors \[E = \sum_j w_j^2 * |y_j - p(x_j)|^2,\] where the \(w_j\) are the weights. This problem is solved by setting up as the (typically) overdetermined matrix equation \[V(x) * c = w * y,\] where V is the weighted pseudo Vandermonde matrix of x, c are the coefficients to be solved for, w are the weights, and y are the observed values. This equation is then solved using the singular value decomposition of V. If some of the singular values of V are so small that they are neglected, then a RankWarning will be issued. This means that the coefficient values may be poorly determined. Using a lower order fit will usually get rid of the warning. The rcond parameter can also be set to a value smaller than its default, but the resulting fit may be spurious and have large contributions from roundoff error. Fits using Laguerre series are probably most useful when the data can be approximated by sqrt(w(x)) * p(x), where w(x) is the Laguerre weight. In that case the weight sqrt(w(x[i])) should be used together with data values y[i]/sqrt(w(x[i])). The weight function is available as lagweight. References 1
Wikipedia, “Curve fitting”, https://en.wikipedia.org/wiki/Curve_fitting Examples >>> from numpy.polynomial.laguerre import lagfit, lagval
>>> x = np.linspace(0, 10)
>>> err = np.random.randn(len(x))/10
>>> y = lagval(x, [1, 2, 3]) + err
>>> lagfit(x, y, 2)
array([ 0.96971004, 2.00193749, 3.00288744]) # may vary | numpy.reference.generated.numpy.polynomial.laguerre.lagfit |
numpy.polynomial.laguerre.lagfromroots polynomial.laguerre.lagfromroots(roots)[source]
Generate a Laguerre series with given roots. The function returns the coefficients of the polynomial \[p(x) = (x - r_0) * (x - r_1) * ... * (x - r_n),\] in Laguerre form, where the r_n are the roots specified in roots. If a zero has multiplicity n, then it must appear in roots n times. For instance, if 2 is a root of multiplicity three and 3 is a root of multiplicity 2, then roots looks something like [2, 2, 2, 3, 3]. The roots can appear in any order. If the returned coefficients are c, then \[p(x) = c_0 + c_1 * L_1(x) + ... + c_n * L_n(x)\] The coefficient of the last term is not generally 1 for monic polynomials in Laguerre form. Parameters
rootsarray_like
Sequence containing the roots. Returns
outndarray
1-D array of coefficients. If all roots are real then out is a real array, if some of the roots are complex, then out is complex even if all the coefficients in the result are real (see Examples below). See also numpy.polynomial.polynomial.polyfromroots
numpy.polynomial.legendre.legfromroots
numpy.polynomial.chebyshev.chebfromroots
numpy.polynomial.hermite.hermfromroots
numpy.polynomial.hermite_e.hermefromroots
Examples >>> from numpy.polynomial.laguerre import lagfromroots, lagval
>>> coef = lagfromroots((-1, 0, 1))
>>> lagval((-1, 0, 1), coef)
array([0., 0., 0.])
>>> coef = lagfromroots((-1j, 1j))
>>> lagval((-1j, 1j), coef)
array([0.+0.j, 0.+0.j]) | numpy.reference.generated.numpy.polynomial.laguerre.lagfromroots |
numpy.polynomial.laguerre.laggauss polynomial.laguerre.laggauss(deg)[source]
Gauss-Laguerre quadrature. Computes the sample points and weights for Gauss-Laguerre quadrature. These sample points and weights will correctly integrate polynomials of degree \(2*deg - 1\) or less over the interval \([0, \inf]\) with the weight function \(f(x) = \exp(-x)\). Parameters
degint
Number of sample points and weights. It must be >= 1. Returns
xndarray
1-D ndarray containing the sample points.
yndarray
1-D ndarray containing the weights. Notes New in version 1.7.0. The results have only been tested up to degree 100 higher degrees may be problematic. The weights are determined by using the fact that \[w_k = c / (L'_n(x_k) * L_{n-1}(x_k))\] where \(c\) is a constant independent of \(k\) and \(x_k\) is the k’th root of \(L_n\), and then scaling the results to get the right value when integrating 1. | numpy.reference.generated.numpy.polynomial.laguerre.laggauss |
numpy.polynomial.laguerre.laggrid2d polynomial.laguerre.laggrid2d(x, y, c)[source]
Evaluate a 2-D Laguerre series on the Cartesian product of x and y. This function returns the values: \[p(a,b) = \sum_{i,j} c_{i,j} * L_i(a) * L_j(b)\] where the points (a, b) consist of all pairs formed by taking a from x and b from y. The resulting points form a grid with x in the first dimension and y in the second. The parameters x and y are converted to arrays only if they are tuples or a lists, otherwise they are treated as a scalars. In either case, either x and y or their elements must support multiplication and addition both with themselves and with the elements of c. If c has fewer than two dimensions, ones are implicitly appended to its shape to make it 2-D. The shape of the result will be c.shape[2:] + x.shape + y.shape. Parameters
x, yarray_like, compatible objects
The two dimensional series is evaluated at the points in the Cartesian product of x and y. If x or y is a list or tuple, it is first converted to an ndarray, otherwise it is left unchanged and, if it isn’t an ndarray, it is treated as a scalar.
carray_like
Array of coefficients ordered so that the coefficient of the term of multi-degree i,j is contained in c[i,j]. If c has dimension greater than two the remaining indices enumerate multiple sets of coefficients. Returns
valuesndarray, compatible object
The values of the two dimensional Chebyshev series at points in the Cartesian product of x and y. See also
lagval, lagval2d, lagval3d, laggrid3d
Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.laguerre.laggrid2d |
numpy.polynomial.laguerre.laggrid3d polynomial.laguerre.laggrid3d(x, y, z, c)[source]
Evaluate a 3-D Laguerre series on the Cartesian product of x, y, and z. This function returns the values: \[p(a,b,c) = \sum_{i,j,k} c_{i,j,k} * L_i(a) * L_j(b) * L_k(c)\] where the points (a, b, c) consist of all triples formed by taking a from x, b from y, and c from z. The resulting points form a grid with x in the first dimension, y in the second, and z in the third. The parameters x, y, and z are converted to arrays only if they are tuples or a lists, otherwise they are treated as a scalars. In either case, either x, y, and z or their elements must support multiplication and addition both with themselves and with the elements of c. If c has fewer than three dimensions, ones are implicitly appended to its shape to make it 3-D. The shape of the result will be c.shape[3:] + x.shape + y.shape + z.shape. Parameters
x, y, zarray_like, compatible objects
The three dimensional series is evaluated at the points in the Cartesian product of x, y, and z. If x,`y`, or z is a list or tuple, it is first converted to an ndarray, otherwise it is left unchanged and, if it isn’t an ndarray, it is treated as a scalar.
carray_like
Array of coefficients ordered so that the coefficients for terms of degree i,j are contained in c[i,j]. If c has dimension greater than two the remaining indices enumerate multiple sets of coefficients. Returns
valuesndarray, compatible object
The values of the two dimensional polynomial at points in the Cartesian product of x and y. See also
lagval, lagval2d, laggrid2d, lagval3d
Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.laguerre.laggrid3d |
numpy.polynomial.laguerre.lagint polynomial.laguerre.lagint(c, m=1, k=[], lbnd=0, scl=1, axis=0)[source]
Integrate a Laguerre series. Returns the Laguerre series coefficients c integrated m times from lbnd along axis. At each iteration the resulting series is multiplied by scl and an integration constant, k, is added. The scaling factor is for use in a linear change of variable. (“Buyer beware”: note that, depending on what one is doing, one may want scl to be the reciprocal of what one might expect; for more information, see the Notes section below.) The argument c is an array of coefficients from low to high degree along each axis, e.g., [1,2,3] represents the series L_0 + 2*L_1 + 3*L_2 while [[1,2],[1,2]] represents 1*L_0(x)*L_0(y) + 1*L_1(x)*L_0(y) + 2*L_0(x)*L_1(y) +
2*L_1(x)*L_1(y) if axis=0 is x and axis=1 is y. Parameters
carray_like
Array of Laguerre series coefficients. If c is multidimensional the different axis correspond to different variables with the degree in each axis given by the corresponding index.
mint, optional
Order of integration, must be positive. (Default: 1)
k{[], list, scalar}, optional
Integration constant(s). The value of the first integral at lbnd is the first value in the list, the value of the second integral at lbnd is the second value, etc. If k == [] (the default), all constants are set to zero. If m == 1, a single scalar can be given instead of a list.
lbndscalar, optional
The lower bound of the integral. (Default: 0)
sclscalar, optional
Following each integration the result is multiplied by scl before the integration constant is added. (Default: 1)
axisint, optional
Axis over which the integral is taken. (Default: 0). New in version 1.7.0. Returns
Sndarray
Laguerre series coefficients of the integral. Raises
ValueError
If m < 0, len(k) > m, np.ndim(lbnd) != 0, or np.ndim(scl) != 0. See also lagder
Notes Note that the result of each integration is multiplied by scl. Why is this important to note? Say one is making a linear change of variable \(u = ax + b\) in an integral relative to x. Then \(dx = du/a\), so one will need to set scl equal to \(1/a\) - perhaps not what one would have first thought. Also note that, in general, the result of integrating a C-series needs to be “reprojected” onto the C-series basis set. Thus, typically, the result of this function is “unintuitive,” albeit correct; see Examples section below. Examples >>> from numpy.polynomial.laguerre import lagint
>>> lagint([1,2,3])
array([ 1., 1., 1., -3.])
>>> lagint([1,2,3], m=2)
array([ 1., 0., 0., -4., 3.])
>>> lagint([1,2,3], k=1)
array([ 2., 1., 1., -3.])
>>> lagint([1,2,3], lbnd=-1)
array([11.5, 1. , 1. , -3. ])
>>> lagint([1,2], m=2, k=[1,2], lbnd=-1)
array([ 11.16666667, -5. , -3. , 2. ]) # may vary | numpy.reference.generated.numpy.polynomial.laguerre.lagint |
numpy.polynomial.laguerre.lagline polynomial.laguerre.lagline(off, scl)[source]
Laguerre series whose graph is a straight line. Parameters
off, sclscalars
The specified line is given by off + scl*x. Returns
yndarray
This module’s representation of the Laguerre series for off + scl*x. See also numpy.polynomial.polynomial.polyline
numpy.polynomial.chebyshev.chebline
numpy.polynomial.legendre.legline
numpy.polynomial.hermite.hermline
numpy.polynomial.hermite_e.hermeline
Examples >>> from numpy.polynomial.laguerre import lagline, lagval
>>> lagval(0,lagline(3, 2))
3.0
>>> lagval(1,lagline(3, 2))
5.0 | numpy.reference.generated.numpy.polynomial.laguerre.lagline |
numpy.polynomial.laguerre.lagmul polynomial.laguerre.lagmul(c1, c2)[source]
Multiply one Laguerre series by another. Returns the product of two Laguerre series c1 * c2. The arguments are sequences of coefficients, from lowest order “term” to highest, e.g., [1,2,3] represents the series P_0 + 2*P_1 + 3*P_2. Parameters
c1, c2array_like
1-D arrays of Laguerre series coefficients ordered from low to high. Returns
outndarray
Of Laguerre series coefficients representing their product. See also
lagadd, lagsub, lagmulx, lagdiv, lagpow
Notes In general, the (polynomial) product of two C-series results in terms that are not in the Laguerre polynomial basis set. Thus, to express the product as a Laguerre series, it is necessary to “reproject” the product onto said basis set, which may produce “unintuitive” (but correct) results; see Examples section below. Examples >>> from numpy.polynomial.laguerre import lagmul
>>> lagmul([1, 2, 3], [0, 1, 2])
array([ 8., -13., 38., -51., 36.]) | numpy.reference.generated.numpy.polynomial.laguerre.lagmul |
numpy.polynomial.laguerre.lagmulx polynomial.laguerre.lagmulx(c)[source]
Multiply a Laguerre series by x. Multiply the Laguerre series c by x, where x is the independent variable. Parameters
carray_like
1-D array of Laguerre series coefficients ordered from low to high. Returns
outndarray
Array representing the result of the multiplication. See also
lagadd, lagsub, lagmul, lagdiv, lagpow
Notes The multiplication uses the recursion relationship for Laguerre polynomials in the form \[xP_i(x) = (-(i + 1)*P_{i + 1}(x) + (2i + 1)P_{i}(x) - iP_{i - 1}(x))\] Examples >>> from numpy.polynomial.laguerre import lagmulx
>>> lagmulx([1, 2, 3])
array([-1., -1., 11., -9.]) | numpy.reference.generated.numpy.polynomial.laguerre.lagmulx |
numpy.polynomial.laguerre.lagone polynomial.laguerre.lagone = array([1])
An array object represents a multidimensional, homogeneous array of fixed-size items. An associated data-type object describes the format of each element in the array (its byte-order, how many bytes it occupies in memory, whether it is an integer, a floating point number, or something else, etc.) Arrays should be constructed using array, zeros or empty (refer to the See Also section below). The parameters given here refer to a low-level method (ndarray(…)) for instantiating an array. For more information, refer to the numpy module and examine the methods and attributes of an array. Parameters
(for the __new__ method; see Notes below)
shapetuple of ints
Shape of created array.
dtypedata-type, optional
Any object that can be interpreted as a numpy data type.
bufferobject exposing buffer interface, optional
Used to fill the array with data.
offsetint, optional
Offset of array data in buffer.
stridestuple of ints, optional
Strides of data in memory.
order{‘C’, ‘F’}, optional
Row-major (C-style) or column-major (Fortran-style) order. See also array
Construct an array. zeros
Create an array, each element of which is zero. empty
Create an array, but leave its allocated memory unchanged (i.e., it contains “garbage”). dtype
Create a data-type. numpy.typing.NDArray
An ndarray alias generic w.r.t. its dtype.type. Notes There are two modes of creating an array using __new__: If buffer is None, then only shape, dtype, and order are used. If buffer is an object exposing the buffer interface, then all keywords are interpreted. No __init__ method is needed because the array is fully initialized after the __new__ method. Examples These examples illustrate the low-level ndarray constructor. Refer to the See Also section above for easier ways of constructing an ndarray. First mode, buffer is None: >>> np.ndarray(shape=(2,2), dtype=float, order='F')
array([[0.0e+000, 0.0e+000], # random
[ nan, 2.5e-323]])
Second mode: >>> np.ndarray((2,), buffer=np.array([1,2,3]),
... offset=np.int_().itemsize,
... dtype=int) # offset = 1*itemsize, i.e. skip first element
array([2, 3])
Attributes
Tndarray
Transpose of the array.
databuffer
The array’s elements, in memory.
dtypedtype object
Describes the format of the elements in the array.
flagsdict
Dictionary containing information related to memory use, e.g., ‘C_CONTIGUOUS’, ‘OWNDATA’, ‘WRITEABLE’, etc.
flatnumpy.flatiter object
Flattened version of the array as an iterator. The iterator allows assignments, e.g., x.flat = 3 (See ndarray.flat for assignment examples; TODO).
imagndarray
Imaginary part of the array.
realndarray
Real part of the array.
sizeint
Number of elements in the array.
itemsizeint
The memory use of each array element in bytes.
nbytesint
The total number of bytes required to store the array data, i.e., itemsize * size.
ndimint
The array’s number of dimensions.
shapetuple of ints
Shape of the array.
stridestuple of ints
The step-size required to move from one element to the next in memory. For example, a contiguous (3, 4) array of type int16 in C-order has strides (8, 2). This implies that to move from element to element in memory requires jumps of 2 bytes. To move from row-to-row, one needs to jump 8 bytes at a time (2 * 4).
ctypesctypes object
Class containing properties of the array needed for interaction with ctypes.
basendarray
If the array is a view into another array, that array is its base (unless that array is also a view). The base array is where the array data is actually stored. | numpy.reference.generated.numpy.polynomial.laguerre.lagone |
numpy.polynomial.laguerre.lagpow polynomial.laguerre.lagpow(c, pow, maxpower=16)[source]
Raise a Laguerre series to a power. Returns the Laguerre series c raised to the power pow. The argument c is a sequence of coefficients ordered from low to high. i.e., [1,2,3] is the series P_0 + 2*P_1 + 3*P_2. Parameters
carray_like
1-D array of Laguerre series coefficients ordered from low to high.
powinteger
Power to which the series will be raised
maxpowerinteger, optional
Maximum power allowed. This is mainly to limit growth of the series to unmanageable size. Default is 16 Returns
coefndarray
Laguerre series of power. See also
lagadd, lagsub, lagmulx, lagmul, lagdiv
Examples >>> from numpy.polynomial.laguerre import lagpow
>>> lagpow([1, 2, 3], 2)
array([ 14., -16., 56., -72., 54.]) | numpy.reference.generated.numpy.polynomial.laguerre.lagpow |
numpy.polynomial.laguerre.lagroots polynomial.laguerre.lagroots(c)[source]
Compute the roots of a Laguerre series. Return the roots (a.k.a. “zeros”) of the polynomial \[p(x) = \sum_i c[i] * L_i(x).\] Parameters
c1-D array_like
1-D array of coefficients. Returns
outndarray
Array of the roots of the series. If all the roots are real, then out is also real, otherwise it is complex. See also numpy.polynomial.polynomial.polyroots
numpy.polynomial.legendre.legroots
numpy.polynomial.chebyshev.chebroots
numpy.polynomial.hermite.hermroots
numpy.polynomial.hermite_e.hermeroots
Notes The root estimates are obtained as the eigenvalues of the companion matrix, Roots far from the origin of the complex plane may have large errors due to the numerical instability of the series for such values. Roots with multiplicity greater than 1 will also show larger errors as the value of the series near such points is relatively insensitive to errors in the roots. Isolated roots near the origin can be improved by a few iterations of Newton’s method. The Laguerre series basis polynomials aren’t powers of x so the results of this function may seem unintuitive. Examples >>> from numpy.polynomial.laguerre import lagroots, lagfromroots
>>> coef = lagfromroots([0, 1, 2])
>>> coef
array([ 2., -8., 12., -6.])
>>> lagroots(coef)
array([-4.4408921e-16, 1.0000000e+00, 2.0000000e+00]) | numpy.reference.generated.numpy.polynomial.laguerre.lagroots |
numpy.polynomial.laguerre.lagsub polynomial.laguerre.lagsub(c1, c2)[source]
Subtract one Laguerre series from another. Returns the difference of two Laguerre series c1 - c2. The sequences of coefficients are from lowest order term to highest, i.e., [1,2,3] represents the series P_0 + 2*P_1 + 3*P_2. Parameters
c1, c2array_like
1-D arrays of Laguerre series coefficients ordered from low to high. Returns
outndarray
Of Laguerre series coefficients representing their difference. See also
lagadd, lagmulx, lagmul, lagdiv, lagpow
Notes Unlike multiplication, division, etc., the difference of two Laguerre series is a Laguerre series (without having to “reproject” the result onto the basis set) so subtraction, just like that of “standard” polynomials, is simply “component-wise.” Examples >>> from numpy.polynomial.laguerre import lagsub
>>> lagsub([1, 2, 3, 4], [1, 2, 3])
array([0., 0., 0., 4.]) | numpy.reference.generated.numpy.polynomial.laguerre.lagsub |
numpy.polynomial.laguerre.lagtrim polynomial.laguerre.lagtrim(c, tol=0)[source]
Remove “small” “trailing” coefficients from a polynomial. “Small” means “small in absolute value” and is controlled by the parameter tol; “trailing” means highest order coefficient(s), e.g., in [0, 1, 1, 0, 0] (which represents 0 + x + x**2 + 0*x**3 + 0*x**4) both the 3-rd and 4-th order coefficients would be “trimmed.” Parameters
carray_like
1-d array of coefficients, ordered from lowest order to highest.
tolnumber, optional
Trailing (i.e., highest order) elements with absolute value less than or equal to tol (default value is zero) are removed. Returns
trimmedndarray
1-d array with trailing zeros removed. If the resulting series would be empty, a series containing a single zero is returned. Raises
ValueError
If tol < 0 See also trimseq
Examples >>> from numpy.polynomial import polyutils as pu
>>> pu.trimcoef((0,0,3,0,5,0,0))
array([0., 0., 3., 0., 5.])
>>> pu.trimcoef((0,0,1e-3,0,1e-5,0,0),1e-3) # item == tol is trimmed
array([0.])
>>> i = complex(0,1) # works for complex
>>> pu.trimcoef((3e-4,1e-3*(1-i),5e-4,2e-5*(1+i)), 1e-3)
array([0.0003+0.j , 0.001 -0.001j]) | numpy.reference.generated.numpy.polynomial.laguerre.lagtrim |
numpy.polynomial.laguerre.Laguerre.__call__ method polynomial.laguerre.Laguerre.__call__(arg)[source]
Call self as a function. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.__call__ |
numpy.polynomial.laguerre.Laguerre.basis method classmethod polynomial.laguerre.Laguerre.basis(deg, domain=None, window=None)[source]
Series basis polynomial of degree deg. Returns the series representing the basis polynomial of degree deg. New in version 1.7.0. Parameters
degint
Degree of the basis polynomial for the series. Must be >= 0.
domain{None, array_like}, optional
If given, the array must be of the form [beg, end], where beg and end are the endpoints of the domain. If None is given then the class domain is used. The default is None.
window{None, array_like}, optional
If given, the resulting array must be if the form [beg, end], where beg and end are the endpoints of the window. If None is given then the class window is used. The default is None. Returns
new_seriesseries
A series with the coefficient of the deg term set to one and all others zero. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.basis |
numpy.polynomial.laguerre.Laguerre.cast method classmethod polynomial.laguerre.Laguerre.cast(series, domain=None, window=None)[source]
Convert series to series of this class. The series is expected to be an instance of some polynomial series of one of the types supported by by the numpy.polynomial module, but could be some other class that supports the convert method. New in version 1.7.0. Parameters
seriesseries
The series instance to be converted.
domain{None, array_like}, optional
If given, the array must be of the form [beg, end], where beg and end are the endpoints of the domain. If None is given then the class domain is used. The default is None.
window{None, array_like}, optional
If given, the resulting array must be if the form [beg, end], where beg and end are the endpoints of the window. If None is given then the class window is used. The default is None. Returns
new_seriesseries
A series of the same kind as the calling class and equal to series when evaluated. See also convert
similar instance method | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.cast |
numpy.polynomial.laguerre.Laguerre.convert method polynomial.laguerre.Laguerre.convert(domain=None, kind=None, window=None)[source]
Convert series to a different kind and/or domain and/or window. Parameters
domainarray_like, optional
The domain of the converted series. If the value is None, the default domain of kind is used.
kindclass, optional
The polynomial series type class to which the current instance should be converted. If kind is None, then the class of the current instance is used.
windowarray_like, optional
The window of the converted series. If the value is None, the default window of kind is used. Returns
new_seriesseries
The returned class can be of different type than the current instance and/or have a different domain and/or different window. Notes Conversion between domains and class types can result in numerically ill defined series. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.convert |
numpy.polynomial.laguerre.Laguerre.copy method polynomial.laguerre.Laguerre.copy()[source]
Return a copy. Returns
new_seriesseries
Copy of self. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.copy |
numpy.polynomial.laguerre.Laguerre.cutdeg method polynomial.laguerre.Laguerre.cutdeg(deg)[source]
Truncate series to the given degree. Reduce the degree of the series to deg by discarding the high order terms. If deg is greater than the current degree a copy of the current series is returned. This can be useful in least squares where the coefficients of the high degree terms may be very small. New in version 1.5.0. Parameters
degnon-negative int
The series is reduced to degree deg by discarding the high order terms. The value of deg must be a non-negative integer. Returns
new_seriesseries
New instance of series with reduced degree. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.cutdeg |
numpy.polynomial.laguerre.Laguerre.degree method polynomial.laguerre.Laguerre.degree()[source]
The degree of the series. New in version 1.5.0. Returns
degreeint
Degree of the series, one less than the number of coefficients. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.degree |
numpy.polynomial.laguerre.Laguerre.deriv method polynomial.laguerre.Laguerre.deriv(m=1)[source]
Differentiate. Return a series instance of that is the derivative of the current series. Parameters
mnon-negative int
Find the derivative of order m. Returns
new_seriesseries
A new series representing the derivative. The domain is the same as the domain of the differentiated series. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.deriv |
numpy.polynomial.laguerre.Laguerre.domain attribute polynomial.laguerre.Laguerre.domain = array([0, 1]) | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.domain |
numpy.polynomial.laguerre.Laguerre.fit method classmethod polynomial.laguerre.Laguerre.fit(x, y, deg, domain=None, rcond=None, full=False, w=None, window=None)[source]
Least squares fit to data. Return a series instance that is the least squares fit to the data y sampled at x. The domain of the returned instance can be specified and this will often result in a superior fit with less chance of ill conditioning. Parameters
xarray_like, shape (M,)
x-coordinates of the M sample points (x[i], y[i]).
yarray_like, shape (M,)
y-coordinates of the M sample points (x[i], y[i]).
degint or 1-D array_like
Degree(s) of the fitting polynomials. If deg is a single integer all terms up to and including the deg’th term are included in the fit. For NumPy versions >= 1.11.0 a list of integers specifying the degrees of the terms to include may be used instead.
domain{None, [beg, end], []}, optional
Domain to use for the returned series. If None, then a minimal domain that covers the points x is chosen. If [] the class domain is used. The default value was the class domain in NumPy 1.4 and None in later versions. The [] option was added in numpy 1.5.0.
rcondfloat, optional
Relative condition number of the fit. Singular values smaller than this relative to the largest singular value will be ignored. The default value is len(x)*eps, where eps is the relative precision of the float type, about 2e-16 in most cases.
fullbool, optional
Switch determining nature of return value. When it is False (the default) just the coefficients are returned, when True diagnostic information from the singular value decomposition is also returned.
warray_like, shape (M,), optional
Weights. If not None, the weight w[i] applies to the unsquared residual y[i] - y_hat[i] at x[i]. Ideally the weights are chosen so that the errors of the products w[i]*y[i] all have the same variance. When using inverse-variance weighting, use w[i] = 1/sigma(y[i]). The default value is None. New in version 1.5.0.
window{[beg, end]}, optional
Window to use for the returned series. The default value is the default class domain New in version 1.6.0. Returns
new_seriesseries
A series that represents the least squares fit to the data and has the domain and window specified in the call. If the coefficients for the unscaled and unshifted basis polynomials are of interest, do new_series.convert().coef.
[resid, rank, sv, rcond]list
These values are only returned if full == True resid – sum of squared residuals of the least squares fit rank – the numerical rank of the scaled Vandermonde matrix sv – singular values of the scaled Vandermonde matrix rcond – value of rcond. For more details, see linalg.lstsq. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.fit |
numpy.polynomial.laguerre.Laguerre.fromroots method classmethod polynomial.laguerre.Laguerre.fromroots(roots, domain=[], window=None)[source]
Return series instance that has the specified roots. Returns a series representing the product (x - r[0])*(x - r[1])*...*(x - r[n-1]), where r is a list of roots. Parameters
rootsarray_like
List of roots.
domain{[], None, array_like}, optional
Domain for the resulting series. If None the domain is the interval from the smallest root to the largest. If [] the domain is the class domain. The default is [].
window{None, array_like}, optional
Window for the returned series. If None the class window is used. The default is None. Returns
new_seriesseries
Series with the specified roots. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.fromroots |
numpy.polynomial.laguerre.Laguerre.has_samecoef method polynomial.laguerre.Laguerre.has_samecoef(other)[source]
Check if coefficients match. New in version 1.6.0. Parameters
otherclass instance
The other class must have the coef attribute. Returns
boolboolean
True if the coefficients are the same, False otherwise. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.has_samecoef |
numpy.polynomial.laguerre.Laguerre.has_samedomain method polynomial.laguerre.Laguerre.has_samedomain(other)[source]
Check if domains match. New in version 1.6.0. Parameters
otherclass instance
The other class must have the domain attribute. Returns
boolboolean
True if the domains are the same, False otherwise. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.has_samedomain |
numpy.polynomial.laguerre.Laguerre.has_sametype method polynomial.laguerre.Laguerre.has_sametype(other)[source]
Check if types match. New in version 1.7.0. Parameters
otherobject
Class instance. Returns
boolboolean
True if other is same class as self | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.has_sametype |
numpy.polynomial.laguerre.Laguerre.has_samewindow method polynomial.laguerre.Laguerre.has_samewindow(other)[source]
Check if windows match. New in version 1.6.0. Parameters
otherclass instance
The other class must have the window attribute. Returns
boolboolean
True if the windows are the same, False otherwise. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.has_samewindow |
numpy.polynomial.laguerre.Laguerre.identity method classmethod polynomial.laguerre.Laguerre.identity(domain=None, window=None)[source]
Identity function. If p is the returned series, then p(x) == x for all values of x. Parameters
domain{None, array_like}, optional
If given, the array must be of the form [beg, end], where beg and end are the endpoints of the domain. If None is given then the class domain is used. The default is None.
window{None, array_like}, optional
If given, the resulting array must be if the form [beg, end], where beg and end are the endpoints of the window. If None is given then the class window is used. The default is None. Returns
new_seriesseries
Series of representing the identity. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.identity |
numpy.polynomial.laguerre.Laguerre.integ method polynomial.laguerre.Laguerre.integ(m=1, k=[], lbnd=None)[source]
Integrate. Return a series instance that is the definite integral of the current series. Parameters
mnon-negative int
The number of integrations to perform.
karray_like
Integration constants. The first constant is applied to the first integration, the second to the second, and so on. The list of values must less than or equal to m in length and any missing values are set to zero.
lbndScalar
The lower bound of the definite integral. Returns
new_seriesseries
A new series representing the integral. The domain is the same as the domain of the integrated series. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.integ |
numpy.polynomial.laguerre.Laguerre.linspace method polynomial.laguerre.Laguerre.linspace(n=100, domain=None)[source]
Return x, y values at equally spaced points in domain. Returns the x, y values at n linearly spaced points across the domain. Here y is the value of the polynomial at the points x. By default the domain is the same as that of the series instance. This method is intended mostly as a plotting aid. New in version 1.5.0. Parameters
nint, optional
Number of point pairs to return. The default value is 100.
domain{None, array_like}, optional
If not None, the specified domain is used instead of that of the calling instance. It should be of the form [beg,end]. The default is None which case the class domain is used. Returns
x, yndarray
x is equal to linspace(self.domain[0], self.domain[1], n) and y is the series evaluated at element of x. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.linspace |
numpy.polynomial.laguerre.Laguerre.mapparms method polynomial.laguerre.Laguerre.mapparms()[source]
Return the mapping parameters. The returned values define a linear map off + scl*x that is applied to the input arguments before the series is evaluated. The map depends on the domain and window; if the current domain is equal to the window the resulting map is the identity. If the coefficients of the series instance are to be used by themselves outside this class, then the linear function must be substituted for the x in the standard representation of the base polynomials. Returns
off, sclfloat or complex
The mapping function is defined by off + scl*x. Notes If the current domain is the interval [l1, r1] and the window is [l2, r2], then the linear mapping function L is defined by the equations: L(l1) = l2
L(r1) = r2 | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.mapparms |
numpy.polynomial.laguerre.Laguerre.roots method polynomial.laguerre.Laguerre.roots()[source]
Return the roots of the series polynomial. Compute the roots for the series. Note that the accuracy of the roots decrease the further outside the domain they lie. Returns
rootsndarray
Array containing the roots of the series. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.roots |
numpy.polynomial.laguerre.Laguerre.trim method polynomial.laguerre.Laguerre.trim(tol=0)[source]
Remove trailing coefficients Remove trailing coefficients until a coefficient is reached whose absolute value greater than tol or the beginning of the series is reached. If all the coefficients would be removed the series is set to [0]. A new series instance is returned with the new coefficients. The current instance remains unchanged. Parameters
tolnon-negative number.
All trailing coefficients less than tol will be removed. Returns
new_seriesseries
New instance of series with trimmed coefficients. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.trim |
numpy.polynomial.laguerre.Laguerre.truncate method polynomial.laguerre.Laguerre.truncate(size)[source]
Truncate series to length size. Reduce the series to length size by discarding the high degree terms. The value of size must be a positive integer. This can be useful in least squares where the coefficients of the high degree terms may be very small. Parameters
sizepositive int
The series is reduced to length size by discarding the high degree terms. The value of size must be a positive integer. Returns
new_seriesseries
New instance of series with truncated coefficients. | numpy.reference.generated.numpy.polynomial.laguerre.laguerre.truncate |
numpy.polynomial.laguerre.lagval polynomial.laguerre.lagval(x, c, tensor=True)[source]
Evaluate a Laguerre series at points x. If c is of length n + 1, this function returns the value: \[p(x) = c_0 * L_0(x) + c_1 * L_1(x) + ... + c_n * L_n(x)\] The parameter x is converted to an array only if it is a tuple or a list, otherwise it is treated as a scalar. In either case, either x or its elements must support multiplication and addition both with themselves and with the elements of c. If c is a 1-D array, then p(x) will have the same shape as x. If c is multidimensional, then the shape of the result depends on the value of tensor. If tensor is true the shape will be c.shape[1:] + x.shape. If tensor is false the shape will be c.shape[1:]. Note that scalars have shape (,). Trailing zeros in the coefficients will be used in the evaluation, so they should be avoided if efficiency is a concern. Parameters
xarray_like, compatible object
If x is a list or tuple, it is converted to an ndarray, otherwise it is left unchanged and treated as a scalar. In either case, x or its elements must support addition and multiplication with with themselves and with the elements of c.
carray_like
Array of coefficients ordered so that the coefficients for terms of degree n are contained in c[n]. If c is multidimensional the remaining indices enumerate multiple polynomials. In the two dimensional case the coefficients may be thought of as stored in the columns of c.
tensorboolean, optional
If True, the shape of the coefficient array is extended with ones on the right, one for each dimension of x. Scalars have dimension 0 for this action. The result is that every column of coefficients in c is evaluated for every element of x. If False, x is broadcast over the columns of c for the evaluation. This keyword is useful when c is multidimensional. The default value is True. New in version 1.7.0. Returns
valuesndarray, algebra_like
The shape of the return value is described above. See also
lagval2d, laggrid2d, lagval3d, laggrid3d
Notes The evaluation uses Clenshaw recursion, aka synthetic division. Examples >>> from numpy.polynomial.laguerre import lagval
>>> coef = [1,2,3]
>>> lagval(1, coef)
-0.5
>>> lagval([[1,2],[3,4]], coef)
array([[-0.5, -4. ],
[-4.5, -2. ]]) | numpy.reference.generated.numpy.polynomial.laguerre.lagval |
numpy.polynomial.laguerre.lagval2d polynomial.laguerre.lagval2d(x, y, c)[source]
Evaluate a 2-D Laguerre series at points (x, y). This function returns the values: \[p(x,y) = \sum_{i,j} c_{i,j} * L_i(x) * L_j(y)\] The parameters x and y are converted to arrays only if they are tuples or a lists, otherwise they are treated as a scalars and they must have the same shape after conversion. In either case, either x and y or their elements must support multiplication and addition both with themselves and with the elements of c. If c is a 1-D array a one is implicitly appended to its shape to make it 2-D. The shape of the result will be c.shape[2:] + x.shape. Parameters
x, yarray_like, compatible objects
The two dimensional series is evaluated at the points (x, y), where x and y must have the same shape. If x or y is a list or tuple, it is first converted to an ndarray, otherwise it is left unchanged and if it isn’t an ndarray it is treated as a scalar.
carray_like
Array of coefficients ordered so that the coefficient of the term of multi-degree i,j is contained in c[i,j]. If c has dimension greater than two the remaining indices enumerate multiple sets of coefficients. Returns
valuesndarray, compatible object
The values of the two dimensional polynomial at points formed with pairs of corresponding values from x and y. See also
lagval, laggrid2d, lagval3d, laggrid3d
Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.laguerre.lagval2d |
numpy.polynomial.laguerre.lagval3d polynomial.laguerre.lagval3d(x, y, z, c)[source]
Evaluate a 3-D Laguerre series at points (x, y, z). This function returns the values: \[p(x,y,z) = \sum_{i,j,k} c_{i,j,k} * L_i(x) * L_j(y) * L_k(z)\] The parameters x, y, and z are converted to arrays only if they are tuples or a lists, otherwise they are treated as a scalars and they must have the same shape after conversion. In either case, either x, y, and z or their elements must support multiplication and addition both with themselves and with the elements of c. If c has fewer than 3 dimensions, ones are implicitly appended to its shape to make it 3-D. The shape of the result will be c.shape[3:] + x.shape. Parameters
x, y, zarray_like, compatible object
The three dimensional series is evaluated at the points (x, y, z), where x, y, and z must have the same shape. If any of x, y, or z is a list or tuple, it is first converted to an ndarray, otherwise it is left unchanged and if it isn’t an ndarray it is treated as a scalar.
carray_like
Array of coefficients ordered so that the coefficient of the term of multi-degree i,j,k is contained in c[i,j,k]. If c has dimension greater than 3 the remaining indices enumerate multiple sets of coefficients. Returns
valuesndarray, compatible object
The values of the multidimensional polynomial on points formed with triples of corresponding values from x, y, and z. See also
lagval, lagval2d, laggrid2d, laggrid3d
Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.laguerre.lagval3d |
numpy.polynomial.laguerre.lagvander polynomial.laguerre.lagvander(x, deg)[source]
Pseudo-Vandermonde matrix of given degree. Returns the pseudo-Vandermonde matrix of degree deg and sample points x. The pseudo-Vandermonde matrix is defined by \[V[..., i] = L_i(x)\] where 0 <= i <= deg. The leading indices of V index the elements of x and the last index is the degree of the Laguerre polynomial. If c is a 1-D array of coefficients of length n + 1 and V is the array V = lagvander(x, n), then np.dot(V, c) and lagval(x, c) are the same up to roundoff. This equivalence is useful both for least squares fitting and for the evaluation of a large number of Laguerre series of the same degree and sample points. Parameters
xarray_like
Array of points. The dtype is converted to float64 or complex128 depending on whether any of the elements are complex. If x is scalar it is converted to a 1-D array.
degint
Degree of the resulting matrix. Returns
vanderndarray
The pseudo-Vandermonde matrix. The shape of the returned matrix is x.shape + (deg + 1,), where The last index is the degree of the corresponding Laguerre polynomial. The dtype will be the same as the converted x. Examples >>> from numpy.polynomial.laguerre import lagvander
>>> x = np.array([0, 1, 2])
>>> lagvander(x, 3)
array([[ 1. , 1. , 1. , 1. ],
[ 1. , 0. , -0.5 , -0.66666667],
[ 1. , -1. , -1. , -0.33333333]]) | numpy.reference.generated.numpy.polynomial.laguerre.lagvander |
numpy.polynomial.laguerre.lagvander2d polynomial.laguerre.lagvander2d(x, y, deg)[source]
Pseudo-Vandermonde matrix of given degrees. Returns the pseudo-Vandermonde matrix of degrees deg and sample points (x, y). The pseudo-Vandermonde matrix is defined by \[V[..., (deg[1] + 1)*i + j] = L_i(x) * L_j(y),\] where 0 <= i <= deg[0] and 0 <= j <= deg[1]. The leading indices of V index the points (x, y) and the last index encodes the degrees of the Laguerre polynomials. If V = lagvander2d(x, y, [xdeg, ydeg]), then the columns of V correspond to the elements of a 2-D coefficient array c of shape (xdeg + 1, ydeg + 1) in the order \[c_{00}, c_{01}, c_{02} ... , c_{10}, c_{11}, c_{12} ...\] and np.dot(V, c.flat) and lagval2d(x, y, c) will be the same up to roundoff. This equivalence is useful both for least squares fitting and for the evaluation of a large number of 2-D Laguerre series of the same degrees and sample points. Parameters
x, yarray_like
Arrays of point coordinates, all of the same shape. The dtypes will be converted to either float64 or complex128 depending on whether any of the elements are complex. Scalars are converted to 1-D arrays.
deglist of ints
List of maximum degrees of the form [x_deg, y_deg]. Returns
vander2dndarray
The shape of the returned matrix is x.shape + (order,), where \(order = (deg[0]+1)*(deg[1]+1)\). The dtype will be the same as the converted x and y. See also
lagvander, lagvander3d, lagval2d, lagval3d
Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.laguerre.lagvander2d |
numpy.polynomial.laguerre.lagvander3d polynomial.laguerre.lagvander3d(x, y, z, deg)[source]
Pseudo-Vandermonde matrix of given degrees. Returns the pseudo-Vandermonde matrix of degrees deg and sample points (x, y, z). If l, m, n are the given degrees in x, y, z, then The pseudo-Vandermonde matrix is defined by \[V[..., (m+1)(n+1)i + (n+1)j + k] = L_i(x)*L_j(y)*L_k(z),\] where 0 <= i <= l, 0 <= j <= m, and 0 <= j <= n. The leading indices of V index the points (x, y, z) and the last index encodes the degrees of the Laguerre polynomials. If V = lagvander3d(x, y, z, [xdeg, ydeg, zdeg]), then the columns of V correspond to the elements of a 3-D coefficient array c of shape (xdeg + 1, ydeg + 1, zdeg + 1) in the order \[c_{000}, c_{001}, c_{002},... , c_{010}, c_{011}, c_{012},...\] and np.dot(V, c.flat) and lagval3d(x, y, z, c) will be the same up to roundoff. This equivalence is useful both for least squares fitting and for the evaluation of a large number of 3-D Laguerre series of the same degrees and sample points. Parameters
x, y, zarray_like
Arrays of point coordinates, all of the same shape. The dtypes will be converted to either float64 or complex128 depending on whether any of the elements are complex. Scalars are converted to 1-D arrays.
deglist of ints
List of maximum degrees of the form [x_deg, y_deg, z_deg]. Returns
vander3dndarray
The shape of the returned matrix is x.shape + (order,), where \(order = (deg[0]+1)*(deg[1]+1)*(deg[2]+1)\). The dtype will be the same as the converted x, y, and z. See also
lagvander, lagvander3d, lagval2d, lagval3d
Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.laguerre.lagvander3d |
numpy.polynomial.laguerre.lagweight polynomial.laguerre.lagweight(x)[source]
Weight function of the Laguerre polynomials. The weight function is \(exp(-x)\) and the interval of integration is \([0, \inf]\). The Laguerre polynomials are orthogonal, but not normalized, with respect to this weight function. Parameters
xarray_like
Values at which the weight function will be computed. Returns
wndarray
The weight function at x. Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.laguerre.lagweight |
numpy.polynomial.laguerre.lagx polynomial.laguerre.lagx = array([ 1, -1])
An array object represents a multidimensional, homogeneous array of fixed-size items. An associated data-type object describes the format of each element in the array (its byte-order, how many bytes it occupies in memory, whether it is an integer, a floating point number, or something else, etc.) Arrays should be constructed using array, zeros or empty (refer to the See Also section below). The parameters given here refer to a low-level method (ndarray(…)) for instantiating an array. For more information, refer to the numpy module and examine the methods and attributes of an array. Parameters
(for the __new__ method; see Notes below)
shapetuple of ints
Shape of created array.
dtypedata-type, optional
Any object that can be interpreted as a numpy data type.
bufferobject exposing buffer interface, optional
Used to fill the array with data.
offsetint, optional
Offset of array data in buffer.
stridestuple of ints, optional
Strides of data in memory.
order{‘C’, ‘F’}, optional
Row-major (C-style) or column-major (Fortran-style) order. See also array
Construct an array. zeros
Create an array, each element of which is zero. empty
Create an array, but leave its allocated memory unchanged (i.e., it contains “garbage”). dtype
Create a data-type. numpy.typing.NDArray
An ndarray alias generic w.r.t. its dtype.type. Notes There are two modes of creating an array using __new__: If buffer is None, then only shape, dtype, and order are used. If buffer is an object exposing the buffer interface, then all keywords are interpreted. No __init__ method is needed because the array is fully initialized after the __new__ method. Examples These examples illustrate the low-level ndarray constructor. Refer to the See Also section above for easier ways of constructing an ndarray. First mode, buffer is None: >>> np.ndarray(shape=(2,2), dtype=float, order='F')
array([[0.0e+000, 0.0e+000], # random
[ nan, 2.5e-323]])
Second mode: >>> np.ndarray((2,), buffer=np.array([1,2,3]),
... offset=np.int_().itemsize,
... dtype=int) # offset = 1*itemsize, i.e. skip first element
array([2, 3])
Attributes
Tndarray
Transpose of the array.
databuffer
The array’s elements, in memory.
dtypedtype object
Describes the format of the elements in the array.
flagsdict
Dictionary containing information related to memory use, e.g., ‘C_CONTIGUOUS’, ‘OWNDATA’, ‘WRITEABLE’, etc.
flatnumpy.flatiter object
Flattened version of the array as an iterator. The iterator allows assignments, e.g., x.flat = 3 (See ndarray.flat for assignment examples; TODO).
imagndarray
Imaginary part of the array.
realndarray
Real part of the array.
sizeint
Number of elements in the array.
itemsizeint
The memory use of each array element in bytes.
nbytesint
The total number of bytes required to store the array data, i.e., itemsize * size.
ndimint
The array’s number of dimensions.
shapetuple of ints
Shape of the array.
stridestuple of ints
The step-size required to move from one element to the next in memory. For example, a contiguous (3, 4) array of type int16 in C-order has strides (8, 2). This implies that to move from element to element in memory requires jumps of 2 bytes. To move from row-to-row, one needs to jump 8 bytes at a time (2 * 4).
ctypesctypes object
Class containing properties of the array needed for interaction with ctypes.
basendarray
If the array is a view into another array, that array is its base (unless that array is also a view). The base array is where the array data is actually stored. | numpy.reference.generated.numpy.polynomial.laguerre.lagx |
numpy.polynomial.laguerre.lagzero polynomial.laguerre.lagzero = array([0])
An array object represents a multidimensional, homogeneous array of fixed-size items. An associated data-type object describes the format of each element in the array (its byte-order, how many bytes it occupies in memory, whether it is an integer, a floating point number, or something else, etc.) Arrays should be constructed using array, zeros or empty (refer to the See Also section below). The parameters given here refer to a low-level method (ndarray(…)) for instantiating an array. For more information, refer to the numpy module and examine the methods and attributes of an array. Parameters
(for the __new__ method; see Notes below)
shapetuple of ints
Shape of created array.
dtypedata-type, optional
Any object that can be interpreted as a numpy data type.
bufferobject exposing buffer interface, optional
Used to fill the array with data.
offsetint, optional
Offset of array data in buffer.
stridestuple of ints, optional
Strides of data in memory.
order{‘C’, ‘F’}, optional
Row-major (C-style) or column-major (Fortran-style) order. See also array
Construct an array. zeros
Create an array, each element of which is zero. empty
Create an array, but leave its allocated memory unchanged (i.e., it contains “garbage”). dtype
Create a data-type. numpy.typing.NDArray
An ndarray alias generic w.r.t. its dtype.type. Notes There are two modes of creating an array using __new__: If buffer is None, then only shape, dtype, and order are used. If buffer is an object exposing the buffer interface, then all keywords are interpreted. No __init__ method is needed because the array is fully initialized after the __new__ method. Examples These examples illustrate the low-level ndarray constructor. Refer to the See Also section above for easier ways of constructing an ndarray. First mode, buffer is None: >>> np.ndarray(shape=(2,2), dtype=float, order='F')
array([[0.0e+000, 0.0e+000], # random
[ nan, 2.5e-323]])
Second mode: >>> np.ndarray((2,), buffer=np.array([1,2,3]),
... offset=np.int_().itemsize,
... dtype=int) # offset = 1*itemsize, i.e. skip first element
array([2, 3])
Attributes
Tndarray
Transpose of the array.
databuffer
The array’s elements, in memory.
dtypedtype object
Describes the format of the elements in the array.
flagsdict
Dictionary containing information related to memory use, e.g., ‘C_CONTIGUOUS’, ‘OWNDATA’, ‘WRITEABLE’, etc.
flatnumpy.flatiter object
Flattened version of the array as an iterator. The iterator allows assignments, e.g., x.flat = 3 (See ndarray.flat for assignment examples; TODO).
imagndarray
Imaginary part of the array.
realndarray
Real part of the array.
sizeint
Number of elements in the array.
itemsizeint
The memory use of each array element in bytes.
nbytesint
The total number of bytes required to store the array data, i.e., itemsize * size.
ndimint
The array’s number of dimensions.
shapetuple of ints
Shape of the array.
stridestuple of ints
The step-size required to move from one element to the next in memory. For example, a contiguous (3, 4) array of type int16 in C-order has strides (8, 2). This implies that to move from element to element in memory requires jumps of 2 bytes. To move from row-to-row, one needs to jump 8 bytes at a time (2 * 4).
ctypesctypes object
Class containing properties of the array needed for interaction with ctypes.
basendarray
If the array is a view into another array, that array is its base (unless that array is also a view). The base array is where the array data is actually stored. | numpy.reference.generated.numpy.polynomial.laguerre.lagzero |
numpy.polynomial.laguerre.poly2lag polynomial.laguerre.poly2lag(pol)[source]
Convert a polynomial to a Laguerre series. Convert an array representing the coefficients of a polynomial (relative to the “standard” basis) ordered from lowest degree to highest, to an array of the coefficients of the equivalent Laguerre series, ordered from lowest to highest degree. Parameters
polarray_like
1-D array containing the polynomial coefficients Returns
cndarray
1-D array containing the coefficients of the equivalent Laguerre series. See also lag2poly
Notes The easy way to do conversions between polynomial basis sets is to use the convert method of a class instance. Examples >>> from numpy.polynomial.laguerre import poly2lag
>>> poly2lag(np.arange(4))
array([ 23., -63., 58., -18.]) | numpy.reference.generated.numpy.polynomial.laguerre.poly2lag |
numpy.polynomial.legendre.leg2poly polynomial.legendre.leg2poly(c)[source]
Convert a Legendre series to a polynomial. Convert an array representing the coefficients of a Legendre series, ordered from lowest degree to highest, to an array of the coefficients of the equivalent polynomial (relative to the “standard” basis) ordered from lowest to highest degree. Parameters
carray_like
1-D array containing the Legendre series coefficients, ordered from lowest order term to highest. Returns
polndarray
1-D array containing the coefficients of the equivalent polynomial (relative to the “standard” basis) ordered from lowest order term to highest. See also poly2leg
Notes The easy way to do conversions between polynomial basis sets is to use the convert method of a class instance. Examples >>> from numpy import polynomial as P
>>> c = P.Legendre(range(4))
>>> c
Legendre([0., 1., 2., 3.], domain=[-1, 1], window=[-1, 1])
>>> p = c.convert(kind=P.Polynomial)
>>> p
Polynomial([-1. , -3.5, 3. , 7.5], domain=[-1., 1.], window=[-1., 1.])
>>> P.leg2poly(range(4))
array([-1. , -3.5, 3. , 7.5]) | numpy.reference.generated.numpy.polynomial.legendre.leg2poly |
numpy.polynomial.legendre.legadd polynomial.legendre.legadd(c1, c2)[source]
Add one Legendre series to another. Returns the sum of two Legendre series c1 + c2. The arguments are sequences of coefficients ordered from lowest order term to highest, i.e., [1,2,3] represents the series P_0 + 2*P_1 + 3*P_2. Parameters
c1, c2array_like
1-D arrays of Legendre series coefficients ordered from low to high. Returns
outndarray
Array representing the Legendre series of their sum. See also
legsub, legmulx, legmul, legdiv, legpow
Notes Unlike multiplication, division, etc., the sum of two Legendre series is a Legendre series (without having to “reproject” the result onto the basis set) so addition, just like that of “standard” polynomials, is simply “component-wise.” Examples >>> from numpy.polynomial import legendre as L
>>> c1 = (1,2,3)
>>> c2 = (3,2,1)
>>> L.legadd(c1,c2)
array([4., 4., 4.]) | numpy.reference.generated.numpy.polynomial.legendre.legadd |
numpy.polynomial.legendre.legcompanion polynomial.legendre.legcompanion(c)[source]
Return the scaled companion matrix of c. The basis polynomials are scaled so that the companion matrix is symmetric when c is an Legendre basis polynomial. This provides better eigenvalue estimates than the unscaled case and for basis polynomials the eigenvalues are guaranteed to be real if numpy.linalg.eigvalsh is used to obtain them. Parameters
carray_like
1-D array of Legendre series coefficients ordered from low to high degree. Returns
matndarray
Scaled companion matrix of dimensions (deg, deg). Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.legendre.legcompanion |
numpy.polynomial.legendre.legder polynomial.legendre.legder(c, m=1, scl=1, axis=0)[source]
Differentiate a Legendre series. Returns the Legendre series coefficients c differentiated m times along axis. At each iteration the result is multiplied by scl (the scaling factor is for use in a linear change of variable). The argument c is an array of coefficients from low to high degree along each axis, e.g., [1,2,3] represents the series 1*L_0 + 2*L_1 + 3*L_2 while [[1,2],[1,2]] represents 1*L_0(x)*L_0(y) + 1*L_1(x)*L_0(y) +
2*L_0(x)*L_1(y) + 2*L_1(x)*L_1(y) if axis=0 is x and axis=1 is y. Parameters
carray_like
Array of Legendre series coefficients. If c is multidimensional the different axis correspond to different variables with the degree in each axis given by the corresponding index.
mint, optional
Number of derivatives taken, must be non-negative. (Default: 1)
sclscalar, optional
Each differentiation is multiplied by scl. The end result is multiplication by scl**m. This is for use in a linear change of variable. (Default: 1)
axisint, optional
Axis over which the derivative is taken. (Default: 0). New in version 1.7.0. Returns
derndarray
Legendre series of the derivative. See also legint
Notes In general, the result of differentiating a Legendre series does not resemble the same operation on a power series. Thus the result of this function may be “unintuitive,” albeit correct; see Examples section below. Examples >>> from numpy.polynomial import legendre as L
>>> c = (1,2,3,4)
>>> L.legder(c)
array([ 6., 9., 20.])
>>> L.legder(c, 3)
array([60.])
>>> L.legder(c, scl=-1)
array([ -6., -9., -20.])
>>> L.legder(c, 2,-1)
array([ 9., 60.]) | numpy.reference.generated.numpy.polynomial.legendre.legder |
numpy.polynomial.legendre.legdiv polynomial.legendre.legdiv(c1, c2)[source]
Divide one Legendre series by another. Returns the quotient-with-remainder of two Legendre series c1 / c2. The arguments are sequences of coefficients from lowest order “term” to highest, e.g., [1,2,3] represents the series P_0 + 2*P_1 + 3*P_2. Parameters
c1, c2array_like
1-D arrays of Legendre series coefficients ordered from low to high. Returns
quo, remndarrays
Of Legendre series coefficients representing the quotient and remainder. See also
legadd, legsub, legmulx, legmul, legpow
Notes In general, the (polynomial) division of one Legendre series by another results in quotient and remainder terms that are not in the Legendre polynomial basis set. Thus, to express these results as a Legendre series, it is necessary to “reproject” the results onto the Legendre basis set, which may produce “unintuitive” (but correct) results; see Examples section below. Examples >>> from numpy.polynomial import legendre as L
>>> c1 = (1,2,3)
>>> c2 = (3,2,1)
>>> L.legdiv(c1,c2) # quotient "intuitive," remainder not
(array([3.]), array([-8., -4.]))
>>> c2 = (0,1,2,3)
>>> L.legdiv(c2,c1) # neither "intuitive"
(array([-0.07407407, 1.66666667]), array([-1.03703704, -2.51851852])) # may vary | numpy.reference.generated.numpy.polynomial.legendre.legdiv |
numpy.polynomial.legendre.legdomain polynomial.legendre.legdomain = array([-1, 1])
An array object represents a multidimensional, homogeneous array of fixed-size items. An associated data-type object describes the format of each element in the array (its byte-order, how many bytes it occupies in memory, whether it is an integer, a floating point number, or something else, etc.) Arrays should be constructed using array, zeros or empty (refer to the See Also section below). The parameters given here refer to a low-level method (ndarray(…)) for instantiating an array. For more information, refer to the numpy module and examine the methods and attributes of an array. Parameters
(for the __new__ method; see Notes below)
shapetuple of ints
Shape of created array.
dtypedata-type, optional
Any object that can be interpreted as a numpy data type.
bufferobject exposing buffer interface, optional
Used to fill the array with data.
offsetint, optional
Offset of array data in buffer.
stridestuple of ints, optional
Strides of data in memory.
order{‘C’, ‘F’}, optional
Row-major (C-style) or column-major (Fortran-style) order. See also array
Construct an array. zeros
Create an array, each element of which is zero. empty
Create an array, but leave its allocated memory unchanged (i.e., it contains “garbage”). dtype
Create a data-type. numpy.typing.NDArray
An ndarray alias generic w.r.t. its dtype.type. Notes There are two modes of creating an array using __new__: If buffer is None, then only shape, dtype, and order are used. If buffer is an object exposing the buffer interface, then all keywords are interpreted. No __init__ method is needed because the array is fully initialized after the __new__ method. Examples These examples illustrate the low-level ndarray constructor. Refer to the See Also section above for easier ways of constructing an ndarray. First mode, buffer is None: >>> np.ndarray(shape=(2,2), dtype=float, order='F')
array([[0.0e+000, 0.0e+000], # random
[ nan, 2.5e-323]])
Second mode: >>> np.ndarray((2,), buffer=np.array([1,2,3]),
... offset=np.int_().itemsize,
... dtype=int) # offset = 1*itemsize, i.e. skip first element
array([2, 3])
Attributes
Tndarray
Transpose of the array.
databuffer
The array’s elements, in memory.
dtypedtype object
Describes the format of the elements in the array.
flagsdict
Dictionary containing information related to memory use, e.g., ‘C_CONTIGUOUS’, ‘OWNDATA’, ‘WRITEABLE’, etc.
flatnumpy.flatiter object
Flattened version of the array as an iterator. The iterator allows assignments, e.g., x.flat = 3 (See ndarray.flat for assignment examples; TODO).
imagndarray
Imaginary part of the array.
realndarray
Real part of the array.
sizeint
Number of elements in the array.
itemsizeint
The memory use of each array element in bytes.
nbytesint
The total number of bytes required to store the array data, i.e., itemsize * size.
ndimint
The array’s number of dimensions.
shapetuple of ints
Shape of the array.
stridestuple of ints
The step-size required to move from one element to the next in memory. For example, a contiguous (3, 4) array of type int16 in C-order has strides (8, 2). This implies that to move from element to element in memory requires jumps of 2 bytes. To move from row-to-row, one needs to jump 8 bytes at a time (2 * 4).
ctypesctypes object
Class containing properties of the array needed for interaction with ctypes.
basendarray
If the array is a view into another array, that array is its base (unless that array is also a view). The base array is where the array data is actually stored. | numpy.reference.generated.numpy.polynomial.legendre.legdomain |
numpy.polynomial.legendre.Legendre.__call__ method polynomial.legendre.Legendre.__call__(arg)[source]
Call self as a function. | numpy.reference.generated.numpy.polynomial.legendre.legendre.__call__ |
numpy.polynomial.legendre.Legendre.basis method classmethod polynomial.legendre.Legendre.basis(deg, domain=None, window=None)[source]
Series basis polynomial of degree deg. Returns the series representing the basis polynomial of degree deg. New in version 1.7.0. Parameters
degint
Degree of the basis polynomial for the series. Must be >= 0.
domain{None, array_like}, optional
If given, the array must be of the form [beg, end], where beg and end are the endpoints of the domain. If None is given then the class domain is used. The default is None.
window{None, array_like}, optional
If given, the resulting array must be if the form [beg, end], where beg and end are the endpoints of the window. If None is given then the class window is used. The default is None. Returns
new_seriesseries
A series with the coefficient of the deg term set to one and all others zero. | numpy.reference.generated.numpy.polynomial.legendre.legendre.basis |
numpy.polynomial.legendre.Legendre.cast method classmethod polynomial.legendre.Legendre.cast(series, domain=None, window=None)[source]
Convert series to series of this class. The series is expected to be an instance of some polynomial series of one of the types supported by by the numpy.polynomial module, but could be some other class that supports the convert method. New in version 1.7.0. Parameters
seriesseries
The series instance to be converted.
domain{None, array_like}, optional
If given, the array must be of the form [beg, end], where beg and end are the endpoints of the domain. If None is given then the class domain is used. The default is None.
window{None, array_like}, optional
If given, the resulting array must be if the form [beg, end], where beg and end are the endpoints of the window. If None is given then the class window is used. The default is None. Returns
new_seriesseries
A series of the same kind as the calling class and equal to series when evaluated. See also convert
similar instance method | numpy.reference.generated.numpy.polynomial.legendre.legendre.cast |
numpy.polynomial.legendre.Legendre.convert method polynomial.legendre.Legendre.convert(domain=None, kind=None, window=None)[source]
Convert series to a different kind and/or domain and/or window. Parameters
domainarray_like, optional
The domain of the converted series. If the value is None, the default domain of kind is used.
kindclass, optional
The polynomial series type class to which the current instance should be converted. If kind is None, then the class of the current instance is used.
windowarray_like, optional
The window of the converted series. If the value is None, the default window of kind is used. Returns
new_seriesseries
The returned class can be of different type than the current instance and/or have a different domain and/or different window. Notes Conversion between domains and class types can result in numerically ill defined series. | numpy.reference.generated.numpy.polynomial.legendre.legendre.convert |
numpy.polynomial.legendre.Legendre.copy method polynomial.legendre.Legendre.copy()[source]
Return a copy. Returns
new_seriesseries
Copy of self. | numpy.reference.generated.numpy.polynomial.legendre.legendre.copy |
numpy.polynomial.legendre.Legendre.cutdeg method polynomial.legendre.Legendre.cutdeg(deg)[source]
Truncate series to the given degree. Reduce the degree of the series to deg by discarding the high order terms. If deg is greater than the current degree a copy of the current series is returned. This can be useful in least squares where the coefficients of the high degree terms may be very small. New in version 1.5.0. Parameters
degnon-negative int
The series is reduced to degree deg by discarding the high order terms. The value of deg must be a non-negative integer. Returns
new_seriesseries
New instance of series with reduced degree. | numpy.reference.generated.numpy.polynomial.legendre.legendre.cutdeg |
numpy.polynomial.legendre.Legendre.degree method polynomial.legendre.Legendre.degree()[source]
The degree of the series. New in version 1.5.0. Returns
degreeint
Degree of the series, one less than the number of coefficients. | numpy.reference.generated.numpy.polynomial.legendre.legendre.degree |
numpy.polynomial.legendre.Legendre.deriv method polynomial.legendre.Legendre.deriv(m=1)[source]
Differentiate. Return a series instance of that is the derivative of the current series. Parameters
mnon-negative int
Find the derivative of order m. Returns
new_seriesseries
A new series representing the derivative. The domain is the same as the domain of the differentiated series. | numpy.reference.generated.numpy.polynomial.legendre.legendre.deriv |
numpy.polynomial.legendre.Legendre.domain attribute polynomial.legendre.Legendre.domain = array([-1, 1]) | numpy.reference.generated.numpy.polynomial.legendre.legendre.domain |
numpy.polynomial.legendre.Legendre.fit method classmethod polynomial.legendre.Legendre.fit(x, y, deg, domain=None, rcond=None, full=False, w=None, window=None)[source]
Least squares fit to data. Return a series instance that is the least squares fit to the data y sampled at x. The domain of the returned instance can be specified and this will often result in a superior fit with less chance of ill conditioning. Parameters
xarray_like, shape (M,)
x-coordinates of the M sample points (x[i], y[i]).
yarray_like, shape (M,)
y-coordinates of the M sample points (x[i], y[i]).
degint or 1-D array_like
Degree(s) of the fitting polynomials. If deg is a single integer all terms up to and including the deg’th term are included in the fit. For NumPy versions >= 1.11.0 a list of integers specifying the degrees of the terms to include may be used instead.
domain{None, [beg, end], []}, optional
Domain to use for the returned series. If None, then a minimal domain that covers the points x is chosen. If [] the class domain is used. The default value was the class domain in NumPy 1.4 and None in later versions. The [] option was added in numpy 1.5.0.
rcondfloat, optional
Relative condition number of the fit. Singular values smaller than this relative to the largest singular value will be ignored. The default value is len(x)*eps, where eps is the relative precision of the float type, about 2e-16 in most cases.
fullbool, optional
Switch determining nature of return value. When it is False (the default) just the coefficients are returned, when True diagnostic information from the singular value decomposition is also returned.
warray_like, shape (M,), optional
Weights. If not None, the weight w[i] applies to the unsquared residual y[i] - y_hat[i] at x[i]. Ideally the weights are chosen so that the errors of the products w[i]*y[i] all have the same variance. When using inverse-variance weighting, use w[i] = 1/sigma(y[i]). The default value is None. New in version 1.5.0.
window{[beg, end]}, optional
Window to use for the returned series. The default value is the default class domain New in version 1.6.0. Returns
new_seriesseries
A series that represents the least squares fit to the data and has the domain and window specified in the call. If the coefficients for the unscaled and unshifted basis polynomials are of interest, do new_series.convert().coef.
[resid, rank, sv, rcond]list
These values are only returned if full == True resid – sum of squared residuals of the least squares fit rank – the numerical rank of the scaled Vandermonde matrix sv – singular values of the scaled Vandermonde matrix rcond – value of rcond. For more details, see linalg.lstsq. | numpy.reference.generated.numpy.polynomial.legendre.legendre.fit |
numpy.polynomial.legendre.Legendre.fromroots method classmethod polynomial.legendre.Legendre.fromroots(roots, domain=[], window=None)[source]
Return series instance that has the specified roots. Returns a series representing the product (x - r[0])*(x - r[1])*...*(x - r[n-1]), where r is a list of roots. Parameters
rootsarray_like
List of roots.
domain{[], None, array_like}, optional
Domain for the resulting series. If None the domain is the interval from the smallest root to the largest. If [] the domain is the class domain. The default is [].
window{None, array_like}, optional
Window for the returned series. If None the class window is used. The default is None. Returns
new_seriesseries
Series with the specified roots. | numpy.reference.generated.numpy.polynomial.legendre.legendre.fromroots |
numpy.polynomial.legendre.Legendre.has_samecoef method polynomial.legendre.Legendre.has_samecoef(other)[source]
Check if coefficients match. New in version 1.6.0. Parameters
otherclass instance
The other class must have the coef attribute. Returns
boolboolean
True if the coefficients are the same, False otherwise. | numpy.reference.generated.numpy.polynomial.legendre.legendre.has_samecoef |
numpy.polynomial.legendre.Legendre.has_samedomain method polynomial.legendre.Legendre.has_samedomain(other)[source]
Check if domains match. New in version 1.6.0. Parameters
otherclass instance
The other class must have the domain attribute. Returns
boolboolean
True if the domains are the same, False otherwise. | numpy.reference.generated.numpy.polynomial.legendre.legendre.has_samedomain |
numpy.polynomial.legendre.Legendre.has_sametype method polynomial.legendre.Legendre.has_sametype(other)[source]
Check if types match. New in version 1.7.0. Parameters
otherobject
Class instance. Returns
boolboolean
True if other is same class as self | numpy.reference.generated.numpy.polynomial.legendre.legendre.has_sametype |
numpy.polynomial.legendre.Legendre.has_samewindow method polynomial.legendre.Legendre.has_samewindow(other)[source]
Check if windows match. New in version 1.6.0. Parameters
otherclass instance
The other class must have the window attribute. Returns
boolboolean
True if the windows are the same, False otherwise. | numpy.reference.generated.numpy.polynomial.legendre.legendre.has_samewindow |
numpy.polynomial.legendre.Legendre.identity method classmethod polynomial.legendre.Legendre.identity(domain=None, window=None)[source]
Identity function. If p is the returned series, then p(x) == x for all values of x. Parameters
domain{None, array_like}, optional
If given, the array must be of the form [beg, end], where beg and end are the endpoints of the domain. If None is given then the class domain is used. The default is None.
window{None, array_like}, optional
If given, the resulting array must be if the form [beg, end], where beg and end are the endpoints of the window. If None is given then the class window is used. The default is None. Returns
new_seriesseries
Series of representing the identity. | numpy.reference.generated.numpy.polynomial.legendre.legendre.identity |
numpy.polynomial.legendre.Legendre.integ method polynomial.legendre.Legendre.integ(m=1, k=[], lbnd=None)[source]
Integrate. Return a series instance that is the definite integral of the current series. Parameters
mnon-negative int
The number of integrations to perform.
karray_like
Integration constants. The first constant is applied to the first integration, the second to the second, and so on. The list of values must less than or equal to m in length and any missing values are set to zero.
lbndScalar
The lower bound of the definite integral. Returns
new_seriesseries
A new series representing the integral. The domain is the same as the domain of the integrated series. | numpy.reference.generated.numpy.polynomial.legendre.legendre.integ |
numpy.polynomial.legendre.Legendre.linspace method polynomial.legendre.Legendre.linspace(n=100, domain=None)[source]
Return x, y values at equally spaced points in domain. Returns the x, y values at n linearly spaced points across the domain. Here y is the value of the polynomial at the points x. By default the domain is the same as that of the series instance. This method is intended mostly as a plotting aid. New in version 1.5.0. Parameters
nint, optional
Number of point pairs to return. The default value is 100.
domain{None, array_like}, optional
If not None, the specified domain is used instead of that of the calling instance. It should be of the form [beg,end]. The default is None which case the class domain is used. Returns
x, yndarray
x is equal to linspace(self.domain[0], self.domain[1], n) and y is the series evaluated at element of x. | numpy.reference.generated.numpy.polynomial.legendre.legendre.linspace |
numpy.polynomial.legendre.Legendre.mapparms method polynomial.legendre.Legendre.mapparms()[source]
Return the mapping parameters. The returned values define a linear map off + scl*x that is applied to the input arguments before the series is evaluated. The map depends on the domain and window; if the current domain is equal to the window the resulting map is the identity. If the coefficients of the series instance are to be used by themselves outside this class, then the linear function must be substituted for the x in the standard representation of the base polynomials. Returns
off, sclfloat or complex
The mapping function is defined by off + scl*x. Notes If the current domain is the interval [l1, r1] and the window is [l2, r2], then the linear mapping function L is defined by the equations: L(l1) = l2
L(r1) = r2 | numpy.reference.generated.numpy.polynomial.legendre.legendre.mapparms |
numpy.polynomial.legendre.Legendre.roots method polynomial.legendre.Legendre.roots()[source]
Return the roots of the series polynomial. Compute the roots for the series. Note that the accuracy of the roots decrease the further outside the domain they lie. Returns
rootsndarray
Array containing the roots of the series. | numpy.reference.generated.numpy.polynomial.legendre.legendre.roots |
numpy.polynomial.legendre.Legendre.trim method polynomial.legendre.Legendre.trim(tol=0)[source]
Remove trailing coefficients Remove trailing coefficients until a coefficient is reached whose absolute value greater than tol or the beginning of the series is reached. If all the coefficients would be removed the series is set to [0]. A new series instance is returned with the new coefficients. The current instance remains unchanged. Parameters
tolnon-negative number.
All trailing coefficients less than tol will be removed. Returns
new_seriesseries
New instance of series with trimmed coefficients. | numpy.reference.generated.numpy.polynomial.legendre.legendre.trim |
numpy.polynomial.legendre.Legendre.truncate method polynomial.legendre.Legendre.truncate(size)[source]
Truncate series to length size. Reduce the series to length size by discarding the high degree terms. The value of size must be a positive integer. This can be useful in least squares where the coefficients of the high degree terms may be very small. Parameters
sizepositive int
The series is reduced to length size by discarding the high degree terms. The value of size must be a positive integer. Returns
new_seriesseries
New instance of series with truncated coefficients. | numpy.reference.generated.numpy.polynomial.legendre.legendre.truncate |
numpy.polynomial.legendre.legfit polynomial.legendre.legfit(x, y, deg, rcond=None, full=False, w=None)[source]
Least squares fit of Legendre series to data. Return the coefficients of a Legendre series of degree deg that is the least squares fit to the data values y given at points x. If y is 1-D the returned coefficients will also be 1-D. If y is 2-D multiple fits are done, one for each column of y, and the resulting coefficients are stored in the corresponding columns of a 2-D return. The fitted polynomial(s) are in the form \[p(x) = c_0 + c_1 * L_1(x) + ... + c_n * L_n(x),\] where n is deg. Parameters
xarray_like, shape (M,)
x-coordinates of the M sample points (x[i], y[i]).
yarray_like, shape (M,) or (M, K)
y-coordinates of the sample points. Several data sets of sample points sharing the same x-coordinates can be fitted at once by passing in a 2D-array that contains one dataset per column.
degint or 1-D array_like
Degree(s) of the fitting polynomials. If deg is a single integer all terms up to and including the deg’th term are included in the fit. For NumPy versions >= 1.11.0 a list of integers specifying the degrees of the terms to include may be used instead.
rcondfloat, optional
Relative condition number of the fit. Singular values smaller than this relative to the largest singular value will be ignored. The default value is len(x)*eps, where eps is the relative precision of the float type, about 2e-16 in most cases.
fullbool, optional
Switch determining nature of return value. When it is False (the default) just the coefficients are returned, when True diagnostic information from the singular value decomposition is also returned.
warray_like, shape (M,), optional
Weights. If not None, the weight w[i] applies to the unsquared residual y[i] - y_hat[i] at x[i]. Ideally the weights are chosen so that the errors of the products w[i]*y[i] all have the same variance. When using inverse-variance weighting, use w[i] = 1/sigma(y[i]). The default value is None. New in version 1.5.0. Returns
coefndarray, shape (M,) or (M, K)
Legendre coefficients ordered from low to high. If y was 2-D, the coefficients for the data in column k of y are in column k. If deg is specified as a list, coefficients for terms not included in the fit are set equal to zero in the returned coef.
[residuals, rank, singular_values, rcond]list
These values are only returned if full == True residuals – sum of squared residuals of the least squares fit rank – the numerical rank of the scaled Vandermonde matrix singular_values – singular values of the scaled Vandermonde matrix rcond – value of rcond. For more details, see numpy.linalg.lstsq. Warns
RankWarning
The rank of the coefficient matrix in the least-squares fit is deficient. The warning is only raised if full == False. The warnings can be turned off by >>> import warnings
>>> warnings.simplefilter('ignore', np.RankWarning)
See also numpy.polynomial.polynomial.polyfit
numpy.polynomial.chebyshev.chebfit
numpy.polynomial.laguerre.lagfit
numpy.polynomial.hermite.hermfit
numpy.polynomial.hermite_e.hermefit
legval
Evaluates a Legendre series. legvander
Vandermonde matrix of Legendre series. legweight
Legendre weight function (= 1). numpy.linalg.lstsq
Computes a least-squares fit from the matrix. scipy.interpolate.UnivariateSpline
Computes spline fits. Notes The solution is the coefficients of the Legendre series p that minimizes the sum of the weighted squared errors \[E = \sum_j w_j^2 * |y_j - p(x_j)|^2,\] where \(w_j\) are the weights. This problem is solved by setting up as the (typically) overdetermined matrix equation \[V(x) * c = w * y,\] where V is the weighted pseudo Vandermonde matrix of x, c are the coefficients to be solved for, w are the weights, and y are the observed values. This equation is then solved using the singular value decomposition of V. If some of the singular values of V are so small that they are neglected, then a RankWarning will be issued. This means that the coefficient values may be poorly determined. Using a lower order fit will usually get rid of the warning. The rcond parameter can also be set to a value smaller than its default, but the resulting fit may be spurious and have large contributions from roundoff error. Fits using Legendre series are usually better conditioned than fits using power series, but much can depend on the distribution of the sample points and the smoothness of the data. If the quality of the fit is inadequate splines may be a good alternative. References 1
Wikipedia, “Curve fitting”, https://en.wikipedia.org/wiki/Curve_fitting | numpy.reference.generated.numpy.polynomial.legendre.legfit |
numpy.polynomial.legendre.legfromroots polynomial.legendre.legfromroots(roots)[source]
Generate a Legendre series with given roots. The function returns the coefficients of the polynomial \[p(x) = (x - r_0) * (x - r_1) * ... * (x - r_n),\] in Legendre form, where the r_n are the roots specified in roots. If a zero has multiplicity n, then it must appear in roots n times. For instance, if 2 is a root of multiplicity three and 3 is a root of multiplicity 2, then roots looks something like [2, 2, 2, 3, 3]. The roots can appear in any order. If the returned coefficients are c, then \[p(x) = c_0 + c_1 * L_1(x) + ... + c_n * L_n(x)\] The coefficient of the last term is not generally 1 for monic polynomials in Legendre form. Parameters
rootsarray_like
Sequence containing the roots. Returns
outndarray
1-D array of coefficients. If all roots are real then out is a real array, if some of the roots are complex, then out is complex even if all the coefficients in the result are real (see Examples below). See also numpy.polynomial.polynomial.polyfromroots
numpy.polynomial.chebyshev.chebfromroots
numpy.polynomial.laguerre.lagfromroots
numpy.polynomial.hermite.hermfromroots
numpy.polynomial.hermite_e.hermefromroots
Examples >>> import numpy.polynomial.legendre as L
>>> L.legfromroots((-1,0,1)) # x^3 - x relative to the standard basis
array([ 0. , -0.4, 0. , 0.4])
>>> j = complex(0,1)
>>> L.legfromroots((-j,j)) # x^2 + 1 relative to the standard basis
array([ 1.33333333+0.j, 0.00000000+0.j, 0.66666667+0.j]) # may vary | numpy.reference.generated.numpy.polynomial.legendre.legfromroots |
numpy.polynomial.legendre.leggauss polynomial.legendre.leggauss(deg)[source]
Gauss-Legendre quadrature. Computes the sample points and weights for Gauss-Legendre quadrature. These sample points and weights will correctly integrate polynomials of degree \(2*deg - 1\) or less over the interval \([-1, 1]\) with the weight function \(f(x) = 1\). Parameters
degint
Number of sample points and weights. It must be >= 1. Returns
xndarray
1-D ndarray containing the sample points.
yndarray
1-D ndarray containing the weights. Notes New in version 1.7.0. The results have only been tested up to degree 100, higher degrees may be problematic. The weights are determined by using the fact that \[w_k = c / (L'_n(x_k) * L_{n-1}(x_k))\] where \(c\) is a constant independent of \(k\) and \(x_k\) is the k’th root of \(L_n\), and then scaling the results to get the right value when integrating 1. | numpy.reference.generated.numpy.polynomial.legendre.leggauss |
numpy.polynomial.legendre.leggrid2d polynomial.legendre.leggrid2d(x, y, c)[source]
Evaluate a 2-D Legendre series on the Cartesian product of x and y. This function returns the values: \[p(a,b) = \sum_{i,j} c_{i,j} * L_i(a) * L_j(b)\] where the points (a, b) consist of all pairs formed by taking a from x and b from y. The resulting points form a grid with x in the first dimension and y in the second. The parameters x and y are converted to arrays only if they are tuples or a lists, otherwise they are treated as a scalars. In either case, either x and y or their elements must support multiplication and addition both with themselves and with the elements of c. If c has fewer than two dimensions, ones are implicitly appended to its shape to make it 2-D. The shape of the result will be c.shape[2:] + x.shape + y.shape. Parameters
x, yarray_like, compatible objects
The two dimensional series is evaluated at the points in the Cartesian product of x and y. If x or y is a list or tuple, it is first converted to an ndarray, otherwise it is left unchanged and, if it isn’t an ndarray, it is treated as a scalar.
carray_like
Array of coefficients ordered so that the coefficient of the term of multi-degree i,j is contained in c[i,j]. If c has dimension greater than two the remaining indices enumerate multiple sets of coefficients. Returns
valuesndarray, compatible object
The values of the two dimensional Chebyshev series at points in the Cartesian product of x and y. See also
legval, legval2d, legval3d, leggrid3d
Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.legendre.leggrid2d |
numpy.polynomial.legendre.leggrid3d polynomial.legendre.leggrid3d(x, y, z, c)[source]
Evaluate a 3-D Legendre series on the Cartesian product of x, y, and z. This function returns the values: \[p(a,b,c) = \sum_{i,j,k} c_{i,j,k} * L_i(a) * L_j(b) * L_k(c)\] where the points (a, b, c) consist of all triples formed by taking a from x, b from y, and c from z. The resulting points form a grid with x in the first dimension, y in the second, and z in the third. The parameters x, y, and z are converted to arrays only if they are tuples or a lists, otherwise they are treated as a scalars. In either case, either x, y, and z or their elements must support multiplication and addition both with themselves and with the elements of c. If c has fewer than three dimensions, ones are implicitly appended to its shape to make it 3-D. The shape of the result will be c.shape[3:] + x.shape + y.shape + z.shape. Parameters
x, y, zarray_like, compatible objects
The three dimensional series is evaluated at the points in the Cartesian product of x, y, and z. If x,`y`, or z is a list or tuple, it is first converted to an ndarray, otherwise it is left unchanged and, if it isn’t an ndarray, it is treated as a scalar.
carray_like
Array of coefficients ordered so that the coefficients for terms of degree i,j are contained in c[i,j]. If c has dimension greater than two the remaining indices enumerate multiple sets of coefficients. Returns
valuesndarray, compatible object
The values of the two dimensional polynomial at points in the Cartesian product of x and y. See also
legval, legval2d, leggrid2d, legval3d
Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.legendre.leggrid3d |
numpy.polynomial.legendre.legint polynomial.legendre.legint(c, m=1, k=[], lbnd=0, scl=1, axis=0)[source]
Integrate a Legendre series. Returns the Legendre series coefficients c integrated m times from lbnd along axis. At each iteration the resulting series is multiplied by scl and an integration constant, k, is added. The scaling factor is for use in a linear change of variable. (“Buyer beware”: note that, depending on what one is doing, one may want scl to be the reciprocal of what one might expect; for more information, see the Notes section below.) The argument c is an array of coefficients from low to high degree along each axis, e.g., [1,2,3] represents the series L_0 + 2*L_1 + 3*L_2 while [[1,2],[1,2]] represents 1*L_0(x)*L_0(y) + 1*L_1(x)*L_0(y) + 2*L_0(x)*L_1(y) +
2*L_1(x)*L_1(y) if axis=0 is x and axis=1 is y. Parameters
carray_like
Array of Legendre series coefficients. If c is multidimensional the different axis correspond to different variables with the degree in each axis given by the corresponding index.
mint, optional
Order of integration, must be positive. (Default: 1)
k{[], list, scalar}, optional
Integration constant(s). The value of the first integral at lbnd is the first value in the list, the value of the second integral at lbnd is the second value, etc. If k == [] (the default), all constants are set to zero. If m == 1, a single scalar can be given instead of a list.
lbndscalar, optional
The lower bound of the integral. (Default: 0)
sclscalar, optional
Following each integration the result is multiplied by scl before the integration constant is added. (Default: 1)
axisint, optional
Axis over which the integral is taken. (Default: 0). New in version 1.7.0. Returns
Sndarray
Legendre series coefficient array of the integral. Raises
ValueError
If m < 0, len(k) > m, np.ndim(lbnd) != 0, or np.ndim(scl) != 0. See also legder
Notes Note that the result of each integration is multiplied by scl. Why is this important to note? Say one is making a linear change of variable \(u = ax + b\) in an integral relative to x. Then \(dx = du/a\), so one will need to set scl equal to \(1/a\) - perhaps not what one would have first thought. Also note that, in general, the result of integrating a C-series needs to be “reprojected” onto the C-series basis set. Thus, typically, the result of this function is “unintuitive,” albeit correct; see Examples section below. Examples >>> from numpy.polynomial import legendre as L
>>> c = (1,2,3)
>>> L.legint(c)
array([ 0.33333333, 0.4 , 0.66666667, 0.6 ]) # may vary
>>> L.legint(c, 3)
array([ 1.66666667e-02, -1.78571429e-02, 4.76190476e-02, # may vary
-1.73472348e-18, 1.90476190e-02, 9.52380952e-03])
>>> L.legint(c, k=3)
array([ 3.33333333, 0.4 , 0.66666667, 0.6 ]) # may vary
>>> L.legint(c, lbnd=-2)
array([ 7.33333333, 0.4 , 0.66666667, 0.6 ]) # may vary
>>> L.legint(c, scl=2)
array([ 0.66666667, 0.8 , 1.33333333, 1.2 ]) # may vary | numpy.reference.generated.numpy.polynomial.legendre.legint |
numpy.polynomial.legendre.legline polynomial.legendre.legline(off, scl)[source]
Legendre series whose graph is a straight line. Parameters
off, sclscalars
The specified line is given by off + scl*x. Returns
yndarray
This module’s representation of the Legendre series for off + scl*x. See also numpy.polynomial.polynomial.polyline
numpy.polynomial.chebyshev.chebline
numpy.polynomial.laguerre.lagline
numpy.polynomial.hermite.hermline
numpy.polynomial.hermite_e.hermeline
Examples >>> import numpy.polynomial.legendre as L
>>> L.legline(3,2)
array([3, 2])
>>> L.legval(-3, L.legline(3,2)) # should be -3
-3.0 | numpy.reference.generated.numpy.polynomial.legendre.legline |
numpy.polynomial.legendre.legmul polynomial.legendre.legmul(c1, c2)[source]
Multiply one Legendre series by another. Returns the product of two Legendre series c1 * c2. The arguments are sequences of coefficients, from lowest order “term” to highest, e.g., [1,2,3] represents the series P_0 + 2*P_1 + 3*P_2. Parameters
c1, c2array_like
1-D arrays of Legendre series coefficients ordered from low to high. Returns
outndarray
Of Legendre series coefficients representing their product. See also
legadd, legsub, legmulx, legdiv, legpow
Notes In general, the (polynomial) product of two C-series results in terms that are not in the Legendre polynomial basis set. Thus, to express the product as a Legendre series, it is necessary to “reproject” the product onto said basis set, which may produce “unintuitive” (but correct) results; see Examples section below. Examples >>> from numpy.polynomial import legendre as L
>>> c1 = (1,2,3)
>>> c2 = (3,2)
>>> L.legmul(c1,c2) # multiplication requires "reprojection"
array([ 4.33333333, 10.4 , 11.66666667, 3.6 ]) # may vary | numpy.reference.generated.numpy.polynomial.legendre.legmul |
numpy.polynomial.legendre.legmulx polynomial.legendre.legmulx(c)[source]
Multiply a Legendre series by x. Multiply the Legendre series c by x, where x is the independent variable. Parameters
carray_like
1-D array of Legendre series coefficients ordered from low to high. Returns
outndarray
Array representing the result of the multiplication. See also
legadd, legmul, legdiv, legpow
Notes The multiplication uses the recursion relationship for Legendre polynomials in the form \[xP_i(x) = ((i + 1)*P_{i + 1}(x) + i*P_{i - 1}(x))/(2i + 1)\] Examples >>> from numpy.polynomial import legendre as L
>>> L.legmulx([1,2,3])
array([ 0.66666667, 2.2, 1.33333333, 1.8]) # may vary | numpy.reference.generated.numpy.polynomial.legendre.legmulx |
numpy.polynomial.legendre.legone polynomial.legendre.legone = array([1])
An array object represents a multidimensional, homogeneous array of fixed-size items. An associated data-type object describes the format of each element in the array (its byte-order, how many bytes it occupies in memory, whether it is an integer, a floating point number, or something else, etc.) Arrays should be constructed using array, zeros or empty (refer to the See Also section below). The parameters given here refer to a low-level method (ndarray(…)) for instantiating an array. For more information, refer to the numpy module and examine the methods and attributes of an array. Parameters
(for the __new__ method; see Notes below)
shapetuple of ints
Shape of created array.
dtypedata-type, optional
Any object that can be interpreted as a numpy data type.
bufferobject exposing buffer interface, optional
Used to fill the array with data.
offsetint, optional
Offset of array data in buffer.
stridestuple of ints, optional
Strides of data in memory.
order{‘C’, ‘F’}, optional
Row-major (C-style) or column-major (Fortran-style) order. See also array
Construct an array. zeros
Create an array, each element of which is zero. empty
Create an array, but leave its allocated memory unchanged (i.e., it contains “garbage”). dtype
Create a data-type. numpy.typing.NDArray
An ndarray alias generic w.r.t. its dtype.type. Notes There are two modes of creating an array using __new__: If buffer is None, then only shape, dtype, and order are used. If buffer is an object exposing the buffer interface, then all keywords are interpreted. No __init__ method is needed because the array is fully initialized after the __new__ method. Examples These examples illustrate the low-level ndarray constructor. Refer to the See Also section above for easier ways of constructing an ndarray. First mode, buffer is None: >>> np.ndarray(shape=(2,2), dtype=float, order='F')
array([[0.0e+000, 0.0e+000], # random
[ nan, 2.5e-323]])
Second mode: >>> np.ndarray((2,), buffer=np.array([1,2,3]),
... offset=np.int_().itemsize,
... dtype=int) # offset = 1*itemsize, i.e. skip first element
array([2, 3])
Attributes
Tndarray
Transpose of the array.
databuffer
The array’s elements, in memory.
dtypedtype object
Describes the format of the elements in the array.
flagsdict
Dictionary containing information related to memory use, e.g., ‘C_CONTIGUOUS’, ‘OWNDATA’, ‘WRITEABLE’, etc.
flatnumpy.flatiter object
Flattened version of the array as an iterator. The iterator allows assignments, e.g., x.flat = 3 (See ndarray.flat for assignment examples; TODO).
imagndarray
Imaginary part of the array.
realndarray
Real part of the array.
sizeint
Number of elements in the array.
itemsizeint
The memory use of each array element in bytes.
nbytesint
The total number of bytes required to store the array data, i.e., itemsize * size.
ndimint
The array’s number of dimensions.
shapetuple of ints
Shape of the array.
stridestuple of ints
The step-size required to move from one element to the next in memory. For example, a contiguous (3, 4) array of type int16 in C-order has strides (8, 2). This implies that to move from element to element in memory requires jumps of 2 bytes. To move from row-to-row, one needs to jump 8 bytes at a time (2 * 4).
ctypesctypes object
Class containing properties of the array needed for interaction with ctypes.
basendarray
If the array is a view into another array, that array is its base (unless that array is also a view). The base array is where the array data is actually stored. | numpy.reference.generated.numpy.polynomial.legendre.legone |
numpy.polynomial.legendre.legpow polynomial.legendre.legpow(c, pow, maxpower=16)[source]
Raise a Legendre series to a power. Returns the Legendre series c raised to the power pow. The argument c is a sequence of coefficients ordered from low to high. i.e., [1,2,3] is the series P_0 + 2*P_1 + 3*P_2. Parameters
carray_like
1-D array of Legendre series coefficients ordered from low to high.
powinteger
Power to which the series will be raised
maxpowerinteger, optional
Maximum power allowed. This is mainly to limit growth of the series to unmanageable size. Default is 16 Returns
coefndarray
Legendre series of power. See also
legadd, legsub, legmulx, legmul, legdiv | numpy.reference.generated.numpy.polynomial.legendre.legpow |
numpy.polynomial.legendre.legroots polynomial.legendre.legroots(c)[source]
Compute the roots of a Legendre series. Return the roots (a.k.a. “zeros”) of the polynomial \[p(x) = \sum_i c[i] * L_i(x).\] Parameters
c1-D array_like
1-D array of coefficients. Returns
outndarray
Array of the roots of the series. If all the roots are real, then out is also real, otherwise it is complex. See also numpy.polynomial.polynomial.polyroots
numpy.polynomial.chebyshev.chebroots
numpy.polynomial.laguerre.lagroots
numpy.polynomial.hermite.hermroots
numpy.polynomial.hermite_e.hermeroots
Notes The root estimates are obtained as the eigenvalues of the companion matrix, Roots far from the origin of the complex plane may have large errors due to the numerical instability of the series for such values. Roots with multiplicity greater than 1 will also show larger errors as the value of the series near such points is relatively insensitive to errors in the roots. Isolated roots near the origin can be improved by a few iterations of Newton’s method. The Legendre series basis polynomials aren’t powers of x so the results of this function may seem unintuitive. Examples >>> import numpy.polynomial.legendre as leg
>>> leg.legroots((1, 2, 3, 4)) # 4L_3 + 3L_2 + 2L_1 + 1L_0, all real roots
array([-0.85099543, -0.11407192, 0.51506735]) # may vary | numpy.reference.generated.numpy.polynomial.legendre.legroots |
numpy.polynomial.legendre.legsub polynomial.legendre.legsub(c1, c2)[source]
Subtract one Legendre series from another. Returns the difference of two Legendre series c1 - c2. The sequences of coefficients are from lowest order term to highest, i.e., [1,2,3] represents the series P_0 + 2*P_1 + 3*P_2. Parameters
c1, c2array_like
1-D arrays of Legendre series coefficients ordered from low to high. Returns
outndarray
Of Legendre series coefficients representing their difference. See also
legadd, legmulx, legmul, legdiv, legpow
Notes Unlike multiplication, division, etc., the difference of two Legendre series is a Legendre series (without having to “reproject” the result onto the basis set) so subtraction, just like that of “standard” polynomials, is simply “component-wise.” Examples >>> from numpy.polynomial import legendre as L
>>> c1 = (1,2,3)
>>> c2 = (3,2,1)
>>> L.legsub(c1,c2)
array([-2., 0., 2.])
>>> L.legsub(c2,c1) # -C.legsub(c1,c2)
array([ 2., 0., -2.]) | numpy.reference.generated.numpy.polynomial.legendre.legsub |
numpy.polynomial.legendre.legtrim polynomial.legendre.legtrim(c, tol=0)[source]
Remove “small” “trailing” coefficients from a polynomial. “Small” means “small in absolute value” and is controlled by the parameter tol; “trailing” means highest order coefficient(s), e.g., in [0, 1, 1, 0, 0] (which represents 0 + x + x**2 + 0*x**3 + 0*x**4) both the 3-rd and 4-th order coefficients would be “trimmed.” Parameters
carray_like
1-d array of coefficients, ordered from lowest order to highest.
tolnumber, optional
Trailing (i.e., highest order) elements with absolute value less than or equal to tol (default value is zero) are removed. Returns
trimmedndarray
1-d array with trailing zeros removed. If the resulting series would be empty, a series containing a single zero is returned. Raises
ValueError
If tol < 0 See also trimseq
Examples >>> from numpy.polynomial import polyutils as pu
>>> pu.trimcoef((0,0,3,0,5,0,0))
array([0., 0., 3., 0., 5.])
>>> pu.trimcoef((0,0,1e-3,0,1e-5,0,0),1e-3) # item == tol is trimmed
array([0.])
>>> i = complex(0,1) # works for complex
>>> pu.trimcoef((3e-4,1e-3*(1-i),5e-4,2e-5*(1+i)), 1e-3)
array([0.0003+0.j , 0.001 -0.001j]) | numpy.reference.generated.numpy.polynomial.legendre.legtrim |
numpy.polynomial.legendre.legval polynomial.legendre.legval(x, c, tensor=True)[source]
Evaluate a Legendre series at points x. If c is of length n + 1, this function returns the value: \[p(x) = c_0 * L_0(x) + c_1 * L_1(x) + ... + c_n * L_n(x)\] The parameter x is converted to an array only if it is a tuple or a list, otherwise it is treated as a scalar. In either case, either x or its elements must support multiplication and addition both with themselves and with the elements of c. If c is a 1-D array, then p(x) will have the same shape as x. If c is multidimensional, then the shape of the result depends on the value of tensor. If tensor is true the shape will be c.shape[1:] + x.shape. If tensor is false the shape will be c.shape[1:]. Note that scalars have shape (,). Trailing zeros in the coefficients will be used in the evaluation, so they should be avoided if efficiency is a concern. Parameters
xarray_like, compatible object
If x is a list or tuple, it is converted to an ndarray, otherwise it is left unchanged and treated as a scalar. In either case, x or its elements must support addition and multiplication with with themselves and with the elements of c.
carray_like
Array of coefficients ordered so that the coefficients for terms of degree n are contained in c[n]. If c is multidimensional the remaining indices enumerate multiple polynomials. In the two dimensional case the coefficients may be thought of as stored in the columns of c.
tensorboolean, optional
If True, the shape of the coefficient array is extended with ones on the right, one for each dimension of x. Scalars have dimension 0 for this action. The result is that every column of coefficients in c is evaluated for every element of x. If False, x is broadcast over the columns of c for the evaluation. This keyword is useful when c is multidimensional. The default value is True. New in version 1.7.0. Returns
valuesndarray, algebra_like
The shape of the return value is described above. See also
legval2d, leggrid2d, legval3d, leggrid3d
Notes The evaluation uses Clenshaw recursion, aka synthetic division. | numpy.reference.generated.numpy.polynomial.legendre.legval |
numpy.polynomial.legendre.legval2d polynomial.legendre.legval2d(x, y, c)[source]
Evaluate a 2-D Legendre series at points (x, y). This function returns the values: \[p(x,y) = \sum_{i,j} c_{i,j} * L_i(x) * L_j(y)\] The parameters x and y are converted to arrays only if they are tuples or a lists, otherwise they are treated as a scalars and they must have the same shape after conversion. In either case, either x and y or their elements must support multiplication and addition both with themselves and with the elements of c. If c is a 1-D array a one is implicitly appended to its shape to make it 2-D. The shape of the result will be c.shape[2:] + x.shape. Parameters
x, yarray_like, compatible objects
The two dimensional series is evaluated at the points (x, y), where x and y must have the same shape. If x or y is a list or tuple, it is first converted to an ndarray, otherwise it is left unchanged and if it isn’t an ndarray it is treated as a scalar.
carray_like
Array of coefficients ordered so that the coefficient of the term of multi-degree i,j is contained in c[i,j]. If c has dimension greater than two the remaining indices enumerate multiple sets of coefficients. Returns
valuesndarray, compatible object
The values of the two dimensional Legendre series at points formed from pairs of corresponding values from x and y. See also
legval, leggrid2d, legval3d, leggrid3d
Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.legendre.legval2d |
numpy.polynomial.legendre.legval3d polynomial.legendre.legval3d(x, y, z, c)[source]
Evaluate a 3-D Legendre series at points (x, y, z). This function returns the values: \[p(x,y,z) = \sum_{i,j,k} c_{i,j,k} * L_i(x) * L_j(y) * L_k(z)\] The parameters x, y, and z are converted to arrays only if they are tuples or a lists, otherwise they are treated as a scalars and they must have the same shape after conversion. In either case, either x, y, and z or their elements must support multiplication and addition both with themselves and with the elements of c. If c has fewer than 3 dimensions, ones are implicitly appended to its shape to make it 3-D. The shape of the result will be c.shape[3:] + x.shape. Parameters
x, y, zarray_like, compatible object
The three dimensional series is evaluated at the points (x, y, z), where x, y, and z must have the same shape. If any of x, y, or z is a list or tuple, it is first converted to an ndarray, otherwise it is left unchanged and if it isn’t an ndarray it is treated as a scalar.
carray_like
Array of coefficients ordered so that the coefficient of the term of multi-degree i,j,k is contained in c[i,j,k]. If c has dimension greater than 3 the remaining indices enumerate multiple sets of coefficients. Returns
valuesndarray, compatible object
The values of the multidimensional polynomial on points formed with triples of corresponding values from x, y, and z. See also
legval, legval2d, leggrid2d, leggrid3d
Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.legendre.legval3d |
numpy.polynomial.legendre.legvander polynomial.legendre.legvander(x, deg)[source]
Pseudo-Vandermonde matrix of given degree. Returns the pseudo-Vandermonde matrix of degree deg and sample points x. The pseudo-Vandermonde matrix is defined by \[V[..., i] = L_i(x)\] where 0 <= i <= deg. The leading indices of V index the elements of x and the last index is the degree of the Legendre polynomial. If c is a 1-D array of coefficients of length n + 1 and V is the array V = legvander(x, n), then np.dot(V, c) and legval(x, c) are the same up to roundoff. This equivalence is useful both for least squares fitting and for the evaluation of a large number of Legendre series of the same degree and sample points. Parameters
xarray_like
Array of points. The dtype is converted to float64 or complex128 depending on whether any of the elements are complex. If x is scalar it is converted to a 1-D array.
degint
Degree of the resulting matrix. Returns
vanderndarray
The pseudo-Vandermonde matrix. The shape of the returned matrix is x.shape + (deg + 1,), where The last index is the degree of the corresponding Legendre polynomial. The dtype will be the same as the converted x. | numpy.reference.generated.numpy.polynomial.legendre.legvander |
numpy.polynomial.legendre.legvander2d polynomial.legendre.legvander2d(x, y, deg)[source]
Pseudo-Vandermonde matrix of given degrees. Returns the pseudo-Vandermonde matrix of degrees deg and sample points (x, y). The pseudo-Vandermonde matrix is defined by \[V[..., (deg[1] + 1)*i + j] = L_i(x) * L_j(y),\] where 0 <= i <= deg[0] and 0 <= j <= deg[1]. The leading indices of V index the points (x, y) and the last index encodes the degrees of the Legendre polynomials. If V = legvander2d(x, y, [xdeg, ydeg]), then the columns of V correspond to the elements of a 2-D coefficient array c of shape (xdeg + 1, ydeg + 1) in the order \[c_{00}, c_{01}, c_{02} ... , c_{10}, c_{11}, c_{12} ...\] and np.dot(V, c.flat) and legval2d(x, y, c) will be the same up to roundoff. This equivalence is useful both for least squares fitting and for the evaluation of a large number of 2-D Legendre series of the same degrees and sample points. Parameters
x, yarray_like
Arrays of point coordinates, all of the same shape. The dtypes will be converted to either float64 or complex128 depending on whether any of the elements are complex. Scalars are converted to 1-D arrays.
deglist of ints
List of maximum degrees of the form [x_deg, y_deg]. Returns
vander2dndarray
The shape of the returned matrix is x.shape + (order,), where \(order = (deg[0]+1)*(deg[1]+1)\). The dtype will be the same as the converted x and y. See also
legvander, legvander3d, legval2d, legval3d
Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.legendre.legvander2d |
numpy.polynomial.legendre.legvander3d polynomial.legendre.legvander3d(x, y, z, deg)[source]
Pseudo-Vandermonde matrix of given degrees. Returns the pseudo-Vandermonde matrix of degrees deg and sample points (x, y, z). If l, m, n are the given degrees in x, y, z, then The pseudo-Vandermonde matrix is defined by \[V[..., (m+1)(n+1)i + (n+1)j + k] = L_i(x)*L_j(y)*L_k(z),\] where 0 <= i <= l, 0 <= j <= m, and 0 <= j <= n. The leading indices of V index the points (x, y, z) and the last index encodes the degrees of the Legendre polynomials. If V = legvander3d(x, y, z, [xdeg, ydeg, zdeg]), then the columns of V correspond to the elements of a 3-D coefficient array c of shape (xdeg + 1, ydeg + 1, zdeg + 1) in the order \[c_{000}, c_{001}, c_{002},... , c_{010}, c_{011}, c_{012},...\] and np.dot(V, c.flat) and legval3d(x, y, z, c) will be the same up to roundoff. This equivalence is useful both for least squares fitting and for the evaluation of a large number of 3-D Legendre series of the same degrees and sample points. Parameters
x, y, zarray_like
Arrays of point coordinates, all of the same shape. The dtypes will be converted to either float64 or complex128 depending on whether any of the elements are complex. Scalars are converted to 1-D arrays.
deglist of ints
List of maximum degrees of the form [x_deg, y_deg, z_deg]. Returns
vander3dndarray
The shape of the returned matrix is x.shape + (order,), where \(order = (deg[0]+1)*(deg[1]+1)*(deg[2]+1)\). The dtype will be the same as the converted x, y, and z. See also
legvander, legvander3d, legval2d, legval3d
Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.legendre.legvander3d |
numpy.polynomial.legendre.legweight polynomial.legendre.legweight(x)[source]
Weight function of the Legendre polynomials. The weight function is \(1\) and the interval of integration is \([-1, 1]\). The Legendre polynomials are orthogonal, but not normalized, with respect to this weight function. Parameters
xarray_like
Values at which the weight function will be computed. Returns
wndarray
The weight function at x. Notes New in version 1.7.0. | numpy.reference.generated.numpy.polynomial.legendre.legweight |
Subsets and Splits