Maintainer: Ji-Ping Wang, <jzwang@northwestern.edu>
Reference: Xiong, B., Yang, Y., Fineis, F. Wang, J.-P., DegNorm: normalization of generalized transcript degradation improves accuracy in RNA-seq analysis, Genome Biology, 2019,20:75
DegNorm, short for Degradation Normalization, is a bioinformatics pipeline designed to correct for bias due to the heterogeneous patterns of transcript degradation in RNA-seq data. DegNorm helps improve the accuracy of the differential expression analysis by accounting for this degradation.
In practice, RNA samples are often more-or-less degraded, and the degradation severity is not only sample-specific, but gene-specific as well. It is known that longer genes tend to degrade faster than shorter ones. As such, commonplace global degradation normalization approaches that impose a single normalization factor on all genes within a sample can be ineffective in correcting for RNA degradation bias.
We’ve developed an R package and an indepedent Python package (download), both of which allow to run the entire pipeline from the RNA-seq alignment (.bam) files. For most-updated version, we recommend to use R package from bioconductor.
In version 1.3.1, we made following updates: 1. In plot_coverage funciton, an samples options is provided to allow user to select which samples to plot for coverage curves. 2. We fixed a bug in DegNorm funciton. In earlier version, we used genes with maximum rho<0.1 from initial SVD to determine the scaling factor before running core algorithm. For some data with many samples and large degradation, it may return NA to cause issues.
DegNorm R package contains two major functions: (1) processing the RNA-seq alignment file (.bam) to calculate the coverage; and (2) using a core algorithm written in RcppArmadillo to perform rank-one over-approximation on converage matrices for each gene to estimate the degramation index (DI) score for each gene within each sample.
DegNorm outputs DI scores together with degradation-normalized read counts (based on DI scores). It also provides supplementary functions for visualization of degradation at both gene and sample level. The following diagram illustrates the flow of DegNorm pipeline.
A diagram of DegNorm.
The following vignette is intended to provide example codes for running DegNorm R package. It presumes that you have successfully installed DegNorm package. We illustrate below how to: 1) calculate the read coverage curves for all genes within all samples, and 2) perform degradation normalization on coverage curves. Either step is computing intensive. Dependent upon the number of samples and the sequencing depth, the total computing time may last a few hours. DegNorm utilizes the parallel computing functionality of R and automatically detects the number of cores on your computer to run jobs in parallel. Due to the large size of bam file and limited computing power of personal computer, we recommend users to run it in servers or computing clusters.
## specify bam_files from RNA-seq, you should replace it by your own bam files
bam_file_list=list.files(path=system.file("extdata",package="DegNorm"),
                        pattern=".bam$",full.names=TRUE)The three bam files were subsetted from a specific region of chorosome 21 from the origianl bam for package size limitation. Original files can be found from the included reference above.
## calculate the read coverage score for all genes of all samples
coverage_res_chr21_sub=read_coverage_batch(bam_file_list, gtf_file,cores=2)
#> Parse gtf file...done 
#> Index SRR873822_chr21_9900000-10000000.bam 
#> Computing coverage for SRR873822_chr21_9900000-10000000.bam ... 
#>    SRR873822_chr21_9900000-10000000.bam is a paired-end bam file 
#> SRR873822_chr21_9900000-10000000.bam is done! 
#> 
#> Index SRR873834_chr21_9900000-10000000.bam 
#> Computing coverage for SRR873834_chr21_9900000-10000000.bam ... 
#>    SRR873834_chr21_9900000-10000000.bam is a paired-end bam file 
#> SRR873834_chr21_9900000-10000000.bam is done! 
#> 
#> Index SRR873838_chr21_9900000-10000000.bam 
#> Computing coverage for SRR873838_chr21_9900000-10000000.bam ... 
#>    SRR873838_chr21_9900000-10000000.bam is a paired-end bam file 
#> SRR873838_chr21_9900000-10000000.bam is done!cores argument specifies the number of cores to use. Users should try to use as many as possible cores to maximize the computing efficiency.
Function read_coverage_batch returns the coverage matrices as a list, one per gene, and a dataframe for read counts, each row for one gene and each column for one sample.
data("coverage_res_chr21")
## summarize the coverage results
summary_CoverageClass(coverage_res_chr21)
#> CoverageClass from read_coverage_batch function 
#> $coverage    : list of length 339 
#> $counts  : data.frame of dimension 339 by 3 
#> 
#> Samples:      SRR873822_chr21.bam SRR873834_chr21.bam SRR873838_chr21.bam 
#> Total number genes:   339Run degnorm core algorithm for degradation normalization. DegNorm purpose is for differential expression analysis. Thus genes with extremely low read counts from all samples are filtered out. The current filtering criterion is that if more than half of the samples have less than 5 read count, that gene will not be considered in the degnorm algorithm. In the following example, I am using downsamling to save time below (default). Alternatively you can set down_sampling = 0, which takes longer time. If down_samplin= 1, read coverage scores are binned with size by grid_size for baseline selection to achieve better efficiency. The default grid_size is 10 bp. We recommend to use a grid_size less than 50 bp. iteration specifies the big loop in DegNorm algorithm and 5 is usually sufficient. loop specifies the iteration number in the matrix factorization over-approximation.
res_DegNorm_chr21 = degnorm(read_coverage = coverage_res_chr21[[1]],
                    counts = coverage_res_chr21[[2]],
                    iteration = 5,
                    down_sampling = 1,
                    grid_size=10,
                    loop = 100,
                    cores=2)
