Contents

1 Introduction

omicRexposome is an R package designed to work join with rexposome. The aim of omicRexposome is to perform analysis joining exposome and omic data with the goal to find the relationship between a single or set of exposures (external exposome) and the behavior of a gene, a group of CpGs, the level of a protein, etc. Also to provide a series of tools to analyse exposome and omic data using standard methods from Biocondcutor.

1.1 Installation

omicRexposome is currently in development and not available from CRAN nor Bioconductor. Anyway, the package can be installed by using devtools R package and taking the source from Bioinformatic Research Group in Epidemiology’s GitHub repository.

This can be done by opening an R session and typing the following code:

devtools::install_github("isglobal-brge/omicRexposome")

User must take into account that this sentence do not install the packages’ dependencies.

1.2 Pipeline

Two different types of analyses can be done with omicRexposome:

Analysis omicRexposome function
Association Study association
Integration Study crossomics

Both association and integration studies are based in objects of class MultiDataSet. A MultiDataSet object is a contained for multiple layers of sample information. Once the exposome data and the omics data are encapsulated in a MultiDataSet the object can be used for both association and integration studies.

The method association requires a MultiDataSet object having to types of information: the exposome data from an ExposomeSet object and omic information from objects of class ExpressionSet, MethylationSet, SummarizedExperiment or others. ExposomeSet objects are created with functions read_exposome and load_exposome from rexposome R package (see next section Loading Exposome Data) and encapsulates exposome data. The method crossomics expects a MultiDataSet with any number of different data-sets (at last two). Compared with association method, crossomics do not requires an ExposomeSet.

1.3 Exposome and Omic Data

In order to illustrate the capabilities of omicRexposome and the exposome-omic analysis pipeline, we will use the data from BRGdata package. This package includes different omic-sets including methylation, transcriptome and proteome data-sets and an exposome-data set.

2 Analysis

omicRexposome and MultiDataSet R packages are loaded using the standard library command:

library(omicRexposome)
library(MultiDataSet)

2.1 Association Studies

The association studies are performed using the method association. This method requires, at last four, augments:

  1. Argument object should be filled with a MultiDataSet object.
  2. Argument formula should be filled with an expression containing the covariates used to adjust the model.
  3. Argument expset should be filled with the name that the exposome-set receives in the MultiDataSet object.
  4. Argument omicset should be filled with the name that the omic-set receives in the MultiDataSet object.

The argument formula should follow the pattern: ~sex+age. The method association will fill the formula placing the exposures in the ExposomeSetm between ~ and the covariates sex+age.

association implements the limma pipeline using lmFit and eBayes in the extraction methods from MultiDataSet. The method takes care of the missing data in exposures, outcomes and omics data and locating and is subsets both data-sets, exposome data and omic data, by common samples. The argument method allows to select the fitting method used in lmFit. By default it takes the value "ls" for least squares but it can also takes "robust" for robust regression.

The following subsections illustrates the usage of association with different types of omics data: methylome, transcriptome and proteome.

2.1.1 Exposome - Transcriptome Data Association

First we get the exposome data from BRGdata package that we will use in the whole section.

data("brge_expo", package = "brgedata")
class(brge_expo)
## [1] "ExposomeSet"
## attr(,"package")
## [1] "rexposome"

The aim of this analysis is to perform an association test between the gene expression levels and the exposures. So the first point is to obtain the transcriptome data from the brgedata package.

data("brge_gexp", package = "brgedata")

The association studies between exposures and transcriptome are done in the same way that the ones with methylome. The method used is association, that takes as input an object of MultiDataSet class with both exposome and expression data.

mds <- createMultiDataSet()
mds <- add_genexp(mds, brge_gexp)
mds <- add_exp(mds, brge_expo)

gexp <- association(mds, formula=~Sex+Age, 
    expset = "exposures", omicset = "expression")

We can have a look to the number of hits and the lambda score of each analysis with the methods tableHits and tableLambda, seen in the previous section.

hit <- tableHits(gexp, th=0.001)
lab <- tableLambda(gexp)
merge(hit, lab, by="exposure")
##    exposure hits    lambda
## 1     BPA_p   19 0.9072377
## 2    BPA_t1   27 0.8807316
## 3    BPA_t3   56 0.9391129
## 4     Ben_p   19 0.8013466
## 5    Ben_t1   12 0.8234104
## 6    Ben_t2    9 0.8393350
## 7    Ben_t3   21 0.8301203
## 8     NO2_p   32 1.0281960
## 9    NO2_t1   16 0.7942881
## 10   NO2_t2   35 1.1482314
## 11   NO2_t3   31 0.8770931
## 12   PCB118   59 0.9308472
## 13   PCB138   38 1.0726221
## 14   PCB153   51 1.1743989
## 15   PCB180   17 0.9790750

