Contents

knitr::opts_chunk$set(
  collapse = TRUE,
  comment = "#>"
)

1 Introduction

This is a package containing unCOVERApp, a shiny graphical application for clinical assessment of sequence coverage. unCOVERApp allows:

2 Installation and example

Install the latest version of uncoverappLib using BiocManager.

uncoverappLib requires:


install.packages("BiocManager")
BiocManager::install("uncoverappLib")
library(uncoverappLib)

Alternatively, it can be installed from GitHub using:


#library(devtools)
#install_github("Manuelaio/uncoverappLib")
#library(uncoverappLib)

When users load uncoverappLib for the first time, the first thing to do is a download of annotation files. getAnnotationFiles() function allows to download the annotation files from Zenodo and parse it using uncoverappLib package. The function does not return an R object but store the annotation files in a cache (sorted.bed.gz and sorted.bed.gz.tbi) and show
the cache path. The local cache is managed by the BiocFileCache Bioconductor package. It is sufficient run the function getAnnotationFiles(verbose= TRUE) one time after installing uncoverappLib package as shown below. The preprocessing time can take few minutes, therefore during running vignette, users can provide vignette= TRUE as a parameter to download an example annotation files, as below.

library(uncoverappLib)
#> 
#> 
#getAnnotationFiles(verbose= TRUE, vignette= TRUE)

The preprocessing time can take few minutes.

3 Input file

All unCOVERApp functionalities are based on the availability of a BED-style formatted input file containing tab-separated specifications of genomic coordinates (chromosome, start position, end position), the coverage value, and the reference:alternate allele counts for each position. In the first page Preprocessing, users can prepare the input file by specifying the genes to be examined and the BAM file(s) to be inspected. Users should be able to provide:

gene.list<- system.file("extdata", "mygene.txt", package = "uncoverappLib")

Type the following command to load our example:


bam_example <- system.file("extdata", "example_POLG.bam", package = "uncoverappLib")

print(bam_example)
#> [1] "/tmp/RtmpXBAPS9/Rinst3b8e61e68c3f4/uncoverappLib/extdata/example_POLG.bam"

write.table(bam_example, file= "./bam.list", quote= FALSE, row.names = FALSE, 
            col.names = FALSE)

and launch run.uncoverapp(where="browser") command. After running run.uncoverapp(where="browser") the shiny app appears in your deafult browser. RStudio user can define where launching uncoverapp using where option:

If option where is not defined uncoverapp will launch with default option of R.

In the first page Preprocessing users can load mygene.txt in Load input file and bam.list in Load bam file(s) list. In general, a target bed can also be used instead of genes name selecting Target Bed option in Choose the type of your input file. Users should also specify the reference genome in Genome box and the chromosome notation of their BAM file(s) in Chromosome Notation box. In the BAM file, the number option refers to 1, 2, …, X,.M chromosome notation, while the chr option refers to chr1, chr2, … chrX, chrM chromosome notation. Users can specify the minimum mapping quality (MAPQ) value in box and minimum base quality (QUAL) value in box. Default values for both mapping and base qualities is 1. Users can download Statistical_Summary report to obtain a coverage metrics per genes (List of genes name) or per amplicons (Target Bed) according to uploaded input file. The report summarizes following information: mean, median, number of positions under 20x and percentage of position above 20x.

To run the example, choose chr chromosome notation, hg19 genome reference and leave minimum mapping and base qualities to the default settings, as shown in the following screenshot of the Preprocessing page:

Screenshot of Preprocessing page.

Figure 1: Screenshot of Preprocessing page

unCOVERApp input file generation fails if incorrect gene names are specified. An unrecognized gene name(s) table is displayed if such a case occurs. Below is a snippet of a the unCOVERApp input file generated as a result of the preprocessing step performed for the example


chr15   89859516        89859516        68      A:68
chr15   89859517        89859517        70      T:70
chr15   89859518        89859518        73      A:2;G:71
chr15   89859519        89859519        73      A:73
chr15   89859520        89859520        74      C:74
chr15   89859521        89859521        75      C:1;T:74

The preprocessing time depends on the size of the BAM file(s) and on the number of genes to investigate. In general, if many (e.g. > 50) genes are to be analyzed, we would recommend to use buildInput function
in R console before launching the app as shown in following example. This function also return a file with .txt estention containg statistical report of each genes/amplicon Alternatively, other tools do a similar job and can be used to generate the unCOVERApp input file ( for instance: bedtools, samtools, gatk). In this case, users can load the file directly on Coverage Analysis page in Select input file box.

Once pre-processing is done, users can move to the Coverage Analysis page and push the load prepared input file button.

Screenshot of Coverage Analysis page.

Figure 2: Screenshot of Coverage Analysis page

