aerosandbox.numpy.linalg#

Module Contents#

Functions#

inner(x, y[, manual])

Inner product of two arrays.

outer(x, y[, manual])

Compute the outer product of two vectors.

solve(A, b)

Solve the linear system Ax=b for x.

inv(A)

Returns the inverse of the matrix A.

pinv(A)

Returns the Moore-Penrose pseudoinverse of the matrix A.

det(A)

Returns the determinant of the matrix A.

norm(x[, ord, axis, keepdims])

Matrix or vector norm.

inv_symmetric_3x3(m11, m22, m33, m12, m23, m13)

Explicitly computes the inverse of a symmetric 3x3 matrix.

aerosandbox.numpy.linalg.inner(x, y, manual=False)[source]#

Inner product of two arrays.

See syntax here: https://numpy.org/doc/stable/reference/generated/numpy.inner.html

aerosandbox.numpy.linalg.outer(x, y, manual=False)[source]#

Compute the outer product of two vectors.

See syntax here: https://numpy.org/doc/stable/reference/generated/numpy.outer.html

aerosandbox.numpy.linalg.solve(A, b)[source]#

Solve the linear system Ax=b for x. :param A: A square matrix. :param b: A vector representing the RHS of the linear system.

Returns: The solution vector x.

aerosandbox.numpy.linalg.inv(A)[source]#

Returns the inverse of the matrix A.

See: https://numpy.org/doc/stable/reference/generated/numpy.linalg.inv.html

aerosandbox.numpy.linalg.pinv(A)[source]#

Returns the Moore-Penrose pseudoinverse of the matrix A.

See: https://numpy.org/doc/stable/reference/generated/numpy.linalg.pinv.html

aerosandbox.numpy.linalg.det(A)[source]#

Returns the determinant of the matrix A.

See: https://numpy.org/doc/stable/reference/generated/numpy.linalg.det.html

aerosandbox.numpy.linalg.norm(x, ord=None, axis=None, keepdims=False)[source]#

Matrix or vector norm.

See syntax here: https://numpy.org/doc/stable/reference/generated/numpy.linalg.norm.html

aerosandbox.numpy.linalg.inv_symmetric_3x3(m11, m22, m33, m12, m23, m13)[source]#

Explicitly computes the inverse of a symmetric 3x3 matrix.

Input matrix (note symmetry):

[m11, m12, m13] [m12, m22, m23] [m13, m23, m33]

Output matrix (note symmetry):

[a11, a12, a13] [a12, a22, a23] [a13, a23, a33]

From https://math.stackexchange.com/questions/233378/inverse-of-a-3-x-3-covariance-matrix-or-any-positive-definite-pd-matrix