Overview
When performing PCA, the first principal component of a set of variables is the derived variable formed as a linear combination of the original variables that explains the most variance. The second principal component explains the most variance in what is left once the effect of the first component is removed, and we may proceed through iterations until all the variance is explained. PCA is most commonly used when many of the variables are highly correlated with each other and it is desirable to reduce their number to an independent set. The first principal component can equivalently be defined as a direction that maximizes the variance of the projected data. The -th principal component can be taken as a direction orthogonal to the first principal components that maximizes the variance of the projected data. For either objective, it can be shown that the principal components are eigenvectors of the data's covariance matrix. Thus, the principal components are often computed by eigendecomposition of the data covariance matrix or singular value decomposition of the data matrix. PCA is the simplest of the true eigenvector-based multivariate analyses and is closely related to factor analysis. Factor analysis typically incorporates more domain-specific assumptions about the underlying structure and solves eigenvectors of a slightly different matrix. PCA is also related to canonical correlation analysis (CCA). CCA defines coordinate systems that optimally describe the cross-covariance between two datasets while PCA defines a new orthogonal coordinate system that optimally describes variance in a single dataset. Robust and L1-norm-based variants of standard PCA have also been proposed.History
PCA was invented in 1901 by Karl Pearson, as an analogue of the principal axis theorem in mechanics; it was later independently developed and named by Harold Hotelling in the 1930s. Depending on the field of application, it is also named the discrete Karhunen–Loève transform (KLT) inIntuition
Details
PCA is defined as an orthogonal linear transformation on a real inner product space that transforms the data to a new coordinate system such that the greatest variance by some scalar projection of the data comes to lie on the first coordinate (called the first principal component), the second greatest variance on the second coordinate, and so on. Consider an data matrix, X, with column-wise zero empirical mean (the sample mean of each column has been shifted to zero), where each of the ''n'' rows represents a different repetition of the experiment, and each of the ''p'' columns gives a particular kind of feature (say, the results from a particular sensor). Mathematically, the transformation is defined by a set of size of ''p''-dimensional vectors of weights or coefficients that map each row vector of X to a new vector of principal component ''scores'' , given by : in such a way that the individual variables of t considered over the data set successively inherit the maximum possible variance from X, with each coefficient vector w constrained to be a unit vector (where is usually selected to be strictly less than to reduce dimensionality). The above may equivalently be written in matrix form as : where , , and .First component
In order to maximize variance, the first weight vector w(1) thus has to satisfy : Equivalently, writing this in matrix form gives : Since w(1) has been defined to be a unit vector, it equivalently also satisfies : The quantity to be maximised can be recognised as a Rayleigh quotient. A standard result for a positive semidefinite matrix such as XTX is that the quotient's maximum possible value is the largest eigenvalue of the matrix, which occurs when ''w'' is the corresponding eigenvector. With w(1) found, the first principal component of a data vector x(''i'') can then be given as a score ''t''1(''i'') = x(''i'') ⋅ w(1) in the transformed co-ordinates, or as the corresponding vector in the original variables, w(1).Further components
The ''k''-th component can be found by subtracting the first ''k'' − 1 principal components from X: : and then finding the weight vector which extracts the maximum variance from this new data matrix : It turns out that this gives the remaining eigenvectors of XTX, with the maximum values for the quantity in brackets given by their corresponding eigenvalues. Thus the weight vectors are eigenvectors of XTX. The ''k''-th principal component of a data vector x(''i'') can therefore be given as a score ''t''''k''(''i'') = x(''i'') ⋅ w(''k'') in the transformed coordinates, or as the corresponding vector in the space of the original variables, w(''k''), where w(''k'') is the ''k''th eigenvector of XTX. The full principal components decomposition of X can therefore be given as : where W is a ''p''-by-''p'' matrix of weights whose columns are the eigenvectors of XTX. The transpose of W is sometimes called the whitening or sphering transformation. Columns of W multiplied by the square root of corresponding eigenvalues, that is, eigenvectors scaled up by the variances, are called ''loadings'' in PCA or in Factor analysis.Covariances
XTX itself can be recognized as proportional to the empirical sample covariance matrix of the dataset XT. The sample covariance ''Q'' between two of the different principal components over the dataset is given by: : where the eigenvalue property of w(''k'') has been used to move from line 2 to line 3. However eigenvectors w(''j'') and w(''k'') corresponding to eigenvalues of a symmetric matrix are orthogonal (if the eigenvalues are different), or can be orthogonalised (if the vectors happen to share an equal repeated value). The product in the final line is therefore zero; there is no sample covariance between different principal components over the dataset. Another way to characterise the principal components transformation is therefore as the transformation to coordinates which diagonalise the empirical sample covariance matrix. In matrix form, the empirical covariance matrix for the original variables can be written : The empirical covariance matrix between the principal components becomes : where Λ is the diagonal matrix of eigenvalues ''λ''(''k'') of XTX. ''λ''(''k'') is equal to the sum of the squares over the dataset associated with each component ''k'', that is, ''λ''(''k'') = Σ''i'' ''t''''k''2(''i'') = Σ''i'' (x(''i'') ⋅ w(''k''))2.Dimensionality reduction
The transformation P = X W maps a data vector x(''i'') from an original space of ''x'' variables to a new space of ''p'' variables which are uncorrelated over the dataset. To non-dimensionalize the centered data, let ''Xc'' represent the characteristic values of data vectors ''Xi'', given by: * (maximum norm), * (mean absolute value), or * (normalized Euclidean norm), for a dataset of size ''n''. These norms are used to transform the original space of variables ''x, y'' to a new space of uncorrelated variables ''p, q'' (given ''Yc'' with same meaning), such that ; and the new variables are linearly related as: . To find the optimal linear relationship, we minimize the total squared reconstruction error: ; such that setting the derivative of the error function to zero yields: where.Singular value decomposition
The principal components transformation can also be associated with another matrix factorization, the singular value decomposition (SVD) of X, : Here Σ is an ''n''-by-''p'' rectangular diagonal matrix of positive numbers ''σ''(''k''), called the singular values of X; U is an ''n''-by-''n'' matrix, the columns of which are orthogonal unit vectors of length ''n'' called the left singular vectors of X; and W is a ''p''-by-''p'' matrix whose columns are orthogonal unit vectors of length ''p'' and called the right singular vectors of X. In terms of this factorization, the matrix XTX can be written : where is the square diagonal matrix with the singular values of X and the excess zeros chopped off that satisfies . Comparison with the eigenvector factorization of XTX establishes that the right singular vectors W of X are equivalent to the eigenvectors of XTX, while the singular values ''σ''(''k'') of are equal to the square-root of the eigenvalues ''λ''(''k'') of XTX. Using the singular value decomposition the score matrix T can be written : so each column of T is given by one of the left singular vectors of X multiplied by the corresponding singular value. This form is also the polar decomposition of T. Efficient algorithms exist to calculate the SVD of X without having to form the matrix XTX, so computing the SVD is now the standard way to calculate a principal components analysis from a data matrix, unless only a handful of components are required. As with the eigen-decomposition, a truncated score matrix TL can be obtained by considering only the first L largest singular values and their singular vectors: : The truncation of a matrix M or T using a truncated singular value decomposition in this way produces a truncated matrix that is the nearest possible matrix of rank ''L'' to the original matrix, in the sense of the difference between the two having the smallest possible Frobenius norm, a result known as the Eckart–Young theorem 936Theorem (Optimal k‑dimensional fit). Let P be an n×m data matrix whose columns have been mean‑centered and scaled, and let be its singular value decomposition. Then the best rank‑k approximation to P in the least‑squares (Frobenius‑norm) sense is , where Vk consists of the first k columns of V. Moreover, the relative residual variance is .
Further considerations
The singular values (in Σ) are the square roots of the eigenvalues of the matrix XTX. Each eigenvalue is proportional to the portion of the "variance" (more correctly of the sum of the squared distances of the points from their multidimensional mean) that is associated with each eigenvector. The sum of all the eigenvalues is equal to the sum of the squared distances of the points from their multidimensional mean. PCA essentially rotates the set of points around their mean in order to align with the principal components. This moves as much of the variance as possible (using an orthogonal transformation) into the first few dimensions. The values in the remaining dimensions, therefore, tend to be small and may be dropped with minimal loss of information (see below). PCA is often used in this manner for dimensionality reduction. PCA has the distinction of being the optimal orthogonal transformation for keeping the subspace that has largest "variance" (as defined above). This advantage, however, comes at the price of greater computational requirements if compared, for example, and when applicable, to the discrete cosine transform, and in particular to the DCT-II which is simply known as the "DCT". Nonlinear dimensionality reduction techniques tend to be more computationally demanding than PCA. PCA is sensitive to the scaling of the variables. Mathematically this sensitivity comes from the way a rescaling changes the sample‑covariance matrix that PCA diagonalises. Let be the *centered* data matrix (''n'' rows, ''p'' columns) and define the covariance If the ‑th variable is multiplied by a factor we obtain Hence the new covariance is Because the eigenvalues and eigenvectors of are those of scaled by , the principal axes rotate toward any column whose variance has been inflated, exactly as the 2‑D example below illustrates. If we have just two variables and they have the same sample variance and are completely correlated, then the PCA will entail a rotation by 45° and the "weights" (they are the cosines of rotation) for the two variables with respect to the principal component will be equal. But if we multiply all values of the first variable by 100, then the first principal component will be almost the same as that variable, with a small contribution from the other variable, whereas the second component will be almost aligned with the second original variable. This means that whenever the different variables have different units (like temperature and mass), PCA is a somewhat arbitrary method of analysis. (Different results would be obtained if one used Fahrenheit rather than Celsius for example.) Pearson's original paper was entitled "On Lines and Planes of Closest Fit to Systems of Points in Space" – "in space" implies physical Euclidean space where such concerns do not arise. One way of making the PCA less arbitrary is to use variables scaled so as to have unit variance, by standardizing the data and hence use the autocorrelation matrix instead of the autocovariance matrix as a basis for PCA. However, this compresses (or expands) the fluctuations in all dimensions of the signal space to unit variance. Classical PCA assumes the cloud of points has already been translated so its centroid is at the origin. Write each observation as Without subtracting we are in effect diagonalising where is the centered matrix. The rank‑one term often dominates, forcing the leading eigenvector to point almost exactly toward the mean and obliterating any structure in the centred part . After mean subtraction that term vanishes and the principal axes align with the true directions of maximal variance. Mean-centering is unnecessary if performing a principal components analysis on a correlation matrix, as the data are already centered after calculating correlations. Correlations are derived from the cross-product of two standard scores (Z-scores) or statistical moments (hence the name: ''Pearson Product-Moment Correlation''). Also see the article by Kromrey & Foster-Johnson (1998) on ''"Mean-centering in Moderated Regression: Much Ado About Nothing"''. Since covariances are correlations of normalized variables ( Z- or standard-scores) a PCA based on the correlation matrix of X is equal to a PCA based on the covariance matrix of Z, the standardized version of X. PCA is a popular primary technique inTable of symbols and abbreviations
Properties and limitations
Properties
Some properties of PCA include: :''Property 1'': For any integer ''q'', 1 ≤ ''q'' ≤ ''p'', consider the orthogonal linear transformation :: :where is a ''q-element'' vector and is a (''q'' × ''p'') matrix, and let be the variance- covariance matrix for . Then the trace of , denoted , is maximized by taking , where consists of the first ''q'' columns of is the transpose of . ( is not defined here) :''Property 2'': Consider again the orthonormal transformation :: :with and defined as before. Then is minimized by taking where consists of the last ''q'' columns of . The statistical implication of this property is that the last few PCs are not simply unstructured left-overs after removing the important PCs. Because these last PCs have variances as small as possible they are useful in their own right. They can help to detect unsuspected near-constant linear relationships between the elements of , and they may also be useful in regression, in selecting a subset of variables from , and in outlier detection. :''Property 3'': (Spectral decomposition of ) :: Before we look at its usage, we first look at diagonal elements, : Then, perhaps the main statistical implication of the result is that not only can we decompose the combined variances of all the elements of into decreasing contributions due to each PC, but we can also decompose the whole covariance matrix into contributions from each PC. Although not strictly decreasing, the elements of will tend to become smaller as increases, as is nonincreasing for increasing , whereas the elements of tend to stay about the same size because of the normalization constraints: .Limitations
As noted above, the results of PCA depend on the scaling of the variables. This can be cured by scaling each feature by its standard deviation, so that one ends up with dimensionless features with unital variance.Leznik, M; Tofallis, C. 200PCA and information theory
Dimensionality reduction results in a loss of information, in general. PCA-based dimensionality reduction tends to minimize that information loss, under certain signal and noise models. Under the assumption that : that is, that the data vector is the sum of the desired information-bearing signal and a noise signal one can show that PCA can be optimal for dimensionality reduction, from an information-theoretic point-of-view. In particular, Linsker showed that if is Gaussian and is Gaussian noise with a covariance matrix proportional to the identity matrix, the PCA maximizes the mutual information between the desired information and the dimensionality-reduced output . If the noise is still Gaussian and has a covariance matrix proportional to the identity matrix (that is, the components of the vector are iid), but the information-bearing signal is non-Gaussian (which is a common scenario), PCA at least minimizes an upper bound on the ''information loss'', which is defined as : The optimality of PCA is also preserved if the noise is iid and at least more Gaussian (in terms of the Kullback–Leibler divergence) than the information-bearing signal . In general, even if the above signal model holds, PCA loses its information-theoretic optimality as soon as the noise becomes dependent.Computation using the covariance method
The following is a detailed description of PCA using the covariance method as opposed to the correlation method. The goal is to transform a given data set X of dimension ''p'' to an alternative data set Y of smaller dimension ''L''. Equivalently, we are seeking to find the matrix Y, where Y is the Karhunen–Loève transform (KLT) of matrix X:Derivation using the covariance method
Let X be a ''d''-dimensional random vector expressed as column vector. Without loss of generality, assume X has zero mean. We want to find a orthonormal transformation matrix P so that PX has a diagonal covariance matrix (that is, PX is a random vector with all its distinct components pairwise uncorrelated). A quick computation assuming were unitary yields: : Hence holds if and only if were diagonalisable by . This is very constructive, as cov(X) is guaranteed to be a non-negative definite matrix and thus is guaranteed to be diagonalisable by some unitary matrix.Covariance-free computation
In practical implementations, especially with high dimensional data (large ), the naive covariance method is rarely used because it is not efficient due to high computational and memory costs of explicitly determining the covariance matrix. The covariance-free approach avoids the operations of explicitly calculating and storing the covariance matrix , instead utilizing one of matrix-free methods, for example, based on the function evaluating the product at the cost of operations.Iterative computation
One way to compute the first principal component efficientlyRoweis, Sam. "EM Algorithms for PCA and SPCA." Advances in Neural Information Processing Systems. Ed. Michael I. Jordan, Michael J. Kearns, and Sara A. Solla The MIT Press, 1998. is shown in the following pseudo-code, for a data matrix with zero mean, without ever computing its covariance matrix. = a random vector of length r = r / norm(r) do times: (a vector of length ) return This power iteration algorithm simply calculates the vector , normalizes, and places the result back in . The eigenvalue is approximated by , which is the Rayleigh quotient on the unit vector for the covariance matrix . If the largest singular value is well separated from the next largest one, the vector gets close to the first principal component of within the number of iterations , which is small relative to , at the total cost . The power iteration convergence can be accelerated without noticeably sacrificing the small cost per iteration using more advanced matrix-free methods, such as the Lanczos algorithm or the Locally Optimal Block Preconditioned Conjugate Gradient ( LOBPCG) method. Subsequent principal components can be computed one-by-one via deflation or simultaneously as a block. In the former approach, imprecisions in already computed approximate principal components additively affect the accuracy of the subsequently computed principal components, thus increasing the error with every new computation. The latter approach in the block power method replaces single-vectors and with block-vectors, matrices and . Every column of approximates one of the leading principal components, while all columns are iterated simultaneously. The main calculation is evaluation of the product . Implemented, for example, in LOBPCG, efficient blocking eliminates the accumulation of the errors, allows using high-level BLAS matrix-matrix product functions, and typically leads to faster convergence, compared to the single-vector one-by-one technique.The NIPALS method
''Non-linear iterative partial least squares (NIPALS)'' is a variant the classical power iteration with matrix deflation by subtraction implemented for computing the first few components in a principal component or partial least squares analysis. For very-high-dimensional datasets, such as those generated in the *omics sciences (for example, genomics, metabolomics) it is usually only necessary to compute the first few PCs. The non-linear iterative partial least squares (NIPALS) algorithm updates iterative approximations to the leading scores and loadings t1 and r1T by the power iteration multiplying on every iteration by X on the left and on the right, that is, calculation of the covariance matrix is avoided, just as in the matrix-free implementation of the power iterations to , based on the function evaluating the product . The matrix deflation by subtraction is performed by subtracting the outer product, t1r1T from X leaving the deflated residual matrix used to calculate the subsequent leading PCs. For large data matrices, or matrices that have a high degree of column collinearity, NIPALS suffers from loss of orthogonality of PCs due to machine precision round-off errors accumulated in each iteration and matrix deflation by subtraction. A Gram–Schmidt re-orthogonalization algorithm is applied to both the scores and the loadings at each iteration step to eliminate this loss of orthogonality. NIPALS reliance on single-vector multiplications cannot take advantage of high-level BLAS and results in slow convergence for clustered leading singular values—both these deficiencies are resolved in more sophisticated matrix-free block solvers, such as the Locally Optimal Block Preconditioned Conjugate Gradient ( LOBPCG) method.Online/sequential estimation
In an "online" or "streaming" situation with data arriving piece by piece rather than being stored in a single batch, it is useful to make an estimate of the PCA projection that can be updated sequentially. This can be done efficiently, but requires different algorithms.Qualitative variables
In PCA, it is common that we want to introduce qualitative variables as supplementary elements. For example, many quantitative variables have been measured on plants. For these plants, some qualitative variables are available as, for example, the species to which the plant belongs. These data were subjected to PCA for quantitative variables. When analyzing the results, it is natural to connect the principal components to the qualitative variable ''species''. For this, the following results are produced. * Identification, on the factorial planes, of the different species, for example, using different colors. * Representation, on the factorial planes, of the centers of gravity of plants belonging to the same species. * For each center of gravity and each axis, p-value to judge the significance of the difference between the center of gravity and origin. These results are what is called ''introducing a qualitative variable as supplementary element''. This procedure is detailed in and Husson, Lê, & Pagès (2009) and Pagès (2013). Few software offer this option in an "automatic" way. This is the case oApplications
Intelligence
The earliest application of factor analysis was in locating and measuring components of human intelligence. It was believed that intelligence had various uncorrelated components such as spatial intelligence, verbal intelligence, induction, deduction etc and that scores on these could be adduced by factor analysis from results on various tests, to give a single index known as theResidential differentiation
In 1949, Shevky and Williams introduced the theory of factorial ecology, which dominated studies of residential differentiation from the 1950s to the 1970s. Neighbourhoods in a city were recognizable or could be distinguished from one another by various characteristics which could be reduced to three by factor analysis. These were known as 'social rank' (an index of occupational status), 'familism' or family size, and 'ethnicity'; Cluster analysis could then be applied to divide the city into clusters or precincts according to values of the three key factor variables. An extensive literature developed around factorial ecology in urban geography, but the approach went out of fashion after 1980 as being methodologically primitive and having little place in postmodern geographical paradigms. One of the problems with factor analysis has always been finding convincing names for the various artificial factors. In 2000, Flood revived the factorial ecology approach to show that principal components analysis actually gave meaningful answers directly, without resorting to factor rotation. The principal components were actually dual variables or shadow prices of 'forces' pushing people together or apart in cities. The first component was 'accessibility', the classic trade-off between demand for travel and demand for space, around which classical urban economics is based. The next two components were 'disadvantage', which keeps people of similar status in separate neighbourhoods (mediated by planning), and ethnicity, where people of similar ethnic backgrounds try to co-locate. About the same time, the Australian Bureau of Statistics defined distinct indexes of advantage and disadvantage taking the first principal component of sets of key variables that were thought to be important. These SEIFA indexes are regularly published for various jurisdictions, and are used frequently in spatial analysis.Development indexes
PCA can be used as a formal method for the development of indexes. As an alternative confirmatory composite analysis has been proposed to develop and assess indexes. The City Development Index was developed by PCA from about 200 indicators of city outcomes in a 1996 survey of 254 global cities. The first principal component was subject to iterative regression, adding the original variables singly until about 90% of its variation was accounted for. The index ultimately used about 15 indicators but was a good predictor of many more variables. Its comparative value agreed very well with a subjective assessment of the condition of each city. The coefficients on items of infrastructure were roughly proportional to the average costs of providing the underlying services, suggesting the Index was actually a measure of effective physical and social investment in the city. The country-levelPopulation genetics
In 1978 Cavalli-Sforza and others pioneered the use of principal components analysis (PCA) to summarise data on variation in human gene frequencies across regions. The components showed distinctive patterns, including gradients and sinusoidal waves. They interpreted these patterns as resulting from specific ancient migration events. Since then, PCA has been ubiquitous in population genetics, with thousands of papers using PCA as a display mechanism. Genetics varies largely according to proximity, so the first two principal components actually show spatial distribution and may be used to map the relative geographical location of different population groups, thereby showing individuals who have wandered from their original locations. PCA in genetics has been technically controversial, in that the technique has been performed on discrete non-normal variables and often on binary allele markers. The lack of any measures of standard error in PCA are also an impediment to more consistent usage. In August 2022, the molecular biologist Eran Elhaik published a theoretical paper in Scientific Reports analyzing 12 PCA applications. He concluded that it was easy to manipulate the method, which, in his view, generated results that were 'erroneous, contradictory, and absurd.' Specifically, he argued, the results achieved in population genetics were characterized by cherry-picking and circular reasoning.Market research and indexes of attitude
Market research has been an extensive user of PCA. It is used to develop customer satisfaction or customer loyalty scores for products, and with clustering, to develop market segments that may be targeted with advertising campaigns, in much the same way as factorial ecology will locate geographical areas with similar characteristics. PCA rapidly transforms large amounts of data into smaller, easier-to-digest variables that can be more rapidly and readily analyzed. In any consumer questionnaire, there are series of questions designed to elicit consumer attitudes, and principal components seek out latent variables underlying these attitudes. For example, the Oxford Internet Survey in 2013 asked 2000 people about their attitudes and beliefs, and from these analysts extracted four principal component dimensions, which they identified as 'escape', 'social networking', 'efficiency', and 'problem creating'. Another example from Joe Flood in 2008 extracted an attitudinal index toward housing from 28 attitude questions in a national survey of 2697 households in Australia. The first principal component represented a general attitude toward property and home ownership. The index, or the attitude questions it embodied, could be fed into a General Linear Model of tenure choice. The strongest determinant of private renting by far was the attitude index, rather than income, marital status or household type.Quantitative finance
In quantitative finance, PCA is usedSee Ch. 9 in Michael B. Miller (2013). ''Mathematics and Statistics for Financial Risk Management'', 2nd Edition. Wiley inNeuroscience
A variant of principal components analysis is used in neuroscience to identify the specific properties of a stimulus that increases a neuron's probability of generating an action potential.Brenner, N., Bialek, W., & de Ruyter van Steveninck, R.R. (2000). This technique is known as spike-triggered covariance analysis. In a typical application an experimenter presents a white noise process as a stimulus (usually either as a sensory input to a test subject, or as a current injected directly into the neuron) and records a train of action potentials, or spikes, produced by the neuron as a result. Presumably, certain features of the stimulus make the neuron more likely to spike. In order to extract these features, the experimenter calculates the covariance matrix of the ''spike-triggered ensemble'', the set of all stimuli (defined and discretized over a finite time window, typically on the order of 100 ms) that immediately preceded a spike. The eigenvectors of the difference between the spike-triggered covariance matrix and the covariance matrix of the ''prior stimulus ensemble'' (the set of all stimuli, defined over the same length time window) then indicate the directions in theRelation with other methods
Correspondence analysis
Correspondence analysis (CA) was developed by Jean-Paul Benzécri and is conceptually similar to PCA, but scales the data (which should be non-negative) so that rows and columns are treated equivalently. It is traditionally applied to contingency tables. CA decomposes the chi-squared statistic associated to this table into orthogonal factors. Because CA is a descriptive technique, it can be applied to tables for which the chi-squared statistic is appropriate or not. Several variants of CA are available including detrended correspondence analysis and canonical correspondence analysis. One special extension is multiple correspondence analysis, which may be seen as the counterpart of principal component analysis for categorical data.Factor analysis
-means clustering
It has been asserted that the relaxed solution of -means clustering, specified by the cluster indicators, is given by the principal components, and the PCA subspace spanned by the principal directions is identical to the cluster centroid subspace. However, that PCA is a useful relaxation of -means clustering was not a new result, and it is straightforward to uncover counterexamples to the statement that the cluster centroid subspace is spanned by the principal directions.Non-negative matrix factorization
Non-negative matrix factorization (NMF) is a dimension reduction method where only non-negative elements in the matrices are used, which is therefore a promising method in astronomy, in the sense that astrophysical signals are non-negative. The PCA components are orthogonal to each other, while the NMF components are all non-negative and therefore constructs a non-orthogonal basis. In PCA, the contribution of each component is ranked based on the magnitude of its corresponding eigenvalue, which is equivalent to the fractional residual variance (FRV) in analyzing empirical data. For NMF, its components are ranked based only on the empirical FRV curves. The residual fractional eigenvalue plots, that is, as a function of component number given a total of components, for PCA have a flat plateau, where no data is captured to remove the quasi-static noise, then the curves drop quickly as an indication of over-fitting (random noise). The FRV curves for NMF is decreasing continuously when the NMF components are constructed sequentially, indicating the continuous capturing of quasi-static noise; then converge to higher levels than PCA, indicating the less over-fitting property of NMF.Iconography of correlations
It is often difficult to interpret the principal components when the data include many variables of various origins, or when some variables are qualitative. This leads the PCA user to a delicate elimination of several variables. If observations or variables have an excessive impact on the direction of the axes, they should be removed and then projected as supplementary elements. In addition, it is necessary to avoid interpreting the proximities between the points close to the center of the factorial plane.Generalizations
Sparse PCA
A particular disadvantage of PCA is that the principal components are usually linear combinations of all input variables. Sparse PCA overcomes this disadvantage by finding linear combinations that contain just a few input variables. It extends the classic method of principal component analysis (PCA) for the reduction of dimensionality of data by adding sparsity constraint on the input variables. Several approaches have been proposed, including * a regression framework, * a convex relaxation/semidefinite programming framework, * a generalized power method framework * an alternating maximization framework * forward-backward greedy search and exact methods using branch-and-bound techniques, * Bayesian formulation framework. The methodological and theoretical developments of Sparse PCA as well as its applications in scientific studies were recently reviewed in a survey paper.Nonlinear PCA
Robust PCA
While PCA finds the mathematically optimal method (as in minimizing the squared error), it is still sensitive toSimilar techniques
Independent component analysis
Independent component analysis (ICA) is directed to similar problems as principal component analysis, but finds additively separable components rather than successive approximations.Network component analysis
Given a matrix , it tries to decompose it into two matrices such that . A key difference from techniques such as PCA and ICA is that some of the entries of are constrained to be 0. Here is termed the regulatory layer. While in general such a decomposition can have multiple solutions, they prove that if the following conditions are satisfied : # has full column rank # Each column of must have at least zeroes where is the number of columns of (or alternatively the number of rows of ). The justification for this criterion is that if a node is removed from the regulatory layer along with all the output nodes connected to it, the result must still be characterized by a connectivity matrix with full column rank. # must have full row rank. then the decomposition is unique up to multiplication by a scalar.Discriminant analysis of principal components
Discriminant analysis of principal components (DAPC) is a multivariate method used to identify and describe clusters of genetically related individuals. Genetic variation is partitioned into two components: variation between groups and within groups, and it maximizes the former. Linear discriminants are linear combinations of alleles which best separate the clusters. Alleles that most contribute to this discrimination are therefore those that are the most markedly different across groups. The contributions of alleles to the groupings identified by DAPC can allow identifying regions of the genome driving the genetic divergence among groups In DAPC, data is first transformed using a principal components analysis (PCA) and subsequently clusters are identified using discriminant analysis (DA). A DAPC can be realized on R using the package Adegenet. (more infoDirectional component analysis
Directional component analysis (DCA) is a method used in the atmospheric sciences for analysing multivariate datasets. Like PCA, it allows for dimension reduction, improved visualization and improved interpretability of large data-sets. Also like PCA, it is based on a covariance matrix derived from the input dataset. The difference between PCA and DCA is that DCA additionally requires the input of a vector direction, referred to as the impact. Whereas PCA maximises explained variance, DCA maximises probability density given impact. The motivation for DCA is to find components of a multivariate dataset that are both likely (measured using probability density) and important (measured using the impact). DCA has been used to find the most likely and most serious heat-wave patterns in weather prediction ensembles , and the most likely and most impactful changes in rainfall due to climate change .Software/source code
* ALGLIB – a C++ and C# library that implements PCA and truncated PCA * Analytica – The built-in EigenDecomp function computes principal components. * ELKI – includes PCA for projection, including robust variants of PCA, as well as PCA-based clustering algorithms. * Gretl – principal component analysis can be performed either via thepca
command or via the princomp()
function.
* Julia – Supports PCA with the pca
function in the MultivariateStats package
* KNIME – A java based nodal arranging software for Analysis, in this the nodes called PCA, PCA compute, PCA Apply, PCA inverse make it easily.
* Maple (software) – The PCA command is used to perform a principal component analysis on a set of data.
* Mathematica – Implements principal component analysis with the PrincipalComponents command using both covariance and correlation methods.
princomp
and pca
(R2012b) give the principal components, while the function pcares
gives the residuals and reconstructed matrix for a low-rank PCA approximation.
* Matplotlib – Python library have a PCA package in the .mlab module.
* mlpack – Provides an implementation of principal component analysis in C++.
g03aa
routine (available in both the Fortran versions of the Library).
* NMath – Proprietary numerical library containing PCA for the .NET Framework.
* GNU Octave – Free software computational environment mostly compatible with MATLAB, the function princomp
gives the principal component.
* OpenCV
* Oracle Database 12c – Implemented via DBMS_DATA_MINING.SVDS_SCORING_MODE
by specifying setting value SVDS_SCORING_PCA
* Orange (software) – Integrates PCA in its visual programming environment. PCA displays a scree plot (degree of explained variance) where user can interactively select the number of principal components.
* Origin – Contains PCA in its Pro version.
* Qlucore – Commercial software for analyzing multivariate data with instant response using PCA.
* R – Free statistical package, the functions princomp
and prcomp
can be used for principal component analysis; prcomp
uses singular value decomposition which generally gives better numerical accuracy. Some packages that implement PCA in R, include, but are not limited to: ade4
, vegan
, ExPosition
, dimRed
, and FactoMineR
.
* SAS – Proprietary software; for example, see
* scikit-learn – Python library for machine learning which contains PCA, Probabilistic PCA, Kernel PCA, Sparse PCA and other techniques in the decomposition module.
* Scilab – Free and open-source, cross-platform numerical computational package, the function princomp
computes principal component analysis, the function pca
computes principal component analysis with standardized variables.
* SPSS – Proprietary software most commonly used by social scientists for PCA, factor analysis and associated cluster analysis.
* Weka – Java library for machine learning which contains modules for computing principal components.
See also
* Correspondence analysis (for contingency tables) * Multiple correspondence analysis (for qualitative variables) * Factor analysis of mixed data (for quantitative and qualitative variables) * Canonical correlation * CUR matrix approximation (can replace of low-rank SVD approximation) * Detrended correspondence analysis * Directional component analysis * Dynamic mode decomposition * Eigenface * Expectation–maximization algorithm * Exploratory factor analysis (Wikiversity) * Factorial code * Functional principal component analysis * Geometric data analysis * Independent component analysis * Kernel PCA * L1-norm principal component analysis * Low-rank approximation * Matrix decomposition * Non-negative matrix factorization * Nonlinear dimensionality reduction * Oja's rule * Point distribution model (PCA applied to morphometry and computer vision) * Principal component analysis (Wikibooks) * Principal component regression * Singular spectrum analysis * Singular value decomposition * Sparse PCA * Transform coding * Weighted least squaresReferences
Further reading
* Jackson, J.E. (1991). ''A User's Guide to Principal Components'' (Wiley). * * * Husson François, Lê Sébastien & Pagès Jérôme (2009). ''Exploratory Multivariate Analysis by Example Using R''. Chapman & Hall/CRC The R Series, London. 224p. * Pagès Jérôme (2014).External links
* *