Contents

1 Citation

Note: if you use animalcules in published research, please cite:

Zhao, Y., Federico, A., Faits, T. et al. (2021) animalcules: interactive microbiome analytics and visualization in R Microbiome, 9(1), 1-16. 10.1186/s40168-021-01013-0

2 Introduction

animalcules is an R package for utilizing up-to-date data analytics, visualization methods, and machine learning models to provide users an easy-to-use interactive microbiome analysis framework. It can be used as a standalone software package or users can explore their data with the accompanying interactive R Shiny application. Traditional microbiome analysis such as alpha/beta diversity and differential abundance analysis are enhanced, while new methods like biomarker identification are introduced by animalcules. Powerful interactive and dynamic figures generated by animalcules enable users to understand their data better and discover new insights.

3 Installation

Install the development version of the package from Bioconductor.

if (!requireNamespace("BiocManager", quietly=TRUE))
  install.packages("BiocManager")
BiocManager::install("compbiomed/animalcules")

Or install the development version of the package from Github.

if (!requireNamespace("devtools", quietly=TRUE))
  install.packages("devtools")
devtools::install_github("compbiomed/animalcules")

4 Load Packages

Load the packages needed into R session.

library(animalcules)
library(SummarizedExperiment)

5 Run Shiny App

This command is to start the animalcules shiny app. For shiny app tutorials, please go to our website, and click the tab “Interactive Shiny Analysis”.

The rest of the vignette is for the command line version of animalcules, which could also be found in our website, and click the tab “Command Line Analysis”.

run_animalcules()

6 Load Toy Dataset

This toy dataset contains 50 simulated samples. Throughout the vignette, we will use the data structure MultiAssayExperiment (MAE) as the input to all functions.

data_dir = system.file("extdata/TB_example_dataset.rds", package = "animalcules")
MAE = readRDS(data_dir)

For users who would like to use their own dataset, please follow the following steps:

data_dir = "PATH_TO_THE_ANIMALCULES_FILE"
MAE = readRDS(data_dir)

7 Summary and Categorize

One of the first steps in the data analysis process involves summarizing the data and looking for outliers or other obvious data issues that may cause issue with downstream analysis.

7.1 Summary Plot (Pie Chart or Box plot)

One type of summarization plot returns either a box plot or pie chart for continous or categorical data respectively.

p <- filter_summary_pie_box(MAE,
                            samples_discard = c("SRR1204622"),
                            filter_type = "By Metadata",
                            sample_condition = "age_s")
p

7.2 Summary Plot (Density Plot or Bar Plot)

One type of summarization plot returns either a density plot or bar plot for continous or categorical data respectively.

p <- filter_summary_bar_density(MAE,
                                samples_discard = c("SRR1204622"),
                                filter_type = "By Metadata",
                                sample_condition = "sex_s")
p

7.3 Categorize

It is often necessary to bin continuous data into categories when performing analyses that require categorical input. To help ease this process, users can automatically categorize categorical data and provide custom bin breaks and labels in doing so.

microbe <- MAE[['MicrobeGenetics']]
samples <- as.data.frame(colData(microbe))
result <- filter_categorize(samples,
                            sample_condition="age_s",
                            new_label="AGE_GROUP",
                            bin_breaks=c(0,30,40,100),
                            bin_labels=c('a','b',"c"))
head(result$sam_table)
#            isolate_s Disease age_s sex_s   tissue_s AGE_GROUP
# SRR1204622 Patient 1      TB    45     F     Sputum         c
# SRR1204623 Patient 1      TB    45     F      Nasal         c
# SRR1204624 Patient 1      TB    45     F Oropharynx         c
# SRR1204625 Patient 2      TB    29     M     Sputum         a
# SRR1204626 Patient 2      TB    29     M      Nasal         a
# SRR1204627 Patient 2      TB    29     M Oropharynx         a
result$plot.unbinned
result$plot.binned

8 Visualization

A typical analysis involves visualization of microbe abundances across samples or groups of samples. Animalcules implements three common types of visualization plots including stacked bar plots, heat map, and box plots generated with Plotly.

8.1 Relative Abundance Stacked Bar Plot

The stacked bar plots are used to visualize the relative abundance of microbes at a given taxonomical level in each sample represented as a single bar.

p <- relabu_barplot(MAE,
                    tax_level="genus",
                    sort_by="conditions",
                    sample_conditions=c('Disease'),
                    show_legend=TRUE)
p

8.2 Relative Abundance Heatmap