To assess sequence coverage of the example, the following input parameters must be specified in the sidebar of the Coverage Analysis section

Other input sections, as Chromosome, Transcript ID, START genomic position, END genomic position and Region coordinate, are dynamically filled.

4 Output

unCOVERApp generates the following outputs :

Screenshot of output of UCSC gene table.

Figure 3: Screenshot of output of UCSC gene table

Screenshot of output of Exon genomic coordinate positions from UCSC table.

Figure 4: Screenshot of output of Exon genomic coordinate positions from UCSC table

Screenshot of output of gene coverage.

Figure 5: Screenshot of output of gene coverage

zoom of exon 10

Figure 6: zoom of exon 10

 Example of uncovered positions annotate with dbNSFP.

Figure 7: Example of uncovered positions annotate with dbNSFP

By clicking on the download button, users can save the table as spreadsheet format with certain cells colored according to pre-specified thresholds for AF, CADD, MAP-CAP, SIFT, Polyphen2, ClinVar, OMIM ID, HGVSp and HGVSc, …).

In Calculate maximum credible allele frequency page, users can set allele frequency cut-offs based on specific assumptions about the genetic architecture of the disease. If not specified, variants with allele frequency > 5 % will be instead filtered out. More details are available here. Moreover, users may click on the ”download” button and save the resulting table as spreadsheet format.

The Binomial distribution page returns the 95 % binomial probability distribution of the variant supporting reads on the input genomic position (Genomic position). Users should define the expected allele fraction (the expected fraction of variant reads, probability of success) and Variant reads (the minimum number of variant reads required by the user to support variant calling, number of successes). The comment color change according to binomial proportion intervals. If the estimated intervals , with 95% confidence, is included or higher than user-defined Variant reads the color of comment appears blue, otherwise if it is lower the color appears red.

5 Session information