Since most of all models have a lambda under one, we should consider use Surrogate Variable Analysis. This can be done using the same association method but by setting the argument sva to "fast" so the pipeline of isva and SmartSVA R packages is applied. If sva is set to "slow" the applied. pipeline is the one from sva R package.

gexp <- association(mds, formula=~Sex+Age, 
    expset = "exposures", omicset = "expression", sva = "fast")

We can re-check the results creating the same table than before:

hit <- tableHits(gexp, th=0.001)
lab <- tableLambda(gexp)
merge(hit, lab, by="exposure")
##    exposure hits    lambda
## 1     BPA_p   50 0.9874152
## 2    BPA_t1   51 0.9453795
## 3    BPA_t3   61 0.9842216
## 4     Ben_p   76 1.0117733
## 5    Ben_t1   64 1.0115515
## 6    Ben_t2   71 1.0089834
## 7    Ben_t3   59 0.9969123
## 8     NO2_p   78 1.0117151
## 9    NO2_t1   68 1.0056950
## 10   NO2_t2   69 1.0210000
## 11   NO2_t3   49 0.9802407
## 12   PCB118  129 1.0518170
## 13   PCB138   67 1.0094139
## 14   PCB153   58 0.9924482
## 15   PCB180   67 0.9973381

The objects of class ResultSet have a method called plotAssociation that allows to create QQ Plots (that are another useful way to see if there are some inflation/deflation in the P-Values).

gridExtra::grid.arrange(
    plotAssociation(gexp, rid="Ben_p", type="qq") + 
        ggplot2::ggtitle("Transcriptome - Pb Association"),
    plotAssociation(gexp, rid="BPA_p", type="qq") + 
        ggplot2::ggtitle("Transcriptome - THM Association"),
    ncol=2
)

Following this line, the same method plotAssociation can be used to create volcano plots.

gridExtra::grid.arrange(
    plotAssociation(gexp, rid="Ben_p", type="volcano", tPV=-log10(1e-04)) + 
        ggplot2::ggtitle("Transcriptome - Pb Association"),
    plotAssociation(gexp, rid="BPA_p", type="volcano", tPV=-log10(1e-04)) + 
        ggplot2::ggtitle("Transcriptome - THM Association"),
    ncol=2
)

2.1.2 Exposome - Proteome Data Association

The proteome data-set included in brgedata has 47 proteins for 90 samples.

data("brge_prot", package="brgedata")
brge_prot
## ExpressionSet (storageMode: lockedEnvironment)
## assayData: 47 features, 90 samples 
##   element names: exprs 
## protocolData: none
## phenoData
##   sampleNames: x0001 x0002 ... x0090 (90 total)
##   varLabels: age sex
##   varMetadata: labelDescription
## featureData
##   featureNames: Adiponectin_ok Alpha1AntitrypsinAAT_ok ...
##     VitaminDBindingProte_ok (47 total)
##   fvarLabels: chr start end
##   fvarMetadata: labelDescription
## experimentData: use 'experimentData(object)'
## Annotation:

The association analysis between exposures and proteome is also done using association.

mds <- createMultiDataSet()
mds <- add_eset(mds, brge_prot, dataset.type  ="proteome")
mds <- add_exp(mds, brge_expo)

prot <- association(mds, formula=~Sex+Age,
    expset = "exposures", omicset = "proteome")

The tableHits indicates that no association was found between the 47 proteins and the exposures.

tableHits(prot, th=0.001)
##        exposure hits
## Ben_p     Ben_p    0
## Ben_t1   Ben_t1    0
## Ben_t2   Ben_t2    0
## Ben_t3   Ben_t3    0
## BPA_p     BPA_p    0
## BPA_t1   BPA_t1    0
## BPA_t3   BPA_t3    0
## NO2_p     NO2_p    0
## NO2_t1   NO2_t1    1
## NO2_t2   NO2_t2    0
## NO2_t3   NO2_t3    0
## PCB118   PCB118    0
## PCB138   PCB138    0
## PCB153   PCB153    0
## PCB180   PCB180    0

This is also seen in the Manhattan plot for proteins that can be obtained from plotAssociation.

gridExtra::grid.arrange(
    plotAssociation(prot, rid="Ben_p", type="protein") + 
        ggplot2::ggtitle("Proteome - Cd Association") +
        ggplot2::geom_hline(yintercept = 1, color = "LightPink"),
    plotAssociation(prot, rid="NO2_p", type="protein") + 
        ggplot2::ggtitle("Proteome - Cotinine Association") +
        ggplot2::geom_hline(yintercept = 1, color = "LightPink"),
    ncol=2
)