The heatmap represents a sample by organisms matrix that can be visualized at different taxonomic levels.

p <- relabu_heatmap(MAE,
                   tax_level="genus",
                   sort_by="conditions",
                   sample_conditions=c("sex_s", "age_s"))
p

8.3 Relative Abundance Boxplot

The boxplot visualization allows users to compare the abundance of one or more organisms between categorical attributes.

p <- relabu_boxplot(MAE,
                    tax_level="genus",
                    organisms=c("Streptococcus", "Staphylococcus"),
                    condition="sex_s",
                    datatype="logcpm")
p
# Warning in RColorBrewer::brewer.pal(N, "Set2"): minimal value for n is 3, returning requested palette with 3 different levels

# Warning in RColorBrewer::brewer.pal(N, "Set2"): minimal value for n is 3, returning requested palette with 3 different levels
# Warning: 'layout' objects don't have these attributes: 'boxmode'
# Valid attributes include:
# '_deprecated', 'activeshape', 'annotations', 'autosize', 'autotypenumbers', 'calendar', 'clickmode', 'coloraxis', 'colorscale', 'colorway', 'computed', 'datarevision', 'dragmode', 'editrevision', 'editType', 'font', 'geo', 'grid', 'height', 'hidesources', 'hoverdistance', 'hoverlabel', 'hovermode', 'images', 'legend', 'mapbox', 'margin', 'meta', 'metasrc', 'modebar', 'newshape', 'paper_bgcolor', 'plot_bgcolor', 'polar', 'scene', 'selectdirection', 'selectionrevision', 'separators', 'shapes', 'showlegend', 'sliders', 'spikedistance', 'template', 'ternary', 'title', 'transition', 'uirevision', 'uniformtext', 'updatemenus', 'width', 'xaxis', 'yaxis', 'barmode', 'bargap', 'mapType'

9 Diversity

9.1 Alpha Diversity Boxplot

Alpha diversity, which describes the richness and evenness of sample microbial community, is a vital indicator in the microbiome analysis. animalcules provides the interactive boxplot comparison of alpha diversity between selected groups of samples. Both taxonomy levels and alpha diversity metrics (Shannon, Gini Simpson, Inverse Simpson) can be changed. Users can also conduct alpha diversity statistical tests including Wilcoxon rank sum test, T test and Kruskal-Wallis test.

Plot the alpha diversity boxplot between the levels in selected condition.

alpha_div_boxplot(MAE = MAE,
                  tax_level = "genus",
                  condition = "Disease",
                  alpha_metric = "shannon")

9.2 Alpha Diversity Statistical Test

Conduct statistical test on the alpha diversity between the levels in selected condition.

do_alpha_div_test(MAE = MAE,
                  tax_level = "genus",
                  condition = "Disease",
                  alpha_metric = "shannon",
                  alpha_stat = "T-test")
#         Wilcoxon rank sum exact test Welch Two Sample t-test
# P-value                  0.006682257             0.006483754

9.3 Beta Diversity Heatmap

On the other hand, by defining distances between each sample, beta diversity is another key metric to look at. Users can plot the beta diversity heatmap by selecting different beta diversity dissimilarity metrics including Bray-Curtis and Jaccard. Users can also conduct beta diversity statistical testing between groups including PERMANOVA, Wilcoxon rank sum test and Kruskal-Wallis.

Plot the beta diversity heatmap with selected condition.

diversity_beta_heatmap(MAE = MAE, 
                       tax_level = 'genus', 
                       input_beta_method = "bray",
                       input_bdhm_select_conditions = 'Disease',
                       input_bdhm_sort_by = 'condition')
# Warning: 'layout' objects don't have these attributes: 'orientation'
# Valid attributes include:
# '_deprecated', 'activeshape', 'annotations', 'autosize', 'autotypenumbers', 'calendar', 'clickmode', 'coloraxis', 'colorscale', 'colorway', 'computed', 'datarevision', 'dragmode', 'editrevision', 'editType', 'font', 'geo', 'grid', 'height', 'hidesources', 'hoverdistance', 'hoverlabel', 'hovermode', 'images', 'legend', 'mapbox', 'margin', 'meta', 'metasrc', 'modebar', 'newshape', 'paper_bgcolor', 'plot_bgcolor', 'polar', 'scene', 'selectdirection', 'selectionrevision', 'separators', 'shapes', 'showlegend', 'sliders', 'spikedistance', 'template', 'ternary', 'title', 'transition', 'uirevision', 'uniformtext', 'updatemenus', 'width', 'xaxis', 'yaxis', 'barmode', 'bargap', 'mapType'

