Table of contents

signeR

Rodrigo Drummond, Renan Valieris, Rafael Rosales and Israel Tojal da Silva

1: Introduction

Motivation: Cancer is an evolutionary process driven by continuous acquisition of genetic variations in individual cells. The diversity and the complexity of somatic mutational processes is a conspicuous feature orchestrated by DNA damage agents and repair processes, including exogenous or endogenous mutagen exposures, defects in DNA mismatch repair and enzymatic modification of DNA. The identification of the underlying mutational processes are central to the understanding of cancer origin and evolution.

The signeR package focuses on the estimation and further analysis of mutational signatures. The functionalities of this package can be divided into three categories. First, it provides tools to process VCF files and generate matrices of SNV mutation counts and mutational opportunities, both defined according to a 3bp context (mutation site and its neighboring 3' and 5' bases). Second, these count matrices are considered as input for the estimation of the underlying mutational signatures and the number of active mutational processes. Third, the package provides tools to correlate the activities of those signatures with other relevant information such as clinical data, in order to draw conclusions about the analyzed genome samples, which can be useful for clinical applications. These include the Differential Exposure Score and the a posteriori sample classification.

Although signeR is intended for the estimation of mutational signatures, it actually provides a full Bayesian treatment to the non-negative matrix factorisation (NMF) model. Further details about the method can be found in Rosales & Drummond et al., 2016 (see section 9.1 below).

This vignette briefly explains the use of signeR through examples.

2: Installation

Before installing, please make sure you have the latest version of R and Bioconductor installed.

To install signeR, start R and enter:

install.packages("BiocManager")
BiocManager::install("signeR")

For more information, see this page.

Once installed the library can be loaded as

library(signeR)

OS X users might experience compilation errors due to missing gfortran libraries. Please read this section.

3: Preparing the input

signeR takes as input a count matrix of samples x features. Each feature is usually an SNV mutation within a 3bp context (96 features, 6 types of SNV mutations and 4 possibilities for the bases at each side of the SNV change). Optionally, an opportunity matrix can also be provided containing the count frequency of the features in the whole analyzed region for each sample. Although not required, this argument is highly recommended because it allows signeR to normalize the feature frequency over the analyzed region.

Input matrices can be read both from a VCF, MAF or a tab-delimited file, as described next.

3.1: Input from VCF

The VCF file format is the most common format for storing genetic variations, the signeR package includes a utility function for generating a count matrix from the VCF:

library(VariantAnnotation)

# BSgenome, equivalent to the one used on the variant call
library(BSgenome.Hsapiens.UCSC.hg19)

vcfobj <- readVcf("/path/to/a/file.vcf", "hg19")
mut <- genCountMatrixFromVcf(BSgenome.Hsapiens.UCSC.hg19, vcfobj)

This function will generate a matrix of mutation counts for each sample in the provided VCF.

If you have one VCF per sample you can combine the results into a single matrix like this:

mut = matrix(ncol=96,nrow=0)
for(i in vcf_files) {
    vo = readVcf(i, "hg19")
    # sample name (should pick up from the vcf automatically if available)
    # colnames(vo) = i
    m0 = genCountMatrixFromVcf(mygenome, vo)
    mut = rbind(mut, m0)
}
dim(mut) # matrix with all samples

The opportunity matrix can also be generated from the reference genome (hg19 in the following case):

library(rtracklayer)

target_regions <- import(con="/path/to/a/target.bed", format="bed")
opp <- genOpportunityFromGenome(BSgenome.Hsapiens.UCSC.hg19,
    target_regions, nsamples=nrow(mut))

Where target.bed is a bed file containing the genomic regions analyzed by the variant caller.

If a BSgenome is not available for your genome, you can use a fasta file:

library(Rsamtools)

# make sure /path/to/genome.fasta.fai exists !
# you can use "samtools faidx" command to create it
mygenome <- FaFile("/path/to/genome.fasta")

mut <- genCountMatrixFromVcf(mygenome, vcfobj)
opp <- genOpportunityFromGenome(mygenome, target_regions)

3.2: Input from MAF

The MAF file format is another popular format for storing somatic genetic variants, the signeR package also includes a function for generating a count matrix from the MAF:
mut <- genCountMatrixFromMAF(mygenome, "my_file.maf")

3.3: Input from tab-delimited file