NOTE: A real Manhattan plot can be draw with plot method for ResultSet objects by setting the argument type to "manhattan".

##            used  (Mb) gc trigger   (Mb)  max used   (Mb)
## Ncells  6303499 336.7   11964735  639.0  11964735  639.0
## Vcells 18593965 141.9  377730728 2881.9 472163410 3602.4

2.2 Integration Analysis

omicRexposome allows to study the relation between exposures and omic-features from another perspective, different from the association analyses. The integration analysis can be done, in omicRexposome using multi canonical correlation analysis or using multiple co-inertia analysis. The first methods is implemented in R package PMA (CRAN) and the second in omicade4 R package (Bioconductor). The two methods are encapsulated in the crossomics method.

The differences between association and crossomics are that the first method test association between two complete data-sets, by removing the samples having missing values in any of the involved data-sets, and the second try to find latent relationships between two or more sets.

Hence, we need to explore the missing data in the exposome data-set. This can be done using the methods plotMissings and tableMissings from rexposome R package.

library(rexposome)
plotMissings(brge_expo, set = "exposures")

From the plot we can see that more of the exposures have up to 25% of missing values. Hence the first step in the integration analysis is to avoid missing values. so, we perform a fast imputation on the exposures side:

brge_expo <- imputation(brge_expo)

crossomics function expects to obtain the different data-sets in a single labelled-list, in the argument called list. The argument method from crossomics function can be set to mcia (for multiple co-inertia analysis) or to mcca (for multi canonical correlation analysis).

The following code shows how to perform the integration of the exposome and the proteome. The method crossomics request a MultiDataSet object as input, containing the data-set to be integrated.

mds <- createMultiDataSet()
mds <- add_genexp(mds, brge_gexp)
mds <- add_eset(mds, brge_prot, dataset.type = "proteome")
mds <- add_exp(mds, brge_expo)

cr_mcia <- crossomics(mds, method = "mcia", verbose = TRUE)
cr_mcia
## Object of class 'ResultSet'
##  . created with: crossomics 
##  . sva:   
##     . method: mcia  ( omicade4 )
##  . #results: 1 ( error: 0 )
##  . featureData:  3 
##     . expression: 67528x11
##     . proteome: 47x3
##     . exposures: 15x12

As can be seen, crossomics returns an object of class ResultSet. In the integration process, the different data-sets are subset by common samples. This is done taking advantage of MultiDataSet capabilities.

The same is done when method is set to mcca.

cr_mcca <- crossomics(mds, method = "mcca", permute=c(4, 2))
cr_mcca

We used an extra argument (permute) into the previous call to crossomics using multi canonical correlation analysis. This argument allows to set the internal argument corresponding to permutations and iterations, that are used to tune-up internal parameters.

When a ResultSet is generated using crossomics the methods plotHits, plotLambda and plotAssociation can NOT be used. But the plotIntegration will help us to understand what was done. This method allows to provide the colors to be used on the plots:

colors <- c("green", "blue", "red")
names(colors) <- names(mds)

The graphical representation of the results from a multiple co-inertia analysis is a composition of four different plots.

plotIntegration(cr_mcia, colors=colors)

The first plot (first row, first column) is the samples space. It illustrates how the different data-sets are related in terms of intra-sample variability (each data-set has a different color). The second plot (first row, second column) shows the feature space. The features of each set are drawn on the same components so the relation between each data-set can be seen (the features are colored depending of the set were they belong).

The third plot (second row, first column) shows the inertia of each component. The two first plots are drawn on the first and second component. Finally, the fourth plot shows the behavior of the data-sets.

A radar plots is obtained when plotIntegration is used on a ResultSet created though multi canonical correlation analysis.

plotIntegration(cr_mcca, colors=colors)

This plot shows the features of the three data-sets in the same 2D space.The relation between the features can be understood by proximity. This means that the features that clusters, or that are in the same quadrant are related and goes in a different direction than the features in the other quadrants.

rm(cr_mcia, cr_mcca)

Session info