# Warning: 'layout' objects don't have these attributes: 'orientation'
# Valid attributes include:
# '_deprecated', 'activeshape', 'annotations', 'autosize', 'autotypenumbers', 'calendar', 'clickmode', 'coloraxis', 'colorscale', 'colorway', 'computed', 'datarevision', 'dragmode', 'editrevision', 'editType', 'font', 'geo', 'grid', 'height', 'hidesources', 'hoverdistance', 'hoverlabel', 'hovermode', 'images', 'legend', 'mapbox', 'margin', 'meta', 'metasrc', 'modebar', 'newshape', 'paper_bgcolor', 'plot_bgcolor', 'polar', 'scene', 'selectdirection', 'selectionrevision', 'separators', 'shapes', 'showlegend', 'sliders', 'spikedistance', 'template', 'ternary', 'title', 'transition', 'uirevision', 'uniformtext', 'updatemenus', 'width', 'xaxis', 'yaxis', 'barmode', 'bargap', 'mapType'

# Warning: 'layout' objects don't have these attributes: 'orientation'
# Valid attributes include:
# '_deprecated', 'activeshape', 'annotations', 'autosize', 'autotypenumbers', 'calendar', 'clickmode', 'coloraxis', 'colorscale', 'colorway', 'computed', 'datarevision', 'dragmode', 'editrevision', 'editType', 'font', 'geo', 'grid', 'height', 'hidesources', 'hoverdistance', 'hoverlabel', 'hovermode', 'images', 'legend', 'mapbox', 'margin', 'meta', 'metasrc', 'modebar', 'newshape', 'paper_bgcolor', 'plot_bgcolor', 'polar', 'scene', 'selectdirection', 'selectionrevision', 'separators', 'shapes', 'showlegend', 'sliders', 'spikedistance', 'template', 'ternary', 'title', 'transition', 'uirevision', 'uniformtext', 'updatemenus', 'width', 'xaxis', 'yaxis', 'barmode', 'bargap', 'mapType'

# Warning: 'layout' objects don't have these attributes: 'orientation'
# Valid attributes include:
# '_deprecated', 'activeshape', 'annotations', 'autosize', 'autotypenumbers', 'calendar', 'clickmode', 'coloraxis', 'colorscale', 'colorway', 'computed', 'datarevision', 'dragmode', 'editrevision', 'editType', 'font', 'geo', 'grid', 'height', 'hidesources', 'hoverdistance', 'hoverlabel', 'hovermode', 'images', 'legend', 'mapbox', 'margin', 'meta', 'metasrc', 'modebar', 'newshape', 'paper_bgcolor', 'plot_bgcolor', 'polar', 'scene', 'selectdirection', 'selectionrevision', 'separators', 'shapes', 'showlegend', 'sliders', 'spikedistance', 'template', 'ternary', 'title', 'transition', 'uirevision', 'uniformtext', 'updatemenus', 'width', 'xaxis', 'yaxis', 'barmode', 'bargap', 'mapType'

# Warning: 'layout' objects don't have these attributes: 'orientation'
# Valid attributes include:
# '_deprecated', 'activeshape', 'annotations', 'autosize', 'autotypenumbers', 'calendar', 'clickmode', 'coloraxis', 'colorscale', 'colorway', 'computed', 'datarevision', 'dragmode', 'editrevision', 'editType', 'font', 'geo', 'grid', 'height', 'hidesources', 'hoverdistance', 'hoverlabel', 'hovermode', 'images', 'legend', 'mapbox', 'margin', 'meta', 'metasrc', 'modebar', 'newshape', 'paper_bgcolor', 'plot_bgcolor', 'polar', 'scene', 'selectdirection', 'selectionrevision', 'separators', 'shapes', 'showlegend', 'sliders', 'spikedistance', 'template', 'ternary', 'title', 'transition', 'uirevision', 'uniformtext', 'updatemenus', 'width', 'xaxis', 'yaxis', 'barmode', 'bargap', 'mapType'

9.4 Beta Diversity Boxplot

Plot the beta diversity boxplot within and between conditions.

diversity_beta_boxplot(MAE = MAE, 
                       tax_level = 'genus', 
                       input_beta_method = "bray",
                       input_select_beta_condition = 'Disease')

9.5 Beta Diversity Test

Conduct statistical test on the beta diversity between the levels in selected condition.

