The iasva package can be used to detect hidden heterogenity within bulk or single cell sequencing data. To illustrate how to use the iasva package for heterogenity detection, we use real-world single cell RNA sequencing (scRNA-Seq) data obtained from human pancreatic islet samples (Lawlor et. al., 2016).
To illustrate how IA-SVA can be used to detect hidden heterogeneity within a homogenous cell population (i.e., alpha cells), we use read counts of alpha cells from healthy (non-diabetic) subjects (n = 101).
counts_file <- system.file("extdata", "iasva_counts_test.Rds",
                         package = "iasva")
# matrix of read counts where genes are rows, samples are columns
counts <- readRDS(counts_file)
# matrix of sample annotations/metadata
anns_file <- system.file("extdata", "iasva_anns_test.Rds",
                         package = "iasva")
anns <- readRDS(anns_file)It is well known that the geometric library size (i.e., library size of log-transfromed read counts) or proportion of expressed genes in each cell explains a very large portion of variability of scRNA-Seq data (Hicks et. al. 2015 BioRxiv, McDavid et. al. 2016 Nature Biotechnology). Frequently, the first principal component of log-transformed scRNA-Seq read counts is highly correlated with the geometric library size (r ~ 0.9). Here, we calculate the geometric library size vector, which will be used as a known factor in the IA-SVA algorithm.
geo_lib_size <- colSums(log(counts + 1))
barplot(geo_lib_size, xlab = "Cell", ylab = "Geometric Lib Size", las = 2)lcounts <- log(counts + 1)
# PC1 and Geometric library size correlation
pc1 <- irlba(lcounts - rowMeans(lcounts), 1)$v[, 1]
cor(geo_lib_size, pc1)## [1] -0.99716Here, we run IA-SVA using patient_id and geo_lib_size as known factors and identify five hidden factors. SVs are plotted in a pairwise fashion to uncover which SVs can seperate cell types.
set.seed(100)
patient_id <- anns$Patient_ID
mod <- model.matrix(~patient_id + geo_lib_size)
# create a summarizedexperiment class
summ_exp <- SummarizedExperiment(assays = counts)
iasva.res<- iasva(summ_exp, mod[, -1],verbose = FALSE, 
                  permute = FALSE, num.sv = 5)## IA-SVA running...## 
## SV 1 Detected!## 
## SV 2 Detected!## 
## SV 3 Detected!## 
## SV 4 Detected!## 
## SV 5 Detected!## 
## # of significant surrogate variables: 5cell_type <- as.factor(iasva.sv[, 1] > -0.1) 
levels(cell_type) <- c("Cell1", "Cell2")
table(cell_type)## cell_type
## Cell1 Cell2 
##     6    95# We identified 6 outlier cells based on SV1 that are marked in red
pairs(iasva.sv, main = "IA-SVA", pch = 21, col = color.vec[cell_type],
      bg = color.vec[cell_type], oma = c(4,4,6,12))
legend("right", levels(cell_type), fill = color.vec, bty = "n")plot(iasva.sv[, 1:2], main = "IA-SVA", pch = 21, xlab = "SV1", ylab = "SV2",
     col = color.vec[cell_type], bg = color.vec[cell_type])## [1] -0.1469422As shown in the above figure, SV1 clearly separates alpha cells into two groups: 6 outlier cells (marked in red) and the rest of the alpha cells (marked in blue). ## Find marker genes for the detected heterogeneity (SV1). Here, using the find_markers() function we find marker genes that are significantly associated with SV1 (multiple testing adjusted p-value < 0.05, default significance cutoff, and R-squared value > 0.3, default R-squared cutoff).
## # of markers (): 33## total # of unique markers: 33## [1] 33##  [1] "PMEPA1"   "FAM198B"  "FLT1"     "ENG"      "SOX4"     "ITGA5"   
##  [7] "PXDN"     "PRDM1"    "ERG"      "CLIC4"    "A2M"      "PPAP2B"  
## [13] "THBS1"    "CLIC2"    "S100A16"  "STC1"     "ACVRL1"   "COL4A1"  
## [19] "MSN"      "TNFAIP2"  "MMP2"     "SERPINE1" "SPARC"    "SPARCL1" 
## [25] "ESAM"     "KDR"      "CD9"      "CXCR4"    "PODXL"    "PLVAP"   
## [31] "CALD1"    "MMP1"     "ADAMTS4"anno.col <- data.frame(cell_type = cell_type)
rownames(anno.col) <- colnames(marker.counts)
head(anno.col)##             cell_type
## 4th-C63_S30     Cell2
## 4th-C66_S36     Cell2
## 4th-C18_S31     Cell2
## 4th-C57_S18     Cell1
## 4th-C56_S17     Cell2
## 4th-C68_S41     Cell2pheatmap(log(marker.counts + 1), show_colnames = FALSE,
         clustering_method = "ward.D2", cutree_cols = 2,
         annotation_col = anno.col)Here, we apply tSNE on the marker genes for SV1 obtained from IA-SVA
