Fact-checked by Grok 2 weeks ago

Permutation matrix

A permutation matrix is a square derived from the by rearranging its rows according to a of the indices, resulting in exactly one entry of in each row and each column, with all other entries being 0. For an n \times n , there are precisely n! such matrices, each corresponding to one of the n! possible permutations of \{[1](/page/1), 2, \dots, n\}. These matrices form a fundamental tool in linear algebra for representing permutations as linear transformations. Permutation matrices exhibit several key properties that underscore their importance. They are orthogonal, meaning their equals their (P^T = P^{-1}), and thus preserve the Euclidean norm when multiplying vectors. The product of two permutation matrices is another permutation matrix, corresponding to the of their associated , and the of a permutation matrix is either +1 or -1, equal to the sign of the permutation (the of the number of needed to achieve it). Left-multiplying a matrix by a permutation matrix permutes its rows, while right-multiplication permutes the columns, making them essential for reordering data in computational algorithms and solving systems of equations. In broader applications, permutation matrices play a central role in the Leibniz formula for the determinant of a general matrix, where the determinant is expressed as a signed over all . They also appear in group theory as representations of the S_n and in for optimizing matrix factorizations, such as in with partial pivoting. Their binary structure—consisting solely of 0s and 1s—facilitates efficient implementation in for tasks like and algorithms.

Definition and Representation

Correspondence to Permutations

A permutation of a is defined as a bijective \sigma: \{1, \dots, [n](/page/N+)\} \to \{1, \dots, [n](/page/N+)\}, which rearranges the of the set while preserving the number of elements. The set of all such bijections forms the S_n under composition, which has order n!. There exists a natural between the elements of the S_n and the set of n \times n permutation matrices, where a permutation matrix P_\sigma corresponding to \sigma \in S_n is the with entries P_{i,j} = [1](/page/1) if \sigma(i) = j and $0 otherwise. This correspondence associates each with a unique matrix that has exactly one $1 in each row and each column, and zeros elsewhere. For example, with n=3, the identity permutation \sigma = (1,2,3) corresponds to the identity matrix \begin{pmatrix} 1 & 0 & 0 \\ 0 & 1 & 0 \\ 0 & 0 & 1 \end{pmatrix}. The transposition (1\ 2), or \sigma = (2,1,3), corresponds to the matrix \begin{pmatrix} 0 & 1 & 0 \\ 1 & 0 & 0 \\ 0 & 0 & 1 \end{pmatrix}, where the $1s in the first two rows and columns are swapped relative to the identity. To see that the correspondence is a , note that for any \sigma \in S_n, the matrix P_\sigma is uniquely determined by placing a $1 at position (i, \sigma(i)) for each i, ensuring exactly one $1 per row and column since \sigma is bijective. Conversely, any n \times n with exactly one $1 per row and column defines a unique \sigma by setting \sigma(i) = j where the $1 in row i is in column j, and the bijectivity follows from the single $1 per column.

Explicit Matrix Construction

A permutation matrix P corresponding to a permutation \sigma of \{1, 2, \dots, n\} is constructed row-wise by placing a 1 in the i-th row at column \sigma(i), with all other entries in that row being 0, for each i = 1 to n. Mathematically, the entry P_{i,j} is given by P_{i,j} = \begin{cases} 1 & \text{if } j = \sigma(i), \\ 0 & \text{otherwise}. \end{cases} This ensures exactly one 1 per row, positioned according to the permutation mapping. An equivalent column-wise construction places a 1 in column j at row \sigma^{-1}(j), filling the matrix with 0s elsewhere, which yields the same matrix since the positions satisfy the row-wise condition reciprocally. In programming contexts, the matrix can be generated algorithmically by initializing an n \times n and setting the specified indices to 1. The following illustrates this for the row-wise approach:
function permutation_matrix(sigma, n):
    P = zeros(n, n)  // Initialize n x n matrix with zeros
    for i in 1 to n:
        j = sigma(i)
        P[i, j] = 1
    return P
This method efficiently produces the matrix in O(n) time, assuming \sigma is provided as an array or . For example, consider the 3-cycle permutation \sigma = (1\ 2\ 3), where \sigma(1) = 2, \sigma(2) = 3, \sigma(3) = 1. The resulting 3×3 permutation matrix is \begin{pmatrix} 0 & 1 & 0 \\ 0 & 0 & 1 \\ 1 & 0 & 0 \end{pmatrix}. Each row has a single 1 at the column indicated by \sigma. The mapping from permutations to permutation matrices is a bijection: no two distinct permutations yield the same matrix. To see this, note that any permutation matrix has exactly one 1 in each row and each column, defining a unique permutation \sigma by \sigma(i) = j where the 1 in row i is at column j. The single 1 per column ensures \sigma is bijective, as the images \sigma(i) are distinct and cover \{1, \dots, n\}. Conversely, any such \sigma produces a valid permutation matrix by the construction above.

