R TUTORIAL:

Perform pathway enrichment analysis with clusterProfiler() in R

Table of contents

5
Before you start
5
Step-by-step clusterProfiler tutorial
9
Step 0: Set up your script and load the data
9
Step 1: Prepare inputs for clusterProfiler
9
Step 2: Run clusterProfiler
9
Step 3: Visualise your pathway enrichment analysis results
5
SessionInfo()

Before you start…

Welcome to Biostatsquid’s easy and step-by-step tutorial on ClusterProfiler! In this guide, we will explore an essential tool for functional enrichment analysis and interpretation of gene sets or clusters of genes.

So what does clusterProfiler do? Functional enrichment analysis plays a crucial role in understanding the biological processes, molecular functions, and cellular components associated with a set of genes. CluserProfiler will allow us to identify and visualize enriched functional terms, such as Gene Ontology (GO) terms and biological pathways, within our gene sets.

Throughout this tutorial, we will walk you through the key features and steps involved in using ClusterProfiler. You will learn how to annotate genes, perform enrichment analysis, apply multiple testing correction, and interpret the results. In part 2, we will explore the various visualization techniques available in ClusterProfiler, helping you gain a comprehensive understanding of the enriched functional annotations.

For this tutorial you will need R, or Rstudio, and you will need to install the following packages:

# For data management
install.packages('tidyverse')
BiocManager::install("clusterProfiler")
BiocManager::install("org.Hs.eg.db")
# For visualisation
install.packages('pheatmap')
install.packages("DOSE")
install.packages("enrichplot")
install.packages("ggupset")

If you are a beginner in R, don’t be overwhelmed! This tutorial will go step-by-step and I will explain (almost!) every line of code so you know what is happening at each point of the workflow.

You might also want to check out my Youtube tutorial on how to do pathway enrichment analysis using clusterProfiler. Or if you prefer a written step-by-step guide, then continue reading and don’t forget you can just copy the code by clicking on the top right corner of the code snippets in this post.

But enough introduction! Ready to enter the world of functional enrichment analysis with ClusterProfiler? Let’s dive in!

Squidtip

Want to know more about functional enrichment analysis? Check out my blogposts on Pathway Enrichment Analysis and Gene Set Enrichment Analysis – simply explained!

In this Youtube video, I explain how to do Pathway Enrichment Analysis with the R package clusterProfiler()!

Step-by-step clusterProfiler tutorial

The dataset

For this tutorial, I will use the differential gene expression results we used in my volcano plots tutorial. It is the human COVID T cell single-cell RNA-seq dataset from Bacher et al. (2020). You can read more about the dataset and obtain it for free here.

I already pre-processed the data and carried out the differential gene expression analysis between severe and healthy samples for Tfh-like cells. To follow this tutorial, you can just download the DGE results here. Right click, then ‘Save link as’.

If you would like to use your own data, you just need a simple gene expression dataframe with the following columns:

  • gene_symbol: the gene symbols (or IDs, i.e., ENSEMBLE IDs)
  • pval: p-values from your differential gene expression analysis.
  • padj: p-adjusted values from your differential gene expression analysis (p-value is enough)
  • log2fc: your log2 fold change values, showing the direction of the change (upregulation or downregulation).

Step 0: Set up your script and load the data

Before we start, it’s always good practice to clean-up our environment in case we have hidden objects in the background, free up memory, and set our working directory. We also need to load the necessary libraries. Today we will be working with clusterProfiler() package, and several other R libraries for data visualisation and management. You might need to install them first using install.packages() or BiocManager::install().

# Setting up environment ===================================================

# Clean environment
rm(list = ls(all.names = TRUE)) # will clear all objects including hidden objects
gc() # free up memory and report the memory usage
options(max.print = .Machine$integer.max, scipen = 999, stringsAsFactors = F, dplyr.summarise.inform = F) # avoid truncated output in R console and scientific notation


# Loading relevant libraries 
library(tidyverse) # includes ggplot2, for data visualisation. dplyr, for data manipulation.
library(RColorBrewer) # for a colourful plot
library(pheatmap)
library(clusterProfiler) # for PEA analysis
library('org.Hs.eg.db')
library(DOSE)
library(enrichplot) # for visualisations
library(ggupset) # for visualisations