## R version 3.6.1 (2019-07-05)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 18.04.3 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.10-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.10-bioc/R/lib/libRlapack.so
## 
## 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       
## 
## attached base packages:
## [1] parallel  stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
## [1] rexposome_1.8.0     MultiDataSet_1.14.0 omicRexposome_1.8.0
## [4] Biobase_2.46.0      BiocGenerics_0.32.0 BiocStyle_2.14.0   
## 
## loaded via a namespace (and not attached):
##   [1] minqa_1.2.4                 colorspace_1.4-1           
##   [3] pryr_0.1.4                  circlize_0.4.8             
##   [5] qvalue_2.18.0               htmlTable_1.13.2           
##   [7] qqman_0.1.4                 XVector_0.26.0             
##   [9] GenomicRanges_1.38.0        GlobalOptions_0.1.1        
##  [11] base64enc_0.1-3             clue_0.3-57                
##  [13] rstudioapi_0.10             ggrepel_0.8.1              
##  [15] bit64_0.9-7                 mvtnorm_1.0-11             
##  [17] AnnotationDbi_1.48.0        RSpectra_0.15-0            
##  [19] codetools_0.2-16            splines_3.6.1              
##  [21] leaps_3.0                   impute_1.60.0              
##  [23] knitr_1.25                  zeallot_0.1.0              
##  [25] ade4_1.7-13                 Formula_1.2-3              
##  [27] lsr_0.5                     nloptr_1.2.1               
##  [29] annotate_1.64.0             cluster_2.1.0              
##  [31] BiocManager_1.30.9          compiler_3.6.1             
##  [33] backports_1.1.5             assertthat_0.2.1           
##  [35] Matrix_1.2-17               lazyeval_0.2.2             
##  [37] gmm_1.6-2                   SmartSVA_0.1.3             
##  [39] limma_3.42.0                acepack_1.4.1              
##  [41] htmltools_0.4.0             tools_3.6.1                
##  [43] gtable_0.3.0                glue_1.3.1                 
##  [45] GenomeInfoDbData_1.2.2      reshape2_1.4.3             
##  [47] dplyr_0.8.3                 FactoMineR_1.42            
##  [49] Rcpp_1.0.2                  vctrs_0.2.0                
##  [51] gdata_2.18.0                JADE_2.0-2                 
##  [53] nlme_3.1-141                iterators_1.0.12           
##  [55] made4_1.60.0                tmvtnorm_1.4-10            
##  [57] xfun_0.10                   stringr_1.4.0              
##  [59] lme4_1.1-21                 gtools_3.8.1               
##  [61] XML_3.98-1.20               isva_1.9                   
##  [63] zoo_1.8-6                   zlibbioc_1.32.0            
##  [65] MASS_7.3-51.4               scales_1.0.0               
##  [67] pcaMethods_1.78.0           sandwich_2.5-1             
##  [69] SummarizedExperiment_1.16.0 RColorBrewer_1.1-2         
##  [71] yaml_2.2.0                  memoise_1.1.0              
##  [73] gridExtra_2.3               ggplot2_3.2.1              
##  [75] rpart_4.1-15                fastICA_1.2-2              
##  [77] calibrate_1.7.5             latticeExtra_0.6-28        
##  [79] stringi_1.4.3               RSQLite_2.1.2              
##  [81] genefilter_1.68.0           S4Vectors_0.24.0           
##  [83] foreach_1.4.7               corrplot_0.84              
##  [85] checkmate_1.9.4             caTools_1.17.1.2           
##  [87] boot_1.3-23                 BiocParallel_1.20.0        
##  [89] shape_1.4.4                 GenomeInfoDb_1.22.0        
##  [91] rlang_0.4.1                 pkgconfig_2.0.3            
##  [93] matrixStats_0.55.0          bitops_1.0-6               
##  [95] imputeLCMD_2.0              evaluate_0.14              
##  [97] lattice_0.20-38             PMA_1.1                    
##  [99] purrr_0.3.3                 labeling_0.3               
## [101] htmlwidgets_1.5.1           omicade4_1.26.0            
## [103] bit_1.1-14                  tidyselect_0.2.5           
## [105] norm_1.0-9.5                plyr_1.8.4                 
## [107] magrittr_1.5                bookdown_0.14              
## [109] R6_2.4.0                    gplots_3.0.1.1             
## [111] IRanges_2.20.0              Hmisc_4.2-0                
## [113] DelayedArray_0.12.0         DBI_1.0.0                  
## [115] pillar_1.4.2                foreign_0.8-72             
## [117] mgcv_1.8-30                 survival_2.44-1.1          
## [119] scatterplot3d_0.3-41        RCurl_1.95-4.12            
## [121] nnet_7.3-12                 tibble_2.1.3               
## [123] crayon_1.3.4                KernSmooth_2.23-16         
## [125] rmarkdown_1.16              grid_3.6.1                 
## [127] sva_3.34.0                  data.table_1.12.6          
## [129] blob_1.2.0                  digest_0.6.22              
## [131] flashClust_1.01-2           xtable_1.8-4               
## [133] glmnet_2.0-18               stats4_3.6.1               
## [135] munsell_0.5.0