By convention, the input file should be tab-delimited with sample names as row names and features as column names. Features should be referred to in the format "base change:triplet", e.g. "C>A:TCG", as can be seen in the example below. Similarly, the opportunity matrix can be provided in a tab-delimited file with the same structure as the mutation counts file. An example of the required matrix format can be seen here.

This tutorial uses as input the 21 breast cancer dataset described in Nik-Zainal et al 2012. For the sake of convenience, this dataset is included with the package and can be accessed by using the system.file function:

mut <- read.table(system.file("extdata","21_breast_cancers.mutations.txt",
    package="signeR"), header=TRUE, check.names=FALSE)
opp <- read.table(system.file("extdata","21_breast_cancers.opportunity.txt",
    package="signeR"))

3.4: Known signatures

signeR analysis can incorporate any previous knowledge about the signatures present in the dataset. If signatures are known in advance, they can be provided as a matrix, which may be used by signeR in two different ways: a starting value that will be updated according to mutation patterns found on present data or a fixed set of parameters, kept unchanged during the estimation of exposures.

The signatures matrix shall contain each signature in one column. An example of the required matrix format can be seen here.

Along this tutorial a matrix of signatures found in breast cancer, as described in Cosmic database. For the sake of convenience this matrix is included with the package and can be accessed by the system.file function:

Pmatrix <- as.matrix(read.table(system.file("extdata","Cosmic_signatures_BRC.txt",
    package="signeR"), sep="\t", check.names=FALSE))

4: Estimating the number of mutational processes and their signatures

signeR takes a count matrix as its only required parameter, but the user can provide an opportunity matrix as well. The algorithm allows the assessment of the number of signatures by three options, as follows.

  1. signeR detects the number of signatures at run time by considering the best NMF factorization rank between 1 and min(G, K)-1, with G = number of genomes and K = number of features (i.e. 96):
    signatures <- signeR(M=mut, Opport=opp)
    
  2. The user can give an interval of the possible numbers of signatures as the parameter nlim. signeR will calculate the optimal number of signatures within this range, for example:
    signatures <- signeR(M=mut, Opport=opp, nlim=c(3,7))
    
  3. signeR can also be run by passing the number of signatures as the parameter nsig. In this setting, the algorithm is faster. For example, the following command will make signeR consider only the rank N=5 to estimate the signatures and their exposures:
    signatures <- signeR(M=mut, Opport=opp, nsig=3, main_eval=100, EM_eval=50, EMit_lim=20)
    
  4. Finally, when signatures are known in advance, signeR can use them as a starting point for the estimation of signatures in the present dataset. To this end, signatures must be provided in a matrix, as described in item 3.4 above. For example, the following command will make signeR use six Cosmic signatures found on breast cancer as a starting point:
    signatures.Pstart <- signeR(M=mut, Opport=opp, P=Pmatrix, fixedP=FALSE, main_eval=100, EM_eval=50, EMit_lim=20)
    

The parameters testing_burn and testing_eval control the number of iterations used to estimate the number of signatures (default value is 1000 for both parameters). There are other arguments that may be passed on to signeR. Please have a look at signeR's manual, issued by typing help(signeR).

Whenever signeR is left to decide which number of signatures is optimal, it will search for the rank Nsig that maximizes the median Bayesian Information Criterion (BIC). After the processing is done, this information can be plotted by the following command:

BICboxplot(signatures)

Boxplot of BIC values, showing that the optimal number of signatures for this dataset is 5.

5: Estimating exposures to known signatures.

signeR also offers the possibility to estimate exposures to known signatures as, for example, the ones described on Cosmic database. In this case, signatures should be provided in a matrix, as described in item 3.4 above, and should be kept constant during analysis:

Pmatrix <- as.matrix(read.table(system.file("extdata","Cosmic_signatures_BRC.txt",
    package="signeR"), sep="\t", check.names=FALSE))

The following command will make signeR estimate the exposures to the Cosmic signatures found on breast cancer:

exposures.known.sigs <- signeR(M=mut, Opport=opp, P=Pmatrix, fixedP=TRUE, main_eval=100, EM_eval=50, EMit_lim=20)

Exposures can then be recovered from the signeR output by the following command (as in any signeR analysis):

exposures <- Median_exp(exposures.known.sigs$SignExposures)

6: Results and plots