Basic Actions and Properties

Permuting Rows, Columns, and Vectors

Permutation matrices serve as linear transformations that rearrange the components of vectors and the entries of matrices according to a specified permutation \sigma. For a vector \mathbf{v} \in \mathbb{R}^n and the permutation matrix P_\sigma associated with \sigma, the action is given by (P_\sigma \mathbf{v})_i = v_{\sigma^{-1}(i)} for each index i = 1, \dots, n. This formula indicates that the i-th component of the transformed vector receives the value from the \sigma^{-1}(i)-th position of the original vector, effectively reordering the entries to reflect the inverse permutation on the indices. When applied to matrices, permutation matrices enable systematic reordering of rows and columns. Specifically, left-multiplication by P_\sigma permutes the rows of a A \in \mathbb{R}^{m \times n} according to \sigma^{-1}, such that the i-th row of P_\sigma A is the \sigma^{-1}(i)-th row of A. In contrast, right-multiplication A P_\sigma permutes the columns of A by \sigma, where the j-th column of A P_\sigma is the \sigma(j)-th column of A. These operations preserve the structure and dimensions of the matrix while simply exchanging positions. To illustrate, consider a $2 \times 2 A = \begin{pmatrix} a & b \\ c & d \end{pmatrix} and the \sigma = (1\ 2), which swaps indices 1 and 2, with corresponding P_\sigma = \begin{pmatrix} 0 & 1 \\ 1 & 0 \end{pmatrix}. Then, P_\sigma A = \begin{pmatrix} 0 & 1 \\ 1 & 0 \end{pmatrix} \begin{pmatrix} a & b \\ c & d \end{pmatrix} = \begin{pmatrix} c & d \\ a & b \end{pmatrix}, permuting the rows by swapping them. Similarly, A P_\sigma = \begin{pmatrix} a & b \\ c & d \end{pmatrix} \begin{pmatrix} 0 & 1 \\ 1 & 0 \end{pmatrix} = \begin{pmatrix} b & a \\ d & c \end{pmatrix}, which swaps the columns of A. Geometrically, a permutation matrix P_\sigma represents a reordering of the standard basis vectors in the vector space \mathbb{R}^n, mapping e_j to e_{\sigma(j)} for each standard basis vector e_j. This basis reordering is a linear that preserves vector norms and inner products, as permutation matrices are orthogonal. The appearance of \sigma^{-1} in the vector action formula, rather than \sigma directly, ensures consistency with the intuitive notion of as a relabeling of positions: the value originally at position k moves to \sigma(k), so the value arriving at i originates from \sigma^{-1}(i). This inverse arises naturally from the matrix-vector multiplication, where row indices of P_\sigma select from the input vector.

Orthogonality and the Inverse-Transpose Relation