diversity_beta_test(MAE = MAE, 
                    tax_level = 'genus',
                    input_beta_method = "bray",
                    input_select_beta_condition =  'Disease',
                    input_select_beta_stat_method = 'PERMANOVA',
                    input_num_permutation_permanova = 999)
# Permutation test for adonis under reduced model
# Terms added sequentially (first to last)
# Permutation: free
# Number of permutations: 999
# 
# vegan::adonis2(formula = dist.mat ~ condition, data = sam_table, permutations = input_num_permutation_permanova)
#           Df SumOfSqs      R2     F Pr(>F)   
# condition  1   1.1942 0.13939 4.535  0.003 **
# Residual  28   7.3730 0.86061                
# Total     29   8.5671 1.00000                
# ---
# Signif. codes:  0 '***' 0.001 '**' 0.01 '*' 0.05 '.' 0.1 ' ' 1

10 Dimensionality Reduction

10.1 PCA

A wrapper for conduction 2D and 3D Principal Component Analysis.

result <- dimred_pca(MAE,
                     tax_level="genus",
                     color="age_s",
                     shape="Disease",
                     pcx=1,
                     pcy=2,
                     datatype="logcpm")
result$plot
head(result$table)
#      PC Standard Deviation Variance Explained Cumulative Variance
# PC1 PC1               5.76            18.881%              18.88%
# PC2 PC2               4.54            11.732%              30.61%
# PC3 PC3               3.63             7.475%              38.09%
# PC4 PC4               3.53             7.066%              45.15%
# PC5 PC5               3.24             5.972%              51.12%
# PC6 PC6               2.95             4.943%              56.07%

10.2 PCoA

A wrapper for conduction 2D and 3D Principal Coordinate Analysis.

result <- dimred_pcoa(MAE,
                      tax_level="genus",
                      color="age_s",
                      shape="Disease",
                      axx=1,
                      axy=2,
                      method="bray")
result$plot
head(result$table)
#          Axis Eigenvalue Variance Explained Cumulative Variance
# Axis.1 Axis.1      3.550            30.456%              30.46%
# Axis.2 Axis.2      1.590            14.187%              44.64%
# Axis.3 Axis.3      1.120            10.303%              54.95%
# Axis.4 Axis.4      0.751             7.224%              62.17%
# Axis.5 Axis.5      0.381             4.155%              66.32%
# Axis.6 Axis.6      0.304             3.521%              69.85%

10.3 UMAP

A wrapper for conduction 2D and 3D Uniform Manifold Approximation and Projection.

result <- dimred_umap(MAE,
                      tax_level="genus",
                      color="age_s",
                      shape="Disease",
                      cx=1,
                      cy=2,
                      n_neighbors=15,
                      metric="euclidean",
                      datatype="logcpm")
result$plot

10.4 t-SNE

A wrapper for conduction 2D and 3D t-distributed stochastic neighbor embedding.

# result <- dimred_tsne(MAE,
#                       tax_level="phylum",
#                       color="age_s",
#                       shape="Disease",
#                       k="3D",
#                       initial_dims=30,
#                       perplexity=10,
#                       datatype="logcpm")
# result$plot

11 Differential Analysis

Here in animalcules, we provide a DESeq2-based differential abundance analysis. Users can choose the target variable, covariate variable, taxonomy level, minimum count cut-off, and an adjusted p-value threshold. The analysis report will output not only the adjusted p-value and log2-fold-change of the microbes, but also the percentage, prevalence, and the group size-adjusted fold change.

p <- differential_abundance(MAE,
                            tax_level="phylum",
                            input_da_condition=c("Disease"),
                            min_num_filter = 2,
                            input_da_padj_cutoff = 0.5)
p
#          microbe   padj pValue log2FoldChange    TB Control prevalence
# 1     Firmicutes 0.0936 0.0170          1.010 18/18   12/12    100.00%
# 2 Proteobacteria 0.0936 0.0109          1.970 17/18   12/12     96.67%
# 3  Bacteroidetes 0.1130 0.0307         -2.000 17/18   12/12     96.67%
# 4 Actinobacteria 0.1330 0.0484         -0.929 18/18   12/12    100.00%
# 5    Tenericutes 0.3350 0.1520         -2.610  5/18    3/12     26.67%
# 6  Cyanobacteria 0.4290 0.2340         -2.400  3/18    4/12     23.33%
#   Group Size adjusted fold change
# 1                            1.00
# 2                            1.06
# 3                            1.06
# 4                            1.00
# 5                            1.11
# 6                            2.00