signeR offers several plots to visualize estimated signatures and their exposures, as well as the convergence of the MCMC used to estimate them.

6.1: Plot the MCMC paths for the NMF parameters (P and E matrices)

The following instruction plots the MCMC sample paths for each entry of the signature matrix P and their exposures, i.e. the E matrix. Only post-burnin paths are available for plotting. Those plots are useful for checking if entries have leveled off, reflecting the sampler convergence.

Paths(signatures$SignExposures)
plot of chunk unnamed-chunk-20

Each plot shows the entries and exposures of one signature along sampler iterations.

6.2: Plot the signatures

Once the processing is done, the estimated signatures can be displayed in two charts, described below.

Signature barplot

Signatures can be visualized in a barplot by issuing the following command:

SignPlot(signatures$SignExposures)
plot of chunk unnamed-chunk-21

Signatures barplot with error bars reflecting the sample percentiles 0.05, 0.25, 0.75, and 0.95 for each entry.

Signature heatmap

Estimated signatures can also be visualized in a heatmap, generated by the following command:

SignHeat(signatures$SignExposures)
plot of chunk unnamed-chunk-22

Heatmap showing the entries of each signature.

6.3: Plot the exposures

The relative contribution of each signature to the inspected genomes can be displayed in several ways. signeR currently provides three alternatives.

Exposure boxplot

The levels of exposure to each signature in all genome samples can also be plotted:

ExposureBoxplot(signatures$SignExposures)
plot of chunk unnamed-chunk-23

Exposure barplot

The contribution of the signatures to the mutations found on each genome sample can also be visualized in a barplot, plotted by the following command:

ExposureBarplot(signatures$SignExposures)
plot of chunk unnamed-chunk-24

Barplot showing the contributions of the signatures to genome samples mutation counts.

The relative contribution of signatures on each genome sample can also be visualized in a barplot, setting the relative parameter to TRUE:

ExposureBarplot(signatures$SignExposures, relative=TRUE)
plot of chunk unnamed-chunk-25

Barplot showing the relative contributions of signatures to genome samples.

Exposure heatmap

The levels of exposure to each signature can also be plotted in a heatmap:

ExposureHeat(signatures$SignExposures)
plot of chunk unnamed-chunk-26

Heatmap showing the exposures for each genome sample. Samples are grouped according to their levels of exposure to the signatures, as can be seen in the dendrogram on the left.

7: Supervised approaches to exposure analysis

If additional information is available for the samples analyzed signeR is able to evaluate how those relate to the estimated exposures to mutational signatures. When additional data is categorical, differences in exposures among groups can be analyzed and if some of the samples are unlabeled they can be labeled based on the similarity of their exposure profiles to those of labeled samples. In the case of a continuous additional feature, its correlation to estimated exposures can be evaluated. Survival data can also be analyzed and the relation of signatures to survival can be accessed. In every case, analyses are repeated for all samples of the exposure matrix generated by signeR sampler and results are considered significant if they are consistently found on most of them.

7.1: Differential Exposure Analysis

signeR can highlight signatures that are differentially active among previously defined groups of samples. To perform this task signeR needs a vector of group labels. In this example the samples were divided according to germline mutations at BRCA genes: groups wt, BRCA1+ and BRCA2+, taken from the description of the 21 breast cancer data set.

# group labels, respective to each row of the mutation count matrix
BRCA_labels <- c("wt","BRCA1+","BRCA2+","BRCA1+","BRCA2+","BRCA1+","BRCA1+",
    "wt","wt","wt","wt","BRCA1+","wt","BRCA2+","BRCA2+","wt","wt","wt",
    "wt","wt","wt")

diff_exposure <- DiffExp(signatures$SignExposures, labels=BRCA_labels)
plot of chunk unnamed-chunk-27
plot of chunk unnamed-chunk-27

Top chart: DES plot showing that the BRCA+ samples were significantly more exposed to signatures S3, S4 and S5. Bottom chart: plots showing the significant differences found when groups are compared against each other. These last plots are generated only when there are more than two groups in the analysis and any signature is found to be differentially active. Groups marked by the same letter are not significantly different from the corresponding signature.

The Pvquant vector holds the pvalues quantile of the test for each signature (by default, the 0.5 quantile, i.e. the median). The logarithms of those are considered the Differential Exposure Scores (DES). Signatures with Pvquant values below the cutoff, 0.05 by default, are considered differentially exposed.

