Introduction to SigsPack

Sigspack provides tools for easy computation of signature exposures from mutational catalogues.

The package provides several features, allowing to read the primary mutation data, normalise the mutational catalogues if necessary and compute signature exposures with their bootstrapped variation estimates.

Loading the package

library(SigsPack)

Loading a VCF

In most cases you will want to analyse real data, e.g. fit a sample’s mutational profile to known mutational signatures. You can easily load your data and use it with the package.

if (require(BSgenome.Hsapiens.UCSC.hg19)) {
  sample <- vcf2mut_cat(
    system.file("extdata", "example.vcf.gz", package="SigsPack"),
    BSgenome.Hsapiens.UCSC.hg19
  )
}
#> Loading required package: BSgenome.Hsapiens.UCSC.hg19
#> Loading required package: BSgenome
#> Loading required package: BiocGenerics
#> 
#> Attaching package: 'BiocGenerics'
#> The following object is masked from 'package:SigsPack':
#> 
#>     normalize
#> The following objects are masked from 'package:stats':
#> 
#>     IQR, mad, sd, var, xtabs
#> The following objects are masked from 'package:base':
#> 
#>     Filter, Find, Map, Position, Reduce, anyDuplicated, aperm, append,
#>     as.data.frame, basename, cbind, colnames, dirname, do.call,
#>     duplicated, eval, evalq, get, grep, grepl, intersect, is.unsorted,
#>     lapply, mapply, match, mget, order, paste, pmax, pmax.int, pmin,
#>     pmin.int, rank, rbind, rownames, sapply, setdiff, table, tapply,
#>     union, unique, unsplit, which.max, which.min
#> Loading required package: S4Vectors
#> Loading required package: stats4
#> 
#> Attaching package: 'S4Vectors'
#> The following object is masked from 'package:utils':
#> 
#>     findMatches
#> The following objects are masked from 'package:base':
#> 
#>     I, expand.grid, unname
#> Loading required package: IRanges
#> Loading required package: GenomeInfoDb
#> Loading required package: GenomicRanges
#> Loading required package: Biostrings
#> Loading required package: XVector
#> 
#> Attaching package: 'Biostrings'
#> The following object is masked from 'package:base':
#> 
#>     strsplit
#> Loading required package: BiocIO
#> Loading required package: rtracklayer
#> 
#> Attaching package: 'rtracklayer'
#> The following object is masked from 'package:BiocIO':
#> 
#>     FileForFormat

It will be transformed into a ‘mutational profile’ sorting all single nucleotide variants according to their trinucleotide context and mutation. The result is a 96 by 1 matrix that can be used as input to the analysis functions of the package as well as in most other packages of this field.

Simulating data

Instead of using real-life data it is also possible to generate synthetic data that can be used to analyse signatures stability. The following code generates 10 mutational catalogues with exposure to the COSMIC signatures 2, 6, 15 and 27. The catalogues consist of mutation counts sampled from a distribution that is a linear combination of the aforementioned signatures. The weight of each of these signatures can optionally be specified, too. For convenience, the COSMIC reference signature matrix is included in the package and used as default in the functions. However, it is also possible to use all functions with a custom signature matrix.

data("cosmicSigs")

cats <- create_mut_catalogues(10, 500, P=cosmicSigs, sig_set = c(2,6,15,27))
knitr::kable(head(cats[['catalogues']]))
sample_1 sample_2 sample_3 sample_4 sample_5 sample_6 sample_7 sample_8 sample_9 sample_10
A[C>A]A 1 2 2 1 0 2 3 1 2 0
A[C>A]C 1 4 1 1 1 0 0 4 1 0
A[C>A]G 0 0 0 0 0 0 0 0 0 0
A[C>A]T 2 1 1 3 3 3 3 1 0 1
C[C>A]A 1 5 2 1 2 5 4 3 5 4
C[C>A]C 1 6 10 7 5 2 4 8 5 6

Estimating signature exposures and bootstrapping samples

