jax.scipy package¶
jax.scipy.linalg¶
|
Create a block diagonal matrix from provided arrays. |
|
Compute the Cholesky decomposition of a matrix, to use in cho_solve |
|
Solve the linear equations A x = b, given the Cholesky factorization of A. |
|
Compute the Cholesky decomposition of a matrix. |
|
Compute the determinant of a matrix |
|
Solve a standard or generalized eigenvalue problem for a complex Hermitian or real symmetric matrix. |
|
Compute the matrix exponential using Pade approximation. |
|
Frechet derivative of the matrix exponential of A in the direction E. |
|
Compute the inverse of a matrix. |
|
Compute pivoted LU decomposition of a matrix. |
|
Compute pivoted LU decomposition of a matrix. |
|
Solve an equation system, a x = b, given the LU factorization of a |
|
Compute QR decomposition of a matrix. |
|
Solves the linear equation set |
|
Solve the equation a x = b for x, assuming a is a triangular matrix. |
|
Singular Value Decomposition. |
|
Make a copy of a matrix with elements above the kth diagonal zeroed. |
|
Make a copy of a matrix with elements below the kth diagonal zeroed. |
jax.scipy.ndimage¶
|
Map the input array to new coordinates by interpolation. |
jax.scipy.optimize¶
|
Minimization of scalar function of one or more variables. |
jax.scipy.signal¶
|
Convolve two N-dimensional arrays. |
|
Convolve two 2-dimensional arrays. |
|
Cross-correlate two N-dimensional arrays. |
|
Cross-correlate two 2-dimensional arrays. |
jax.scipy.sparse.linalg¶
|
Use Conjugate Gradient iteration to solve |
|
GMRES solves the linear system A x = b for x, given A and b. |
jax.scipy.special¶
|
Incomplete beta function. |
|
The digamma function. |
|
Elementwise function for computing entropy. |
|
Returns the error function of complex argument. |
|
Complementary error function, |
|
Inverse of the error function. |
Expit (a.k.a. |
|
|
Regularized lower incomplete gamma function. |
|
Regularized upper incomplete gamma function. |
|
Logarithm of the absolute value of the gamma function. |
|
Modified Bessel function of order 0. |
|
Exponentially scaled modified Bessel function of order 0. |
|
Modified Bessel function of order 1. |
|
Exponentially scaled modified Bessel function of order 1. |
Log Normal distribution function. |
|
Logit ufunc for ndarrays. |
|
|
Compute the log of the sum of exponentials of input elements. |
|
Returns the log of multivariate gamma, also sometimes called the |
|
Normal distribution function. |
|
The inverse of the CDF of the Normal distribution function. |
|
Polygamma functions. |
|
Compute |
|
Compute |
|
Riemann or Hurwitz zeta function. |
jax.scipy.stats¶
jax.scipy.stats.bernoulli¶
|
Log of the probability mass function at k of the given RV. |
|
Probability mass function at k of the given RV. |
jax.scipy.stats.beta¶
|
Log of the probability density function at x of the given RV. |
|
Probability density function at x of the given RV. |
jax.scipy.stats.cauchy¶
|
Log of the probability density function at x of the given RV. |
|
Probability density function at x of the given RV. |
jax.scipy.stats.dirichlet¶
|
Log of the Dirichlet probability density function. |
|
The Dirichlet probability density function. |
jax.scipy.stats.expon¶
|
Log of the probability density function at x of the given RV. |
|
Probability density function at x of the given RV. |
jax.scipy.stats.gamma¶
|
Log of the probability density function at x of the given RV. |
|
Probability density function at x of the given RV. |
jax.scipy.stats.geom¶
|
Log of the probability mass function at k of the given RV. |
|
Probability mass function at k of the given RV. |
jax.scipy.stats.laplace¶
|
Cumulative distribution function of the given RV. |
|
Log of the probability density function at x of the given RV. |
|
Probability density function at x of the given RV. |
jax.scipy.stats.logistic¶
|
Cumulative distribution function of the given RV. |
|
Inverse survival function (inverse of sf) at q of the given RV. |
|
Log of the probability density function at x of the given RV. |
|
Probability density function at x of the given RV. |
|
Percent point function (inverse of cdf) at q of the given RV. |
|
Survival function (1 - cdf) at x of the given RV. |
jax.scipy.stats.multivariate_normal¶
|
Log of the multivariate normal probability density function. |
|
Multivariate normal probability density function. |
jax.scipy.stats.norm¶
|
Cumulative distribution function of the given RV. |
|
Log of the cumulative distribution function at x of the given RV. |
|
Log of the probability density function at x of the given RV. |
|
Probability density function at x of the given RV. |
|
Percent point function (inverse of cdf) at q of the given RV. |
jax.scipy.stats.pareto¶
|
Log of the probability density function at x of the given RV. |
|
Probability density function at x of the given RV. |
jax.scipy.stats.poisson¶
|
Log of the probability mass function at k of the given RV. |
|
Probability mass function at k of the given RV. |