Last updated: 2022-03-29
Checks: 7 0
Knit directory: logistic-susie-gsea/
This reproducible R Markdown analysis was created with workflowr (version 1.7.0). The Checks tab describes the reproducibility checks that were applied when the results were created. The Past versions tab lists the development history.
Great! Since the R Markdown file has been committed to the Git repository, you know the exact version of the code that produced these results.
Great job! The global environment was empty. Objects defined in the global environment can affect the analysis in your R Markdown file in unknown ways. For reproduciblity it’s best to always run the code in an empty environment.
The command set.seed(20220105)
was run prior to running the code in the R Markdown file. Setting a seed ensures that any results that rely on randomness, e.g. subsampling or permutations, are reproducible.
Great job! Recording the operating system, R version, and package versions is critical for reproducibility.
Nice! There were no cached chunks for this analysis, so you can be confident that you successfully produced the results during this run.
Great job! Using relative paths to the files within your workflowr project makes it easier to run your code on other machines.
Great! You are using Git for version control. Tracking code development and connecting the code version to the results is critical for reproducibility.
The results in this page were generated with repository version 51647d4. See the Past versions tab to see a history of the changes made to the R Markdown and HTML files.
Note that you need to be careful to ensure that all relevant files for the analysis have been committed to Git prior to generating the results (you can use wflow_publish
or wflow_git_commit
). workflowr only checks the R Markdown file, but you know if there are other scripts or data files that it depends on. Below is the status of the Git repository when the results were generated:
Ignored files:
Ignored: .DS_Store
Ignored: .RData
Ignored: .Rhistory
Ignored: .Rproj.user/
Ignored: analysis/figure/
Ignored: library/
Ignored: renv/library/
Ignored: renv/staging/
Ignored: staging/
Untracked files:
Untracked: _targets.R
Untracked: _targets.html
Untracked: _targets.md
Untracked: _targets/
Untracked: _targets_r/
Untracked: analysis/fetal_reference_cellid_gsea.Rmd
Untracked: analysis/fixed_intercept.Rmd
Untracked: analysis/iDEA_examples.Rmd
Untracked: analysis/latent_gene_list.Rmd
Untracked: analysis/latent_logistic_susie.Rmd
Untracked: analysis/libra_setup.Rmd
Untracked: analysis/linear_method_failure_modes.Rmd
Untracked: analysis/linear_regression_failure_regime.Rmd
Untracked: analysis/logistic_susie_veb_boost_vs_vb.Rmd
Untracked: analysis/references.bib
Untracked: analysis/simulations.Rmd
Untracked: analysis/test.Rmd
Untracked: analysis/wenhe_baboon_example.Rmd
Untracked: build_site.R
Untracked: cache/
Untracked: code/latent_logistic_susie.R
Untracked: code/marginal_sumstat_gsea_collapsed.R
Untracked: data/adipose_2yr_topsnp.txt
Untracked: data/fetal_reference_cellid_gene_sets.RData
Untracked: data/pbmc-purified/
Untracked: docs.zip
Untracked: index.md
Untracked: latent_logistic_susie_cache/
Untracked: simulation_targets/
Untracked: single_cell_pbmc_cache/
Untracked: summary_stat_gsea_exploration_cache/
Unstaged changes:
Modified: _simulation_targets.R
Modified: _targets.Rmd
Modified: analysis/gseabenchmark_tcga.Rmd
Modified: code/fit_baselines.R
Modified: code/fit_logistic_susie.R
Modified: code/fit_mr_ash.R
Modified: code/fit_susie.R
Modified: code/load_gene_sets.R
Modified: code/marginal_sumstat_gsea.R
Modified: code/simulate_gene_lists.R
Modified: code/utils.R
Modified: target_components/factories.R
Modified: target_components/methods.R
Note that any generated files, e.g. HTML, png, CSS, etc., are not included in this status report because it is ok for generated content to have uncommitted changes.
These are the previous versions of the repository in which changes were made to the R Markdown (analysis/single_cell_pbmc.Rmd
) and HTML (docs/single_cell_pbmc.html
) files. If you’ve configured a remote Git repository (see ?wflow_git_remote
), click on the hyperlinks in the table below to view the files as they were in that past version.
File | Version | Author | Date | Message |
---|---|---|---|---|
Rmd | 51647d4 | karltayeb | 2022-03-29 | wflow_publish(“analysis/single_cell_pbmc.Rmd”) |
html | 3da7c5b | karltayeb | 2022-03-29 | Build site. |
Rmd | fc1f3c1 | karltayeb | 2022-03-29 | wflow_publish(“analysis/single_cell_pbmc.Rmd”) |
html | 8646723 | karltayeb | 2022-03-29 | Build site. |
Rmd | 6143c44 | karltayeb | 2022-03-29 | wflow_publish(“analysis/single_cell_pbmc.Rmd”) |
html | 56f8130 | karltayeb | 2022-03-29 | Build site. |
html | a2bdb56 | karltayeb | 2022-03-29 | Build site. |
Rmd | 122deec | karltayeb | 2022-03-29 | wflow_publish(pages) |
Our goals here are to run Logistic SuSiE on differential expression results from TCGA. We want to assess:
library(GSEABenchmarkeR)
library(EnrichmentBrowser)
library(tidyverse)
library(susieR)
library(DT)
source('code/load_gene_sets.R')
source('code/utils.R')
source('code/logistic_susie_vb.R')
source('code/logistic_susie_veb_boost.R')
source('code/latent_logistic_susie.R')
loadGeneSetX
uniformly formats gene sets and generates the \(X\) matrix We can source any gene set from WebGestaltR::listGeneSet()
gs_list <- WebGestaltR::listGeneSet()
gobp <- loadGeneSetX('geneontology_Biological_Process', min.size=50) # just huge number of gene sets
gobp_nr <- loadGeneSetX('geneontology_Biological_Process_noRedundant', min.size=1)
gomf <- loadGeneSetX('geneontology_Molecular_Function', min.size=1)
kegg <- loadGeneSetX('pathway_KEGG', min.size=1)
reactome <- loadGeneSetX('pathway_Reactome', min.size=1)
wikipathway_cancer <- loadGeneSetX('pathway_Wikipathway_cancer', min.size=1)
wikipathway <- loadGeneSetX('pathway_Wikipathway', min.size=1)
genesets <- list(
gobp=gobp,
gobp_nr=gobp_nr,
gomf=gomf,
kegg=kegg,
reactome=reactome,
wikipathway_cancer=wikipathway_cancer,
wikipathway=wikipathway
)
load('data/pbmc-purified/deseq2-pbmc-purified.RData')
convert_labels <- function(y, from='SYMBOL', to='ENTREZID'){
hs <- org.Hs.eg.db::org.Hs.eg.db
gene_symbols <- names(y)
symbol2entrez <- AnnotationDbi::select(hs, keys=gene_symbols, columns=c(to, from), keytype = from)
symbol2entrez <- symbol2entrez[!duplicated(symbol2entrez[[from]]),]
symbol2entrez <- symbol2entrez[!is.na(symbol2entrez[[to]]),]
symbol2entrez <- symbol2entrez[!is.na(symbol2entrez[[from]]),]
rownames(symbol2entrez) <- symbol2entrez[[from]]
ysub <- y[names(y) %in% symbol2entrez[[from]]]
names(ysub) <- symbol2entrez[names(ysub),][[to]]
return(ysub)
}
par(mfrow=c(1,1))
deseq$`CD19+ B` %>% .$padj %>% hist(main='CD19+B p-values')
Loading required package: DESeq2
Version | Author | Date |
---|---|---|
a2bdb56 | karltayeb | 2022-03-29 |
logistic_susie_driver = function(db, celltype, thresh){
gs <- genesets[[db]]
data <- deseq[[celltype]]
# set up binary y
y <- data %>%
as.data.frame %>%
rownames_to_column('gene') %>%
dplyr::select(gene, padj) %>%
filter(!is.na(padj)) %>%
mutate(y = as.integer(padj < thresh)) %>%
select(gene, y) %>%
tibble2namedlist %>%
convert_labels('ENSEMBL')
u <- process_input(gs$X, y) # subset to common genes
vb.fit <- logistic.susie( # fit model
u$X, u$y, L=10, init.intercept = 0, verbose=1, maxit=100)
# summarise results
set.summary <- vb.fit$pip %>%
as_tibble(rownames='geneSet') %>%
rename(pip=value) %>%
mutate(
top_component = apply(vb.fit$alpha, 2, which.max),
active_set = top_component %in% vb.fit$sets$cs_index,
top_component = paste0('L', top_component),
cs = purrr::map(top_component, ~tryCatch(
colnames(gs$X)[get(.x, vb.fit$sets$cs)], error = function(e) list())),
in_cs = geneSet %in% cs,
beta = colSums(vb.fit$mu * vb.fit$alpha),
geneListSize = sum(u$y),
geneSetSize = colSums(u$X),
overlap = (u$y %*% u$X)[1,],
nGenes = length(u$y),
propSetInList = overlap / geneSetSize,
oddsRatio = (overlap / (geneListSize - overlap)) / (
(geneSetSize - overlap) / (nGenes - geneSetSize + overlap)),
pValueHypergeometric = phyper(
overlap-1, geneListSize, nGenes, geneSetSize, lower.tail= FALSE),
db = db,
celltype = celltype,
thresh = thresh
) %>% left_join(gs$geneSet$geneSetDes)
return(list(fit = vb.fit, set.summary=set.summary))
}
For each celltype, we fit logistic SuSiE using multiple gene set sources at various threshold of padj
.
celltypes <- names(deseq)
pthresh <- c(0.1, 0.01, 0.001, 0.0001, 0.00001, 0.000001)
db_name <- names(genesets)
crossed <- cross3(db_name, celltypes, pthresh)
pbmc_res <- xfun::cache_rds({
res <- purrr::map(crossed, purrr::lift_dl(logistic_susie_driver))
for (i in 1:length(res)){ # save some space
res[[i]]$fit$dat <- NULL
}
res
}, file = 'logistic_susie_pbmc_genesets_pthresh.rds'
)
pbmc_res_set_summary <- dplyr::bind_rows(purrr::map(pbmc_res, ~ pluck(.x, 'set.summary')))
Just a few functions to help streamline looking at output
pval_focussed_table = function(thresh=1e-3, filter_db=NULL, filter_celltype=NULL, top.n=50){
pbmc_res_set_summary %>%
filter(
case_when(
is.null(filter_db) ~ TRUE,
!is.null(filter_db) ~ db %in% filter_db
) &
thresh == thresh &
case_when(
is.null(filter_celltype) ~ TRUE,
!is.null(filter_celltype) ~ celltype %in% filter_celltype
)
) %>%
dplyr::arrange(celltype, db, pValueHypergeometric) %>%
group_by(celltype, db) %>% slice(1:top.n) %>%
select(celltype, db, geneSet, description, pip, top_component, oddsRatio, propSetInList, pValueHypergeometric) %>%
mutate_at(vars(celltype, db), factor) %>%
datatable(filter = 'top')
}
set_focussed_table = function(thresh=1e-3, filter_db=NULL, filter_celltype=NULL){
pbmc_res_set_summary %>%
filter(
case_when(
is.null(filter_db) ~ TRUE,
!is.null(filter_db) ~ db %in% filter_db
) &
thresh == 1e-3 &
in_cs & active_set &
case_when(
is.null(filter_celltype) ~ TRUE,
!is.null(filter_celltype) ~ celltype %in% filter_celltype
)
) %>%
dplyr::arrange(celltype, db, desc(pip)) %>%
select(celltype, db, geneSet, description, pip, top_component, oddsRatio, propSetInList, pValueHypergeometric) %>%
mutate_at(vars(celltype, geneSet, db), factor) %>%
datatable(filter = 'top')
}
Our goal is to assess 1. The quality of the gene set enrichments we get from each celltype - do reported gene set enrichments seem celltype specific/celltype relevant? - how much “interesting” marginal enrichment do we fail to capture in the multivariate model - how sensitive are we to the choice of pvalue threshold
Lets take a look at what enrichment we’re getting across cell-types. ### Overview
pbmc_res_set_summary %>%
filter(active_set, thresh==1e-4) %>%
group_by(celltype, thresh, db, top_component) %>%
chop(description) %>%
select(celltype, db, thresh, cs, description) %>%
knitr::kable()
Adding missing grouping variables: `top_component`
top_component | celltype | db | thresh | cs | description |
---|---|---|---|---|---|
L5 | CD19+ B | gobp | 1e-04 | GO:0001775 | cell activation |
L5 | CD19+ B | gobp | 1e-04 | GO:0001775 | cell activation involved in immune response |
L5 | CD19+ B | gobp | 1e-04 | GO:0001775 | leukocyte activation involved in immune response |
L1 | CD19+ B | gobp | 1e-04 | GO:0002376 | immune system process |
L5 | CD19+ B | gobp | 1e-04 | GO:0001775 | leukocyte activation |
L3 | CD19+ B | gobp | 1e-04 | GO:0042773, GO:0042775 | oxidative phosphorylation |
L6 | CD19+ B | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | mRNA processing |
L6 | CD19+ B | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | mRNA metabolic process |
L2 | CD19+ B | gobp | 1e-04 | GO:0045047 | protein targeting to ER |
L2 | CD19+ B | gobp | 1e-04 | GO:0045047 | establishment of protein localization to endoplasmic reticulum |
L6 | CD19+ B | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | regulation of mRNA processing |
L3 | CD19+ B | gobp | 1e-04 | GO:0042773, GO:0042775 | ATP synthesis coupled electron transport |
L3 | CD19+ B | gobp | 1e-04 | GO:0042773, GO:0042775 | mitochondrial ATP synthesis coupled electron transport |
L6 | CD19+ B | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | RNA splicing |
L6 | CD19+ B | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | regulation of RNA splicing |
L6 | CD19+ B | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | RNA splicing, via transesterification reactions |
L6 | CD19+ B | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | RNA splicing, via transesterification reactions with bulged adenosine as nucleophile |
L6 | CD19+ B | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | mRNA splicing, via spliceosome |
L6 | CD19+ B | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | regulation of mRNA splicing, via spliceosome |
L6 | CD19+ B | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | alternative mRNA splicing, via spliceosome |
L2 | CD19+ B | gobp | 1e-04 | GO:0045047 | cotranslational protein targeting to membrane |
L2 | CD19+ B | gobp | 1e-04 | GO:0045047 | SRP-dependent cotranslational protein targeting to membrane |
L1 | CD19+ B | gobp_nr | 1e-04 | GO:0002446, GO:0036230 | neutrophil mediated immunity |
L5 | CD19+ B | gobp_nr | 1e-04 | GO:0002764 | immune response-regulating signaling pathway |
L4 | CD19+ B | gobp_nr | 1e-04 | GO:0009123 | nucleoside monophosphate metabolic process |
L4 | CD19+ B | gobp_nr | 1e-04 | GO:0009123 | nucleoside triphosphate metabolic process |
L1 | CD19+ B | gobp_nr | 1e-04 | GO:0002446, GO:0036230 | granulocyte activation |
L2 | CD19+ B | gobp_nr | 1e-04 | GO:0070972 | protein localization to endoplasmic reticulum |
L1 | CD19+ B | gomf | 1e-04 | GO:0003723 | RNA binding |
L3 | CD19+ B | gomf | 1e-04 | GO:0000977, GO:0000987, GO:0001012 | transcription regulatory region sequence-specific DNA binding |
L3 | CD19+ B | gomf | 1e-04 | GO:0000977, GO:0000987, GO:0001012 | RNA polymerase II regulatory region sequence-specific DNA binding |
L3 | CD19+ B | gomf | 1e-04 | GO:0000977, GO:0000987, GO:0001012 | RNA polymerase II proximal promoter sequence-specific DNA binding |
L3 | CD19+ B | gomf | 1e-04 | GO:0000977, GO:0000987, GO:0001012 | proximal promoter sequence-specific DNA binding |
L3 | CD19+ B | gomf | 1e-04 | GO:0000977, GO:0000987, GO:0001012 | RNA polymerase II regulatory region DNA binding |
L3 | CD19+ B | gomf | 1e-04 | GO:0000977, GO:0000987, GO:0001012 | regulatory region nucleic acid binding |
L3 | CD19+ B | gomf | 1e-04 | GO:0000977, GO:0000987, GO:0001012 | double-stranded DNA binding |
L3 | CD19+ B | gomf | 1e-04 | GO:0000977, GO:0000987, GO:0001012 | transcription regulatory region DNA binding |
L3 | CD19+ B | gomf | 1e-04 | GO:0000977, GO:0000987, GO:0001012 | sequence-specific double-stranded DNA binding |
L7 | CD19+ B | gomf | 1e-04 | GO:0016651, GO:0016655, GO:0003954, GO:0008137, GO:0050136 | oxidoreductase activity, acting on NAD(P)H |
L7 | CD19+ B | gomf | 1e-04 | GO:0016651, GO:0016655, GO:0003954, GO:0008137, GO:0050136 | oxidoreductase activity, acting on NAD(P)H, quinone or similar compound as acceptor |
L2 | CD19+ B | gomf | 1e-04 | GO:0000981 | DNA-binding transcription factor activity, RNA polymerase II-specific |
L2 | CD19+ B | gomf | 1e-04 | GO:0000981 | DNA-binding transcription factor activity |
L6 | CD19+ B | gomf | 1e-04 | GO:0003735 | structural constituent of ribosome |
L7 | CD19+ B | gomf | 1e-04 | GO:0016651, GO:0016655, GO:0003954, GO:0008137, GO:0050136 | NADH dehydrogenase activity |
L7 | CD19+ B | gomf | 1e-04 | GO:0016651, GO:0016655, GO:0003954, GO:0008137, GO:0050136 | NADH dehydrogenase (ubiquinone) activity |
L7 | CD19+ B | gomf | 1e-04 | GO:0016651, GO:0016655, GO:0003954, GO:0008137, GO:0050136 | NADH dehydrogenase (quinone) activity |
L1 | CD19+ B | kegg | 1e-04 | hsa00190 | Oxidative phosphorylation |
L3 | CD19+ B | kegg | 1e-04 | hsa03010 | Ribosome |
L2 | CD19+ B | kegg | 1e-04 | hsa04640 | Hematopoietic cell lineage |
L1 | CD19+ B | kegg | 1e-04 | hsa00190 | Parkinson disease |
L8 | CD19+ B | reactome | 1e-04 | R-HSA-114608, R-HSA-76002 , R-HSA-76005 | Hemostasis |
L8 | CD19+ B | reactome | 1e-04 | R-HSA-114608, R-HSA-76002 , R-HSA-76005 | Platelet degranulation |
L1 | CD19+ B | reactome | 1e-04 | R-HSA-168256 | Immune System |
L8 | CD19+ B | reactome | 1e-04 | R-HSA-114608, R-HSA-76002 , R-HSA-76005 | Platelet activation, signaling and aggregation |
L8 | CD19+ B | reactome | 1e-04 | R-HSA-114608, R-HSA-76002 , R-HSA-76005 | Response to elevated platelet cytosolic Ca2+ |
L3 | CD19+ B | reactome | 1e-04 | R-HSA-212436, R-HSA-74160 | Generic Transcription Pathway |
L3 | CD19+ B | reactome | 1e-04 | R-HSA-212436, R-HSA-74160 | RNA Polymerase II Transcription |
L3 | CD19+ B | reactome | 1e-04 | R-HSA-212436, R-HSA-74160 | Gene expression (Transcription) |
L5 | CD19+ B | reactome | 1e-04 | R-HSA-983168 | Antigen processing: Ubiquitination & Proteasome degradation |
L5 | CD19+ B | reactome | 1e-04 | R-HSA-983168 | Class I MHC mediated antigen processing & presentation |
L7 | CD19+ B | reactome | 1e-04 | R-HSA-72163, R-HSA-72172 | mRNA Splicing - Major Pathway |
L7 | CD19+ B | reactome | 1e-04 | R-HSA-72163, R-HSA-72172 | mRNA Splicing |
L7 | CD19+ B | reactome | 1e-04 | R-HSA-72163, R-HSA-72172 | Processing of Capped Intron-Containing Pre-mRNA |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Signaling by the B Cell Receptor (BCR) |
L4 | CD19+ B | reactome | 1e-04 | R-HSA-1428517, R-HSA-163200 | The citric acid (TCA) cycle and respiratory electron transport |
L4 | CD19+ B | reactome | 1e-04 | R-HSA-1428517, R-HSA-163200 | Respiratory electron transport, ATP synthesis by chemiosmotic coupling, and heat production by uncoupling proteins. |
L4 | CD19+ B | reactome | 1e-04 | R-HSA-1428517, R-HSA-163200 | Respiratory electron transport |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Metabolism of polyamines |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | p53-Dependent G1 DNA Damage Response |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | p53-Dependent G1/S DNA damage checkpoint |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | G1/S DNA Damage Checkpoints |
L7 | CD19+ B | reactome | 1e-04 | R-HSA-72163, R-HSA-72172 | Cleavage of Growing Transcript in the Termination Region |
L7 | CD19+ B | reactome | 1e-04 | R-HSA-72163, R-HSA-72172 | RNA Polymerase II Transcription Termination |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Ubiquitin-dependent degradation of Cyclin D1 |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Ubiquitin-dependent degradation of Cyclin D |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Activation of NF-kappaB in B cells |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Regulation of Hypoxia-inducible Factor (HIF) by oxygen |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Oxygen-dependent proline hydroxylation of Hypoxia-inducible Factor Alpha |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Cross-presentation of soluble exogenous antigens (endosomes) |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Regulation of Apoptosis |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Autodegradation of Cdh1 by Cdh1:APC/C |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | SCF-beta-TrCP mediated degradation of Emi1 |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | APC/C:Cdc20 mediated degradation of Securin |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | APC/C:Cdh1 mediated degradation of Cdc20 and other APC/C:Cdh1 targeted proteins in late mitosis/early G1 |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Cdc20:Phospho-APC/C mediated degradation of Cyclin A |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | APC/C:Cdc20 mediated degradation of mitotic proteins |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | APC:Cdc20 mediated degradation of cell cycle proteins prior to satisfation of the cell cycle checkpoint |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Vpu mediated degradation of CD4 |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Vif-mediated degradation of APOBEC3G |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Regulation of activated PAK-2p34 by proteasome mediated degradation |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Cellular response to hypoxia |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Autodegradation of the E3 ubiquitin ligase COP1 |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Regulation of ornithine decarboxylase (ODC) |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | AUF1 (hnRNP D0) binds and destabilizes mRNA |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Hh mutants that don’t undergo autocatalytic processing are degraded by ERAD |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Degradation of GLI1 by the proteasome |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Assembly of the pre-replicative complex |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Stabilization of p53 |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Ubiquitin Mediated Degradation of Phosphorylated Cdc25A |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | p53-Independent DNA Damage Response |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | p53-Independent G1/S DNA damage checkpoint |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | FBXL7 down-regulates AURKA during mitotic entry and in early mitosis |
L6 | CD19+ B | reactome | 1e-04 | R-HSA-69229 , R-HSA-75815 , R-HSA-1234176, R-HSA-169911 , R-HSA-180534 , R-HSA-180585 , R-HSA-211733 , R-HSA-349425 , R-HSA-69541 , R-HSA-69601 , R-HSA-69610 , R-HSA-69613 | Negative regulation of NOTCH4 signaling |
L2 | CD19+ B | reactome | 1e-04 | R-HSA-156842, R-HSA-156902, R-HSA-192823 | L13a-mediated translational silencing of Ceruloplasmin expression |
L2 | CD19+ B | reactome | 1e-04 | R-HSA-156842, R-HSA-156902, R-HSA-192823 | Formation of a pool of free 40S subunits |
L2 | CD19+ B | reactome | 1e-04 | R-HSA-156842, R-HSA-156902, R-HSA-192823 | GTP hydrolysis and joining of the 60S ribosomal subunit |
L2 | CD19+ B | reactome | 1e-04 | R-HSA-156842, R-HSA-156902, R-HSA-192823 | SRP-dependent cotranslational protein targeting to membrane |
L2 | CD19+ B | reactome | 1e-04 | R-HSA-156842, R-HSA-156902, R-HSA-192823 | Eukaryotic Translation Elongation |
L2 | CD19+ B | reactome | 1e-04 | R-HSA-156842, R-HSA-156902, R-HSA-192823 | Peptide chain elongation |
L2 | CD19+ B | reactome | 1e-04 | R-HSA-156842, R-HSA-156902, R-HSA-192823 | Viral mRNA Translation |
L2 | CD19+ B | reactome | 1e-04 | R-HSA-156842, R-HSA-156902, R-HSA-192823 | Selenocysteine synthesis |
L2 | CD19+ B | reactome | 1e-04 | R-HSA-156842, R-HSA-156902, R-HSA-192823 | Eukaryotic Translation Termination |
L1 | CD19+ B | wikipathway_cancer | 1e-04 | WP619 | Type II interferon signaling (IFNG) |
L2 | CD19+ B | wikipathway | 1e-04 | WP111 | Electron Transport Chain (OXPHOS system in mitochondria) |
L1 | CD19+ B | wikipathway | 1e-04 | WP477 | Cytoplasmic Ribosomal Proteins |
L1 | CD56+ NK | gobp | 1e-04 | GO:0002376 | immune system process |
L4 | CD56+ NK | gobp | 1e-04 | GO:0006119 | nucleoside monophosphate metabolic process |
L4 | CD56+ NK | gobp | 1e-04 | GO:0006119 | purine nucleoside monophosphate metabolic process |
L4 | CD56+ NK | gobp | 1e-04 | GO:0006119 | ribonucleoside monophosphate metabolic process |
L4 | CD56+ NK | gobp | 1e-04 | GO:0006119 | purine ribonucleoside monophosphate metabolic process |
L4 | CD56+ NK | gobp | 1e-04 | GO:0006119 | ATP metabolic process |
L4 | CD56+ NK | gobp | 1e-04 | GO:0006119 | oxidative phosphorylation |
L5 | CD56+ NK | gobp | 1e-04 | GO:0006397, GO:0008380, GO:0000375, GO:0000377, GO:0000398 | mRNA processing |
L5 | CD56+ NK | gobp | 1e-04 | GO:0006397, GO:0008380, GO:0000375, GO:0000377, GO:0000398 | mRNA metabolic process |
L4 | CD56+ NK | gobp | 1e-04 | GO:0006119 | electron transport chain |
L2 | CD56+ NK | gobp | 1e-04 | GO:0045047, GO:0072599, GO:0006614 | protein targeting to ER |
L2 | CD56+ NK | gobp | 1e-04 | GO:0045047, GO:0072599, GO:0006614 | establishment of protein localization to endoplasmic reticulum |
L4 | CD56+ NK | gobp | 1e-04 | GO:0006119 | respiratory electron transport chain |
L4 | CD56+ NK | gobp | 1e-04 | GO:0006119 | ATP synthesis coupled electron transport |
L4 | CD56+ NK | gobp | 1e-04 | GO:0006119 | mitochondrial ATP synthesis coupled electron transport |
L5 | CD56+ NK | gobp | 1e-04 | GO:0006397, GO:0008380, GO:0000375, GO:0000377, GO:0000398 | RNA splicing |
L5 | CD56+ NK | gobp | 1e-04 | GO:0006397, GO:0008380, GO:0000375, GO:0000377, GO:0000398 | RNA splicing, via transesterification reactions |
L5 | CD56+ NK | gobp | 1e-04 | GO:0006397, GO:0008380, GO:0000375, GO:0000377, GO:0000398 | RNA splicing, via transesterification reactions with bulged adenosine as nucleophile |
L5 | CD56+ NK | gobp | 1e-04 | GO:0006397, GO:0008380, GO:0000375, GO:0000377, GO:0000398 | mRNA splicing, via spliceosome |
L2 | CD56+ NK | gobp | 1e-04 | GO:0045047, GO:0072599, GO:0006614 | cotranslational protein targeting to membrane |
L2 | CD56+ NK | gobp | 1e-04 | GO:0045047, GO:0072599, GO:0006614 | SRP-dependent cotranslational protein targeting to membrane |
L1 | CD56+ NK | gobp_nr | 1e-04 | GO:0002446, GO:0036230 | neutrophil mediated immunity |
L2 | CD56+ NK | gobp_nr | 1e-04 | GO:0006413 | translational initiation |
L3 | CD56+ NK | gobp_nr | 1e-04 | GO:0042110 | leukocyte cell-cell adhesion |
L4 | CD56+ NK | gobp_nr | 1e-04 | GO:0009123 | nucleoside monophosphate metabolic process |
L4 | CD56+ NK | gobp_nr | 1e-04 | GO:0009123 | nucleoside triphosphate metabolic process |
L4 | CD56+ NK | gobp_nr | 1e-04 | GO:0009123 | ribonucleotide metabolic process |
L1 | CD56+ NK | gobp_nr | 1e-04 | GO:0002446, GO:0036230 | granulocyte activation |
L3 | CD56+ NK | gobp_nr | 1e-04 | GO:0042110 | T cell activation |
L5 | CD56+ NK | gobp_nr | 1e-04 | GO:0042113 | B cell activation |
L3 | CD56+ NK | gomf | 1e-04 | GO:0000976, GO:0000977, GO:0001012 | transcription regulatory region sequence-specific DNA binding |
L3 | CD56+ NK | gomf | 1e-04 | GO:0000976, GO:0000977, GO:0001012 | RNA polymerase II regulatory region sequence-specific DNA binding |
L3 | CD56+ NK | gomf | 1e-04 | GO:0000976, GO:0000977, GO:0001012 | proximal promoter sequence-specific DNA binding |
L3 | CD56+ NK | gomf | 1e-04 | GO:0000976, GO:0000977, GO:0001012 | RNA polymerase II regulatory region DNA binding |
L3 | CD56+ NK | gomf | 1e-04 | GO:0000976, GO:0000977, GO:0001012 | regulatory region nucleic acid binding |
L3 | CD56+ NK | gomf | 1e-04 | GO:0000976, GO:0000977, GO:0001012 | double-stranded DNA binding |
L3 | CD56+ NK | gomf | 1e-04 | GO:0000976, GO:0000977, GO:0001012 | sequence-specific DNA binding |
L3 | CD56+ NK | gomf | 1e-04 | GO:0000976, GO:0000977, GO:0001012 | transcription regulatory region DNA binding |
L3 | CD56+ NK | gomf | 1e-04 | GO:0000976, GO:0000977, GO:0001012 | sequence-specific double-stranded DNA binding |
L2 | CD56+ NK | gomf | 1e-04 | GO:0000981 | DNA-binding transcription factor activity, RNA polymerase II-specific |
L2 | CD56+ NK | gomf | 1e-04 | GO:0000981 | DNA-binding transcription factor activity |
L1 | CD56+ NK | gomf | 1e-04 | GO:0003735 | structural constituent of ribosome |
L1 | CD56+ NK | kegg | 1e-04 | hsa03010 | Ribosome |
L3 | CD56+ NK | kegg | 1e-04 | hsa04640 | Hematopoietic cell lineage |
L2 | CD56+ NK | kegg | 1e-04 | hsa05012 | Parkinson disease |
L1 | CD56+ NK | reactome | 1e-04 | R-HSA-168256 | Immune System |
L3 | CD56+ NK | reactome | 1e-04 | R-HSA-212436, R-HSA-74160 | Generic Transcription Pathway |
L3 | CD56+ NK | reactome | 1e-04 | R-HSA-212436, R-HSA-74160 | RNA Polymerase II Transcription |
L3 | CD56+ NK | reactome | 1e-04 | R-HSA-212436, R-HSA-74160 | Gene expression (Transcription) |
L5 | CD56+ NK | reactome | 1e-04 | R-HSA-8878171 | Signaling by NOTCH |
L6 | CD56+ NK | reactome | 1e-04 | R-HSA-983168, R-HSA-983169 | Neddylation |
L6 | CD56+ NK | reactome | 1e-04 | R-HSA-983168, R-HSA-983169 | Antigen processing: Ubiquitination & Proteasome degradation |
L6 | CD56+ NK | reactome | 1e-04 | R-HSA-983168, R-HSA-983169 | Class I MHC mediated antigen processing & presentation |
L5 | CD56+ NK | reactome | 1e-04 | R-HSA-8878171 | Transcriptional regulation by RUNX1 |
L4 | CD56+ NK | reactome | 1e-04 | R-HSA-163200 | The citric acid (TCA) cycle and respiratory electron transport |
L4 | CD56+ NK | reactome | 1e-04 | R-HSA-163200 | Respiratory electron transport, ATP synthesis by chemiosmotic coupling, and heat production by uncoupling proteins. |
L4 | CD56+ NK | reactome | 1e-04 | R-HSA-163200 | Respiratory electron transport |
L5 | CD56+ NK | reactome | 1e-04 | R-HSA-8878171 | RUNX1 regulates transcription of genes involved in differentiation of HSCs |
L2 | CD56+ NK | reactome | 1e-04 | R-HSA-156842, R-HSA-156902 | Formation of a pool of free 40S subunits |
L2 | CD56+ NK | reactome | 1e-04 | R-HSA-156842, R-HSA-156902 | Eukaryotic Translation Elongation |
L2 | CD56+ NK | reactome | 1e-04 | R-HSA-156842, R-HSA-156902 | Peptide chain elongation |
L2 | CD56+ NK | reactome | 1e-04 | R-HSA-156842, R-HSA-156902 | Viral mRNA Translation |
L2 | CD56+ NK | reactome | 1e-04 | R-HSA-156842, R-HSA-156902 | Eukaryotic Translation Termination |
L2 | CD56+ NK | wikipathway | 1e-04 | WP111 | Electron Transport Chain (OXPHOS system in mitochondria) |
L2 | CD56+ NK | wikipathway | 1e-04 | WP111 | Oxidative phosphorylation |
L1 | CD56+ NK | wikipathway | 1e-04 | WP477 | Cytoplasmic Ribosomal Proteins |
L1 | T cell | gobp | 1e-04 | GO:0001775 | cell activation |
L5 | T cell | gobp | 1e-04 | GO:0002376 | immune system process |
L5 | T cell | gobp | 1e-04 | GO:0002376 | immune response |
L1 | T cell | gobp | 1e-04 | GO:0001775 | leukocyte activation |
L3 | T cell | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | positive regulation of biological process |
L3 | T cell | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | negative regulation of biological process |
L3 | T cell | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | positive regulation of cellular process |
L3 | T cell | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | apoptotic process |
L3 | T cell | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | cell death |
L3 | T cell | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | regulation of cell death |
L3 | T cell | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | programmed cell death |
L3 | T cell | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | regulation of apoptotic process |
L3 | T cell | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | regulation of programmed cell death |
L3 | T cell | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | apoptotic signaling pathway |
L3 | T cell | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | positive regulation of cell death |
L3 | T cell | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | positive regulation of apoptotic process |
L3 | T cell | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | positive regulation of programmed cell death |
L2 | T cell | gobp | 1e-04 | GO:0006119 | oxidative phosphorylation |
L4 | T cell | gobp | 1e-04 | GO:0070972, GO:0045047, GO:0072599, GO:0006614 | protein localization to endoplasmic reticulum |
L4 | T cell | gobp | 1e-04 | GO:0070972, GO:0045047, GO:0072599, GO:0006614 | protein targeting to ER |
L4 | T cell | gobp | 1e-04 | GO:0070972, GO:0045047, GO:0072599, GO:0006614 | establishment of protein localization to endoplasmic reticulum |
L2 | T cell | gobp | 1e-04 | GO:0006119 | ATP synthesis coupled electron transport |
L2 | T cell | gobp | 1e-04 | GO:0006119 | mitochondrial ATP synthesis coupled electron transport |
L4 | T cell | gobp | 1e-04 | GO:0070972, GO:0045047, GO:0072599, GO:0006614 | cotranslational protein targeting to membrane |
L4 | T cell | gobp | 1e-04 | GO:0070972, GO:0045047, GO:0072599, GO:0006614 | SRP-dependent cotranslational protein targeting to membrane |
L1 | T cell | gobp_nr | 1e-04 | GO:0002446, GO:0036230 | neutrophil mediated immunity |
L1 | T cell | gobp_nr | 1e-04 | GO:0002446, GO:0036230 | granulocyte activation |
L2 | T cell | gobp_nr | 1e-04 | GO:0042110 | T cell activation |
L3 | T cell | gobp_nr | 1e-04 | GO:0070972 | protein localization to endoplasmic reticulum |
L1 | T cell | gomf | 1e-04 | GO:0005515 | protein binding |
L1 | T cell | kegg | 1e-04 | hsa05010 | Alzheimer disease |
L1 | T cell | reactome | 1e-04 | R-HSA-6798695 | Neutrophil degranulation |
L2 | T cell | reactome | 1e-04 | R-HSA-156827, R-HSA-72706 | L13a-mediated translational silencing of Ceruloplasmin expression |
L2 | T cell | reactome | 1e-04 | R-HSA-156827, R-HSA-72706 | Eukaryotic Translation Initiation |
L2 | T cell | reactome | 1e-04 | R-HSA-156827, R-HSA-72706 | Formation of a pool of free 40S subunits |
L2 | T cell | reactome | 1e-04 | R-HSA-156827, R-HSA-72706 | GTP hydrolysis and joining of the 60S ribosomal subunit |
L2 | T cell | reactome | 1e-04 | R-HSA-156827, R-HSA-72706 | Cap-dependent Translation Initiation |
L2 | T cell | reactome | 1e-04 | R-HSA-156827, R-HSA-72706 | Peptide chain elongation |
L2 | T cell | reactome | 1e-04 | R-HSA-156827, R-HSA-72706 | Viral mRNA Translation |
L4 | CD14+ Monocyte | gobp | 1e-04 | GO:0016192 | transport |
L4 | CD14+ Monocyte | gobp | 1e-04 | GO:0016192 | exocytosis |
L4 | CD14+ Monocyte | gobp | 1e-04 | GO:0016192 | vesicle-mediated transport |
L4 | CD14+ Monocyte | gobp | 1e-04 | GO:0016192 | regulated exocytosis |
L4 | CD14+ Monocyte | gobp | 1e-04 | GO:0016192 | establishment of localization |
L1 | CD14+ Monocyte | gobp | 1e-04 | GO:0001775, GO:0045321 | cell activation |
L4 | CD14+ Monocyte | gobp | 1e-04 | GO:0016192 | immune system process |
L4 | CD14+ Monocyte | gobp | 1e-04 | GO:0016192 | immune response |
L4 | CD14+ Monocyte | gobp | 1e-04 | GO:0016192 | neutrophil activation |
L1 | CD14+ Monocyte | gobp | 1e-04 | GO:0001775, GO:0045321 | leukocyte activation |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | response to stimulus |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | response to stress |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | positive regulation of biological process |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | negative regulation of biological process |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | negative regulation of cellular process |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | regulation of catalytic activity |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | cellular response to stimulus |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | cellular response to chemical stimulus |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | positive regulation of cellular process |
L6 | CD14+ Monocyte | gobp | 1e-04 | GO:0006412, GO:0006518, GO:0043043 | cellular amide metabolic process |
L6 | CD14+ Monocyte | gobp | 1e-04 | GO:0006412, GO:0006518, GO:0043043 | amide biosynthetic process |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | response to organic substance |
L6 | CD14+ Monocyte | gobp | 1e-04 | GO:0006412, GO:0006518, GO:0043043 | translation |
L6 | CD14+ Monocyte | gobp | 1e-04 | GO:0006412, GO:0006518, GO:0043043 | peptide metabolic process |
L6 | CD14+ Monocyte | gobp | 1e-04 | GO:0006412, GO:0006518, GO:0043043 | peptide biosynthetic process |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | apoptotic process |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | cell death |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | regulation of cell death |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | programmed cell death |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | regulation of apoptotic process |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | negative regulation of apoptotic process |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | regulation of programmed cell death |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | negative regulation of programmed cell death |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | negative regulation of cell death |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | apoptotic signaling pathway |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | positive regulation of cell death |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | positive regulation of apoptotic process |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | positive regulation of programmed cell death |
L3 | CD14+ Monocyte | gobp | 1e-04 | GO:0006119 | oxidative phosphorylation |
L5 | CD14+ Monocyte | gobp | 1e-04 | GO:0006915, GO:0008219, GO:0010941, GO:0012501, GO:0042981, GO:0043067 | regulation of apoptotic signaling pathway |
L7 | CD14+ Monocyte | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | mRNA processing |
L7 | CD14+ Monocyte | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | mRNA metabolic process |
L2 | CD14+ Monocyte | gobp | 1e-04 | GO:0045047, GO:0006613, GO:0006614 | protein localization to endoplasmic reticulum |
L2 | CD14+ Monocyte | gobp | 1e-04 | GO:0045047, GO:0006613, GO:0006614 | protein targeting to ER |
L2 | CD14+ Monocyte | gobp | 1e-04 | GO:0045047, GO:0006613, GO:0006614 | establishment of protein localization to endoplasmic reticulum |
L3 | CD14+ Monocyte | gobp | 1e-04 | GO:0006119 | ATP synthesis coupled electron transport |
L3 | CD14+ Monocyte | gobp | 1e-04 | GO:0006119 | mitochondrial ATP synthesis coupled electron transport |
L7 | CD14+ Monocyte | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | RNA splicing |
L7 | CD14+ Monocyte | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | RNA splicing, via transesterification reactions |
L7 | CD14+ Monocyte | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | RNA splicing, via transesterification reactions with bulged adenosine as nucleophile |
L7 | CD14+ Monocyte | gobp | 1e-04 | GO:0008380, GO:0000375, GO:0000377, GO:0000398 | mRNA splicing, via spliceosome |
L2 | CD14+ Monocyte | gobp | 1e-04 | GO:0045047, GO:0006613, GO:0006614 | cotranslational protein targeting to membrane |
L2 | CD14+ Monocyte | gobp | 1e-04 | GO:0045047, GO:0006613, GO:0006614 | SRP-dependent cotranslational protein targeting to membrane |
L1 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0036230 | neutrophil mediated immunity |
L4 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0002521, GO:0042110 | leukocyte differentiation |
L4 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0002521, GO:0042110 | regulation of leukocyte activation |
L5 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0006397, GO:0008380 | mRNA processing |
L2 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0006413 | translational initiation |
L6 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0070972, GO:0090150 | protein targeting |
L5 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0006397, GO:0008380 | RNA splicing |
L3 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0009123 | nucleoside monophosphate metabolic process |
L3 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0009123 | nucleoside triphosphate metabolic process |
L1 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0036230 | granulocyte activation |
L4 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0002521, GO:0042110 | T cell activation |
L6 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0070972, GO:0090150 | protein localization to endoplasmic reticulum |
L6 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0070972, GO:0090150 | establishment of protein localization to membrane |
L5 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0006397, GO:0008380 | regulation of mRNA metabolic process |
L4 | CD14+ Monocyte | gobp_nr | 1e-04 | GO:0002521, GO:0042110 | regulation of hemopoiesis |
L1 | CD14+ Monocyte | gomf | 1e-04 | GO:0003723 | RNA binding |
L3 | CD14+ Monocyte | gomf | 1e-04 | GO:0000977, GO:0001012 | transcription regulatory region sequence-specific DNA binding |
L3 | CD14+ Monocyte | gomf | 1e-04 | GO:0000977, GO:0001012 | RNA polymerase II regulatory region sequence-specific DNA binding |
L3 | CD14+ Monocyte | gomf | 1e-04 | GO:0000977, GO:0001012 | RNA polymerase II proximal promoter sequence-specific DNA binding |
L3 | CD14+ Monocyte | gomf | 1e-04 | GO:0000977, GO:0001012 | proximal promoter sequence-specific DNA binding |
L3 | CD14+ Monocyte | gomf | 1e-04 | GO:0000977, GO:0001012 | RNA polymerase II regulatory region DNA binding |
L3 | CD14+ Monocyte | gomf | 1e-04 | GO:0000977, GO:0001012 | sequence-specific DNA binding |
L3 | CD14+ Monocyte | gomf | 1e-04 | GO:0000977, GO:0001012 | transcription regulatory region DNA binding |
L3 | CD14+ Monocyte | gomf | 1e-04 | GO:0000977, GO:0001012 | sequence-specific double-stranded DNA binding |
L6 | CD14+ Monocyte | gomf | 1e-04 | GO:0050839, GO:0045296 | cell adhesion molecule binding |
L6 | CD14+ Monocyte | gomf | 1e-04 | GO:0050839, GO:0045296 | cadherin binding |
L5 | CD14+ Monocyte | gomf | 1e-04 | GO:0016655, GO:0008137, GO:0050136 | oxidoreductase activity, acting on NAD(P)H |
L5 | CD14+ Monocyte | gomf | 1e-04 | GO:0016655, GO:0008137, GO:0050136 | oxidoreductase activity, acting on NAD(P)H, quinone or similar compound as acceptor |
L2 | CD14+ Monocyte | gomf | 1e-04 | GO:0000981 | DNA-binding transcription factor activity, RNA polymerase II-specific |
L2 | CD14+ Monocyte | gomf | 1e-04 | GO:0000981 | DNA-binding transcription factor activity |
L4 | CD14+ Monocyte | gomf | 1e-04 | GO:0003735 | structural constituent of ribosome |
L5 | CD14+ Monocyte | gomf | 1e-04 | GO:0016655, GO:0008137, GO:0050136 | NADH dehydrogenase activity |
L5 | CD14+ Monocyte | gomf | 1e-04 | GO:0016655, GO:0008137, GO:0050136 | NADH dehydrogenase (ubiquinone) activity |
L5 | CD14+ Monocyte | gomf | 1e-04 | GO:0016655, GO:0008137, GO:0050136 | NADH dehydrogenase (quinone) activity |
L1 | CD14+ Monocyte | kegg | 1e-04 | hsa03010 | Ribosome |
L2 | CD14+ Monocyte | kegg | 1e-04 | hsa05012 | Parkinson disease |
L1 | CD14+ Monocyte | reactome | 1e-04 | R-HSA-6798695 | Neutrophil degranulation |
L6 | CD14+ Monocyte | reactome | 1e-04 | R-HSA-198933 | Immunoregulatory interactions between a Lymphoid and a non-Lymphoid cell |
L5 | CD14+ Monocyte | reactome | 1e-04 | R-HSA-72163, R-HSA-72172 | mRNA Splicing - Major Pathway |
L5 | CD14+ Monocyte | reactome | 1e-04 | R-HSA-72163, R-HSA-72172 | mRNA Splicing |
L5 | CD14+ Monocyte | reactome | 1e-04 | R-HSA-72163, R-HSA-72172 | Processing of Capped Intron-Containing Pre-mRNA |
L2 | CD14+ Monocyte | reactome | 1e-04 | R-HSA-72766 | Translation |
L3 | CD14+ Monocyte | reactome | 1e-04 | R-HSA-163200 | Respiratory electron transport, ATP synthesis by chemiosmotic coupling, and heat production by uncoupling proteins. |
L3 | CD14+ Monocyte | reactome | 1e-04 | R-HSA-163200 | Respiratory electron transport |
L7 | CD14+ Monocyte | reactome | 1e-04 | R-HSA-379726 | Mitochondrial tRNA aminoacylation |
L2 | CD14+ Monocyte | wikipathway | 1e-04 | WP111 | Electron Transport Chain (OXPHOS system in mitochondria) |
L1 | CD14+ Monocyte | wikipathway | 1e-04 | WP477 | Cytoplasmic Ribosomal Proteins |
L1 | CD34+ | gobp | 1e-04 | GO:0001775 | cell activation |
L1 | CD34+ | gobp | 1e-04 | GO:0001775 | leukocyte activation |
L3 | CD34+ | gobp | 1e-04 | GO:0006119 | oxidative phosphorylation |
L4 | CD34+ | gobp | 1e-04 | GO:0016032, GO:0044403, GO:0044419 | viral process |
L4 | CD34+ | gobp | 1e-04 | GO:0016032, GO:0044403, GO:0044419 | symbiont process |
L4 | CD34+ | gobp | 1e-04 | GO:0016032, GO:0044403, GO:0044419 | interspecies interaction between organisms |
L2 | CD34+ | gobp | 1e-04 | GO:0006613, GO:0006614 | protein targeting to ER |
L2 | CD34+ | gobp | 1e-04 | GO:0006613, GO:0006614 | establishment of protein localization to endoplasmic reticulum |
L3 | CD34+ | gobp | 1e-04 | GO:0006119 | ATP synthesis coupled electron transport |
L3 | CD34+ | gobp | 1e-04 | GO:0006119 | mitochondrial ATP synthesis coupled electron transport |
L2 | CD34+ | gobp | 1e-04 | GO:0006613, GO:0006614 | cotranslational protein targeting to membrane |
L2 | CD34+ | gobp | 1e-04 | GO:0006613, GO:0006614 | SRP-dependent cotranslational protein targeting to membrane |
L1 | CD34+ | gobp_nr | 1e-04 | GO:0002446, GO:0036230 | neutrophil mediated immunity |
L2 | CD34+ | gobp_nr | 1e-04 | GO:0006413 | translational initiation |
L1 | CD34+ | gobp_nr | 1e-04 | GO:0002446, GO:0036230 | granulocyte activation |
L2 | CD34+ | gomf | 1e-04 | GO:0005515 | protein binding |
L1 | CD34+ | gomf | 1e-04 | GO:0003735 | structural constituent of ribosome |
L1 | CD34+ | kegg | 1e-04 | hsa00190 | Oxidative phosphorylation |
L2 | CD34+ | kegg | 1e-04 | hsa03010 | Ribosome |
L1 | CD34+ | kegg | 1e-04 | hsa00190 | Parkinson disease |
L2 | CD34+ | reactome | 1e-04 | R-HSA-6798695 | Innate Immune System |
L2 | CD34+ | reactome | 1e-04 | R-HSA-6798695 | Neutrophil degranulation |
L4 | CD34+ | reactome | 1e-04 | R-HSA-198933 | Immunoregulatory interactions between a Lymphoid and a non-Lymphoid cell |
L3 | CD34+ | reactome | 1e-04 | R-HSA-163200 | Respiratory electron transport, ATP synthesis by chemiosmotic coupling, and heat production by uncoupling proteins. |
L3 | CD34+ | reactome | 1e-04 | R-HSA-163200 | Respiratory electron transport |
L1 | CD34+ | reactome | 1e-04 | R-HSA-72764 | Eukaryotic Translation Elongation |
L1 | CD34+ | reactome | 1e-04 | R-HSA-72764 | Peptide chain elongation |
L1 | CD34+ | reactome | 1e-04 | R-HSA-72764 | Eukaryotic Translation Termination |
L2 | CD34+ | wikipathway | 1e-04 | WP111 | Electron Transport Chain (OXPHOS system in mitochondria) |
L1 | CD34+ | wikipathway | 1e-04 | WP477 | Cytoplasmic Ribosomal Proteins |
knitr::knit_exit()