Currently, there is only a development version. scMappR relies on the following dependencies which should be downloaded/updated with scMappR automatically. Please ensure that these packages are not open when installing scMappR. \
Install GSVA and pcaMethods from bioconductor first, as devtools::install_githb() will automatically install CRAN. 
if (!requireNamespace("BiocManager", quietly = TRUE))
    install.packages("BiocManager")
if (!requireNamespace("devtools", quietly = TRUE))
    install.packages("devtools")
BiocManager::install("pcaMethods")
BiocManager::install("GSVA")
devtools::install_github("DustinSokolowski/scMappR")
if (!requireNamespace("BiocManager", quietly = TRUE))
    install.packages("BiocManager")
if (!requireNamespace("devtools", quietly = TRUE))
    install.packages("devtools")
BiocManager::install("pcaMethods")
BiocManager::install("GSVA")
install.packages("scMappR")
Before using scMappR, we strongly recommend that you download data files from “https://github.com/DustinSokolowski/scMappR_Data”. As a default, it is assumed that these rda files have been downloaded and stored in ~/scMappR/data. These data files can be downloaded anywhere as long as the 'rda_data' parameter is changed to this directory when using scMappR. When data are not downloaded, the Downloader R package will temporarily download data files they are required within functions. Naturally, stable internet is required for this.
Many of the functions in scMappR print files or even generate directories. To return the full output of scMappR, please change the 'toSave' parameters from FALSE to TRUE in any of the functions being used. Otherwise, the functions in scMappR will only return a small portion of what scMappR has to offer. Due to CRAN packages not allowing for their packages to print files/make directories, toSave is set to FALSE as default.
When toSave == TRUE, it is also required to set the directory where files can be saved. In this vignette, it is assumed that there is a directory called vignette_dir in the working directory. To change the directory where files are saved, change the path argument. This vignette sets path to tempdir(). When using scMappR, change tempdir() to the directories where files should be saved.
tissue_scMappR_custom(): This function visualizes signature matrix, clusters subsetted genes, completes enrichment of individual cell-types and co-enrichment. tissue_scMappR_internal(): This function loops through every signature matrix in a particular tissue and generates heatmaps, cell-type preferences, and co-enrichment.scMappR_and_pathway_analysis(): This function generates cell-weighted fold changes (cellWeighted_Foldchanges), visualizes them in a heatmap, and completes pathway enrichment of cellWeighted_Foldchanges and bulk gene list.tissue_by_celltype_enrichment(): This function completes a fishers exact test of an input list of genes against one of the two curated tissue by cell-type marker datasets from scMappR.process_dgTMatrix_lists(): This function takes a list of count matrices, processes them, calls cell-types, and generates signature matrices.Given a tissue and an unranked list of genes (i.e. without a count matrix or summary statistics), the tissue_scMappR_custom() and tissue_scMappR_internal() functions visualizes cell-type markers contained within the gene-list and tests for the enrichment of cell-types within that tissue. When there is no custom signature matrix, providing a tissue present in “https://github.com/DustinSokolowski/scMappR_Data/blob/master/Signature_matrices_Pval.rda” will complete cell-type specific gene visualization and enrichment for every signature matrix in the tissue.
data(POA_example) # region to preoptic area
Signature <- POA_example$POA_Rank_signature # signature matrix 
rowname <- get_gene_symbol(Signature) # get signature
rownames(Signature) <- rowname$rowname
genes <- rownames(Signature)[1:60]
rda_path1 = "" # data directory (if it exists)
# Identify tissues available for tissue_scMappR_internal
data(scMappR_tissues)
"Hypothalamus" %in% toupper(scMappR_tissues)
internal <- tissue_scMappR_internal(genes, "mouse", output_directory = "scMappR_Test_Internal", 
tissue = "hypothalamus", rda_path = rda_path1, toSave = TRUE, path = tempdir())
This function returns a list “internal”. Using the example of internal[[4]], the prophetic area of the hypothalamus, you can see four objects. 
When toSave == TRUE, a directory is generated with visualization of each signature matrix, the signature matrix subsetted by input genes, and statistical enrichment.
tissue_scMappR_custom() assumes a custom signature matrix, or an inputted gene x cell-type matrix that is filled with the cell-type preferences of each gene (Rank is recommended but any value will suffice). If the value filling the matrix is not rank, you will need to change the gene_cutoff from 1 to whatever cutoff you need. Furthermore, if is_pvalue == TRUE, tissue_scMappR_custom() will transform the p-values into ranks rank := -1log10(Padj)*sign(FC). We strongly recommend that you generate these ranks before using tissue_scMappR_custom(); however, we assume that all fold changes are positive and therefore sign(FC) = 1.
# Acquiring the gene list
data(POA_example)
Signature <- POA_example$POA_Rank_signature
rowname <- get_gene_symbol(Signature)
rownames(Signature) <- rowname$rowname
genes <- rownames(Signature)[1:200]
#running tisue_scMappR_custom
internal <- tissue_scMappR_custom(genes,Signature,output_directory = "scMappR_Test_custom", toSave = F)
The output is identical to that found in tissue_scMappR_internal() but with only one study, or the example shown above. \
If you choose to set toSave = TRUE. This function will return a directory with a number of relevant files.
When toSave == TRUE, a directory is generated with visualization of each signature matrix, the signature matrix subsetted by input genes, and statistical enrichment.
The scMappR_and_pathway_analysis() function generates cellWeighted_Foldchanges based on an inputted signature matrix, normalized RNA-seq count matrix, and list of differentially-expressed genes (DEGs) before creating cell-weighted Fold Changes (cwFold-changes) (cellWeighted_Foldchanges), visualizing these cellWeighted_Foldchange's against the cell-type preferences of these DEGs, that are also cell-type markers, visualizing cellWeighted_Foldchange's regardless of if the cellWeighted_Foldchange is cell-type markers, and if allowed, pathway enrichment of DEGs re-ranked by cell-type. \ 
The example below has toSave = FALSE, up_and_downregulated = FALSE and internet = FALSE. When running scMappR yourself, it is strongly recommended to set all to TRUE. toSave = TRUE allows for the printing of folders, images, and files onto a desktop/cluster. up_and_downregulated = TRUE repeats pathway analysis for up and down-regulated genes separately. internet = TRUE allows for the completion of pathway analysis altogether. Tissue-types are available in data(scMappR_tissues), and the signature matrices themselves from https://github.com/DustinSokolowski/scMappR_Data/blob/master/Signature_matrices_OR.rda
data(PBMC_scMappR) # load data example of PBMC bulk- and cell-sorted RNA-seq data
bulk_DE_cors <- PBMC_example$bulk_DE_cors # 59 sex-specific DEGs in bulk PBMC (up-regulated = female-biased)
bulk_normalized <- PBMC_example$bulk_normalized # log CPM normalized bulk RNA-seq data
odds_ratio_in <- PBMC_example$odds_ratio_in # signature matrix developed from cell-sorted RNA-seq
case_grep <- "_female" # flag for 'cases' (up-regulated), index is also acceptable
control_grep <- "_male" # flag for 'control' (down-regulated), index is also acceptable
max_proportion_change <- 10 # maximum cell-type proportion change -- this is good for cell-types that are uncomon in population and small absolute changes may yield large relative changes
theSpecies <- "human" # these RNA-seq data have human gene symbols (and are also from human)
# When running scMappR, it is strongly recommended to use scMappR_and_pathway analysis with the parameters below.
toOut <- scMappR_and_pathway_analysis(bulk_normalized, odds_ratio_in, 
                                      bulk_DE_cors, case_grep = case_grep,
                                      control_grep = control_grep, rda_path = "", 
                                      max_proportion_change = 10, print_plots = TRUE, 
                                      plot_names = "scMappR_vignette_", theSpecies = "human", 
                                      output_directory = "scMappR_vignette_",
                                      sig_matrix_size = 3000, up_and_downregulated = TRUE, 
                                      internet = TRUE, toSave = TRUE, path = tempdir())