12 Biomarker

One unique feature of animalcules is the biomarker identification module built on machine learning models. Users can choose one classification model from logistic regression, gradient boosting machine, or random forest to identify a microbes biomarker list. The feature importance score for each microbe will be provided. To evaluate the biomarker performance, the ROC plot and the AUC value using cross-validation outputs are shown to users. Note: Results may vary each run.

12.1 Train biomarker

p <- find_biomarker(MAE,
                    tax_level = "genus",
                    input_select_target_biomarker = c("Disease"),
                    nfolds = 3,
                    nrepeats = 3,
                    seed = 99,
                    percent_top_biomarker = 0.2,
                    model_name = "logistic regression")
# biomarker
p$biomarker
#             biomarker_list
# 1            Mesorhizobium
# 2          Streptobacillus
# 3                Olsenella
# 4        Pseudarthrobacter
# 5            Mycobacterium
# 6         Paraburkholderia
# 7             Blastococcus
# 8              Caulobacter
# 9             Acidiphilium
# 10         Arcanobacterium
# 11           Anoxybacillus
# 12              Prevotella
# 13              Aerococcus
# 14            Nocardioides
# 15               Spirosoma
# 16         Cryptobacterium
# 17             Veillonella
# 18            Glaesserella
# 19         Aggregatibacter
# 20              Salmonella
# 21            Methylomonas
# 22          Pectobacterium
# 23               Moraxella
# 24              Aliivibrio
# 25          Mageeibacillus
# 26           Chelativorans
# 27               Weissella
# 28            Anaerostipes
# 29           Desulfovibrio
# 30            Thiobacillus
# 31 Pseudopropionibacterium
# 32             Geobacillus
# 33         Novosphingobium
# 34          Herbaspirillum
# 35           Streptococcus
# importance plot
p$importance_plot

# ROC plot
p$roc_plot

13 Session Info