# Set input path
in_path <- "Datasets/" # input path, where your data is located
out_path <- "PEA/Results/" # output path, where you want your results exported to
bg_path <- "PEA/Background_genes/" # folder with your background genes used for PEA

Additionally, we will define a function, matrix_to_list(), which takes an adjacency matrix as input and converts it into a list representation, which will be the format we will manage through our analysis.

# Functions ------------------------------------------------
## Function: Adjacency matrix to list ####
matrix_to_list <- function(pws){
  pws.l <- list()
  for (pw in colnames(pws)) {
    pws.l[[pw]] <- rownames(pws)[as.logical(pws[, pw])]
  }
  return(pws.l)
}

Let’s get started! The first step is of course to load our differential gene expression results. If you have your own dataset, just read it into RStudio, and make sure you have a dataframe as I describe above. We can also add a new column, diffexpressed, which indicates whether a gene is UPregulated, DOWNregulated or NOt differentially expressed. I used a log2fc = 0 and p-adjusted value of 0.05 to define the thresholds, but you might want to tweak it depending on how permissive you want to be (or how many differentially expressed genes you have!).

# Read in data ===================================================
list.files(in_path)
df <- read.csv(paste0(in_path, 'severevshealthy_degresults.csv'), row.names = 1)

# Annotate according to differential expression
df <- df %>% mutate(diffexpressed = case_when(
  log2fc > 0 & padj < 0.05 ~ 'UP',
  log2fc < 0 & padj < 0.05 ~ 'DOWN',
  padj > 0.05 ~ 'NO'
))
Squidtip

Did you notice? Instead of writing the full path of my data file (e.g., ‘/home/Biostatsquid/Scripts/rnaseq/PEA/Datasets/severevshealthy_degresults.csv’), I just pasted together in_path (which I previously defined as ‘Datasets/’), and the name of the file, ‘severevshealthy_degresults.csv’ with the paste0 function.

Ok! So before we can start our analysis we need to check what clusterProfiler needs. If you would like to read more about the method, I recommend reading the publication. The reference manual lists all the functions of the package.

For the sake of making this tutorial as generalisable as possible, I will explain how to use the enricher() function which allows you to use any set of background genes.

  • This means we will need a bit more code to provide the background gene list. But don’t worry, we will go through all of the steps, it’s easier than you think! This is a more customisable way of doing things, but a bit more complicated (not too much though!)
  • However, clusterProfiler already provides functions for some pathway databases like enrichKEGG() and enrichGO(). So take a look at the clusterProfiler package, it has a lot to offer!

 

Step 1: Prepare inputs for clusterProfiler

Prepare background genes

1. Get your gene set .gmt files. For example, you can download them from:

https://www.gsea-msigdb.org/gsea/msigdb/collections.jsp

Just select ‘Gene Symbols’.

2. Filter the .gmt file and convert it to a format accepted by clusterProfiler. As I explain in my previous post, we need to use a set of background genes that contain only the genes present in our dataframe, to avoid bias. You can use the following code:

# Get the genes that are present in your dataframe
genes_in_data <- df$gene_symbol

# Read in the .gmt file
file <- "PEA/Background_genes/c2.cp.kegg.v7.5.1.symbols.gmt"
pwl2 <- read.gmt(file) 
# Subset to the genes that are present in our dataset
pwl2 <- pwl2[pwl2$gene %in% genes_in_data,] 
# Save the filtered background gene set
filename <- 'kegg.RDS'
saveRDS(pwl2, filename)

            
# SQUIDTIP! If you want to parse several .gmt files at once, you can use a loop:
gmt_files <- list.files(path = bg_path, pattern = '.gmt', full.names = TRUE)
for (file in gmt_files){
	file <- gmt_files[1]
        pwl2 <- read.gmt(file) 
	pwl2 <- pwl2[pwl2$gene %in% genes_in_data,]
        filename <- paste(gsub('c.\\.', '', gsub('.v7.5.*$', '', file)), '.RDS', sep = '')
	saveRDS(pwl2, filename)
}