# pvalues
diff_exposure$Pvquant
## [1] 0.7732577405 0.0008188777 0.3970037614

The MostExposed vector contains the name of the group where each differentially exposed signature showed the highest levels of activity.

# most exposed group
diff_exposure$MostExposed
## [1] NA       "BRCA1+" NA

7.2: Sample Classification

signeR can also classify samples based on their exposures to mutational processes. In order to do this, a vector of target labels must be provided to the function ExposureClassify. Samples corresponding to NA values in this vector will be classified according to the similarity of their mutational profiles to the ones of labeled samples. Several classification algorithms are available: k-nearest neighbor (knn), linear vector quantization (lvq), Logistic regression (logreg), linear discriminant analysis (lda), least absolute shrinkage and selection operator (lasso), naive bayes(nb), support vector machines (svm), random forests (rf) and adaboost (ab). The following example uses the sample labels defined in the DES analysis performed previously.

# note that BRCA_labels [15],[20] and [21] are set to NA
BRCA_labels <- c("wt","BRCA+","BRCA+","BRCA+","BRCA+","BRCA+","BRCA+","wt","wt",
    "wt","wt","BRCA+","wt","BRCA+",NA,"wt","wt","wt","wt",NA,NA)

Class <- ExposureClassify(signatures$SignExposures, labels=BRCA_labels, method="knn")
plot of chunk unnamed-chunk-30

Barplot showing the relative frequencies of assignment of each unlabeled sample to the selected group.

# Final assignments
Class$class
## PD4116a PD4199a PD4248a 
## "BRCA+"    "wt"    "wt"
# Relative frequencies of assignment to selected groups
Class$freq
## PD4116a PD4199a PD4248a 
##       1       1       1
# All assigment frequencies
Class$allfreqs
##       PD4116a PD4199a PD4248a
## BRCA+     100       0       0
## wt          0     100     100

7.3: Correlation Analysis

When a continuous feature is available for the samples being analyzed, signeR can evaluate its correlation to exposures to mutational signatures. The following command applies the cor.test function to evaluate the correlation between the provided feature and the levels of exposure of each signature:

# feature values, respective to each row of the mutation count matrix. 
# The feature simulated below will be correlated with exposures to signature 2.
myFeature <- (10^6)*Median_exp(signatures$SignExposures)[2,] + rnorm(21,0,1)

ExpCorr <- ExposureCorrelation(signatures$SignExposures, feature=myFeature)
## `geom_smooth()` using formula = 'y ~ x'
plot of chunk unnamed-chunk-32

P-values boxplot and scatterplots showing the correlations of exposures and the provided feature.

The output ExpCorr will contain a list with two vectors: the estimated correlations of the signatures to the feature and their estimated pvalues.

7.4: Linear Regression

A continuous feature may also be modeled by its exposure to mutational signatures. The following command applies the glm function to fit a linear model with the provided feature as output of the levels of exposures to mutational signatures:

ExpLM <- ExposureGLM(signatures$SignExposures, feature=myFeature)
plot of chunk unnamed-chunk-33

P-values boxplot showing the relevance of exposures in final model of provided feature.

7.5: Survival Analysis

If survival data is available for the samples being analyzed, signeR can evaluate the effect of exposure on survival. The following function performs an independent test for the exposure levels of each mutational signature, as opposed to the Cox regression described in next item. If method = logrank samples are separated according to their exposure and top and bottom groups are compared by the log-rank test. Otherwise, method = cox and a Cox's proportional hazards model are fitted to exposure levels and evaluate their effects upon survival.

# survival times and censoring, respective to each row of the mutation count matrix. 
#Time is simulated so that it is correlated to exposures to signature 3.
critical_sig<-Median_exp(signatures$SignExposures)[2,]
probs<-(critical_sig-min(critical_sig))/(max(critical_sig)-min(critical_sig))
su<-as.matrix(data.frame(time=sample(80:150,21,replace=T),
                         status=sapply(probs,function(p){sample(c(0,1),1,prob=c(p,1-p))})))

ExpSurv <- ExposureSurvival(Exposures=signatures$SignExposures,
                            surv=su, method="logrank")
plot of chunk unnamed-chunk-34