The function bootstrap_mut_catalogues bootstraps a sample returning a specified amount of re-samples which can be used to gain a better variability estimation of the sample’s signature exposure.

The signature exposure is calculated using quadratic programming. This can be done on one or several samples at once. The COSMIC signatures have been included in the package, and are used by default. However, it is possible to use your own signature matrix, or use a sub-set of COSMIC signatures, instead of the whole matrix.


reps <- bootstrap_mut_catalogues(n = 1000, original = cats[["catalogues"]][,1])

# using only signatures 4, 17, 23 and 30 for signature estimation
sigs <- signature_exposure(reps, sig_set = c(4,17,23,30))

print(sigs$exposures[,1])
#>  Signature 1  Signature 2  Signature 3  Signature 4  Signature 5  Signature 6 
#>   0.00000000   0.00000000   0.00000000   0.31185097   0.00000000   0.00000000 
#>  Signature 7  Signature 8  Signature 9 Signature 10 Signature 11 Signature 12 
#>   0.00000000   0.00000000   0.00000000   0.00000000   0.00000000   0.00000000 
#> Signature 13 Signature 14 Signature 15 Signature 16 Signature 17 Signature 18 
#>   0.00000000   0.00000000   0.00000000   0.00000000   0.05600143   0.00000000 
#> Signature 19 Signature 20 Signature 21 Signature 22 Signature 23 Signature 24 
#>   0.00000000   0.00000000   0.00000000   0.00000000   0.00000000   0.00000000 
#> Signature 25 Signature 26 Signature 27 Signature 28 Signature 29 Signature 30 
#>   0.00000000   0.00000000   0.00000000   0.00000000   0.00000000   0.63214759

With one command you can bootstrap a mutational catalogue and obtain a table and a plot illustrating the results of the signature estimation for this sample and the bootstrapped re-samples. The plot shows the distribution of estimated signature exposure for all the re-samples, highlighting the one of the original mutational catalogue, thus providing insights on the reliability of the estimates.


report <- summarize_exposures(reps[,1])

knitr::kable(
  head(report)
  )
original exposure min 1. quartile median 3. quartile max
Signature 1 0.0686219 0.0000000 0.0427968 0.0657182 0.0859837 0.1567116
Signature 2 0.2095900 0.1136255 0.1877136 0.2073143 0.2292090 0.2947286
Signature 3 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000
Signature 4 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000
Signature 5 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000
Signature 6 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0409183

Tri-nucleotide contexts and normalization

Accurate exposures estimation requires matching tri-nucleotide frequencies between observations and the signature matrix. The COSMIC signature matrix provided in the package is relative to the whole genome (GRCh37) tri-nucleotide frequencies. So if you want to fit those signatures to exome data, the data need to be normalized to match the signatures prior to exposures estimation.

Let’s say, that the vcf we derived the mutational catalogue from contained exome data. In the case of this example, we want to scale our exome data to the genome ‘space’ to match the COSMIC reference signatures. Hence, we need both the tri-nucleotide distribution of the human genome (GRCh37) and the exome that our data were collected on.

Extract the tri-nucleotide context frequencies from a genome (BSgenome object) or exome and use them to normalize the data.

if (require(BSgenome.Hsapiens.UCSC.hg19)){
  genome_contexts <- get_context_freq(BSgenome.Hsapiens.UCSC.hg19)
  exome_contexts <- get_context_freq(
    BSgenome.Hsapiens.UCSC.hg19,
    system.file("extdata", "example.bed.gz", package="SigsPack")
  )
  normalized_mut_cat <- SigsPack::normalize(sample, exome_contexts, hg19context_freq)
}

The normalization returns frequencies, not count numbers. If you want to use them for exposure estimation or for bootstrapping, the catalogue size must be scaled, or input together with the normalized catalogue.

if (require(BSgenome.Hsapiens.UCSC.hg19)) {
  sigs_norm <- signature_exposure(sum(sample) * normalized_mut_cat)
  report_norm <- summarize_exposures(normalized_mut_cat, m=sum(sample))
  reps_norm <- bootstrap_mut_catalogues(
      n=1000,
      original=normalized_mut_cat, 
      m=sum(sample)
  )
}