You should now have an .RDS file with the background genes in your folder.

Basically, it should look like this:

Prepare differential gene expression results

We will:

  • Remove non-significant genes: since we only want the enriched pathways of the significantly differentially expressed genes.
  • Substitute names so they are annotated nicely in the heatmap later
  • Split the data into a list of 2 sub-dataframes: upregulated, downregulated genes.
## Prepare deg results -----------------------------------------------

# If you forgot to do that before, annotate according to differential expression
df <- df %>% mutate(diffexpressed = case_when(
  log2fc > 0 & padj < 0.05 ~ 'UP',
  log2fc < 0 & padj < 0.05 ~ 'DOWN',
  padj > 0.05 ~ 'NO'
  
))

# Remove non-significant genes
df <- df[df$diffexpressed != 'NO', ]

# Substitute names so they are annotated nicely in the heatmap later
df$diffexpressed <- gsub('DOWN', 'Healthy', gsub('UP', 'Severe', df$diffexpressed))
unique(df$diffexpressed)

# Split the dataframe into a list of sub-dataframes: upregulated, downregulated genes
deg_results_list <- split(df, df$diffexpressed)

Step 2: Run clusterProfiler

Wohoo! After all these steps… we are finally ready to run clusterProfiler! Are you excited?

First, let’s set some variables. This is not essential but it will make your life easier in case you need to change them later on.

## Run ClusterProfiler -----------------------------------------------

# Settings
name_of_comparison <- 'severevshealthy' # for our filename
background_genes <- 'reactome' # for our filename
bg_genes <- readRDS(paste0(bg_path, 'reactome.RDS')) # read in the background genes
padj_cutoff <- 0.05 # p-adjusted threshold, used to filter out pathways
genecount_cutoff <- 5 # minimum number of genes in the pathway, used to filter out pathways
filename <- paste0(out_path, 'clusterProfiler/', name_of_comparison, '_', background_genes) # filename of our PEA results
Squidtip

You don’t need to set all these variables to run clusterProfiler.

But! If you have a lot of differential gene expression results and/or background gene sets… you will have to copy paste your code maaany times and just change a few names… This is very tedious, time-consuming and error-prone! A bit of code can save you a lot of time. If you haven’t thought about it yet- I’m talking about building your own function!

These variables set-up is a good place to start. If you are interested in a blogpost explaining how to create a function that runs clusterProfiler and outputs your results and plots by just giving it a few variables – leave me a comment down below!

# SQUIDTIP! An option to read in your background genes by only defining your 'background_genes' variable
if(background_genes == 'KEGG'){
  bg_genes <- readRDS(paste0(bg_path, 'kegg.RDS'))
} else if(background_genes == 'reactome'){
  bg_genes <- readRDS(paste0(bg_path, 'reactome.RDS'))
} else if(background_genes == 'go.bp'){
  bg_genes <- readRDS(paste0(bg_path, 'go.bp.RDS'))
} else {
  stop('Invalid background genes. Select one of the following: KEGG, Reactome, GO, or add new pwl to function')
}

Now that we have our background genes and our differential expressed genes ready… let’s call the enricher() function from clusterProfiler.

We use lapply as we are applying the function to our list (remember we split the data into a list of 2 subsets).

# Run clusterProfiler on each sub-dataframe
res <- lapply(names(deg_results_list),
                 function(x) enricher(gene = deg_results_list[[x]]$gene_symbol,
                                      TERM2GENE = bg_genes))
names(res) <- names(deg_results_list)

#Convert the list of enrichResults for each sample_pattern to a dataframe with the pathways
res_df <- lapply(names(res), function(x) rbind(res[[x]]@result))
names(res_df) <- names(res)
res_df <- do.call(rbind, res_df)
head(res_df)

Great! We now have a list with our pathway enrichment analysis results. Let’s make it more readable and convert it to a dataframe with the following lines of code:

#Convert the enrichResults to a dataframe with the pathways
res_df <- lapply(names(res), function(x) rbind(res[[x]]@result))
names(res_df) <- names(res)
res_df <- do.call(rbind, res_df)
head(res_df)

