36
votes

I wonder if it is possible to plot pca biplot results with ggplot2. Suppose if I want to display the following biplot results with ggplot2

fit <- princomp(USArrests, cor=TRUE)
summary(fit)
biplot(fit)

Any help will be highly appreciated. Thanks

7
This thread on the ggplot2 mailing list might be a good place to start.joran
I'd recommend instead accepting MYaseen208's answer about the ggbiplot package. I had started to tweak crayola's answer (which is great, but unnecessary given the package) to do things already available in ggbiplot (e.g. removing labels).Max Ghenis

7 Answers

51
votes

Maybe this will help-- it's adapted from code I wrote some time back. It now draws arrows as well.

PCbiplot <- function(PC, x="PC1", y="PC2") {
    # PC being a prcomp object
    data <- data.frame(obsnames=row.names(PC$x), PC$x)
    plot <- ggplot(data, aes_string(x=x, y=y)) + geom_text(alpha=.4, size=3, aes(label=obsnames))
    plot <- plot + geom_hline(aes(0), size=.2) + geom_vline(aes(0), size=.2)
    datapc <- data.frame(varnames=rownames(PC$rotation), PC$rotation)
    mult <- min(
        (max(data[,y]) - min(data[,y])/(max(datapc[,y])-min(datapc[,y]))),
        (max(data[,x]) - min(data[,x])/(max(datapc[,x])-min(datapc[,x])))
        )
    datapc <- transform(datapc,
            v1 = .7 * mult * (get(x)),
            v2 = .7 * mult * (get(y))
            )
    plot <- plot + coord_equal() + geom_text(data=datapc, aes(x=v1, y=v2, label=varnames), size = 5, vjust=1, color="red")
    plot <- plot + geom_segment(data=datapc, aes(x=0, y=0, xend=v1, yend=v2), arrow=arrow(length=unit(0.2,"cm")), alpha=0.75, color="red")
    plot
}

fit <- prcomp(USArrests, scale=T)
PCbiplot(fit)

You may want to change size of text, as well as transparency and colors, to taste; it would be easy to make them parameters of the function. Note: it occurred to me that this works with prcomp but your example is with princomp. You may, again, need to adapt the code accordingly. Note2: code for geom_segment() is borrowed from the mailing list post linked from comment to OP.

PC biplot

22
votes

Here is the simplest way through ggbiplot:

library(ggbiplot)
fit <- princomp(USArrests, cor=TRUE)
biplot(fit)

enter image description here

ggbiplot(fit, labels =  rownames(USArrests))

enter image description here

12
votes

Aside from the excellent ggbiplot option, you can also use factoextra which also has a ggplot2 backend:

library("devtools")
install_github("kassambara/factoextra")
fit <- princomp(USArrests, cor=TRUE)
fviz_pca_biplot(fit)

enter image description here

Or ggord :

install_github('fawda123/ggord')
library(ggord)
ggord(fit)+theme_grey()

enter image description here

Or ggfortify :

devtools::install_github("sinhrks/ggfortify")
library(ggfortify)
ggplot2::autoplot(fit, label = TRUE, loadings.label = TRUE)

enter image description here

8
votes

If you use the excellent FactoMineR package for pca, you might find this useful for making plots with ggplot2

# Plotting the output of FactoMineR's PCA using ggplot2
#
# load libraries
library(FactoMineR)
library(ggplot2)
library(scales)
library(grid)
library(plyr)
library(gridExtra)
#
# start with a clean slate
rm(list=ls(all=TRUE)) 
#
# load example data from the FactoMineR package
data(decathlon)
#
# compute PCA
res.pca <- PCA(decathlon, quanti.sup = 11:12, quali.sup=13, graph = FALSE)
#
# extract some parts for plotting
PC1 <- res.pca$ind$coord[,1]
PC2 <- res.pca$ind$coord[,2]
labs <- rownames(res.pca$ind$coord)
PCs <- data.frame(cbind(PC1,PC2))
rownames(PCs) <- labs
#
# Just showing the individual samples...
ggplot(PCs, aes(PC1,PC2, label=rownames(PCs))) + 
  geom_text() 