P.values boxplots and plots of survival data comparing, for each signature, sample groups showing top or bottom exposure levels.

ExpSurv.cox <- ExposureSurvival(Exposures=signatures$SignExposures,
                                surv=su, method="cox")
## Warning: There was 1 warning in `mutate()`.
## ℹ In argument: `factor.name = map_chr(coefficient_labels, symbol_substring,
##   call_symbols)`.
## Caused by warning:
## ! `as_logical()` is deprecated as of rlang 0.4.0
## Please use `vctrs::vec_cast()` instead.
## This warning is displayed once every 8 hours.
## Warning: Removed 1 rows containing missing values (`geom_segment()`).
plot of chunk unnamed-chunk-35

P.values boxplots and forest plot showing the effect of each signature upon survival according to univariate Cox's proportional hazards model.

7.6: Cox regression

signeR can also evaluate the combined effect on survival of exposure levels to different signatures. The following command fits Cox's proportional hazards model on exposures. It generates a p-values boxplot and a forest plot (from package forestplot) to show the relevance of each mutational signature to survival.

BRCA_labels <- c("wt","BRCA+","BRCA+","BRCA+","BRCA+","BRCA+","BRCA+",
    "wt","wt","wt","wt","BRCA+","wt","BRCA+","BRCA+","wt","wt","wt",
    "wt","wt","wt")

ExpSurvMd <- ExposureSurvModel(Exposures=signatures$SignExposures, surv=su, addata=data.frame(as.factor(BRCA_labels)))
## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 1 ; coefficient may be infinite.
## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.

## Warning in coxph.fit(X, Y, istrat, offset, init, control, weights = weights, :
## Loglik converged before variable 4 ; coefficient may be infinite.
## Warning: Removed 1 rows containing missing values (`geom_pointrange()`).
## Warning: Removed 1 rows containing missing values (`geom_segment()`).
## Warning: Removed 2 rows containing missing values (`geom_segment()`).
plot of chunk unnamed-chunk-36

Forestplot: Cox proportional model p-values and hazard ratios for each signature.

8: Unsupervised approaches to exposure analysis

When no additional information is available for the samples analyzed, signeR can search patterns on estimated exposures. Unsupervised analysis can be performed on all generated samples of the exposure matrix and consistent results are reported as significant.

8.1: Hierarchical Clustering

Samples can be hierarchically clustered according to their exposures to mutational signatures. The function HClustExp applies the R function hclust to each sampled exposure matrix. Dendogram branches consistently found in most of the analyses are reported:

# feature values, respective to each row of the mutation count matrix
HCE <- HClustExp(signatures$SignExposures,method.dist="euclidean", method.hclust="average")
plot of chunk unnamed-chunk-37

Hierarchical structure found on data, each branch showing the frequency of its occurrence in the analysis of sampled exposure matrices.

8.2: Fuzzy Clustering

signeR can also perform a Fuzzy clustering of the samples according to their exposures to mutational signatures. The function FuzzyClustExp applies a clustering algorithm (hard or fuzzy) to each sampled exposure matrix and averages the fuzzy membership degrees of samples to clusters. The number of clusters can be defined by the user (Clim parameter), otherwise different numbers of clusters are tested and the one that maximizes the PBMF index is used (the search algorithm used is similar to the one applied to estimate the number of signatures present in a dataset):

FCE <- FuzzyClustExp(signatures$SignExposures, Clim=c(3,7))
## Evaluating models with the number of groups ranging from 3 to 7, please be patient.
## Testing 3 groups.
## Testing 4 groups.
## Testing 5 groups.
## Testing 6 groups.
## Testing 7 groups.
## Optimum number of groups is 6. Performing final clustering.
plot of chunk unnamed-chunk-38
plot of chunk unnamed-chunk-38
plot of chunk unnamed-chunk-38
plot of chunk unnamed-chunk-38
plot of chunk unnamed-chunk-38

Heatmap showing the mean fuzzy membership degrees of samples to clusters.

The function's output is a list of three elements: the mean matrix of fuzzy membership degrees of samples to clusters, the full array of all fuzzy membership degrees found by the analysis of sampled exposure matrices and the matrix of membership degrees found by the analysis of median exposures of samples to signatures.

9: Frequently Asked Questions

9.1: Citing signeR