#> R version 4.3.1 (2023-06-16)
#> Platform: x86_64-pc-linux-gnu (64-bit)
#> Running under: Ubuntu 22.04.3 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.18-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] uncoverappLib_1.12.0 BiocStyle_2.30.0    
#> 
#> loaded via a namespace (and not attached):
#>   [1] later_1.3.1                             
#>   [2] BiocIO_1.12.0                           
#>   [3] bitops_1.0-7                            
#>   [4] filelock_1.0.2                          
#>   [5] tibble_3.2.1                            
#>   [6] graph_1.80.0                            
#>   [7] XML_3.99-0.14                           
#>   [8] rpart_4.1.21                            
#>   [9] lifecycle_1.0.3                         
#>  [10] Homo.sapiens_1.3.1                      
#>  [11] processx_3.8.2                          
#>  [12] lattice_0.22-5                          
#>  [13] ensembldb_2.26.0                        
#>  [14] OrganismDbi_1.44.0                      
#>  [15] backports_1.4.1                         
#>  [16] magrittr_2.0.3                          
#>  [17] openxlsx_4.2.5.2                        
#>  [18] Hmisc_5.1-1                             
#>  [19] sass_0.4.7                              
#>  [20] rmarkdown_2.25                          
#>  [21] jquerylib_0.1.4                         
#>  [22] yaml_2.3.7                              
#>  [23] rlist_0.4.6.2                           
#>  [24] shinyBS_0.61.1                          
#>  [25] httpuv_1.6.12                           
#>  [26] zip_2.3.0                               
#>  [27] Gviz_1.46.0                             
#>  [28] DBI_1.1.3                               
#>  [29] RColorBrewer_1.1-3                      
#>  [30] abind_1.4-5                             
#>  [31] zlibbioc_1.48.0                         
#>  [32] GenomicRanges_1.54.0                    
#>  [33] AnnotationFilter_1.26.0                 
#>  [34] biovizBase_1.50.0                       
#>  [35] BiocGenerics_0.48.0                     
#>  [36] RCurl_1.98-1.12                         
#>  [37] nnet_7.3-19                             
#>  [38] VariantAnnotation_1.48.0                
#>  [39] rappdirs_0.3.3                          
#>  [40] GenomeInfoDbData_1.2.11                 
#>  [41] IRanges_2.36.0                          
#>  [42] S4Vectors_0.40.0                        
#>  [43] condformat_0.10.1                       
#>  [44] codetools_0.2-19                        
#>  [45] DelayedArray_0.28.0                     
#>  [46] DT_0.30                                 
#>  [47] xml2_1.3.5                              
#>  [48] tidyselect_1.2.0                        
#>  [49] shinyWidgets_0.8.0                      
#>  [50] matrixStats_1.0.0                       
#>  [51] stats4_4.3.1                            
#>  [52] BiocFileCache_2.10.0                    
#>  [53] base64enc_0.1-3                         
#>  [54] GenomicAlignments_1.38.0                
#>  [55] jsonlite_1.8.7                          
#>  [56] ellipsis_0.3.2                          
#>  [57] Formula_1.2-5                           
#>  [58] tools_4.3.1                             
#>  [59] progress_1.2.2                          
#>  [60] TxDb.Hsapiens.UCSC.hg19.knownGene_3.2.2 
#>  [61] Rcpp_1.0.11                             
#>  [62] glue_1.6.2                              
#>  [63] gridExtra_2.3                           
#>  [64] SparseArray_1.2.0                       
#>  [65] xfun_0.40                               
#>  [66] MatrixGenerics_1.14.0                   
#>  [67] GenomeInfoDb_1.38.0                     
#>  [68] dplyr_1.1.3                             
#>  [69] BiocManager_1.30.22                     
#>  [70] fastmap_1.1.1                           
#>  [71] latticeExtra_0.6-30                     
#>  [72] fansi_1.0.5                             
#>  [73] shinyjs_2.1.0                           
#>  [74] digest_0.6.33                           
#>  [75] R6_2.5.1                                
#>  [76] mime_0.12                               
#>  [77] colorspace_2.1-0                        
#>  [78] GO.db_3.18.0                            
#>  [79] jpeg_0.1-10                             
#>  [80] dichromat_2.0-0.1                       
#>  [81] markdown_1.11                           
#>  [82] biomaRt_2.58.0                          
#>  [83] RSQLite_2.3.1                           
#>  [84] utf8_1.2.4                              
#>  [85] generics_0.1.3                          
#>  [86] data.table_1.14.8                       
#>  [87] rtracklayer_1.62.0                      
#>  [88] prettyunits_1.2.0                       
#>  [89] httr_1.4.7                              
#>  [90] htmlwidgets_1.6.2                       
#>  [91] S4Arrays_1.2.0                          
#>  [92] pkgconfig_2.0.3                         
#>  [93] gtable_0.3.4                            
#>  [94] blob_1.2.4                              
#>  [95] XVector_0.42.0                          
#>  [96] htmltools_0.5.6.1                       
#>  [97] bookdown_0.36                           
#>  [98] RBGL_1.78.0                             
#>  [99] ProtGenerics_1.34.0                     
#> [100] scales_1.2.1                            
#> [101] Biobase_2.62.0                          
#> [102] TxDb.Hsapiens.UCSC.hg38.knownGene_3.18.0
#> [103] png_0.1-8                               
#> [104] EnsDb.Hsapiens.v75_2.99.0               
#> [105] knitr_1.44                              
#> [106] rstudioapi_0.15.0                       
#> [107] rjson_0.2.21                            
#> [108] checkmate_2.2.0                         
#> [109] curl_5.1.0                              
#> [110] org.Hs.eg.db_3.18.0                     
#> [111] cachem_1.0.8                            
#> [112] stringr_1.5.0                           
#> [113] parallel_4.3.1                          
#> [114] shinycssloaders_1.0.0                   
#> [115] foreign_0.8-85                          
#> [116] AnnotationDbi_1.64.0                    
#> [117] restfulr_0.0.15                         
#> [118] pillar_1.9.0                            
#> [119] grid_4.3.1                              
#> [120] vctrs_0.6.4                             
#> [121] promises_1.2.1                          
#> [122] dbplyr_2.3.4                            
#> [123] EnsDb.Hsapiens.v86_2.99.0               
#> [124] xtable_1.8-4                            
#> [125] cluster_2.1.4                           
#> [126] htmlTable_2.4.1                         
#> [127] evaluate_0.22                           
#> [128] GenomicFeatures_1.54.0                  
#> [129] cli_3.6.1                               
#> [130] compiler_4.3.1                          
#> [131] Rsamtools_2.18.0                        
#> [132] rlang_1.1.1                             
#> [133] crayon_1.5.2                            
#> [134] interp_1.1-4                            
#> [135] ps_1.7.5                                
#> [136] stringi_1.7.12                          
#> [137] deldir_1.0-9                            
#> [138] BiocParallel_1.36.0                     
#> [139] munsell_0.5.0                           
#> [140] Biostrings_2.70.0                       
#> [141] lazyeval_0.2.2                          
#> [142] Matrix_1.6-1.1                          
#> [143] BSgenome_1.70.0                         
#> [144] hms_1.1.3                               
#> [145] bit64_4.0.5                             
#> [146] ggplot2_3.4.4                           
#> [147] KEGGREST_1.42.0                         
#> [148] shiny_1.7.5.1                           
#> [149] SummarizedExperiment_1.32.0             
#> [150] memoise_2.0.1                           
#> [151] bslib_0.5.1                             
#> [152] bit_4.0.5