#
# Now get supplementary categorical variables
cPC1 <- res.pca$quali.sup$coor[,1]
cPC2 <- res.pca$quali.sup$coor[,2]
clabs <- rownames(res.pca$quali.sup$coor)
cPCs <- data.frame(cbind(cPC1,cPC2))
rownames(cPCs) <- clabs
colnames(cPCs) <- colnames(PCs)
#
# Put samples and categorical variables (ie. grouping
# of samples) all together
p <- ggplot() + opts(aspect.ratio=1) + theme_bw(base_size = 20) 
# no data so there's nothing to plot...
# add on data 
p <- p + geom_text(data=PCs, aes(x=PC1,y=PC2,label=rownames(PCs)), size=4) 
p <- p + geom_text(data=cPCs, aes(x=cPC1,y=cPC2,label=rownames(cPCs)),size=10)
p # show plot with both layers
#
# clear the plot
dev.off()
#
# Now extract variables
#
vPC1 <- res.pca$var$coord[,1]
vPC2 <- res.pca$var$coord[,2]
vlabs <- rownames(res.pca$var$coord)
vPCs <- data.frame(cbind(vPC1,vPC2))
rownames(vPCs) <- vlabs
colnames(vPCs) <- colnames(PCs)
#
# and plot them
#
pv <- ggplot() + opts(aspect.ratio=1) + theme_bw(base_size = 20) 
# no data so there's nothing to plot
# put a faint circle there, as is customary
angle <- seq(-pi, pi, length = 50) 
df <- data.frame(x = sin(angle), y = cos(angle)) 
pv <- pv + geom_path(aes(x, y), data = df, colour="grey70") 
#
# add on arrows and variable labels
pv <- pv + geom_text(data=vPCs, aes(x=vPC1,y=vPC2,label=rownames(vPCs)), size=4) + xlab("PC1") + ylab("PC2")
pv <- pv + geom_segment(data=vPCs, aes(x = 0, y = 0, xend = vPC1*0.9, yend = vPC2*0.9), arrow = arrow(length = unit(1/2, 'picas')), color = "grey30")
pv # show plot 
#
# clear the plot
dev.off()
#
# Now put them side by side
#
library(gridExtra)
grid.arrange(p,pv,nrow=1)
# 
# Now they can be saved or exported...
#
# tidy up by deleting the plots
#
dev.off()

And here's what the final plots looks like, perhaps the text size on the left plot could be a little smaller:

enter image description here

4
votes

This will get the states plotted, though not the variables

fit.df <- as.data.frame(fit$scores)
fit.df$state <- rownames(fit.df)

library(ggplot2)
ggplot(data=fit.df,aes(x=Comp.1,y=Comp.2))+
  geom_text(aes(label=state,size=1,hjust=0,vjust=0))

enter image description here

1
votes

This draws convex hulls for clusters based on hclust and cutree. It uses cowplot::plot_grid to combine plots for the first eight PCs.

library(tidyverse)
library(cowplot)

t=read.csv("https://pastebin.com/raw/aGPQSC24",row.names=1,header=T,check.names=F)

p=prcomp(t)
pct=paste0(colnames(p$x)," (",sprintf("%.1f",p$sdev/sum(p$sdev)*100),"%)")
p2=as.data.frame(p$x)
p2$k=factor(cutree(hclust(dist(t)),k=12))
load=p$rotation