Assuming toSave = T and up_and_downregulated = T, scMappR_and_pathway_analysis() will also generate a folder in your current directory with a considerable amount of data/figures.
Here, we will walk through the output of the above example sorting by name and working downwards.
scMappR allows for gene-set enrichment of every cell-type marker, sorted by cell-type, tissue, and study, curated while preprocessing all of the signature matrices for the functions within scMappR. The dataset may be downloaded from https://github.com/DustinSokolowski/scMappR_Data, processed into a gmt file using a number of packages (qusage, activepathways etc.) and then used with traditional gene-set-enrichment tools (GSEA, GSVA, gprofiler). Additionally, scMappR contains the “tissue_by_celltype_enrichment.R” function, that enriches a gene list against all cell-type markers using a Fisher's exact test.
Here, we will investigate the tissue x cell-type enrichment of the top 100 genes in the Preoptic area signature matrix.
data(POA_example)
POA_generes <- POA_example$POA_generes
POA_OR_signature <- POA_example$POA_OR_signature
POA_Rank_signature <- POA_example$POA_Rank_signature
Signature <- POA_Rank_signature
rowname <- get_gene_symbol(Signature)
rownames(Signature) <- rowname$rowname
genes <- rownames(Signature)[1:100]
enriched <- tissue_by_celltype_enrichment(gene_list = genes, 
species = "mouse",p_thresh = 0.05, isect_size = 3)
tissue_by_celltype_enrichment() function. This function returns gene set enrichment compatible with plotBP() for all cell-type markers significantly enriched via the function.return_gmt == TRUE, then this downloaded gmt will be returned with the enrichment.toSave == TRUE, then the -log10(P_adj) of the top 10 tissue/cell-types that are enriched are plotted.scMappR inputs a list of count matrices (of class list, dCGMatrix, or matrix) and re-processes it using the standard Seurat V3 vignette (+ removal of cells with > 2 standard deviations of mt contamination than mean). Then, it finds cell-type markers and identifies potential cell-type names using the GSVA and fisher's exact methods on the CellMarker and Panglao databases. Finally, it creates a signature matrix of odds ratios and ranks. There are options to save the Seurat object, gsva cell-type identities and list of cell-type markers. To identify what naming-preferences options are available, download and load https://github.com/DustinSokolowski/scMappR_Data/blob/master/cell_preferences_categorized.rda.
data(sm)
toProcess <- list(example = sm)
tst1 <- process_dgTMatrix_lists(toProcess, name = "testPropcess", species_name = -9,
naming_preference = "eye", rda_path = "", 
toSave = TRUE, saveSCObject = TRUE, path = tempdir())
It is recommended to set toSave == TRUE, allowing for important data objects to be saved. Here, the above function is repeated with toSave == TRUE and saveSCObject == TRUE, and the outputted files will be briefly discussed.
Here, the following objects are saved.
It may be common to generate a signature matrix when clusters and cell-types have already been given for every cell. These examples follow how to make this signature matrix from:
1) A Seurat object with named cell-types 2) A Count matrix with named cell-types.
Generating the Seurat Object for example and making up cell-types. This example will be used from 1-2.
data(sm)
toProcess <- list(sm = sm)
seurat_example <- process_from_count(toProcess, "test_vignette",theSpecies  = -9)
levels(seurat_example@active.ident) <- c("Myoblast", "Neutrophil", "cardiomyoblast", "Mesothelial")
1) A Seurat object with named cell-types. Markers for each cell-type are stored in the generes object and each signature matrix is in gene_out.
    generes <- seurat_to_generes(pbmc = seurat_example, test = "wilcox")
    gene_out <- generes_to_heatmap(generes, make_names = FALSE)