set.seed(100)
tsne.res <- Rtsne(unique(t(log(marker.counts + 1))), dims = 2)
plot(tsne.res$Y, main = "tSNE post IA-SVA", xlab = "tSNE Dim1",
     ylab = "tSNE Dim2", pch = 21, col = color.vec[cell_type],
     bg = color.vec[cell_type], oma = c(4, 4, 6, 12))
legend("bottomright", levels(cell_type), fill = color.vec, bty = "n")tSNE using SV1 marker genes better seperate these ourlier cells. This analyses suggest that gene selection using IA-SVA combined with tSNE analyses can be a powerful way to detect rare cells introducing variability in the single cell gene expression data.
Here, we run a faster implementation of IA-SVA using the same known factors (patient_id and geo_lib_size) as demonstrated above. This function is useful when working with particularly large datasets.
## fast IA-SVA running...## 
## SV 1 Detected!## 
## SV 2 Detected!## 
## SV 3 Detected!## 
## SV 4 Detected!## 
## SV 5 Detected!## 
## # of obtained surrogate variables: 5The R-squared thresholds used to identify marker genes (find_markers) can greatly influence the 1) number of marker genes identified and 2) the quality of clustering results. With the study_R2() function, users can visualize how different R-squared thresholds influence both factors.
## # of markers (): 274## total # of unique markers: 274## # of markers (): 177## total # of unique markers: 177## # of markers (): 123## total # of unique markers: 123## # of markers (): 84## total # of unique markers: 84## # of markers (): 54## total # of unique markers: 54## # of markers (): 39## total # of unique markers: 39## # of markers (): 30## total # of unique markers: 30## # of markers (): 23## total # of unique markers: 23## # of markers (): 7## total # of unique markers: 7## # of markers (): 3## total # of unique markers: 3## # of markers (): 0## total # of unique markers: 0 This function produces a plot of the number of genes selected vs. the cluster quality (average silhouette score) for different R-squared values.
## R version 3.5.2 (2018-12-20)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 16.04.5 LTS
## 
## Matrix products: default
## BLAS: /home/biocbuild/bbs-3.8-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.8-bioc/R/lib/libRlapack.so
## 
## locale:
##  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
##  [3] LC_TIME=en_US.UTF-8        LC_COLLATE=C              
##  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
##  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
##  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
## [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
## 
## attached base packages:
## [1] parallel  stats4    stats     graphics  grDevices utils     datasets 
## [8] methods   base     
## 
## other attached packages:
##  [1] SummarizedExperiment_1.12.0 DelayedArray_0.8.0         
##  [3] matrixStats_0.54.0          Biobase_2.42.0             
##  [5] GenomicRanges_1.34.0        GenomeInfoDb_1.18.1        
##  [7] IRanges_2.16.0              S4Vectors_0.20.1           
##  [9] BiocGenerics_0.28.0         RColorBrewer_1.1-2         
## [11] DescTools_0.99.26           corrplot_0.84              
## [13] pheatmap_1.0.12             Rtsne_0.15                 
## [15] sva_3.30.1                  BiocParallel_1.16.5        
## [17] genefilter_1.64.0           mgcv_1.8-26                
## [19] nlme_3.1-137                iasva_1.0.1                
## [21] irlba_2.3.2                 Matrix_1.2-15              
## 
## loaded via a namespace (and not attached):
##  [1] xfun_0.4               splines_3.5.2          lattice_0.20-38       
##  [4] expm_0.999-3           colorspace_1.3-2       htmltools_0.3.6       
##  [7] yaml_2.2.0             blob_1.1.1             XML_3.98-1.16         
## [10] survival_2.43-3        foreign_0.8-71         DBI_1.0.0             
## [13] bit64_0.9-7            GenomeInfoDbData_1.2.0 stringr_1.3.1         
## [16] zlibbioc_1.28.0        munsell_0.5.0          gtable_0.2.0          
## [19] mvtnorm_1.0-8          evaluate_0.12          memoise_1.1.0         
## [22] knitr_1.21             manipulate_1.0.1       AnnotationDbi_1.44.0  
## [25] Rcpp_1.0.0             xtable_1.8-3           scales_1.0.0          
## [28] limma_3.38.3           annotate_1.60.0        XVector_0.22.0        
## [31] bit_1.1-14             digest_0.6.18          stringi_1.2.4         
## [34] grid_3.5.2             tools_3.5.2            bitops_1.0-6          
## [37] magrittr_1.5           RCurl_1.95-4.11        RSQLite_2.1.1         
## [40] cluster_2.0.7-1        MASS_7.3-51.1          rmarkdown_1.11        
## [43] boot_1.3-20            compiler_3.5.2