sessionInfo

sessionInfo()
#> R Under development (unstable) (2023-10-22 r85388)
#> Platform: x86_64-pc-linux-gnu
#> Running under: Ubuntu 22.04.3 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.19-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] stats4    stats     graphics  grDevices utils     datasets  methods  
#> [8] base     
#> 
#> other attached packages:
#>  [1] BSgenome.Hsapiens.UCSC.hg19_1.4.3 BSgenome_1.71.0                  
#>  [3] rtracklayer_1.63.0                BiocIO_1.13.0                    
#>  [5] Biostrings_2.71.1                 XVector_0.43.0                   
#>  [7] GenomicRanges_1.55.0              GenomeInfoDb_1.39.0              
#>  [9] IRanges_2.37.0                    S4Vectors_0.41.0                 
#> [11] BiocGenerics_0.49.0               SigsPack_1.17.0                  
#> 
#> loaded via a namespace (and not attached):
#>  [1] KEGGREST_1.43.0             SummarizedExperiment_1.33.0
#>  [3] rjson_0.2.21                xfun_0.40                  
#>  [5] bslib_0.5.1                 Biobase_2.63.0             
#>  [7] lattice_0.22-5              quadprog_1.5-8             
#>  [9] generics_0.1.3              vctrs_0.6.4                
#> [11] tools_4.4.0                 bitops_1.0-7               
#> [13] curl_5.1.0                  parallel_4.4.0             
#> [15] tibble_3.2.1                fansi_1.0.5                
#> [17] AnnotationDbi_1.65.0        RSQLite_2.3.1              
#> [19] blob_1.2.4                  pkgconfig_2.0.3            
#> [21] Matrix_1.6-1.1              dbplyr_2.3.4               
#> [23] lifecycle_1.0.3             GenomeInfoDbData_1.2.11    
#> [25] stringr_1.5.0               compiler_4.4.0             
#> [27] Rsamtools_2.19.0            progress_1.2.2             
#> [29] codetools_0.2-19            htmltools_0.5.6.1          
#> [31] sass_0.4.7                  RCurl_1.98-1.12            
#> [33] yaml_2.3.7                  pillar_1.9.0               
#> [35] crayon_1.5.2                jquerylib_0.1.4            
#> [37] BiocParallel_1.37.0         DelayedArray_0.29.0        
#> [39] cachem_1.0.8                abind_1.4-5                
#> [41] tidyselect_1.2.0            digest_0.6.33              
#> [43] stringi_1.7.12              dplyr_1.1.3                
#> [45] restfulr_0.0.15             VariantAnnotation_1.49.0   
#> [47] biomaRt_2.59.0              fastmap_1.1.1              
#> [49] grid_4.4.0                  cli_3.6.1                  
#> [51] SparseArray_1.3.0           magrittr_2.0.3             
#> [53] S4Arrays_1.3.0              GenomicFeatures_1.55.0     
#> [55] utf8_1.2.4                  XML_3.99-0.14              
#> [57] rappdirs_0.3.3              filelock_1.0.2             
#> [59] prettyunits_1.2.0           bit64_4.0.5                
#> [61] rmarkdown_2.25              httr_1.4.7                 
#> [63] matrixStats_1.0.0           bit_4.0.5                  
#> [65] png_0.1-8                   hms_1.1.3                  
#> [67] memoise_2.0.1               evaluate_0.22              
#> [69] knitr_1.44                  BiocFileCache_2.11.0       
#> [71] rlang_1.1.1                 glue_1.6.2                 
#> [73] DBI_1.1.3                   xml2_1.3.5                 
#> [75] jsonlite_1.8.7              R6_2.5.1                   
#> [77] MatrixGenerics_1.15.0       GenomicAlignments_1.39.0   
#> [79] zlibbioc_1.49.0