2) A count matrix with named cell-types.
#Create the cell-type ids and matrix
Cell_type_id <- seurat_example@active.ident
count_file <- sm
rownames_example <- get_gene_symbol(count_file)
rownames(count_file) <- rownames_example$rowname
# make seurat object
seurat_example <- process_from_count(count_file, "test_vignette",theSpecies  = "mouse")
# Intersect column names (cell-types) with labelled CTs
inters <- intersect(colnames(seurat_example), names(Cell_type_id))
seurat_example_inter <- seurat_example[,inters]
Cell_type_id_inter <- Cell_type_id[inters]
seurat_example_inter@active.ident <- Cell_type_id_inter
# Making signature matrices
    generes <- seurat_to_generes(pbmc = seurat_example_inter, test = "wilcox")
    gene_out <- generes_to_heatmap(generes, make_names = FALSE)
The scMappR manuscript describes two pathway enrichment methodologies. Pathway enrichment of the first approach represents biological pathways associated with the rank-change in expression of each cell-type. Secondly, scMappR re-ranks genes by their increase in cell-type specificity before completing an ordered pathway analysis. For example, if a gene is the 150th most DE gene in bulk and the 2nd most DE gene for a cell-type, it would have a score of 148 for that cell-type. Pathway enrichment of the second approach represents biological pathways associated with genes most influenced by scMappR. These two pathway enrichment methodologies are consolodated into a single function separate from scMappR_and_pathway_analysis. Specifically, they are found in two_method_pathway_analysis.
This function requires that you input cwFold-changes computed from scMappR_and_pathway_analysis as well as the bulk DE genes inputted into the original analysis. An example is shown below:
data(PBMC_example)
bulk_DE_cors <- PBMC_example$bulk_DE_cors
bulk_normalized <- PBMC_example$bulk_normalized
odds_ratio_in <- PBMC_example$odds_ratio_in
case_grep <- "_female"
control_grep <- "_male"
max_proportion_change <- 10
print_plots <- FALSE
theSpecies <- "human"
toOut <- scMappR_and_pathway_analysis(bulk_normalized, odds_ratio_in, 
                                      bulk_DE_cors, case_grep = case_grep,
                                      control_grep = control_grep, rda_path = "", 
                                      max_proportion_change = 10, print_plots = TRUE, 
                                      plot_names = "tst1", theSpecies = "human", 
                                      output_directory = "tester",
                                      sig_matrix_size = 3000, up_and_downregulated = FALSE, 
                                      internet = FALSE)