And maybe add a few more columns to our dataframe (I use the gsub() function to make the pathways names shorter):

res_df <- res_df %>% mutate(minuslog10padj = -log10(p.adjust),
                                  diffexpressed = gsub('\\.GOBP.*$|\\.KEGG.*$|\\.REACTOME.*$', '', rownames(res_df)))

Now, we can subset our results. Filter the significant pathways according to p-adjusted threshold and gene count.

# Subset to those pathways that have p adj < cutoff and gene count > cutoff (you can also do this in the enricher function)
target_pws <- unique(res_df$ID[res_df$p.adjust < padj_cutoff & res_df$Count > genecount_cutoff]) # select only target pathways have p adjusted < 0.05 and at least 6 genes
res_df <- res_df[res_df$ID %in% target_pws, ]
Squidtip

Feel free to adjust these thresholds to your own results! You might need to play around with the numbers until you find what best suits your dataset and your goal.

Finally, don’t forget to save your results!

print('Saving clusterprofiler results')
write.csv(res_df, paste0(filename, '_resclusterp.csv'), row.names = FALSE)

Step 3: Visualise your pathway enrichment analysis results

Now it’s time for the fun part! Let’s explore our results by plotting them in different ways.

Check how to visualise your clusterProfiler results and create pretty plots here: Visualisation of pathway enrichment results.

sessionInfo()

Check my sessionInfo() here in case you have trouble reproducting my steps:

> sessionInfo()
R version 4.2.3 (2023-03-15 ucrt)
Platform: x86_64-w64-mingw32/x64 (64-bit)
Running under: Windows 10 x64 (build 22621)

Matrix products: default

locale:
[1] LC_COLLATE=English_Ireland.utf8  LC_CTYPE=English_Ireland.utf8    LC_MONETARY=English_Ireland.utf8 LC_NUMERIC=C                    
[5] LC_TIME=English_Ireland.utf8    

attached base packages:
[1] stats4    stats     graphics  grDevices utils     datasets  methods   base     

other attached packages:
 [1] ggupset_0.3.0         enrichplot_1.18.4     DOSE_3.24.2           org.Hs.eg.db_3.16.0   AnnotationDbi_1.60.2  IRanges_2.32.0       
 [7] S4Vectors_0.36.2      Biobase_2.58.0        BiocGenerics_0.44.0   clusterProfiler_4.6.2 fgsea_1.24.0          mgsa_1.46.0          
[13] gplots_3.1.3          pheatmap_1.0.12       RColorBrewer_1.1-3    lubridate_1.9.2       forcats_1.0.0         stringr_1.5.0.9000   
[19] dplyr_1.0.10          purrr_1.0.1           readr_2.1.4           tidyr_1.2.1           tibble_3.1.8          ggplot2_3.4.2        
[25] tidyverse_2.0.0      

loaded via a namespace (and not attached):
 [1] colorspace_2.1-0       ggtree_3.6.2           gson_0.1.0             ellipsis_0.3.2         qvalue_2.30.0         
 [6] XVector_0.38.0         aplot_0.1.10           rstudioapi_0.14        farver_2.1.1           graphlayouts_1.0.0    