sessionInfo()
# R version 4.2.0 RC (2022-04-19 r82224)
# Platform: x86_64-pc-linux-gnu (64-bit)
# Running under: Ubuntu 20.04.4 LTS
# 
# Matrix products: default
# BLAS:   /home/biocbuild/bbs-3.15-bioc/R/lib/libRblas.so
# LAPACK: /home/biocbuild/bbs-3.15-bioc/R/lib/libRlapack.so
# 
# 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       
# 
# attached base packages:
# [1] stats4    stats     graphics  grDevices utils     datasets  methods  
# [8] base     
# 
# other attached packages:
#  [1] caret_6.0-92                lattice_0.20-45            
#  [3] ggplot2_3.3.5               SummarizedExperiment_1.26.0
#  [5] Biobase_2.56.0              GenomicRanges_1.48.0       
#  [7] GenomeInfoDb_1.32.0         IRanges_2.30.0             
#  [9] S4Vectors_0.34.0            BiocGenerics_0.42.0        
# [11] MatrixGenerics_1.8.0        matrixStats_0.62.0         
# [13] animalcules_1.12.0          testthat_3.1.4             
# [15] BiocStyle_2.24.0           
# 
# loaded via a namespace (and not attached):
#   [1] utf8_1.2.2                  reticulate_1.24            
#   [3] tidyselect_1.1.2            RSQLite_2.2.12             
#   [5] AnnotationDbi_1.58.0        htmlwidgets_1.5.4          
#   [7] grid_4.2.0                  BiocParallel_1.30.0        
#   [9] modeest_2.4.0               covr_3.5.1                 
#  [11] pROC_1.18.0                 devtools_2.4.3             
#  [13] munsell_0.5.0               codetools_0.2-18           
#  [15] statmod_1.4.36              DT_0.22                    
#  [17] umap_0.2.8.0                rentrez_1.2.3              
#  [19] future_1.25.0               withr_2.5.0                
#  [21] colorspace_2.0-3            highr_0.9                  
#  [23] knitr_1.38                  rstudioapi_0.13            
#  [25] listenv_0.8.0               labeling_0.4.2             
#  [27] GenomeInfoDbData_1.2.8      plotROC_2.2.1              
#  [29] farver_2.1.0                bit64_4.0.5                
#  [31] fBasics_3042.89.1           rhdf5_2.40.0               
#  [33] rprojroot_2.0.3             parallelly_1.31.1          
#  [35] vctrs_0.4.1                 generics_0.1.2             
#  [37] ipred_0.9-12                xfun_0.30                  
#  [39] R6_2.5.1                    clue_0.3-60                
#  [41] locfit_1.5-9.5              rex_1.2.1                  
#  [43] bitops_1.0-7                rhdf5filters_1.8.0         
#  [45] cachem_1.0.6                DelayedArray_0.22.0        
#  [47] assertthat_0.2.1            promises_1.2.0.1           
#  [49] scales_1.2.0                nnet_7.3-17                
#  [51] gtable_0.3.0                globals_0.14.0             
#  [53] spatial_7.3-15              processx_3.5.3             
#  [55] timeDate_3043.102           rlang_1.0.2                
#  [57] genefilter_1.78.0           splines_4.2.0              
#  [59] lazyeval_0.2.2              ModelMetrics_1.2.2.2       
#  [61] GUniFrac_1.5                BiocManager_1.30.17        
#  [63] yaml_2.3.5                  reshape2_1.4.4             
#  [65] crosstalk_1.2.0             httpuv_1.6.5               
#  [67] tools_4.2.0                 lava_1.6.10                
#  [69] usethis_2.1.5               bookdown_0.26              
#  [71] ellipsis_0.3.2              jquerylib_0.1.4            
#  [73] biomformat_1.24.0           RColorBrewer_1.1-3         
#  [75] stabledist_0.7-1            sessioninfo_1.2.2          
#  [77] MultiAssayExperiment_1.22.0 Rcpp_1.0.8.3               
#  [79] plyr_1.8.7                  zlibbioc_1.42.0            
#  [81] purrr_0.3.4                 RCurl_1.98-1.6             
#  [83] ps_1.7.0                    prettyunits_1.1.1          
#  [85] rpart_4.1.16                openssl_2.0.0              
#  [87] statip_0.2.3                ggrepel_0.9.1              
#  [89] cluster_2.1.3               fs_1.5.2                   
#  [91] magrittr_2.0.3              magick_2.7.3               
#  [93] timeSeries_3062.100         data.table_1.14.2          
#  [95] RSpectra_0.16-1             pkgload_1.2.4              
#  [97] shinyjs_2.1.0               mime_0.12                  
#  [99] evaluate_0.15               xtable_1.8-4               
# [101] XML_3.99-0.9                shape_1.4.6                
# [103] compiler_4.2.0              tibble_3.1.6               
# [105] crayon_1.5.1                htmltools_0.5.2            
# [107] mgcv_1.8-40                 later_1.3.0                
# [109] tidyr_1.2.0                 geneplotter_1.74.0         
# [111] lubridate_1.8.0             DBI_1.1.2                  
# [113] rmutil_1.1.9                MASS_7.3-57                
# [115] Matrix_1.4-1                permute_0.9-7              
# [117] brio_1.1.3                  cli_3.3.0                  
# [119] parallel_4.2.0              gower_1.0.0                
# [121] forcats_0.5.1               pkgconfig_2.0.3            
# [123] plotly_4.10.0               recipes_0.2.0              
# [125] foreach_1.5.2               annotate_1.74.0            
# [127] bslib_0.3.1                 hardhat_0.2.0              
# [129] XVector_0.36.0              prodlim_2019.11.13         
# [131] stringr_1.4.0               callr_3.7.0                
# [133] digest_0.6.29               tsne_0.1-3.1               
# [135] vegan_2.6-2                 Biostrings_2.64.0          
# [137] rmarkdown_2.14              shiny_1.7.1                
# [139] lifecycle_1.0.1             nlme_3.1-157               
# [141] jsonlite_1.8.0              Rhdf5lib_1.18.0            
# [143] desc_1.4.1                  viridisLite_0.4.0          
# [145] askpass_1.1                 limma_3.52.0               
# [147] fansi_1.0.3                 pillar_1.7.0               
# [149] KEGGREST_1.36.0             fastmap_1.1.0              
# [151] httr_1.4.2                  pkgbuild_1.3.1             
# [153] survival_3.3-1              glue_1.6.2                 
# [155] remotes_2.4.2               png_0.1-7                  
# [157] iterators_1.0.14            glmnet_4.1-4               
# [159] bit_4.0.4                   class_7.3-20               
# [161] stringi_1.7.6               sass_0.4.1                 
# [163] blob_1.2.3                  stable_1.1.6               
# [165] DESeq2_1.36.0               memoise_2.0.1              
# [167] dplyr_1.0.8                 future.apply_1.9.0         
# [169] ape_5.6-2