twoOutFiles <- two_method_pathway_enrichment(bulk_DE_cors, "human", scMappR_vals = toOut$cellWeighted_Foldchange, background_genes = rownames(bulk_normalized), output_directory = "newfun_test",plot_names = "nonreranked_", toSave = FALSE, path=NULL)
# The code below would save graphs and paths into the working directory.  It is commented to not make code in your working directory
#twoOutFiles <- two_method_pathway_enrichment(bulk_DE_cors, "human", scMappR_vals = toOut$cellWeighted_Foldchange, background_genes = rownames(bulk_normalized), output_directory = "newfun_test",plot_names = "nonreranked_", toSave = TRUE, path="./")
Here, the following objects are saved.
scMappR generates heatmaps and barplots. The barplots are generated with plotBP and make_TF_barplot. The plotting code for plotBP is provided. Inputs are a matrix called ordered_back_all of -log10(padj) and term names with the column names log10 and term_name respectively.
# making an example matrix
term_name <- c("one", "two", "three")
log10 <- c(1.5, 4, 2.1)
ordered_back_all <- as.data.frame(cbind(term_name,log10))
#plotting
 g <- ggplot2::ggplot(ordered_back_all, ggplot2::aes(x = stats::reorder(term_name, 
        log10), y = log10)) + ggplot2::geom_bar(stat = "identity", 
        fill = "turquoise") + ggplot2::coord_flip() + ggplot2::labs(y = "-log10(Padj)", 
        x = "Gene Ontology")
    y <- g + ggplot2::theme(axis.text.x = ggplot2::element_text(face = NULL, 
        color = "black", size = 12, angle = 35), axis.text.y = ggplot2::element_text(face = NULL, 
        color = "black", size = 12, angle = 35), axis.title = ggplot2::element_text(size = 16, 
        color = "black"))
print(y)
Here, the heatmaps are for plotting cwFold-changes and cell-type proportions. The same heatmap is used so just an example of one is given.
# Generating a heatmap
# Acquiring the gene list
data(POA_example)
Signature <- POA_example$POA_Rank_signature
rowname <- get_gene_symbol(Signature)
rownames(Signature) <- rowname$rowname
genes <- rownames(Signature)[1:200]
#running tisue_scMappR_custom
internal <- tissue_scMappR_custom(genes,Signature,output_directory = "scMappR_Test_custom", toSave = F)
toPlot <- internal$gene_list_heatmap$geneHeat
#Plotting the heatmap
cex = 0.2 # size of genes
myheatcol <- grDevices::colorRampPalette(c("lightblue", "white", "orange"))(256)
    pheatmap::pheatmap(as.matrix(toPlot), color = myheatcol, scale = "row", fontsize_row = cex, fontsize_col = 10)