A permutation matrix P corresponding to a permutation \sigma of \{1, 2, \dots, n\} is defined such that its columns (or rows) are a rearrangement of the standard basis vectors in \mathbb{R}^n. This structure ensures that P is an orthogonal matrix, satisfying P^T P = I_n, where I_n is the n \times n identity matrix and P^T denotes the transpose of P. To verify this, consider the (i,j)-entry of the product P^T P: it equals the dot product of the i-th row of P and the j-th column of P, which is 1 if i = j (since each row and column has exactly one 1) and 0 otherwise (no overlapping 1's in distinct rows and columns). Since P is orthogonal, its inverse equals its transpose: P^{-1} = P^T. This can be confirmed directly using the permutation representation. The entry (P_\sigma^T)_{i,j} = (P_\sigma)_{j,i} = 1 if and only if \sigma(j) = i, which is equivalent to j = \sigma^{-1}(i). Thus, P_\sigma^T places a 1 in position (i, \sigma^{-1}(i)), meaning P_\sigma^T = P_{\sigma^{-1}}, the permutation matrix for the inverse permutation \sigma^{-1}. As orthogonal matrices, permutation matrices preserve the Euclidean norm and inner products of vectors, meaning they maintain lengths (\|P \mathbf{x}\| = \|\mathbf{x}\|) and angles between vectors, effectively acting as rotations or reflections within the standard basis of \mathbb{R}^n. For example, consider the n=2 transposition permutation \sigma = (1\ 2), with matrix P = \begin{pmatrix} 0 & 1 \\ 1 & 0 \end{pmatrix}. Here, P^T = P, and since P^2 = I_2, it follows that P^{-1} = P, illustrating self-inversality for this transposition.

Multiplication and Composition

Product of Permutation Matrices

The product of two permutation matrices P_\sigma and P_\tau, where \sigma, \tau \in S_n, corresponds to the permutation matrix of the \tau \circ \sigma. Specifically, the (i,j)-entry of the product P_\sigma P_\tau is computed as (P_\sigma P_\tau)_{i,j} = \sum_{k=1}^n (P_\sigma)_{i,k} (P_\tau)_{k,j}. Since each row and column of a permutation matrix contains exactly one 1, the sum equals 1 there exists a k such that (P_\sigma)_{i,k} = 1 and (P_\tau)_{k,j} = 1, meaning k = \sigma(i) and j = \tau(k). Thus, j = \tau(\sigma(i)), so the product has a 1 precisely at positions corresponding to the permutation \tau \circ \sigma, where is right-to-left (apply \sigma first, then \tau). This derivation also establishes closure: the product of any two permutation matrices is itself a permutation matrix, as it has exactly one 1 in each row and column. To see this explicitly via basis vectors, note that P_\sigma P_\tau \mathbf{e}_i = P_\sigma (\mathbf{e}_{\tau(i)}) = \mathbf{e}_{\sigma(\tau(i))} = \mathbf{e}_{(\tau \circ \sigma)(i)} for the \mathbf{e}_i, confirming the action matches P_{\tau \circ \sigma}. For a concrete example in S_3, consider \sigma = (1\ 2) and \tau = (2\ 3). The matrices are P_\sigma = \begin{pmatrix} 0 & 1 & 0 \\ 1 & 0 & 0 \\ 0 & 0 & 1 \end{pmatrix}, \quad P_\tau = \begin{pmatrix} 1 & 0 & 0 \\ 0 & 0 & 1 \\ 0 & 1 & 0 \end{pmatrix}. Their product is P_\sigma P_\tau = \begin{pmatrix} 0 & 0 & 1 \\ 1 & 0 & 0 \\ 0 & 1 & 0 \end{pmatrix}, which corresponds to \tau \circ \sigma = (1\ 3\ 2), as it maps 1 to 3, 3 to 2, and 2 to 1. In computational contexts, multiplying permutation matrices implements sequential index permutation, which is efficient for reordering data structures or simulating transformations in algorithms like or traversals.

Relation to Permutation Composition

The mapping \sigma \mapsto P_\sigma from the S_n (under \circ) to the group of n \times n permutation matrices (under ) defines a , as it is a bijective that sends the group operation in S_n to matrix multiplication in the . Specifically, for permutations \sigma, \tau \in S_n, the product satisfies P_\tau P_\sigma = P_{\tau \circ \sigma}, thereby interpreting matrix multiplication as the realization of permutation composition within the matrix group. This correspondence preserves the group structure, including the —the identity permutation maps to the I_n—and inverses, where P_{\sigma^{-1}} = P_\sigma^{-1}. The associativity of matrix multiplication directly inherits and mirrors the associativity of permutation composition, ensuring that the isomorphic groups share this fundamental property without alteration. In both settings, the operation is associative: (\rho \circ \tau) \circ \sigma = \rho \circ (\tau \circ \sigma) in S_n, and correspondingly P_\rho (P_\tau P_\sigma) = (P_\rho P_\tau) P_\sigma for the matrices. This provides insight into cycle decompositions of , as the product of permutation matrices reflects the cycle structure of the composed ; for instance, disjoint in S_n commute under , and their corresponding matrices likewise commute under multiplication. If \sigma and \tau consist of disjoint , then \sigma \circ \tau = \tau \circ \sigma, and thus P_\sigma P_\tau = P_\tau P_\sigma, highlighting how the matrix representation preserves combinatorial properties of . The construction yields the defining permutation representation of S_n, which is faithful—meaning the homomorphism is injective—and thus embeds S_n injectively into the general linear group GL_n(\mathbb{R}) via permutation matrices. This representation is canonical for capturing the action of S_n on the standard basis of \mathbb{R}^n, distinguishing it as the standard faithful realization of the symmetric group in matrix form.

Group Structure

Representation of the Symmetric Group

Permutation matrices provide a faithful of the S_n, the group of all of n elements. Specifically, the map \rho: S_n \to \mathrm{GL}(n, \mathbb{R}) defined by \rho(\sigma) = P_\sigma, where P_\sigma is the permutation matrix associated to \sigma, is an injective . This injectivity follows from the fact that distinct permutations \sigma and \tau produce matrices with 1s in different positions, ensuring \rho(\sigma) \neq \rho(\tau). The image of \rho is precisely the set of all n \times n permutation matrices, which forms a of the general linear group \mathrm{GL}(n, \mathbb{R}). This acts on the \mathbb{R}^n by permuting the vectors: for the \{e_1, \dots, e_n\}, the action satisfies \rho(\sigma) e_i = e_{\sigma(i)}. Thus, it is known as the of S_n, where group elements permute the coordinates of vectors in \mathbb{R}^n. The of this is n, matching the of \mathbb{R}^n, and the serves as a natural basis for the . The permutation representation is irreducible only for n=1, where S_1 is trivial. For n \geq 2, it is reducible, decomposing as a direct sum of the 1-dimensional trivial representation (spanned by the all-ones vector \sum e_i) and the (n-1)-dimensional standard representation, which is irreducible over \mathbb{R}. This decomposition highlights how the permutation action preserves the subspace orthogonal to the trivial part, consisting of vectors with sum zero. Historically, permutation matrices and their representations were employed in 19th-century invariant theory by Arthur Cayley and others to study polynomials invariant under linear transformations, including those induced by permutations. In modern contexts, this representation is fundamental in computational group theory, enabling algorithms for group computations via matrix operations in systems like GAP. For illustration, consider S_3, which has order 6. The permutation matrices correspond to the elements classified by cycle types: the (type (1,1,1)), three transpositions (type (2,1)), and two 3-cycles (type (3)). These are:
Cycle TypePermutation \sigmaMatrix P_\sigma
(1,1,1)id: (1)(2)(3)\begin{pmatrix} 1 & 0 & 0 \\ 0 & 1 & 0 \\ 0 & 0 & 1 \end{pmatrix}
(2,1)(12): 2→1,1→2,3→3\begin{pmatrix} 0 & 1 & 0 \\ 1 & 0 & 0 \\ 0 & 0 & 1 \end{pmatrix}
(2,1)(13): 3→1,1→3,2→2\begin{pmatrix} 0 & 0 & 1 \\ 0 & 1 & 0 \\ 1 & 0 & 0 \end{pmatrix}
(2,1)(23): 2→3,3→2,1→1\begin{pmatrix} 1 & 0 & 0 \\ 0 & 0 & 1 \\ 0 & 1 & 0 \end{pmatrix}
(3)(123): 1→2,2→3,3→1\begin{pmatrix} 0 & 0 & 1 \\ 1 & 0 & 0 \\ 0 & 1 & 0 \end{pmatrix}
(3)(132): 1→3,3→2,2→1\begin{pmatrix} 0 & 1 & 0 \\ 0 & 0 & 1 \\ 1 & 0 & 0 \end{pmatrix}
This set forms a faithful representation of S_3.

The Permutation Matrix Group

The set of all n \times n permutation matrices, denoted \{P_\sigma \mid \sigma \in S_n\}, forms a group under matrix multiplication that is isomorphic to the symmetric group S_n and thus has order n!. This group is closed under multiplication, as the product of two permutation matrices corresponds to the composition of their associated permutations, and closed under inversion, since the inverse of a permutation matrix is its transpose, which is also a permutation matrix. Furthermore, permutation matrices are orthogonal, satisfying P_\sigma^T P_\sigma = I_n, so the permutation matrix group is a finite subgroup of the orthogonal group O(n). The conjugacy classes within the permutation matrix group mirror those of S_n, determined by the cycle types of the corresponding permutations. For instance, all transposition matrices, which correspond to 2-cycles and have cycle type (2,1^{n-2}), are conjugate to each other within the group. More generally, two permutation matrices P_\sigma and P_\tau are conjugate if and only if \sigma and \tau share the same cycle structure, partitioning n into cycle lengths. The center of the permutation matrix group is trivial for n \geq 3, meaning the only matrix that commutes with every element is the identity. Additionally, the commutator subgroup, generated by all commutators [P_\sigma, P_\tau] = P_\sigma P_\tau P_\sigma^{-1} P_\tau^{-1], coincides with the subgroup of even permutation matrices, isomorphic to the alternating group A_n, for n \geq 3. In computational group theory, the permutation matrix group is implemented efficiently in libraries like and using strong generating sets and stabilizer chains, enabling algorithms for membership testing, subgroup computation, and conjugacy class enumeration that scale well for n up to hundreds as of 2025. These structures exploit the group's faithful permutation representation to minimize storage and runtime for practical applications in symbolic computation.

Doubly Stochastic Matrices

A doubly stochastic matrix is a square matrix with non-negative real entries such that the sum of the entries in each row and each column equals 1. form the extreme points (vertices) of the convex set of all such matrices, known as the Birkhoff polytope. The Birkhoff– theorem states that every doubly stochastic matrix can be expressed as a of . Specifically, for an n \times n doubly stochastic matrix D, there exist P_{\sigma_k} (for permutations \sigma_k) and non-negative coefficients \lambda_k with \sum_k \lambda_k = 1 such that D = \sum_k \lambda_k P_{\sigma_k}. The number of terms in such a decomposition is at most (n-1)^2 + 1. This theorem has applications in combinatorial optimization, particularly in solving the assignment problem, where the goal is to find a permutation matrix that minimizes the total cost of assigning tasks to agents. The Hungarian algorithm, a primal-dual method, efficiently computes such an optimal permutation matrix by reducing the problem to finding perfect matchings in a bipartite graph, with solutions corresponding to vertices of the Birkhoff polytope. For example, consider the average of the permutation matrix and the matrix corresponding to the permutation (1\ 2\ 3) for n=3: P_1 = \begin{pmatrix} 1 & 0 & 0 \\ 0 & 1 & 0 \\ 0 & 0 & 1 \end{pmatrix}, \quad P_2 = \begin{pmatrix} 0 & 1 & 0 \\ 0 & 0 & 1 \\ 1 & 0 & 0 \end{pmatrix}. Their average is \frac{1}{2} (P_1 + P_2) = \begin{pmatrix} 0.5 & 0.5 & 0 \\ 0 & 0.5 & 0.5 \\ 0.5 & 0 & 0.5 \end{pmatrix}, a with entries of 0.5 along the positions of the and the fixed points.

Restricted Permutation Matrices

Restricted permutation matrices are a subclass of permutation matrices where the positions of the 1's are constrained to avoid certain forbidden locations or substructures, often defined by combinatorial restrictions such as partial orders or pattern avoidance. In the case of restricted positions, a permutation matrix corresponds to a \sigma: \to such that (\sigma(i), i) lies in a prescribed B \subseteq \times for all i, ensuring no 1 appears in disallowed entries. More generally, these matrices arise as (0,1)-matrices with exactly one 1 per row and column that avoid specified submatrix patterns, generalizing classical permutation pattern avoidance to broader structural constraints. A prominent example involves permutation matrices corresponding to linear extensions of a poset, where the 1's in row i and column j are permitted only if i \leq j in the poset order, reflecting order-preserving bijections from the poset to a . Another key class consists of -avoiding permutation matrices, such as those avoiding the , which forbid any decreasing of length 3 in the underlying ; these matrices have no 3x3 submatrix matching the anti-diagonal of 1's. In Coxeter groups, particularly the , reduced decompositions of s impose restrictions on the matrix entries, linking to containment where certain relations are avoided in the word representation of the . The enumeration of restricted permutation matrices frequently yields closed-form combinatorial formulas tied to classical sequences. For instance, the number of 321-avoiding permutation matrices of size n equals the nth , C_n = \frac{1}{n+1} \binom{2n}{n}, reflecting the between such permutations and Dyck paths or balanced parentheses. Similarly, for mobile posets (a subclass including ribbons and d-complete posets), the number of corresponding matrices is given by n! times the of a hook-length matrix M, where M_{i,j} = 1 / \prod_{x \in P_{i,j}} h(x) for subposets P_{i,j} and hook lengths h(x), providing an exact count via linear algebra. For monotone grid classes—permutations avoiding patterns defined by monotone subsequences in a grid—the asymptotic enumeration follows from generating functions derived from the grid's dimensions. These matrices find applications in sorting networks, where a network's comparators induce restricted representable as products of permutation matrices with banded or topology-limited 1's, enabling efficient parallel with depth bounded by the graph's sorting number. In the theory of Young tableaux, every n \times n permutation matrix bijects to a pair of generalized Young tableaux of the same shape, with rows non-decreasing and columns strictly increasing, facilitating enumerative connections to representations. Recent developments in highlight restricted permutation matrices in quiver representations, where partial permutation matrices encode dimension vectors and map assignments for type A , aiding the computation of K-polynomials and of closures via permutation actions on positroid varieties.

Linear-Algebraic Properties

Determinants, Eigenvalues, and Trace

The determinant of a permutation matrix P_\sigma, where \sigma is a of \{1, \dots, n\}, equals the of the permutation, \det(P_\sigma) = \sgn(\sigma), which is either +1 or -1. This sign is given by \sgn(\sigma) = (-1)^k, where k is the number of inversions in \sigma (pairs i < j with \sigma(i) > \sigma(j)), or equivalently the of the number of even-length cycles in its cycle decomposition. To see this, apply the Leibniz formula for the : \det(A) = \sum_{\pi \in S_n} \sgn(\pi) \prod_{i=1}^n a_{i, \pi(i)}, where S_n is the on n elements. For P_\sigma, the entry (P_\sigma)_{i,j} = 1 if j = \sigma(i) and 0 otherwise, so the product \prod_{i=1}^n (P_\sigma)_{i, \pi(i)} = 1 only if \pi(i) = \sigma(i) for all i, i.e., \pi = \sigma. All other terms vanish, leaving \det(P_\sigma) = \sgn(\sigma) \cdot 1 = \sgn(\sigma). For the identity permutation I, \det(P_I) = 1 and \tr(P_I) = n; for a transposition \tau, \det(P_\tau) = -1 and \tr(P_\tau) = n-2. Permutation matrices for even permutations (those with \sgn(\sigma) = 1) thus have 1, realizing the defining of the A_n. Permutation matrices are real orthogonal, so P_\sigma^T P_\sigma = I and their eigenvalues \lambda satisfy |\lambda| = 1, lying on the unit circle in the . More precisely, the eigenvalues arise from the cycle decomposition of \sigma: if \sigma consists of disjoint cycles of lengths k_1, k_2, \dots, the eigenvalues are the k_j-th roots of unity for each cycle, with multiplicity according to the cycle structure. For a single k-cycle, these are e^{2\pi i m / k} for m = 0, 1, \dots, k-1. The trace of P_\sigma equals the number of fixed points of \sigma, since the diagonal entry (P_\sigma)_{i,i} = 1 \sigma(i) = i, and 0 otherwise; thus, \tr(P_\sigma) = \sum_{i=1}^n \mathbf{1}_{\sigma(i)=i}. The algebraic multiplicity of the eigenvalue 1 equals the number of cycles in the cycle decomposition of σ, since each cycle contributes exactly one eigenvalue 1.

Applications in Linear Transformations

Permutation matrices encode linear transformations that rearrange the coordinates of vectors according to a given of the . For a \sigma of \{1, \dots, n\}, the corresponding permutation matrix P_\sigma is defined such that its j-th column is the vector e_{\sigma(j)}, resulting in P_\sigma x having components (P_\sigma x)_i = x_{\sigma^{-1}(i)} for any x \in \mathbb{R}^n. This transformation permutes the entries of x by applying \sigma^{-1} to the indices, effectively reordering the coordinates while acting linearly on the . Multiplying a A on the left by P_\sigma permutes its rows according to \sigma, whereas right A P_\sigma permutes the columns. These operations are invertible, with P_\sigma^{-1} = P_{\sigma^{-1}}, and preserve the of linear systems Ax = b since row permutations do not alter the underlying equations. Such permutations are essential for reordering data in computational contexts, such as transforming coordinate systems or basis vectors in linear algebra applications. In numerical methods, permutation matrices play a key role in with partial pivoting to enhance stability. During elimination, if the in column k is small or zero, a P_k swaps the current row with the row containing the largest below the pivot, bringing a more suitable element to the diagonal position. The process yields the decomposition PA = [LU](/page/Lu), where P is the product of these , L is unit lower triangular, and U is upper triangular; this avoids division by near-zero elements and bounds error propagation in to roughly times the of A. Permutation matrices are orthogonal, satisfying P^T P = I, which implies they preserve the Euclidean norm \|Px\| = \|x\| and inner products \langle Px, Py \rangle = \langle x, y \rangle for all vectors x, y. This property positions them as linear isometries, useful in applications requiring undistorted geometric structures, such as coordinate permutations in optimization problems or simulations where spatial relationships must remain intact.

References

  1. [1]
    [PDF] Permutation matrices
    A permutation matrix is a square matrix obtained from the same size identity matrix by a permutation of rows. Such a matrix is always row equivalent to an ...
  2. [2]
    Permutation matrices
    Definition 3.1.​​ A permutation matrix has the rows of the identity matrix, in any order. 🔗
  3. [3]
    [PDF] 18.06.23: Determinants & Permutations - MIT
    Jun 18, 2023 · One can express a permutation very compactly, by writing down the matrix. 𝑃𝜎 = ( ̂𝑒𝜎(1). ⋯̂𝑒𝜎(𝑛) ) called the permutation matrix corresponding to ...<|control11|><|separator|>
  4. [4]
    CS 357 | Special Matrices
    A permuation matrix is a square matrix that is all zero, except for a single entry in each row and each column which is 1. We typically use P for permutation ...Missing: definition | Show results with:definition
  5. [5]
    8.1: Permutations - Mathematics LibreTexts
    Mar 5, 2021 · Definition: Permutation. A permutation \(\pi\) of \(n\) elements is a one-to-one and onto function having the set \(\{1,2,\ldots, n\}\) as both ...
  6. [6]
    [PDF] The Symmetric Group - UBC Math
    The permutation matrices were introduced in the context of row operations, since for any n × n permutation matrix P and any A ∈ Fn×n, PA is A up to the same ...
  7. [7]
    [PDF] About Permutation Matrices
    Oct 6, 2021 · The study of permutations is both ancient and modern. They can be viewed as the integers 1,2,...,n in some order or as n × n permutation.
  8. [8]
    The development of group theory - MacTutor
    Galois in 1831 was the first to really understand that the algebraic solution of an equation was related to the structure of a group le groupe of permutations ...
  9. [9]
    [PDF] Lecture 15 - Math 5111 (Algebra 1)
    Nov 2, 2020 · the determinant of the associated permutation matrix M having a 1 in the entries (i,σ(i)) for each i and 0s elsewhere. Then the fact that ...
  10. [10]
    [PDF] A generating function for all semi-magic squares and the volume of ...
    For any σ ∈ Sn, we associate σ with its corresponding permutation matrix, i.e., the n×n matrix whose (i, σ (i)) entry is 1 and zero otherwise. Throughout ...
  11. [11]
    None
    Summary of each segment:
  12. [12]
    PermutationMatrix - Wolfram Language Documentation
    PermutationMatrix[permv] represents the permutation matrix given by permutation vector permv as a structured array. PermutationMatrix[pmat] converts a ...
  13. [13]
    Permutation matrix - StatLect
    A permutation matrix is obtained by repeatedly interchanging rows and columns of an identity matrix. Each row and column has one 1 and all others 0.
  14. [14]
    Permutation Matrix -- from Wolfram MathWorld
    A permutation matrix is a matrix obtained by permuting the rows of an n×n identity matrix according to some permutation of the numbers 1 to n.
  15. [15]
    ALAFF Permutation matrices - Texas Computer Science
    The last homework shows that applying P(p) P ( p ) to a matrix A A rearranges the rows of that matrix according to the permutation indicated by the vector p. p ...
  16. [16]
    [PDF] 5. Orthogonal matrices
    Orthogonality: permutation matrices are orthogonal. • 𝐴. 𝑇. 𝐴 = 𝐼 because 𝐴 has one element equal to one in each row and column. (𝐴. 𝑇. 𝐴)𝑖𝑗 = 𝑛. ∑︁.
  17. [17]
    [PDF] a1 a2 b2 - Armin Straub
    In general, all permutation matrices P are orthogonal. Why? Because their columns are a permutation of the standard basis. And so we always have PTP = I.
  18. [18]
    [PDF] MAT 312/AMS 351 Notes and Exercises on Permutations and ...
    Proposition 1. For σ, π ∈ S(n), we have Mπσ = MπMσ; i.e. the matrix corresponding to a composition of permutations is the product.
  19. [19]
    [PDF] Math 412. The Symmetric Group Sn.
    The Symmetric Group Sn. DEFINITION: The symmetric group Sn is the group of ... We say that an n × n matrix is a permutation matrix if it can be obtained.
  20. [20]
    Representation Theory of the Symmetric Groups
    Representation Theory of the Symmetric Groups. The Okounkov-Vershik Approach, Character Formulas, and Partition Algebras.<|control11|><|separator|>
  21. [21]
    [PDF] irreducible representations of the symmetric group - UChicago Math
    This paper constructs Specht modules to characterize irreducible representations of the symmetric group, using representation theory and proving their ...
  22. [22]
    Linear representation theory of symmetric group:S3 - Groupprops
    Dec 5, 2021 · Family contexts. , and these give irreducible representations over any field of characteristic not dividing the order of the group. itself ...
  23. [23]
    Permutation Matrix - an overview | ScienceDirect Topics
    A permutation matrix is defined as an orthogonal matrix where the inverse of the matrix is its transpose, and both the inverse and the product of two ...<|control11|><|separator|>
  24. [24]
    [PDF] 21 Conjugacy Classes for Symmetric and Alternating Groups
    Proposition 21.6. Two permutations σ and τ are conjugate if and only if σ and τ have the same cycle type. 21.3 Conjugacy Classes in Sn. Conjugation in Sn can be ...<|control11|><|separator|>
  25. [25]
    [PDF] CONJUGATION IN A GROUP 1. Introduction A reflection across one ...
    We'll look at conjugate elements of Dn in Section 4 and conjugate permutations in Sn and An in Section 5. In Section 6 we will introduce some subgroups that are ...
  26. [26]
    [PDF] Algebra 2. The symmetric groups Sn.
    Dec 15, 2009 · Sn and the subgroups An of even permutations. Lemma 1. Let n > 2. (a) The center of Sn is trivial;. (b) For n > 3 the center of An is trivial.
  27. [27]
    [PDF] Altenating grouops, commutator subgroups
    Jan 22, 2024 · [2.1] Proposition: For n ≥ 2, the commutator subgroup [Sn,Sn] of the symmetric group Sn on n things is the alternating group [6] An. In ...
  28. [28]
    GAP (ref) - Chapter 43: Permutation Groups
    Many of the algorithms for permutation groups use a stabilizer chain of the group. The concepts of stabilizer chains, bases, and strong generating sets were ...
  29. [29]
    Permutation groups - SageMath Documentation
    A permutation group is a finite group whose elements are permutations of a finite set, and whose group operation is the composition of permutations.
  30. [30]
    Doubly Stochastic Matrix -- from Wolfram MathWorld
    A doubly stochastic matrix is a matrix A=(a_(ij)) such that a_(ij)>=0 and sum_(i)a_(ij)=sum_(j)a_(ij)=1 is some field for all i and j.<|control11|><|separator|>
  31. [31]
    [PDF] Notes on Birkhoff-von Neumann decomposition of doubly ... - Hal-Inria
    Abstract: Birkhoff-von Neumann (BvN) decomposition of doubly stochastic matrices expresses a double stochastic matrix as a convex combination of a number of ...
  32. [32]
    [PDF] The Hungarian method for the assignment problem
    It is clear that we can start an assignment by placing unassigned individuals in any unassigned jobs for which they qualify. Thus, we might assign individuals 1 ...
  33. [33]
    DLMF: §26.15 Permutations: Matrix Notation ‣ Properties ‣ Chapter ...
    A permutation with restricted position specifies a subset B ⊆ { 1 , 2 , … , n } × { 1 , 2 , … , n } . If ( j , k ) ∈ B , then ...
  34. [34]
    [2005.00379] Pattern-Avoiding (0,1)-Matrices - arXiv
    May 1, 2020 · We investigate pattern-avoiding (0,1)-matrices as generalizations of pattern-avoiding permutations. Our emphasis is on 123-avoiding and 321-avoiding patterns.
  35. [35]
    [PDF] Counting linear extensions of posets with determinants of hook lengths
    The number of linear extensions of mobile posets, including ribbon and d-complete posets, is given by a determinant of a matrix using hook lengths.<|separator|>
  36. [36]
    Reduced decompositions and permutation patterns
    Jul 11, 2006 · This paper generalizes that result with a detailed study of permutations via their reduced decompositions and the notion of pattern containment.Missing: matrices | Show results with:matrices
  37. [37]
    [PDF] Catalan Numbers and Permutations
    Dec 29, 2022 · permutations of length 4 avoiding both 123 and 321. They are 2143, 2413, 3142, and 3412. Table 2 shows each of these permutations, followed ...
  38. [38]
    [PDF] ON THE GROWTH OF PERMUTATION CLASSES
    First, we consider monotone grid classes of permutations. We present procedures for calculating the generating function of any class whose matrix has dimensions ...
  39. [39]
    Permutations, matrices, and generalized Young tableaux.
    Project Euclid Open Access 1970 Permutations, matrices, and generalized Young tableaux. Donald E. Knuth DOWNLOAD PDF + SAVE TO MY LIBRARY
  40. [40]
    Three combinatorial formulas for type A quiver polynomials and K-polynomials
    ### Summary of Partial Permutation Matrices in Quiver Representations
  41. [41]
    [PDF] Matrix Analysis - Anand Institute Of Mathematics
    Apr 2, 2019 · Horn is a Research Professor in the Department of Mathematics at the University of Utah. He is the author of Topics in Matrix Analysis ( ...
  42. [42]
    [PDF] Permutations and the Determinant 1 Introduction 2 Definition for and ...
    Mar 12, 2007 · Given a positive integer n ∈ Z+, a permutation of an (ordered) list of n distinct objects is any reordering of this list.
  43. [43]
  44. [44]
    [PDF] Permutations by any other name
    So the number of fixed points is equal to the sum of the diagonal entries of the matrix; this sum is called the trace. Page 21. Sym6 Six weeks of fun ...Missing: textbook | Show results with:textbook
  45. [45]
    [PDF] Gaussian Elimination with Pivoting for Solving Linear Systems
    We see that this process involves repeated use of permutation matrix Pk that interchanges rows to bring the entry of largest magnitude on or below the diagonal ...