This vignette shows the relevant steps to QC RNA-seq data. The rationale of this workflow is to assess whether the overall experiment meets desired quality standards and to detect low quality samples.
We start with loading relevant packages for the analysis.
The input to the workflow consists of a genes × samples count matrix and
data.frame
of metadata annotating the samples, where the
number of metadata rows must equal the number of matrix columns. In
addition, the count matrix must have column names and the row names must
be ENSEMBL gene IDs.
As an example, we are analyzing a data set in which T47D cells with
different mutation statuses were treated with E2 (estradiol) or vehicle
(Bahreini et
al. 2017). The input data are stored in this package as a
DESeqDataSet
called T47D
. For demonstration
purposes, we extract the count matrix and sample metadata to show how to
construct an annotated DESeqDataSet
, which is required for
running this package.
count_mat <- counts(T47D)
meta <- data.frame(colData(T47D))
# count matrix; rownames must be ENSEMBL gene IDs
count_mat[head(which(rowSums(count_mat) > 0)), 1:10]
#> veh_WT_rep1 veh_WT_rep2 veh_WT_rep3 veh_WT_rep4 veh_D538G_rep1
#> ENSG00000223972 5 3 3 6 4
#> ENSG00000278267 2 3 2 4 2
#> ENSG00000227232 80 91 95 97 65
#> ENSG00000243485 1 2 1 2 0
#> ENSG00000237613 0 0 0 1 0
#> ENSG00000239945 7 5 7 4 5
#> veh_D538G_rep2 veh_D538G_rep4 veh_Y537S_rep1 veh_Y537S_rep2
#> ENSG00000223972 1 6 3 5
#> ENSG00000278267 2 2 2 2
#> ENSG00000227232 70 73 74 65
#> ENSG00000243485 2 3 1 1
#> ENSG00000237613 0 0 0 0
#> ENSG00000239945 5 5 1 5
#> veh_Y537S_rep3
#> ENSG00000223972 3
#> ENSG00000278267 2
#> ENSG00000227232 89
#> ENSG00000243485 1
#> ENSG00000237613 0
#> ENSG00000239945 7
# metadata of the samples, where row i corresponds to column i in the count matrix
meta
#> treatment mutation replicate
#> veh_WT_rep1 veh WT rep1
#> veh_WT_rep2 veh WT rep2
#> veh_WT_rep3 veh WT rep3
#> veh_WT_rep4 veh WT rep4
#> veh_D538G_rep1 veh D538G rep1
#> veh_D538G_rep2 veh D538G rep2
#> veh_D538G_rep4 veh D538G rep4
#> veh_Y537S_rep1 veh Y537S rep1
#> veh_Y537S_rep2 veh Y537S rep2
#> veh_Y537S_rep3 veh Y537S rep3
#> veh_Y537S_rep4 veh Y537S rep4
#> veh_D538G_rep3 veh D538G rep3
#> E2_WT_rep1 E2 WT rep1
#> E2_WT_rep2 E2 WT rep2
#> E2_WT_rep3 E2 WT rep3
#> E2_WT_rep4 E2 WT rep4
#> E2_Y537S_rep1 E2 Y537S rep1
#> E2_Y537S_rep2 E2 Y537S rep2
#> E2_Y537S_rep3 E2 Y537S rep3
#> E2_Y537S_rep4 E2 Y537S rep4
#> E2_D538G_rep1 E2 D538G rep1
#> E2_D538G_rep2 E2 D538G rep2
#> E2_D538G_rep3 E2 D538G rep3
#> E2_D538G_rep4 E2 D538G rep4
We make a DESeqDataSet
from the input count matrix and
metadata. This step also requires to specify a record identifier from
the AnnotationHub package, that allows to download an EnsDb
object to annotate gene IDs and store them in the rowData
slot. We choose the latest homo sapiens AnnotationHub
record.
Records for other species can be found by running the following code. Ideally, the AnnotationHub record should match the genome build against which the sequencing reads were aligned.
A good metric to start quality control is to look at the total number of counts for each sample. This is also referred to as library size and we typically expect all samples to have total counts within the same order of magnitude.
For each sample, it is shown what fraction of counts is taken up by what fraction of genes. Samples showing a different library complexity than the rest might be considered low quality. In our case, all samples have very similar complexity.
Another interesting quantity is the number of detected genes for each sample. This number depends on the detection threshold, i.e. the minimum count required to call a gene detected and also on the used protocol (e.g. RNA-seq read counts vs. DRUG-seq UMI counts). Thus, different thresholds are of interest. Note that genes in this context refers to ENSEMBL genes and includes protein coding genes, lncRNAs, and various other biotypes.
It is also helpful to stratify the total gene count by the different gene biotypes. The plot below shows for each sample the total (library size) normalized count for the major gene biotypes. In a high quality data set, we expect this plot to show almost horizontal lines. Deviations from the horizontal pattern may correspond to different biological groups in the data set, especially in case of different cell lines, but could also indicate batch effects or low quality samples.
Before continuing with quality control, a useful intermediate step is to remove genes with low counts. This often substantially reduces the total number of genes, and thus the overall size of the data set and computation time. A good strategy is to determine the size of a biological group, i.e. all samples under the same biological condition, and filter (keep) genes with a certain count at least as often as the size of the biological group. In our case, each group is a combination of treatment and mutation status with 4 samples and we choose 5 counts as threshold.
For downstream tasks like clustering or PCA, a transformation is
necessary so that the variance of a gene does not depend on it’s mean,
i.e. we want genes with low and high mean counts to have similar
variances. A transformation that achieves this is called variance
stabilizing and we use the vst
function of DESeq2 for
this task. To check if the variance is indeed stabilized, we plot for
each gene the rank of the mean count versus the standard deviation. In
the resulting plot, the red trend line should be relatively flat with
respect to the scale on the y-axis, as can be seen for our example
data.
Chromosome expression plots can be useful to detect expression patterns related to the chromatin. For each chromosome, we make a heatmap where genes are arranged by chromosomal position along the x-axis and each row is a sample. The columns of the heatmap are scaled such that different genes can be compared to each other. Long red (blue) stretches along the x-axis indicate regions with increased (decreased) expression.
There can be several reasons for differential expression of a chromosomal region, for example duplication of a chromosome band or changes in chromatin accessibility. Also if the data comprise different cell lines or primary cancer samples, differential expression of a region or a whole chromosome could be observed.
In our example, chromosome 1 shows no obvious differentially expressed region, chromosome 5 shows differential expression related to the interaction of treatment and mutation status, and chromosome 14 is down regulated in samples with the D538G mutation.
#>
#> [[2]]
#>
#> [[3]]
A good quality metric on a per-sample basis is to check whether
biological and/or technical replicates are closely correlated. To do
this, we define groups of samples by specifying a column of the
colData
slot as grouping variable, and define all samples
that belong to the same level as group. Subsequently, a reference sample
is computed for each group by taking for each gene the median over all
samples in the group. Finally, we make an MA-plot where each sample is
plotted against its group reference.
In our example, we define a new grouping variable as the combination of treatment and mutation status and show replicate variability for the sample groups veh_WT and veh_Y537S. All shown replicates have high concordance with their respective reference. The only exception is sample veh_Y537S_rep3, which has an increased number down-regulated genes with high mean count.
We can also have a look at the clustering of samples by a distance metric such as euclidean distance or pearson correlation distance. It is useful to define annotation variables for the distance heatmap and relate appearing clusters to the annotation. In our example, samples cluster according to the biological groups defined in the previous section, highlighting the good quality of the data set.
The package also provides wrappers for principal component analysis (PCA) to check whether the main variation in the data is driven by biological or batch effects.
We can also plot the expression of an individual gene, by either specifying a valid rowname or gene name
In addition to defining the PCs to plot and variables of interest for
color or shape, we can also plot the PC loadings, i.e. the genes driving
a principal axis. The plot_loadings
function offers several
options to annotate loadings, e.g. by a column of the
rowData
slot, by highlighting genes of interest or the top
genes of a principal axis. It is also helpful to investigate if
principal axes are driven by the genes GC content, indicating a
potentially sequencing related effect.
plot_loadings(pca_res, PC = 4, color_by = "gene_biotype", show_plot = F)$plot +
theme(legend.position = "bottom")
To investigate multiple PCs simultaneously, we can also make a matrix of scatter plots, to plot all pairs of principal components against each other.
Differential expression analysis is one of the most common tasks for investigating RNA-seq data and can be also used for quality assessment. Before doing differential testing, we start by actually plotting the expression pattern of interesting genes.
Sometimes one has prior knowledge of which genes should be
differentially expressed in a certain condition or one wants to get a
better understanding of the genes driving a principal component. For
such cases, this package offers methods to plot a gene of interest. In
order to make counts between different samples comparable,
sample-specific normalization factors need be computed prior to
plotting. This is either done automatically when the DESeq
function has already been run on the DESeqDataSet
object,
or alternatively directly via estimateSizeFacors
.
dds <- estimateSizeFactors(dds)
plot_gene("CLEC2B", dds, x_var = "mutation", color_by = "treatment")
# modify the plot
plot_gene("CLEC2B", dds, x_var = "mutation", color_by = "treatment", show_plot = F)$plot + scale_color_manual(values=c("orange","blue3"))
# a custom plot type
plot_data <- plot_gene("CLEC2B", dds, show_plot = F)$data
plot_data %>%
ggplot(aes(treatment, count, color = mutation)) +
geom_point() +
geom_path(
aes(x = treatment, y = mean_count, color = mutation, group = mutation),
data = plot_data %>%
group_by(treatment, mutation) %>%
summarize(mean_count = mean(count), .groups = "drop")
) +
labs(y = "log2(norm. count)", title="CLEC2B") +
cowplot::theme_cowplot()
Sometimes it is also useful to inspect a large number of genes simultaneously to get a better understanding of the data. As example, we make a list of plots for the first 100 genes in the dataset and save them as a 4-page PDF file with 25 plots per page.
Differential testing allows to uncover genes that are differentially expressed for a certain comparison. We use DESeq2 for this purpose and refer the reader to the DESeq2 vignette on how to define a design formula and specify contrasts of interest. A good diagnostic plot for assessing the validity of differential testing assumptions is to plot the per-gene dispersion estimates versus the mean expression and check whether the red trend line shows an appropriate fit.
Differential testing results can be visualized in various ways. A
good diagnostic is the MA-plot that plots the mean normalized count
versus the log2-fold change. Ideally, the plot should look
rather symmetric around the horizontal axis. In our example, there are
genes with zero counts in one condition and relatively high counts in
another, leading to very high log2-fold changes. We thus use
lfcShrink
instead of the results
function,
which would be the default way to compute differential testing
results.
There are three different colors in the plot: Light-gray points correspond to genes with very low counts that are not considered for differential testing by the independent filtering step. Points in different shades of gray are not significant and simultaneously display the number of neighboring points to get a better understand where the majority of points are located. Red points indicate differentially expressed genes and we also place labels for the top 5 up- and down-regulated genes.
# get testing results
de_res <- lfcShrink(dds, coef = "mutation_WT_vs_D538G", lfcThreshold = log2(1.5), type = "normal", parallel = TRUE)
# MA plot
plot_ma(de_res, dds, annotate_top_n = 5)
In addition, the plot_ma
function allows to highlight
genes, and they are colored by their respective category, i.e. excluded
by independent filtering, not differentially expressed, and
differentially expressed.
sessionInfo()
#> R version 4.4.1 (2024-06-14)
#> Platform: x86_64-pc-linux-gnu
#> Running under: Ubuntu 24.04.1 LTS
#>
#> Matrix products: default
#> BLAS: /usr/lib/x86_64-linux-gnu/openblas-pthread/libblas.so.3
#> LAPACK: /usr/lib/x86_64-linux-gnu/openblas-pthread/libopenblasp-r0.3.26.so; LAPACK version 3.12.0
#>
#> locale:
#> [1] LC_CTYPE=en_US.UTF-8 LC_NUMERIC=C
#> [3] LC_TIME=en_US.UTF-8 LC_COLLATE=C
#> [5] LC_MONETARY=en_US.UTF-8 LC_MESSAGES=en_US.UTF-8
#> [7] LC_PAPER=en_US.UTF-8 LC_NAME=C
#> [9] LC_ADDRESS=C LC_TELEPHONE=C
#> [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C
#>
#> time zone: Etc/UTC
#> tzcode source: system (glibc)
#>
#> attached base packages:
#> [1] stats4 stats graphics grDevices utils datasets methods
#> [8] base
#>
#> other attached packages:
#> [1] magrittr_2.0.3 tibble_3.2.1
#> [3] tidyr_1.3.1 purrr_1.0.2
#> [5] ggplot2_3.5.1 dplyr_1.1.4
#> [7] ensembldb_2.29.1 AnnotationFilter_1.29.0
#> [9] GenomicFeatures_1.57.1 AnnotationDbi_1.67.0
#> [11] DESeq2_1.45.3 SummarizedExperiment_1.35.4
#> [13] Biobase_2.65.1 MatrixGenerics_1.17.0
#> [15] matrixStats_1.4.1 GenomicRanges_1.57.2
#> [17] GenomeInfoDb_1.41.2 IRanges_2.39.2
#> [19] S4Vectors_0.43.2 BiocGenerics_0.51.3
#> [21] RNAseqQC_0.2.1 rmarkdown_2.28
#>
#> loaded via a namespace (and not attached):
#> [1] DBI_1.2.3 bitops_1.0-9 rlang_1.1.4
#> [4] clue_0.3-65 GetoptLong_1.0.5 compiler_4.4.1
#> [7] RSQLite_2.3.7 mgcv_1.9-1 png_0.1-8
#> [10] vctrs_0.6.5 stringr_1.5.1 ProtGenerics_1.37.1
#> [13] shape_1.4.6.1 pkgconfig_2.0.3 crayon_1.5.3
#> [16] fastmap_1.2.0 XVector_0.45.0 labeling_0.4.3
#> [19] utf8_1.2.4 Rsamtools_2.21.2 UCSC.utils_1.1.0
#> [22] bit_4.5.0 xfun_0.48 zlibbioc_1.51.1
#> [25] cachem_1.1.0 jsonlite_1.8.9 blob_1.2.4
#> [28] highr_0.11 DelayedArray_0.31.14 BiocParallel_1.39.0
#> [31] cluster_2.1.6 parallel_4.4.1 R6_2.5.1
#> [34] RColorBrewer_1.1-3 bslib_0.8.0 stringi_1.8.4
#> [37] rtracklayer_1.65.0 jquerylib_0.1.4 iterators_1.0.14
#> [40] Rcpp_1.0.13 knitr_1.48 splines_4.4.1
#> [43] Matrix_1.7-0 tidyselect_1.2.1 abind_1.4-8
#> [46] yaml_2.3.10 doParallel_1.0.17 codetools_0.2-20
#> [49] curl_5.2.3 lattice_0.22-6 withr_3.0.1
#> [52] KEGGREST_1.45.1 evaluate_1.0.1 circlize_0.4.16
#> [55] Biostrings_2.73.2 pillar_1.9.0 ggpointdensity_0.1.0
#> [58] foreach_1.5.2 generics_0.1.3 RCurl_1.98-1.16
#> [61] munsell_0.5.1 scales_1.3.0 glue_1.8.0
#> [64] lazyeval_0.2.2 maketools_1.3.1 tools_4.4.1
#> [67] BiocIO_1.15.2 sys_3.4.3 locfit_1.5-9.10
#> [70] GenomicAlignments_1.41.0 buildtools_1.0.0 XML_3.99-0.17
#> [73] Cairo_1.6-2 cowplot_1.1.3 grid_4.4.1
#> [76] colorspace_2.1-1 patchwork_1.3.0 nlme_3.1-166
#> [79] GenomeInfoDbData_1.2.13 gghighlight_0.4.1 restfulr_0.0.15
#> [82] cli_3.6.3 fansi_1.0.6 viridisLite_0.4.2
#> [85] S4Arrays_1.5.10 ComplexHeatmap_2.21.1 gtable_0.3.5
#> [88] sass_0.4.9 digest_0.6.37 ggrepel_0.9.6
#> [91] SparseArray_1.5.44 rjson_0.2.23 farver_2.1.2
#> [94] memoise_2.0.1 htmltools_0.5.8.1 lifecycle_1.0.4
#> [97] httr_1.4.7 GlobalOptions_0.1.2 bit64_4.5.2