As mentioned in the vignette Introduction to pathfindR, enrichment analysis with pathfindR is not limited to the built-in data. The users are able to utilize custom protein-protein interaction networks (PINs) as well as custom gene sets. These abilities to use custom data naturally allow for performing pathfindR analysis on non-Homo-sapiens input data. In this vignette, we’ll try to provide an overview of how pathfindR analysis using Mus musculus data can be performed.
As of v1.5, pathfindR offers utility functions for obtaining organism-specific PIN data and organism-specific gene sets data via
get_pin_file()
andget_gene_sets_list()
, respectively. See the vignette Obtaining PIN and Gene Sets Data for detailed information on how to gather PIN and gene sets data (for any organism of your choice) for use with pathfindR.
For performing non-human active-subnetwork-oriented enrichment analysis, the user needs the following resources:
After obtaining and processing these data for use, the user can run pathfindR using custom parameters.
Important Note: Because the non-human organism-specific PIN will likely contain less interactions than the Homo sapiens PIN, pathfindR may result in less (or even no) enriched terms.
We can obtain the up-to-date M.musculus (KEGG identifier: mmu) KEGG
Pathway Gene Sets using the function
get_gene_sets_list()
:
If using another organism, all you have to do is to replace “mmu” with the KEGG organism code in the related arguments in this vignette.
This returns a list containing 2 objects named:
gene_sets
containing sets of genes of each pathway and
desriptions
containing the description of each pathway.
The M.musculus KEGG gene set data mmu_kegg_genes
and
mmu_kegg_descriptions
are already provided in pathfindR.
For other organisms, the user may wish to save the data as RDS files for
future use:
mmu_kegg_genes <- gsets_list$gene_sets
mmu_kegg_descriptions <- gsets_list$descriptions
## Save both as RDS files for later use
saveRDS(mmu_kegg_genes, "mmu_kegg_genes.RDS")
saveRDS(mmu_kegg_descriptions, "mmu_kegg_descriptions.RDS")
These can be later loaded via:
mmu_kegg_genes <- readRDS("mmu_kegg_genes.RDS")
mmu_kegg_descriptions <- readRDS("mmu_kegg_descriptions.RDS")
The function
get_gene_sets_list()
can also be used to obtain gene sets data from other sources. See the vignette Obtaining PIN and Gene Sets Data for more detail.
You may use the function get_pin_file()
to obtain
organism-specific BioGRID PIN data (see the vignette Obtaining PIN and Gene Sets Data)
Note that BioGRID PINs are smaller for non-H.sapiens organisms and this, in turn, results in less or no significantly enriched terms with pathfindR analysis.
Here, we demonstrate obtaining the organism-specific protein-protein interaction network (PIN) from STRING. You may choose the organism of your choice and find the PIN on the downloads page with the description “protein network data (scored links between proteins)”. When processing, we recommend filtering the interactions using a link score threshold (e.g. 800).
Regardless of the resource, the raw PIN data should be processed to a SIF file, each interactor should be specified with their gene symbols. The first 3 interactions from an example SIF file is provided below:
C2cd2 | pp | Ints2 |
Apob | pp | Gpt |
B4galnt1 | pp | Mettl1 |
Notice there are no headers and each line contains an interaction in
the form GeneA pp GeneB
, separated by tab
(i.e. \t
) with no row names and no column names.
Below we download process the STRING PIN for use with pathfindR:
## Downloading the STRING PIN file to tempdir
url <- "https://stringdb-static.org/download/protein.links.v11.0/10090.protein.links.v11.0.txt.gz"
path2file <- file.path(tempdir(check = TRUE), "STRING.txt.gz")
download.file(url, path2file)
## read STRING pin file
mmu_string_df <- read.table(path2file, header = TRUE)
## filter using combined_score cut-off value of 800
mmu_string_df <- mmu_string_df[mmu_string_df$combined_score >= 800, ]
## fix ids
mmu_string_pin <- data.frame(
Interactor_A = sub("^10090\\.", "", mmu_string_df$protein1),
Interactor_B = sub("^10090\\.", "", mmu_string_df$protein2)
)
head(mmu_string_pin, 2)
Interactor_A | Interactor_B |
---|---|
ENSMUSP00000000001 | ENSMUSP00000017460 |
ENSMUSP00000000001 | ENSMUSP00000039107 |
Since the interactors are Ensembl peptide IDs, we’ll need to convert
them to MGI symbols for use with pathfindR. This can be achieved via
biomaRt
or any other conversion method you prefer:
# library(biomaRt)
mmu_ensembl <- useMart("ensembl", dataset = "mmusculus_gene_ensembl")
converted <- getBM(
attributes = c("ensembl_peptide_id", "mgi_symbol"),
filters = "ensembl_peptide_id",
values = unique(unlist(mmu_string_pin)),
mart = mmu_ensembl
)
mmu_string_pin$Interactor_A <- converted$mgi_symbol[match(mmu_string_pin$Interactor_A, converted$ensembl_peptide_id)]
mmu_string_pin$Interactor_B <- converted$mgi_symbol[match(mmu_string_pin$Interactor_B, converted$ensembl_peptide_id)]
mmu_string_pin <- mmu_string_pin[!is.na(mmu_string_pin$Interactor_A) & !is.na(mmu_string_pin$Interactor_B), ]
mmu_string_pin <- mmu_string_pin[mmu_string_pin$Interactor_A != "" & mmu_string_pin$Interactor_B != "", ]
head(mmu_string_pin, 2)
Interactor_A | Interactor_B |
---|---|
Gnai3 | Ppy |
Gnai3 | Ccr3 |
Next, we remove self interactions and any duplicated interactions, format the data frame as SIF:
# remove self interactions
self_intr_cond <- mmu_string_pin$Interactor_A == mmu_string_pin$Interactor_B
mmu_string_pin <- mmu_string_pin[!self_intr_cond, ]
# remove duplicated inteactions (including symmetric ones)
mmu_string_pin <- unique(t(apply(mmu_string_pin, 1, sort))) # this will return a matrix object
mmu_string_pin <- data.frame(
A = mmu_string_pin[, 1],
pp = "pp",
B = mmu_string_pin[, 2]
)
Finally, we save the gene symbol PIN as a SIF file named
“mmusculusPIN.sif” under the temporary directory
(i.e. tempdir()
):
path2SIF <- file.path(tempdir(), "mmusculusPIN.sif")
write.table(mmu_string_pin,
file = path2SIF,
col.names = FALSE,
row.names = FALSE,
sep = "\t",
quote = FALSE
)
path2SIF <- normalizePath(path2SIF)
We’ll use this path to the custom sif for analysis with
run_pathfindR()
.
The STRING Mus musculus PIN created above is available in pathfindR and can be used via setting
pin_name_path = "mmu_STRING"
inrun_pathfindR()
.
The data used in this vignette (example_mmu_input
) is
the data frame of differentially-expressed genes along for the GEO
dataset GSE99393.
The RNA microarray experiment was perform to detail the global program
of gene expression underlying polarization of myeloma-associated
macrophages by CSF1R antibody treatment. The samples are 6 murine bone
marrow derived macrophages co-cultured with myeloma cells
(myeloma-associated macrophages), 3 of which were treated with CSF1R
antibody (treatment group) and the rest were treated with control IgG
antibody (control group). In example_mmu_input
, 45
differentially-expressed genes with |logFC| >= 2 and FDR <= 0.05
are presented.
Gene_Symbol | FDR |
---|---|
Aoah | 8.23e-05 |
AW112010 | 8.23e-05 |
F13a1 | 8.23e-05 |
Pde3b | 8.23e-05 |
P2ry14 | 8.23e-05 |
Fcgrt | 8.23e-05 |
run_pathfindR()
After obtaining the necessary PIN and gene sets data, you can then
perform pathfindR analysis by setting these arguments: -
convert2alias = FALSE
: alias conversion only works on
H.sapiens genes - pin_name_path = path2SIF
: as we’re using
a non-built-in PIN, we need to provide the path to the mmu sif file -
gene_sets = "Custom
: as we’re using a non-built-in source
for gene sets - custom_genes = mmu_kegg_genes
-
custom_descriptions = mmu_kegg_descriptions
example_mmu_output <- run_pathfindR(
input = example_mmu_input,
convert2alias = FALSE,
gene_sets = "Custom",
custom_genes = mmu_kegg_genes,
custom_descriptions = mmu_kegg_descriptions,
pin_name_path = path2SIF
)
#> Plotting the enrichment bubble chart
ID | Term_Description | Fold_Enrichment | occurrence | support | lowest_p | highest_p | Up_regulated | Down_regulated |
---|---|---|---|---|---|---|---|---|
mmu04061 | Viral protein interaction with cytokine and cytokine receptor | 25.162835 | 10 | 0.0714286 | 0.0000006 | 0.0000006 | Ccl8, Ccl12, Cxcl10, Tnfsf10 | |
mmu04060 | Cytokine-cytokine receptor interaction | 13.981904 | 10 | 0.1428571 | 0.0000070 | 0.0000070 | Ccl8, Ccl12, Cxcl10, Il15, Il1b, Tnfsf10, Lifr | |
mmu04657 | IL-17 signaling pathway | 18.448034 | 10 | 0.2142857 | 0.0000091 | 0.0000091 | Cxcl10, Ccl12, Il1b | |
mmu04062 | Chemokine signaling pathway | 9.021291 | 10 | 0.0714286 | 0.0000111 | 0.0000111 | Cxcl10, Ccl12, Ccl8 | |
mmu04668 | TNF signaling pathway | 19.722222 | 10 | 0.0714286 | 0.0000223 | 0.0000223 | Ccl12, Cxcl10, Il1b, Il15 | |
mmu04625 | C-type lectin receptor signaling pathway | 14.659598 | 10 | 0.0714286 | 0.0001883 | 0.0018598 | Il1b, Clec4n, Clec4e | |
mmu00230 | Purine metabolism | 8.485142 | 10 | 0.0714286 | 0.0002888 | 0.0002888 | Gda, Pde3b | |
mmu05144 | Malaria | 21.049679 | 10 | 0.1428571 | 0.0003621 | 0.0003621 | Ccl12, Il1b | |
mmu05171 | Coronavirus disease - COVID-19 | 9.559680 | 10 | 0.1428571 | 0.0004099 | 0.0004099 | Il1b, Ccl12, Cxcl10, F13a1 | |
mmu04217 | Necroptosis | 6.674289 | 10 | 0.0714286 | 0.0005964 | 0.0005964 | Il1b, Tnfsf10 | |
mmu05164 | Influenza A | 13.267677 | 10 | 0.1428571 | 0.0006074 | 0.0006074 | Il1b, Ccl12, Cxcl10, Tnfsf10 | |
mmu04630 | JAK-STAT signaling pathway | 6.515377 | 10 | 0.0714286 | 0.0006414 | 0.0006414 | Il15, Lifr | |
mmu04620 | Toll-like receptor signaling pathway | 11.284364 | 9 | 0.0714286 | 0.0012052 | 0.0012052 | Il1b, Cxcl10 | |
mmu05417 | Lipid and atherosclerosis | 7.672313 | 10 | 0.0714286 | 0.0013307 | 0.0013307 | Ccl12, Il1b, Tnfsf10 | |
mmu05323 | Rheumatoid arthritis | 19.316177 | 10 | 0.0714286 | 0.0016094 | 0.0016094 | Il15, Il1b, Ccl12 | |
mmu05132 | Salmonella infection | 4.431512 | 10 | 0.0714286 | 0.0020500 | 0.0020500 | Il1b, Tnfsf10 | |
mmu05152 | Tuberculosis | 6.149345 | 9 | 0.0714286 | 0.0074842 | 0.0074842 | Clec4e, Il1b | |
mmu00760 | Nicotinate and nicotinamide metabolism | 14.033120 | 10 | 0.0714286 | 0.0080257 | 0.0080257 | Art2b | |
mmu04621 | NOD-like receptor signaling pathway | 11.769713 | 10 | 0.0714286 | 0.0168973 | 0.0168973 | Il1b, Ccl12, Gbp2, Gbp7 | |
mmu04923 | Regulation of lipolysis in adipocytes | 9.601608 | 10 | 0.0714286 | 0.0172702 | 0.0172702 | Pde3b | |
mmu05134 | Legionellosis | 9.276130 | 10 | 0.0714286 | 0.0185127 | 0.0185127 | Il1b | |
mmu05140 | Leishmaniasis | 7.931763 | 10 | 0.1428571 | 0.0253704 | 0.0253704 | Il1b | |
mmu05133 | Pertussis | 7.201206 | 10 | 0.0714286 | 0.0308098 | 0.0308098 | Il1b | |
mmu04012 | ErbB signaling pathway | 6.674289 | 10 | 0.0714286 | 0.0358906 | 0.0358906 | Nrg1 | |
mmu04623 | Cytosolic DNA-sensing pathway | 18.552260 | 1 | 0.0588235 | 0.0369183 | 0.0369183 | Cxcl10, Il1b | |
mmu04914 | Progesterone-mediated oocyte maturation | 6.014194 | 10 | 0.0714286 | 0.0442350 | 0.0442350 | Pde3b |
Because we used a very strict cut-off (logFC >= 2 + FDR <= 0.05), there were only 18 enriched KEGG pathways. However, the pathways identified here are significantly related to the pathways identified in the original publication by Wang et al.1.
As aforementioned, for Mus musculus (only), we have provided the
necessary PIN (mmu_STRING
) and gene set data
(mmu_KEGG
) so you can also run:
Wang Q, Lu Y, Li R, et al. Therapeutic effects of CSF1R-blocking antibodies in multiple myeloma. Leukemia. 2018;32(1):176-183.↩︎