[11] ggrepel_0.9.3          bit64_4.0.5            scatterpie_0.2.1       fansi_1.0.3            codetools_0.2-19      
[16] splines_4.2.3          cachem_1.0.8           GOSemSim_2.24.0        polyclip_1.10-4        jsonlite_1.8.7        
[21] GO.db_3.16.0           png_0.1-8              ggforce_0.4.1          compiler_4.2.3         httr_1.4.6            
[26] Matrix_1.5-3           fastmap_1.1.1          lazyeval_0.2.2         cli_3.6.0              tweenr_2.0.2          
[31] tools_4.2.3            igraph_1.5.0           gtable_0.3.3           glue_1.6.2             GenomeInfoDbData_1.2.9
[36] reshape2_1.4.4         fastmatch_1.1-3        Rcpp_1.0.11            vctrs_0.5.1            Biostrings_2.66.0     
[41] ape_5.7-1              nlme_3.1-162           ggraph_2.1.0           timechange_0.2.0       lifecycle_1.0.3       
[46] gtools_3.9.4           zlibbioc_1.44.0        MASS_7.3-58.2          scales_1.2.1           tidygraph_1.2.3       
[51] hms_1.1.3              parallel_4.2.3         memoise_2.0.1          gridExtra_2.3          downloader_0.4        
[56] ggfun_0.1.1            HDO.db_0.99.1          yulab.utils_0.0.6      stringi_1.7.12         RSQLite_2.3.1         
[61] tidytree_0.4.2         caTools_1.18.2         BiocParallel_1.32.6    GenomeInfoDb_1.34.9    rlang_1.1.1           
[66] pkgconfig_2.0.3        bitops_1.0-7           lattice_0.20-45        treeio_1.22.0          patchwork_1.1.2       
[71] shadowtext_0.1.2       cowplot_1.1.1          bit_4.0.5              tidyselect_1.2.0       plyr_1.8.8            
[76] magrittr_2.0.3         R6_2.5.1               generics_0.1.3         DBI_1.1.3              pillar_1.9.0          
[81] withr_2.5.0            KEGGREST_1.38.0        RCurl_1.98-1.12        crayon_1.5.2           KernSmooth_2.23-20    
[86] utf8_1.2.2             tzdb_0.4.0             viridis_0.6.3          grid_4.2.3             data.table_1.14.8     
[91] blob_1.2.4             digest_0.6.33          gridGraphics_0.5-1     munsell_0.5.0          viridisLite_0.4.2     
[96] ggplotify_0.1.1 

And that is the end of this tutorial!

In this post, I explained how to perform functional enrichment analysis using clusterProfiler. Hope you found it useful!

Before you go, you might want to check:

Squidtastic!

You made it till the end! Hope you found this post useful.

If you have any questions, or if there are any more topics you would like to see here, leave me a comment down below.

Otherwise, have a very nice day and… see you in the next one!