If you use the signeR package in your work, please cite it:
citation("signeR")
## To cite package 'signeR' in publications use:
## 
##   Rafael A. Rosales, Rodrigo D. Drummond, Renan Valieris, Emmanuel
##   Dias-Neto, and Israel T. da Silva (2016): signeR: An empirical
##   Bayesian approach to mutational signature discovery. Bioinformatics
##   September 1, 2016 doi:10.1093/bioinformatics/btw572
## 
## A BibTeX entry for LaTeX users is
## 
##   @Article{,
##     title = {signeR: An empirical Bayesian approach to mutational signature discovery.},
##     author = {Rafael A. Rosales and Rodrigo D. Drummond and Renan Valieris and Emmanuel Dias-Neto and Israel T. da Silva},
##     year = {2016},
##     journal = {Bioinformatics},
##     doi = {10.1093/bioinformatics/btw572},
##   }

9.2: Compilation errors on OS X

OS X users might get compilation errors similar to these:

ld: warning: directory not found for option '-L/usr/local/lib/x86_64'
ld: library not found for -lgfortran
ld: library not found for -lquadmath

This problem arises when the machine is missing gfortran libraries necessary to compile RcppArmadillo and signeR. To install the missing libraries, execute these lines on a terminal:

curl -O http://r.research.att.com/libs/gfortran-4.8.2-darwin13.tar.bz2
sudo tar fvxz gfortran-4.8.2-darwin13.tar.bz2 -C /

For more information see this post and the Rcpp FAQ, section 2.16.

9.3: Missing library headers

Some packages that signeR depends on require that 3rd party library headers be installed. If you see errors like:

Error: checking for curl-config... no
         Cannot find curl-config
or
libopenblas.so.0 not found

It means you need to install these headers with your package manager. For example on Ubuntu:

$ sudo apt-get install libcurl4-openssl-dev libopenblas-dev

10: References

L. B. Alexandrov, S. Nik-Zainal, D. C. Wedge, P. J. Campbell, and M. R. Stratton. Deciphering Signatures of Mutational Processes Operative in Human Cancer. Cell Reports, 3(1):246-259, Jan. 2013. [ DOI ]

A. Fischer, C. J. Illingworth, P. J. Campbell, and V. Mustonen. EMu: probabilistic inference of mutational processes and their localization in the cancer genome. Genome biology, 14(4):R39, Apr. 2013. [ DOI ]

Debug Info

