How to Inverse a Matrix using NumPy Last Updated : 15 Jul, 2025 Comments Improve Suggest changes 12 Likes Like Report The inverse of a matrix is like the reciprocal of a number. When a matrix is multiplied by its inverse, the result is an identity matrix. It is used to solve equations and find unknown values.The inverse of a matrix exists only if the matrix is non-singular i.e., the determinant should not be 0. Using determinant and adjoint, we can easily find the inverse of a square matrix using the below formula:if det(A) != 0: A_inv = adj(A) / det(A)else: print("Inverse doesn't exist")Matrix Equation:=>Ax = B\\ =>A^{-1}Ax = A^{-1}B\\ =>x = A^{-1}Bwhere,A-1: The inverse of matrix Ax: The unknown variable columnB: The solution matrixInverse Matrix using NumPynumpy.linalg.inv() in the NumPy module is used to compute the inverse matrix in Python.Syntax: numpy.linalg.inv(a)Parameters: a - Matrix to be invertedReturns: Inverse of the matrix a.Example 1: This example creates a 3×3 NumPy matrix and finds its inverse using np.linalg.inv() Python import numpy as np A = np.array([[6, 1, 1], [4, -2, 5], [2, 8, 7]]) print(np.linalg.inv(A)) Output[[ 0.17647059 -0.00326797 -0.02287582] [ 0.05882353 -0.13071895 0.08496732] [-0.11764706 0.1503268 0.05228758]] Example 2:This example creates a 4×4 NumPy matrix and computes its inverse using np.linalg.inv() Python import numpy as np A = np.array([[6, 1, 1, 3], [4, -2, 5, 1], [2, 8, 7, 6], [3, 1, 9, 7]]) print(np.linalg.inv(A)) Output:[[ 0.13368984 0.10695187 0.02139037 -0.09090909] [-0.00229183 0.02673797 0.14820474 -0.12987013] [-0.12987013 0.18181818 0.06493506 -0.02597403] [ 0.11000764 -0.28342246 -0.11382735 0.23376623]]Example 3: This example computes the inverses of multiple NumPy matrices using np.linalg.inv() Python import numpy as np A = np.array([[[1., 2.], [3., 4.]], [[1, 3], [3, 5]]]) print(np.linalg.inv(A)) Output[[[-2. 1. ] [ 1.5 -0.5 ]] [[-1.25 0.75] [ 0.75 -0.25]]] Related Articles:python numpymatrix Create Quiz Comment A AmiyaRanjanRout Follow 12 Improve A AmiyaRanjanRout Follow 12 Improve Article Tags : Numpy Python-numpy Explore NumPy Tutorial - Python Library 3 min read IntroductionNumPy Introduction 6 min read Python NumPy 6 min read NumPy Array in Python 2 min read Basics of NumPy Arrays 4 min read Numpy - ndarray 3 min read Data type Object (dtype) in NumPy Python 3 min read Creating NumPy ArrayNumpy - Array Creation 5 min read numpy.arange() in Python 2 min read numpy.zeros() in Python 2 min read NumPy - Create array filled with all ones 2 min read NumPy - linspace() Function 2 min read numpy.eye() in Python 2 min read Creating a one-dimensional NumPy array 2 min read How to create an empty and a full NumPy array 2 min read Create a Numpy array filled with all zeros - Python 2 min read How to generate 2-D Gaussian array using NumPy? 2 min read How to create a vector in Python using NumPy 4 min read Python - Numpy fromrecords() method 2 min read NumPy Array ManipulationNumPy Copy and View of Array 4 min read How to Copy NumPy array into another array? 2 min read Appending values at the end of an NumPy array 4 min read How to swap columns of a given NumPy array? 4 min read Insert a new axis within a NumPy array 4 min read numpy.hstack() in Python 2 min read numpy.vstack() in python 2 min read Joining NumPy Array 3 min read Combining a One and a Two-Dimensional NumPy Array 3 min read Numpy np.ma.concatenate() method-Python 2 min read Numpy dstack() method-Python 2 min read Splitting Arrays in NumPy 6 min read How to compare two NumPy arrays? 2 min read Find the union of two NumPy arrays 2 min read Find unique rows in a NumPy array 3 min read Numpy np.unique() method-Python 2 min read numpy.trim_zeros() in Python 2 min read Matrix in NumPyMatrix manipulation in Python 4 min read numpy matrix operations | empty() function 1 min read numpy matrix operations | zeros() function 2 min read numpy matrix operations | ones() function 2 min read numpy matrix operations | eye() function 2 min read numpy matrix operations | identity() function 1 min read Adding and Subtracting Matrices in Python 2 min read Matrix Multiplication in NumPy 2 min read Numpy ndarray.dot() function | Python 2 min read NumPy | Vector Multiplication 4 min read How to calculate dot product of two vectors in Python? 3 min read Multiplication of two Matrices in Single line using Numpy in Python 3 min read Numpy np.eigvals() method - Python 1 min read How to Calculate the Determinant of a Matrix using NumPy 2 min read Numpy matrix.transpose() in Python 1 min read Python | Numpy matrix.var() 1 min read Compute the inverse of a matrix using NumPy 2 min read Operations on NumPy ArrayNumpy | Binary Operations 8 min read Numpy | Mathematical Function 9 min read Numpy - String Functions & Operations 5 min read Reshaping NumPy ArrayReshape NumPy Array - Python 2 min read Python | Numpy matrix.resize() 1 min read Python | Numpy matrix.reshape() 1 min read NumPy Array Shape 2 min read Change the dimension of a NumPy array 3 min read numpy.ndarray.resize() function - Python 1 min read Flatten a Matrix in Python using NumPy 1 min read numpy.moveaxis() function | Python 2 min read numpy.swapaxes() function - Python 2 min read Python | Numpy matrix.swapaxes() 1 min read numpy.vsplit() function | Python 2 min read numpy.hsplit() function | Python 2 min read Numpy MaskedArray.reshape() function | Python 3 min read Python | Numpy matrix.squeeze() 1 min read Indexing NumPy ArrayBasic Slicing and Advanced Indexing in NumPy 3 min read numpy.compress() in Python 2 min read Accessing Data Along Multiple Dimensions Arrays in Python Numpy 3 min read How to Access Different Rows of a Multidimensional NumPy Array 2 min read numpy.tril_indices() function | Python 1 min read Arithmetic operations on NumPyArrayNumPy Array Broadcasting 6 min read Estimation of Variable | set 1 3 min read Python: Operations on Numpy Arrays 3 min read How to use the NumPy sum function? 4 min read numpy.divide() in Python 3 min read numpy.inner() in python 1 min read Absolute Deviation and Absolute Mean Deviation using NumPy | Python 2 min read Calculate standard deviation of a Matrix in Python 2 min read numpy.gcd() in Python 2 min read Linear Algebra in NumPy ArrayNumpy | Linear Algebra 6 min read Get the QR factorization of a given NumPy array 2 min read How to get the magnitude of a vector in NumPy? 3 min read How to compute the eigenvalues and right eigenvectors of a given square array using NumPY? 2 min read Like