plots=lapply(seq(1,7,2),function(i){
  x=sym(paste0("PC",i))
  y=sym(paste0("PC",i+1))

  mult=min(max(p2[,i])/max(load[,i]),max(p2[,i+1])/max(load[,i+1]))
  colors=hcl(head(seq(15,375,length=length(unique(p2$k))+1),-1),120,50)

  ggplot(p2,aes(!!x,!!y))+
    geom_segment(data=load,aes(x=0,y=0,xend=mult*!!x,yend=mult*!!y),arrow=arrow(length=unit(.3,"lines")),color="gray60",size=.4)+
    annotate("text",x=(mult*load[,i]),y=(mult*load[,i+1]),label=rownames(load),size=2.5,vjust=ifelse(load[,i+1]>0,-.5,1.4))+
    geom_polygon(data=p2%>%group_by(k)%>%slice(chull(!!x,!!y)),aes(color=k,fill=k),size=.3,alpha=.2)+
    geom_point(aes(color=k),size=.6)+
    geom_text(aes(label=rownames(t),color=k),size=2.5,vjust=-.6)+
    # ggrepel::geom_text_repel(aes(label=rownames(t),color=k),max.overlaps=Inf,force=5,size=2.2,min.segment.length=.1,segment.size=.2)+
    labs(x=pct[i],y=pct[i+1])+
    scale_x_continuous(breaks=seq(-100,100,20),expand=expansion(mult=.06))+
    scale_y_continuous(breaks=seq(-100,100,20),expand=expansion(mult=.06))+
    scale_color_manual(values=colors)+
    scale_fill_manual(values=colors)+
    theme(aspect.ratio=1,
          axis.text=element_text(color="black",size=6),
          axis.text.x=element_text(margin=margin(.2,0,0,0,"cm")),
          axis.text.y=element_text(angle=90,vjust=1,hjust=.5,margin=margin(0,.2,0,0,"cm")),
          axis.ticks=element_line(size=.3,color="gray60"),
          axis.ticks.length=unit(-.13,"cm"),
          axis.title=element_text(color="black",size=8),
          legend.position="none",
          panel.background=element_rect(fill="white"),
          panel.border=element_rect(color="gray60",fill=NA,size=.4),
          panel.grid=element_blank())
})

plot_grid(plotlist=plots)
ggsave("a.png",height=12,width=12)

Here's an alternative version that uses a dark color scheme. It draws a line between each point and its three closest neighbors, but you can uncomment the commented out code in order to draw a minimal spanning tree instead. It uses ggforce::geom_mark_hull to draw convex hulls with rounded corners. It uses ggrepel to avoid overlapping text labels.

library(tidyverse)
library(ggforce)
library(ggrepel)

t=read.csv("https://pastebin.com/raw/aGPQSC24",row.names=1,header=T,check.names=F)

p=prcomp(t)
pct=paste0(colnames(p$x)," (",sprintf("%.1f",p$sdev/sum(p$sdev)*100),"%)")
p2=as.data.frame(p$x)
p2$k=as.factor(cutree(hclust(dist(t)),k=12))
load=p$rotation

xpc=1
ypc=2
xsym=sym(paste0("PC",xpc))
ysym=sym(paste0("PC",ypc))

# draw a line from each point to its three nearest neighbors
dist=as.data.frame(as.matrix(dist(t)))
seg0=lapply(1:4,function(i)apply(dist,1,function(x)unlist(p2[names(sort(x)[i]),c(xpc,ypc)],use.names=F))%>%t%>%cbind(p2[,c(xpc,ypc)]))
seg=do.call(rbind,seg0)%>%setNames(paste0("V",1:4))

# draw a minimal spanning tree
# spantree=cbind(2:nrow(t2),vegan::spantree(dist)$kid)
# seg=cbind(p2[spantree[,1],c(xpc,ypc)],p2[spantree[,2],c(xpc,ypc)])%>%setNames(paste0("V",1:4))

mult=min(max(p2[,xpc])/max(load[,xpc]),max(p2[,ypc])/max(load[,ypc]))