#> Filtering out genes with low read counts (x<5)..
#> Initial estimation of count normalization factors...
#> Initial degradation normalization without base-line selection...
#> DegNorm core algorithm starts...
#>    DegNorm iteration 1 
#>    DegNorm iteration 2 
#>    DegNorm iteration 3 
#>    DegNorm iteration 4 
#>    DegNorm iteration 5
#> DegNorm core algorithm done!If down_sampling= 0, then the argument grid_size is ignored.
Function degnorm returns a list of multiple objects. counts_normed is the one with degradation normalized read counts for you to input DeSeq or EdgeR for DE analysis.
## summary of the DegNorm output
summary_DegNormClass(res_DegNorm_chr21)
#> DegNormClass from DegNorm function: 
#> $counts  : data.frame of dimension 132 by 3 
#> $counts_normed   : data.frame of dimension 132 by 3 
#> $DI      : matrix array of dimension 132 by 3 
#> $K       : matrix array of dimension 132 by 3 
#> $convergence     : integer of length 132 
#> $envelop     : list of length 132 
#> 
#> Samples:      SRR873822_chr21.bam SRR873834_chr21.bam SRR873838_chr21.bam 
#> Total number genes:   132The difference of number of genes between res_DegNorm and coverage_res is 207 (339-132). The 207 genes were filtered out from degnorm degradation normalization because less than half of the samples (3) have more than 5 read count.
DegNorm provides four plot functions for visualization of degradation and sample quality diagnosis.
##gene named "SOD1"
plot_coverage(gene_name="SOD1", coverage_output=coverage_res_chr21, 
            degnorm_output=res_DegNorm_chr21,group=c(0,1,1))In version 1.3.1, a new argument \(samples\) was added so the user can specifiy which samples to plot.
##gene named "SOD1"
plot_coverage(gene_name="SOD1", coverage_output=coverage_res_chr21, 
            degnorm_output=res_DegNorm_chr21,group=c(0,1), 
            samples=c("SRR873822_chr21.bam", "SRR873834_chr21.bam"))  