28 Comments
  1. This is a really helpful to us. Thank you very much for this great effort.
    We are also expecting ROC, OPLDA and PCA.

    Reply
    • Hi Mukhtar, thank you so much for your comment and suggestions! Definitely great ideas for my upcoming posts/videos:) I already have a post on PCA which you can find here: https://biostatsquid.com/pca-simply-explained/ (but if there is something particular you would like explained about PCA, do let me know!)

      Reply
  2. very Informative,🌹🌹 waiting for visualization🥺

    Reply
  3. Hi,

    thank you for uploading this! it is so helpfull.
    I have a question about this section:
    bg_path <- "PEA/Background_genes/" # folder with your background genes used for PEA

    this is a folder with background genes. but how do you create such folder? What type of file or directory should be uploaded in this folder?

    Reply
    • Hi Raisa, thanks for your comment! bg_path is just a folder where I saved all the .gmt files which I downloaded from msigdb (check the section: ‘Prepare background genes’). You don’t really need it, you can also just save those files in your results folder and just use 1 folder for everything.
      As for your question, how do you create it, you can just create it like any other folder, wherever you want it (I don’t know if you have Windows or Mac, but just on the file explorer > create folder > give it a name > and then just move your .gmt files there). Alternatively you can also create that folder within R with the command ‘dir.create()’.
      If you check step 2 ‘2. Filter the .gmt file and convert it to a format accepted by clusterProfiler.’, you will see that when reading the .gmt file I am specifying the full path (file <- "PEA/Background_genes/c2.cp.kegg.v7.5.1.symbols.gmt") but you could also write: file <- paste0(bg_path, 'c2.cp.kegg.v7.5.1.symbols.gmt') Hopefully that made sense! If you have more questions, don't hesitate to ask:)

      Reply
  4. Hi there! Many many thanks for this tutorial…! I had a small question-

    We filtered our DEGs against KEGG in the following step-

    # Read in the .gmt file
    file <- "PEA/Background_genes/c2.cp.kegg.v7.5.1.symbols.gmt"
    pwl2 <- read.gmt(file)
    # Subset to the genes that are present in our dataset
    pwl2 <- pwl2[pwl2$gene %in% genes_in_data,]
    # Save the filtered background gene set
    filename <- 'kegg.RDS'

    Then why did we choose REACTOME as bg_genes while running clusterProfiler.
    # Settings
    name_of_comparison <- 'severevshealthy' # for our filename
    background_genes <- 'reactome' # for our filename
    bg_genes <- readRDS(paste0(bg_path, 'reactome.RDS')) # read in the background genes

    Shouldn't the later one be KEGG too with all genes (unfiltered)?

    Apologies if I missed something or if asking a naive question! 🙂

    Many many thanks:)

    Reply
    • Hi! Thanks so much for your comment and the feedback:) You are totally right, well spotted!! I totally missed that one. Since I ran it with different gene sets I created all the .RDS files of filtered gene sets and then tested them out – I corrected it now just to keep it consistent. Thanks so much for letting me know!

      Reply
  5. Should the codes in this chunk:

    # Subset to those pathways that have p adj cutoff (you can also do this in the enricher function)
    target_pws <- unique(res_df$ID[res_df$p.adjust genecount_cutoff]) # select only target pathways have p adjusted < 0.05 and at least 6 genes
    res_df <- res_df[res_df$ID %in% target_pws, ]

    be corrected to:

    res_df % filter(p.adjust genecount_cutoff)

    as there are some cases when one of the two directions (up or down) of pathways with the same name do not pass padj_cutoff, so directly filtering the values themselves would be more accurate?

    Reply
    • **res_df %>% filter(p.adjust genecount_cutoff)

      Reply
    • Hi! Thanks so much for your comment, and sorry for the late reply.
      I’m not sure if I understand – you’d like to filter only based on gene count? What I do is select only pathways that are significant (p-adj < 0.05) and have at least 6 genes. I think the code in your comment might be missing a few symbols - could you let me know again how you propose to filter the pathways? Since you already filtered for upregulated genes BEFORE you ran clusterProfiler, the results should only show you pathways that are enriched with up- OR downregulated genes. But please let me know what you mean! And thanks so much for your improvement suggestion - always happy to correct my code:)

      Reply
  6. Hi there!
    I’m newbie to R, so pretty sure I’m missing something obvious.
    When I read a .gmt file (KEGG for example), pwl2 shows 12797 obs and 2 variables
    plus, genes_in_data from my deg list return 14695 elements. So far, so good.

    Now, to check the subset to the genes that are present in my dataset by running>
    pwl2 <- pwl2[pwl2$gene %in% genes_in_data,], pwl2 returns 0 obs. and 2 variables!

    I wondered if it was an issue with me using Ensemble IDs, but the issue remains even with a file containing gene symbols instead of Ensemble IDs.

    Please advise.

    Reply
    • Hi Ashish, really sorry for the late reply! It’s a bit hard to debug without seeing what your dataframe and genes_in_data looks like but try to go step by step. Are the pwl2$gene gene names and the genes_in_data in EXACTLY the same format? (E.g., gene symbol)
      1. Check pwl2$gene[1:5] -> this will give you the first 5 genes
      2. Try pwl2[pwl2$gene %in% ‘name_of_the_first_gene’,] -> does it give you the first row?
      3. If it does, try it with two genes: pwl2[pwl2$gene %in% c(‘name_of_the_first_gene’, ‘name_of_the_second_gene’),] -> should work
      Otherwise, you can try grepl (since you are using a vector of genes you’ll need to collapse the list of genes using the separator ‘|’)
      Something like pwl2[grepl(paste(genes_in_data , collapse = ‘|’), pwl2$gene),] –> double check though!
      Hope this helps!

      Reply
      • hi there,
        Thank you very much for your very nice tutorials. I have same problem and I tried your suggestions. by running the codes i get any row having the first gene or any row having the second gene. I mean its not returning single row. Is that OK? I also tried grepl but it didnt solve the problem. I always get zero enriched terms at the end. That would be great if you could help me with this.

        Reply
        • Hey! Thanks for your nice feedback:) I don’t really understand your question – what “single row” do you want it to return? Which step are you talking about? Could you explain further?

          Reply
      • Hi again,
        The problem is that in the final table, I get very high pvalue and adjpvalue, and this is ecause of the Generatio, for all pathways i have the same deminator, when I do this reactome analysis this is different for different pathways so I get many enriched pathways. what am i doing wrong that i get this result? I got the ackground gene list from the link you provided and is called “Canonical Pathways gene sets derived from the Reactome pathway database.”

        Reply
        • Hi! The gene ratio’s denominator should always be the same, since it’s the size of the collection of gene sets you are considering (i.e., in this example, the size of “Canonical Pathways…”). See here for more info https://www.biostars.org/p/220465/
          On the other hand, it’s not uncommon to get A LOT of statistically significant pathways (especially in scRNAseq). Often the cause of over-inflated p-values is the background genes you use. Did you subset the background genes the way I explain, to the genes that could have been measured in your experiment? Not sure what the problem is though, please explain further if this doesn’t answer your question!

          Reply
  7. Hi,
    thanks for this tutorial, it’s very useful.

    I can’t download the reactome background file.
    To do that: background_genes <- 'reactome' # for our filename
    bg_genes <- readRDS(paste0(bg_path, 'reactome.RDS')) # read in the background genes

    Thank's for your help
    Best

    Reply
    • Hi Iso, that line does not download the reactome background file, it just reads it in. You need to download it first – check out my Youtube video or the tutorial, I explain where exactly you can get it from. Once you download it you can move it to any folder you want, then set bg_path to that folder path.
      You can make sure it’s there by calling list.files(bg_path) -> this will list all the files in that folder.
      Hope this helped!

      Reply
      • Hi,

        Thank you for your response,
        However, I’ve another question.
        I’m working on RNA-seq data on cervical cancer. Which background gene is best suited to my case?

        Best

        Reply
  8. Thank you for your tutorial. I am new to using R and PEA, so this has been extremely helpful. I am running into an issue at the “# Run clusterProfiler on each sub-dataframe” step. I keep getting a “no gene sets have size between 10 and 500” error. I’ve looked around and found that is intended to keep out small or very large gene set pathways, however, I have not been able to find out how to lower and/or raise the min and max values. do you have any advice for this? thank you

    Reply
    • Hi! Thanks for your comment! You can change the parameters using minGSSize = 10, maxGSSize = 500, (substituting the values by something else). Using my code:
      res <- lapply(names(deg_results_list), function(x) enricher(gene = deg_results_list[[x]]$gene_symbol, TERM2GENE = bg_genes, minGSSize = 5, maxGSSize = 600)) - For example - But I would check again the gene sets you are using and your data, seems like something is off because those are pretty lenient thresholds!

      Reply
  9. Hi, I wonder if I am missing something. When I try to create an enrichres object with new() I get an error that there is no initialization method set and no default. Do you have an initialization method set?

    Reply
    • Hi! Thanks for your comment. Not sure how you would use new() to create an enrichres object… Have you tried directly using one of the clusterProfiler functions and your data in dataframe format instead?

      Reply
  10. Hi! Your tutorials are very useful, thank you!!

    How can I do the enrichment analysis if I already filtered my data, everything is separated in a list with a format .txt (I have 3 conditions and they are separated in up and down regulated), can I use this code skyping the cleaning genelist parts or do I have to do everything again (starting by cleaning my .csv)? I also got a background list, how can I incorporate it?
    Thanks!!!

    Reply
    • Hey, thanks for your comment! I think that makes sense, I would need more info to give you a better answer but if you already have your different lists of genes (i.e., significantly upregulated in condition 1, significantly downregulated in condition 2…etc) then you’re good to go! As for the background list – not sure what you mean by incorporating it but just use it as your background gene set:)

      Reply
  11. Hi Biostatsquid,

    Thanks for great tutorial!

    Do you have an experience with Qiagen’s Ingenuity Pathway Analysis (IPA)?

    If yes, could you make a tutorial with this in the context of pathway enrichment analysis?

    R newbie

    Reply
    • Hi! Thank you so much for your suggestion – I have never used it but I’ll have a look, sounds interesting! I discovered this tool the other day which is very user-friendly PEA, g:Profiler, might be useful to you: https://biit.cs.ut.ee/gprofiler/gost

      Reply

Submit a Comment

Your email address will not be published. Required fields are marked *