ggplot(p2,aes(!!xsym,!!ysym))+
  geom_segment(data=seg,aes(x=V1,y=V2,xend=V3,yend=V4),color="gray10",size=.3)+
  ggforce::geom_mark_hull(aes(color=k,fill=k),concavity=100,radius=unit(.15,"cm"),expand=unit(.15,"cm"),alpha=.15,size=.1)+
  # geom_polygon(data=p2%>%group_by(k)%>%slice(chull(!!xsym,!!ysym)),aes(color=k,fill=k),alpha=.2,size=.2)+
  geom_segment(data=load,aes(x=0,y=0,xend=mult*!!xsym,yend=mult*!!ysym),arrow=arrow(length=unit(.3,"lines")),color="gray90",size=.4)+
  annotate("text",x=(mult*load[,xpc]),y=(mult*load[,ypc]),label=rownames(load),size=2.3,color="gray90",vjust=ifelse(load[,ypc]>0,-.5,1.4))+
  geom_point(aes(color=k),size=.6)+
  ggrepel::geom_text_repel(aes(label=rownames(t),color=k),max.overlaps=Inf,force=5,size=2.3,box.padding=0,point.padding=1,min.segment.length=.2,segment.size=.2)+
  # geom_text(aes(label=rownames(t),color=k),size=2.5,vjust=-.6)+
  labs(x=pct[xpc],y=pct[ypc])+
  scale_x_continuous(breaks=seq(-200,200,20),expand=expansion(mult=.06))+
  scale_y_continuous(breaks=seq(-200,200,20),expand=expansion(mult=.06))+
  scale_color_manual(values=hcl(head(seq(15,375,length=length(unique(p2$k))+1),-1),100,80))+
  theme(axis.text=element_text(color="black",size=6),
        axis.text.y=element_text(angle=90,vjust=1,hjust=.5),
        axis.ticks=element_line(size=.25,color="gray10"),
        axis.title=element_text(color="gray10",size=8),
        legend.position="none",
        panel.background=element_rect(fill="gray40"),
        panel.border=element_rect(color="gray10",fill=NA,size=.5),
        plot.background=element_rect(fill="gray40",color=NA), # color=NA removes a small white border around the plot
        panel.grid=element_blank())

ggsave("a.png",width=6,height=6)

0
votes

If you want to control all style parameters including arrow-color indipendently from label-color etc. I recommend you using ggplot rather than factomineR for plotting. (Packages needed: factomineR, factoextra, ggplot, ggrepel)

res.pca <- PCA(USArrests,  graph = F)# PCA results
eigenvalue <- as.data.frame(get_eig(res.pca))# Get eigenvalues
variance.percent <- round(eigenvalue$variance.percent,1)# Get variance
ind.coord <- as.data.frame(res.pca$ind$coord)# Get individual coordinates
var.coord <- as.data.frame(res.pca$var$coord)# Getvariable coordinates
PCA_Biplot <- ggplot()+
  geom_point(data=ind.coord,aes(Dim.1,Dim.2,stroke=0.7,color=rownames(USArrests)),size=2)+
  #geom_text_repel(data=ind.coord, aes(x=Dim.1, y=Dim.2, label=rownames(USArrests)))+
  geom_segment(data=var.coord, aes(x = 0, y = 0, xend = Dim.1*5, yend = Dim.2*5),arrow = arrow(length = unit(0.2, "cm")),color="#3D3D44")+
  geom_text_repel(data = var.coord, aes(x=Dim.1*5, y=Dim.2*5, label=colnames(USArrests),fontface="bold"))+
  xlab(paste0("Dim1 (", variance.percent[1], "% )" ))+
  ylab(paste0("Dim2 (", variance.percent[2], "% )" ))+
  #ggtitle("USArrests")+
  #scale_color_manual(values= rainbow(50))+
  #scale_shape_manual(values = c(0,1,2,4,5,6,7,8,9,10,11,12))+
  #scale_y_continuous(breaks = c(-5, 0, 5, 10), limits = c(-5.5, 10.5))+
  theme_minimal()+
  labs(tag = "a)")+
  theme(plot.tag = element_text(face = "bold",size = 12),
        #plot.title = element_text(hjust=0.5,face = "bold"),
        axis.title = element_text(size = 10),
        axis.text = element_text(colour = "black",size = 10),
        legend.position = "none" )
PCA_Biplot

PCA_Biplot