jax.scipy
module#
jax.scipy.cluster#
|
Assign codes from a code book to a set of observations. |
jax.scipy.fft#
|
Computes the discrete cosine transform of the input |
|
Computes the multidimensional discrete cosine transform of the input |
|
Computes the inverse discrete cosine transform of the input |
|
Computes the multidimensional inverse discrete cosine transform of the input |
jax.scipy.integrate#
|
Integrate along the given axis using the composite trapezoidal rule. |
jax.scipy.interpolate#
|
Interpolate points on a regular rectangular grid. |
jax.scipy.linalg#
|
Create a block diagonal matrix from input arrays. |
|
Factorization for Cholesky-based linear solves |
|
Solve a linear system using a Cholesky factorization |
|
Compute the Cholesky decomposition of a matrix. |
|
Compute the determinant of a matrix |
|
Compute eigenvalues and eigenvectors for a Hermitian matrix |
|
Solve the eigenvalue problem for a symmetric real tridiagonal matrix |
|
Compute the matrix exponential |
Compute the Frechet derivative of the matrix exponential. |
|
|
Evaluate a matrix-valued function |
Compute the Hessenberg form of the matrix |
|
|
Create a Hilbert matrix of order n. |
|
Return the inverse of a square matrix |
|
Compute the LU decomposition |
|
Factorization for LU-based linear solves |
|
Solve a linear system using an LU factorization |
|
Computes the polar decomposition. |
|
Compute the QR decomposition of an array |
|
Convert real Schur form to complex Schur form. |
|
Compute the Schur decomposition |
|
Solve a linear system of equations. |
|
Solve a triangular linear system of equations |
|
Compute the matrix square root |
|
Compute the singular value decomposition. |
|
Construct a Toeplitz matrix. |
jax.scipy.ndimage#
|
Map the input array to new coordinates using interpolation. |
jax.scipy.optimize#
|
Minimization of scalar function of one or more variables. |
|
Object holding optimization results. |
jax.scipy.signal#
|
Convolve two N-dimensional arrays using Fast Fourier Transform (FFT). |
|
Convolution of two N-dimensional arrays. |
|
Convolution of two 2-dimensional arrays. |
|
Cross-correlation of two N-dimensional arrays. |
|
Cross-correlation of two 2-dimensional arrays. |
|
Estimate cross power spectral density (CSD) using Welch's method. |
|
Remove linear or piecewise linear trends from data. |
|
Perform the inverse short-time Fourier transform (ISTFT). |
|
Compute the short-time Fourier transform (STFT). |
|
Estimate power spectral density (PSD) using Welch's method. |
jax.scipy.spatial.transform#
|
Rotation in 3 dimensions. |
|
Spherical Linear Interpolation of Rotations. |
jax.scipy.sparse.linalg#
|
Use Bi-Conjugate Gradient Stable iteration to solve |
|
Use Conjugate Gradient iteration to solve |
|
GMRES solves the linear system A x = b for x, given A and b. |
jax.scipy.special#
|
Generate the first N Bernoulli numbers. |
|
The beta function |
|
The regularized incomplete beta function. |
|
Natural log of the absolute value of the beta function |
|
The digamma function |
|
The entropy function |
|
The error function |
|
The complement of the error function |
|
The inverse of the error function |
|
Exponential integral function. |
Exponential integral function. |
|
|
The logistic sigmoid (expit) function |
Generalized exponential integral function. |
|
|
Factorial function |
The Fresnel integrals |
|
|
The gamma function. |
|
The regularized lower incomplete gamma function. |
|
The regularized upper incomplete gamma function. |
|
Natural log of the absolute value of the gamma function. |
|
Sign of the gamma function. |
The 1F1 hypergeometric function. |
|
|
Modified bessel function of zeroth order. |
|
Exponentially scaled modified bessel function of zeroth order. |
|
Modified bessel function of first order. |
|
Exponentially scaled modified bessel function of first order. |
|
The Kullback-Leibler divergence. |
Log Normal distribution function. |
|
|
Log-Softmax function. |
The logit function |
|
Log-sum-exp reduction. |
|
|
The associated Legendre functions (ALFs) of the first kind. |
|
The associated Legendre functions (ALFs) of the first kind. |
|
The natural log of the multivariate gamma function. |
|
Normal distribution function. |
|
The inverse of the CDF of the Normal distribution function. |
The Pochammer symbol. |
|
|
The polygamma function. |
|
The relative entropy function. |
|
Softmax function. |
|
Spence's function, also known as the dilogarithm for real values. |
|
Computes the spherical harmonics. |
Compute x*log(1 + y), returning 0 for x=0. |
|
Compute x*log(y), returning 0 for x=0. |
|
The Hurwitz zeta function. |
jax.scipy.stats#
|
Compute the mode (most common value) along an axis of an array. |
|
Compute the rank of data along an array axis. |
|
Compute the standard error of the mean. |
jax.scipy.stats.bernoulli#
|
Bernoulli log probability mass function. |
|
Bernoulli probability mass function. |
|
Bernoulli cumulative distribution function. |
|
Bernoulli percent point function. |
jax.scipy.stats.beta#
|
Beta log probability distribution function. |
|
Beta probability distribution function. |
|
Beta cumulative distribution function |
|
Beta log cumulative distribution function. |
|
Beta distribution survival function. |
|
Beta distribution log survival function. |
jax.scipy.stats.betabinom#
|
Beta-binomial log probability mass function. |
|
Beta-binomial probability mass function. |
jax.scipy.stats.binom#
|
Binomial log probability mass function. |
|
Binomial probability mass function. |
jax.scipy.stats.cauchy#
|
Cauchy log probability distribution function. |
|
Cauchy probability distribution function. |
|
Cauchy cumulative distribution function. |
|
Cauchy log cumulative distribution function. |
|
Cauchy distribution log survival function. |
|
Cauchy distribution log survival function. |
|
Cauchy distribution inverse survival function. |
|
Cauchy distribution percent point function. |
jax.scipy.stats.chi2#
|
Chi-square log probability distribution function. |
|
Chi-square probability distribution function. |
|
Chi-square cumulative distribution function. |
|
Chi-square log cumulative distribution function. |
|
Chi-square survival function. |
|
Chi-square log survival function. |
jax.scipy.stats.dirichlet#
|
Dirichlet log probability distribution function. |
|
Dirichlet probability distribution function. |
jax.scipy.stats.expon#
|
Exponential log probability distribution function. |
|
Exponential probability distribution function. |
|
Exponential log cumulative density function. |
|
Exponential cumulative density function. |
|
Exponential log survival function. |
|
Exponential survival function. |
|
Exponential survival function. |
jax.scipy.stats.gamma#
|
Gamma log probability distribution function. |
|
Gamma probability distribution function. |
|
Gamma cumulative distribution function. |
|
Gamma log cumulative distribution function. |
|
Gamma survival function. |
|
Gamma log survival function. |
jax.scipy.stats.gennorm#
|
Generalized normal cumulative distribution function. |
|
Generalized normal log probability distribution function. |
|
Generalized normal probability distribution function. |
jax.scipy.stats.geom#
|
Geometric log probability mass function. |
|
Geometric probability mass function. |
jax.scipy.stats.laplace#
|
Laplace cumulative distribution function. |
|
Laplace log probability distribution function. |
|
Laplace probability distribution function. |
jax.scipy.stats.logistic#
|
Logistic cumulative distribution function. |
|
Logistic distribution inverse survival function. |
|
Logistic log probability distribution function. |
|
Logistic probability distribution function. |
|
Logistic distribution percent point function. |
|
Logistic distribution survival function. |
jax.scipy.stats.multinomial#
|
Multinomial log probability mass function. |
|
Multinomial probability mass function. |
jax.scipy.stats.multivariate_normal#
|
Multivariate normal log probability distribution function. |
|
Multivariate normal probability distribution function. |
jax.scipy.stats.nbinom#
|
Negative-binomial log probability mass function. |
|
Negative-binomial probability mass function. |
jax.scipy.stats.norm#
|
Normal log probability distribution function. |
|
Normal probability distribution function. |
|
Normal cumulative distribution function. |
|
Normal log cumulative distribution function. |
|
Normal distribution percent point function. |
|
Normal distribution survival function. |
|
Normal distribution log survival function. |
|
Normal distribution inverse survival function. |
jax.scipy.stats.pareto#
|
Pareto log probability distribution function. |
|
Pareto probability distribution function. |
jax.scipy.stats.poisson#
|
Poisson log probability mass function. |
|
Poisson probability mass function. |
|
Poisson cumulative distribution function. |
jax.scipy.stats.t#
|
Student's T log probability distribution function. |
|
Student's T probability distribution function. |
jax.scipy.stats.truncnorm#
|
Truncated normal cumulative distribution function. |
|
Truncated normal log cumulative distribution function. |
|
Truncated normal log probability distribution function. |
|
Truncated normal distribution log survival function. |
|
Truncated normal probability distribution function. |
|
Truncated normal distribution log survival function. |
jax.scipy.stats.uniform#
|
Uniform log probability distribution function. |
|
Uniform probability distribution function. |
|
Uniform cumulative distribution function. |
|
Uniform distribution percent point function. |
jax.scipy.stats.gaussian_kde#
|
Gaussian Kernel Density Estimator |
|
Evaluate the Gaussian KDE on the given points. |
|
Integrate the distribution weighted by a Gaussian. |
|
Integrate the distribution over the given limits. |
|
Integrate the product of two Gaussian KDE distributions. |
|
Randomly sample a dataset from the estimated pdf |
Probability density function |
|
Log probability density function |
jax.scipy.stats.vonmises#
|
von Mises log probability distribution function. |
|
von Mises probability distribution function. |
jax.scipy.stats.wrapcauchy#
|
Wrapped Cauchy log probability distribution function. |
|
Wrapped Cauchy probability distribution function. |