sessionInfo()
#> R version 4.3.0 RC (2023-04-13 r84269)
#> Platform: x86_64-pc-linux-gnu (64-bit)
#> Running under: Ubuntu 22.04.2 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.17-bioc/R/lib/libRblas.so 
#> LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.10.0
#> 
#> locale:
#>  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
#>  [3] LC_TIME=en_GB              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: America/New_York
#> tzcode source: system (glibc)
#> 
#> attached base packages:
#> [1] stats     graphics  grDevices utils     datasets  methods   base     
#> 
#> other attached packages:
#> [1] knitr_1.42     DegNorm_1.10.1
#> 
#> loaded via a namespace (and not attached):
#>   [1] DBI_1.1.3                   bitops_1.0-7               
#>   [3] gridExtra_2.3               biomaRt_2.56.0             
#>   [5] rlang_1.1.1                 magrittr_2.0.3             
#>   [7] matrixStats_0.63.0          compiler_4.3.0             
#>   [9] RSQLite_2.3.1               GenomicFeatures_1.52.0     
#>  [11] reshape2_1.4.4              png_0.1-8                  
#>  [13] vctrs_0.6.2                 stringr_1.5.0              
#>  [15] pkgconfig_2.0.3             crayon_1.5.2               
#>  [17] fastmap_1.1.1               ellipsis_0.3.2             
#>  [19] dbplyr_2.3.2                XVector_0.40.0             
#>  [21] labeling_0.4.2              ca_0.71.1                  
#>  [23] utf8_1.2.3                  Rsamtools_2.16.0           
#>  [25] rmarkdown_2.21              purrr_1.0.1                
#>  [27] bit_4.0.5                   xfun_0.39                  
#>  [29] zlibbioc_1.46.0             cachem_1.0.8               
#>  [31] GenomeInfoDb_1.36.0         jsonlite_1.8.4             
#>  [33] progress_1.2.2              blob_1.2.4                 
#>  [35] highr_0.10                  DelayedArray_0.26.1        
#>  [37] BiocParallel_1.34.0         parallel_4.3.0             
#>  [39] prettyunits_1.1.1           R6_2.5.1                   
#>  [41] bslib_0.4.2                 stringi_1.7.12             
#>  [43] RColorBrewer_1.1-3          rtracklayer_1.60.0         
#>  [45] GenomicRanges_1.52.0        jquerylib_0.1.4            
#>  [47] iterators_1.0.14            Rcpp_1.0.10                
#>  [49] assertthat_0.2.1            SummarizedExperiment_1.30.1
#>  [51] IRanges_2.34.0              Matrix_1.5-4               
#>  [53] tidyselect_1.2.0            yaml_2.3.7                 
#>  [55] viridis_0.6.2               TSP_1.2-4                  
#>  [57] doParallel_1.0.17           codetools_0.2-19           
#>  [59] curl_5.0.0                  plyr_1.8.8                 
#>  [61] lattice_0.21-8              tibble_3.2.1               
#>  [63] withr_2.5.0                 Biobase_2.60.0             
#>  [65] KEGGREST_1.40.0             evaluate_0.20              
#>  [67] heatmaply_1.4.2             BiocFileCache_2.8.0        
#>  [69] xml2_1.3.4                  Biostrings_2.68.0          
#>  [71] pillar_1.9.0                filelock_1.0.2             
#>  [73] MatrixGenerics_1.12.0       foreach_1.5.2              
#>  [75] stats4_4.3.0                plotly_4.10.1              
#>  [77] generics_0.1.3              RCurl_1.98-1.12            
#>  [79] S4Vectors_0.38.1            hms_1.1.3                  
#>  [81] ggplot2_3.4.2               munsell_0.5.0              
#>  [83] scales_1.2.1                glue_1.6.2                 
#>  [85] lazyeval_0.2.2              tools_4.3.0                
#>  [87] dendextend_1.17.1           BiocIO_1.10.0              
#>  [89] data.table_1.14.8           webshot_0.5.4              
#>  [91] GenomicAlignments_1.36.0    registry_0.5-1             
#>  [93] XML_3.99-0.14               grid_4.3.0                 
#>  [95] tidyr_1.3.0                 crosstalk_1.2.0            
#>  [97] seriation_1.4.2             AnnotationDbi_1.62.1       
#>  [99] colorspace_2.1-0            GenomeInfoDbData_1.2.10    
#> [101] restfulr_0.0.15             cli_3.6.1                  
#> [103] rappdirs_0.3.3              fansi_1.0.4                
#> [105] S4Arrays_1.0.1              viridisLite_0.4.1          
#> [107] dplyr_1.1.2                 gtable_0.3.3               
#> [109] sass_0.4.5                  digest_0.6.31              
#> [111] BiocGenerics_0.46.0         farver_2.1.1               
#> [113] rjson_0.2.21                htmlwidgets_1.6.2          
#> [115] memoise_2.0.1               htmltools_0.5.5            
#> [117] lifecycle_1.0.3             httr_1.4.5                 
#> [119] bit64_4.0.5