sessionInfo()
## 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] stats4    stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
##  [1] signeR_2.4.0                NMF_0.26                   
##  [3] bigmemory_4.6.1             cluster_2.1.4              
##  [5] rngtools_1.5.2              registry_0.5-1             
##  [7] VariantAnnotation_1.48.0    Rsamtools_2.18.0           
##  [9] Biostrings_2.70.0           XVector_0.42.0             
## [11] SummarizedExperiment_1.32.0 Biobase_2.62.0             
## [13] GenomicRanges_1.54.0        GenomeInfoDb_1.38.0        
## [15] IRanges_2.36.0              S4Vectors_0.40.0           
## [17] MatrixGenerics_1.14.0       matrixStats_1.0.0          
## [19] BiocGenerics_0.48.0         knitr_1.44                 
## 
## loaded via a namespace (and not attached):
##   [1] splines_4.3.1            later_1.3.1              BiocIO_1.12.0           
##   [4] bitops_1.0-7             filelock_1.0.2           tibble_3.2.1            
##   [7] pROC_1.18.4              XML_3.99-0.14            rpart_4.1.21            
##  [10] lifecycle_1.0.3          rstatix_0.7.2            doParallel_1.0.17       
##  [13] globals_0.16.2           lattice_0.22-5           MASS_7.3-60             
##  [16] kpeaks_1.1.0             backports_1.4.1          magrittr_2.0.3          
##  [19] sass_0.4.7               rmarkdown_2.25           jquerylib_0.1.4         
##  [22] yaml_2.3.7               httpuv_1.6.12            cowplot_1.1.1           
##  [25] DBI_1.1.3                RColorBrewer_1.1-3       lubridate_1.9.3         
##  [28] abind_1.4-5              zlibbioc_1.48.0          purrr_1.0.2             
##  [31] RCurl_1.98-1.12          rappdirs_0.3.3           pvclust_2.2-0           
##  [34] GenomeInfoDbData_1.2.11  KMsurv_0.1-5             listenv_0.9.0           
##  [37] pheatmap_1.0.12          parallelly_1.36.0        codetools_0.2-19        
##  [40] DelayedArray_0.28.0      xml2_1.3.5               SuppDists_1.1-9.7       
##  [43] tidyselect_1.2.0         shape_1.4.6              farver_2.1.1            
##  [46] gmp_0.7-2                shinyWidgets_0.8.0       BiocFileCache_2.10.0    
##  [49] GenomicAlignments_1.38.0 jsonlite_1.8.7           e1071_1.7-13            
##  [52] ellipsis_0.3.2           survival_3.5-7           iterators_1.0.14        
##  [55] BWStest_0.2.3            foreach_1.5.2            tools_4.3.1             
##  [58] progress_1.2.2           PMCMRplus_1.9.8          Rcpp_1.0.11             
##  [61] glue_1.6.2               gridExtra_2.3            SparseArray_1.2.0       
##  [64] mgcv_1.9-0               xfun_0.40                kSamples_1.2-10         
##  [67] dplyr_1.1.3              withr_2.5.1              shinydashboard_0.7.2    
##  [70] BiocManager_1.30.22      fastmap_1.1.1            fansi_1.0.5             
##  [73] digest_0.6.33            timechange_0.2.0         R6_2.5.1                
##  [76] mime_0.12                colorspace_2.1-0         biomaRt_2.58.0          
##  [79] RSQLite_2.3.1            utf8_1.2.4               tidyr_1.3.0             
##  [82] generics_0.1.3           data.table_1.14.8        rtracklayer_1.62.0      
##  [85] class_7.3-22             bsplus_0.1.4             prettyunits_1.2.0       
##  [88] httr_1.4.7               S4Arrays_1.2.0           pkgconfig_2.0.3         
##  [91] gtable_0.3.4             Rmpfr_0.9-3              blob_1.2.4              
##  [94] survMisc_0.5.6           htmltools_0.5.6.1        carData_3.0-5           
##  [97] clue_0.3-65              multcompView_0.1-9       scales_1.2.1            
## [100] png_0.1-8                survivalAnalysis_0.3.0   km.ci_0.5-6             
## [103] bigmemory.sri_0.1.6      tzdb_0.4.0               reshape2_1.4.4          
## [106] rjson_0.2.21             uuid_1.1-1               nlme_3.1-163            
## [109] curl_5.1.0               nloptr_2.0.3             zoo_1.8-12              
## [112] proxy_0.4-27             cachem_1.0.8             stringr_1.5.0           
## [115] parallel_4.3.1           shinycssloaders_1.0.0    AnnotationDbi_1.64.0    
## [118] restfulr_0.0.15          pillar_1.9.0             grid_4.3.1              
## [121] vctrs_0.6.4              maxstat_0.7-25           ggpubr_0.6.0            
## [124] VGAM_1.1-9               promises_1.2.1           randomForest_4.7-1.1    
## [127] car_3.1-2                dbplyr_2.3.4             lhs_1.1.6               
## [130] ada_2.0-5                xtable_1.8-4             evaluate_0.22           
## [133] readr_2.1.4              GenomicFeatures_1.54.0   mvtnorm_1.2-3           
## [136] cli_3.6.1                compiler_4.3.1           rlang_1.1.1             
## [139] crayon_1.5.2             ppclust_1.1.0            ggsignif_0.6.4          
## [142] future.apply_1.11.0      labeling_0.4.3           survminer_0.4.9         
## [145] forcats_1.0.0            plyr_1.8.9               stringi_1.7.12          
## [148] gridBase_0.4-7           BiocParallel_1.36.0      munsell_0.5.0           
## [151] glmnet_4.1-8             Matrix_1.6-1.1           inaparc_1.2.0           
## [154] BSgenome_1.70.0          hms_1.1.3                bit64_4.0.5             
## [157] future_1.33.0            ggplot2_3.4.4            KEGGREST_1.42.0         
## [160] shiny_1.7.5.1            highr_0.10               kknn_1.3.1              
## [163] exactRankTests_0.8-35    broom_1.0.5              igraph_1.5.1            
## [166] memoise_2.0.1            bslib_0.5.1              tidytidbits_0.3.2       
## [169] bit_4.0.5
print(names(dev.cur()))
## [1] "png"