1 Summary

Cross Species Investigation and Analysis (CoSIA) is a package that provides researchers with an alternative methodology for comparing across species and tissues using normal wild-type RNA-Seq Gene Expression data from Bgee. Using RNA-Seq Gene Expression data, CoSIA provides multiple visualization tools to explore the transcriptome diversity and variation across genes, tissues, and species. CoSIA uses the Coefficient of Variation and Shannon Entropy and Specificity to calculate transcriptome diversity and variation. CoSIA also provides additional conversion tools and utilities to provide a streamlined methodology for cross-species comparison.

Figure 1. CoSIA_Workflow

CoSIA is split into 3 methods that provide various resources in order for researchers to conduct cross species analysis using gene expression metrics.

  • Method 1 uses getConversion to convert inputs between different gene identifiers in the same species as well as orthologs in different species. The other modules access tissue- and/or species-specific gene expression.

  • Method 2 uses getGEx to obtain raw read counts that undergo Variance Stabilizing Transformation via DESeq2 methodology. Gene expression values are visualized for a single gene across multiple tissues in single model organism or across multiple species in a single tissue using the plotting methods, plotTissueGEx & plotSpeciesGEx, respectively.

  • Method 3 uses getGExMetrics to calculate median-based Coefficient of Variation (variability) and Shannon Entropy (diversity & specificity). There are two accompanying plotting methods, plotCVGEx & plotDSGEx that are used to visualize the variation and diversity & specificity (DS) of gene expression across genes, tissues, and species.


1.1 Installation

In R:

if (!require("BiocManager", quietly = TRUE))
    install.packages("BiocManager")

BiocManager::install("CoSIA")

1.2 Generating a CoSIAn object

1.2.1 Load CoSIA

library(CoSIA)
load("../inst/extdata/proccessed/monogenic_kidney_genes.rda")


# downsampling data for figure
set.seed(42)
monogenic_kid_sample <- dplyr::sample_n(monogenic_kidney_genes, 50)

1.2.2 Arguments and options table

(#tab:Table1.) CoSIA Arguments and Options.
Slot Name Possible Value Options Default
gene_set “character”, c(characters), data.frame$column N/A
i_species; o_species; map_species “h_sapiens”, “m_musculus”, “r_noregicus”, “d_rerio”, “d_melangoaster”, “c_elegans” N/A
mapping_tool “annotationDBI”, “biomaRt” annotationDBI
input_id; output_ids “Ensembl_id”, “Entrez_id”, “Symbol” N/A
ortholog_database “NCBIOrtho”, “HomoloGene” HomoloGene
map_tissue c(“tissue”), “tissue”; see getTissues N/A
metric_type “CV_Tissue”, “CV_Species”, “DS_Gene”, “DS_Gene_all”, “DS_Tissue”, “DS_Tissue_all” N/A

1.2.3 Find possible tissues with getTissues

The function getTissues retrieves tissues available for a single species:

CoSIA::getTissues("d_rerio")

…or tissues shared across a list of species:

CoSIA::getTissues(c("h_sapiens", "m_musculus", "r_norvegicus"))
#> # A tibble: 17 × 1
#>    Common_Anatomical_Entity_Name
#>    <chr>                        
#>  1 adult mammalian kidney       
#>  2 brain                        
#>  3 cerebellum                   
#>  4 colon                        
#>  5 duodenum                     
#>  6 esophagus                    
#>  7 frontal cortex               
#>  8 heart                        
#>  9 kidney                       
#> 10 liver                        
#> 11 lung                         
#> 12 ovary                        
#> 13 pancreas                     
#> 14 skeletal muscle tissue       
#> 15 spleen                       
#> 16 stomach                      
#> 17 testis

NOTE: To compare across all shared tissues for your selected species, you can assign the getTissues output to an object as input for map_tissues when initializing a CoSIAn object.

1.2.4 Initializing a CoSIAn object

CoSIAn_Obj <- CoSIA::CoSIAn(
    gene_set = unique(monogenic_kid_sample$Gene),
    i_species = "h_sapiens",
    o_species = c(
        "h_sapiens",
        "m_musculus",
        "r_norvegicus"
    ),
    input_id = "Symbol",
    output_ids = "Ensembl_id",
    map_species = c(
        "h_sapiens",
        "m_musculus",
        "r_norvegicus"
    ),
    map_tissues = c(
        "adult mammalian kidney",
        "heart"
    ),
    mapping_tool = "annotationDBI",
    ortholog_database = "HomoloGene",
    metric_type = "CV_Species"
)

str(CoSIAn_Obj)
#> Formal class 'CoSIAn' [package "CoSIA"] with 13 slots
#>   ..@ gene_set         : chr [1:50] "SDCCAG8" "TACO1" "FANCA" "BMP7" ...
#>   ..@ i_species        : chr "h_sapiens"
#>   ..@ input_id         : chr "Symbol"
#>   ..@ o_species        : chr [1:3] "h_sapiens" "m_musculus" "r_norvegicus"
#>   ..@ output_ids       : chr "Ensembl_id"
#>   ..@ mapping_tool     : chr "annotationDBI"
#>   ..@ ortholog_database: chr "HomoloGene"
#>   ..@ converted_id     :'data.frame':    1 obs. of  1 variable:
#>   .. ..$ X0: num 0
#>   ..@ map_tissues      : chr [1:2] "adult mammalian kidney" "heart"
#>   ..@ map_species      : chr [1:3] "h_sapiens" "m_musculus" "r_norvegicus"
#>   ..@ gex              :'data.frame':    1 obs. of  1 variable:
#>   .. ..$ X0: num 0
#>   ..@ metric_type      : chr "CV_Species"
#>   ..@ metric           :'data.frame':    1 obs. of  1 variable:
#>   .. ..$ X0: num 0

NOTE: Any species you plan to compare must be specified in map_species AND o_species.

NOTE: The getGEx function requires that “Ensembl_id” is included as an output_id. Here, we convert gene symbols into Ensembl IDs.

1.3 Use Cases with Monogenic Kidney Disease-Associated Genes

The following use cases provide running examples of CoSIA applications with Natera’s Monogenic Kidney Disease Panel. We will perform id conversion, obtain and visualize gene expression data, and calculate and visualize CV and DS of gene expression across three species (human, mouse, & rat) and two tissues (kidney & heart).

1.3.1 Use Case #1: Converting Gene Symbols to Ensembl IDs (getConversion)

CoSIA can convert input ids to any of the types listed in Table @ref(tab:Table1.).

CoSIAn_Obj_convert <- CoSIA::getConversion(CoSIAn_Obj)

head(CoSIA::viewCoSIAn(CoSIAn_Obj_convert, "converted_id"))
#> [[1]]
#>  [1] "SDCCAG8"  "SDCCAG8"  "TACO1"    "FANCA"    "BMP7"     "AP2S1"   
#>  [7] "SCARB2"   "AQP2"     "XDH"      "PCBD1"    "AMN"      "PPP3CA"  
#> [13] "LMX1B"    "NPHS1"    "EBP"      "SLX4"     "CYP11B2"  "TTR"     
#> [19] "BICC1"    "OFD1"     "UCP3"     "SEC63"    "PDX1"     "INS"     
#> [25] "APOE"     "SLC4A1"   "SMC1A"    "APRT"     "CYP24A1"  "CA2"     
#> [31] "CD151"    "PTPRO"    "PAX2"     "COX14"    "CEP290"   "ADA2"    
#> [37] "FANCF"    "NPHP3"    "WNK4"     "SMAD9"    "ALG13"    "RPS17"   
#> [43] "RPS17"    "GCK"      "WNT4"     "WAS"      "DNASE1L3" "SI"      
#> [49] "G6PC"     "SALL4"    "SARS2"    "SARS2"    "SMARCAL1"

1.3.2 Use Case #2: Obtaining and visualizing curated non-diseased kidney and heart gene expression data for human, mouse, rat from Bgee

Now we will use the converted IDs with getGEx to obtain heart and kidney gene expression data for human, mouse and rat curated from Bgee.

CoSIAn_Obj_gex <- CoSIA::getGEx(CoSIAn_Obj_convert)

head(CoSIA::viewCoSIAn(CoSIAn_Obj_gex, "gex"), 5)
#> [[1]]
#>   [1] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>   [4] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>   [7] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [10] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [13] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [16] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [19] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [22] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [25] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [28] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [31] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [34] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [37] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [40] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [43] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [46] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#>  [49] "adult mammalian kidney" "heart"                  "heart"                 
#>  [52] "heart"                  "heart"                  "heart"                 
#>  [55] "heart"                  "heart"                  "heart"                 
#>  [58] "heart"                  "heart"                  "heart"                 
#>  [61] "heart"                  "heart"                  "heart"                 
#>  [64] "heart"                  "heart"                  "heart"                 
#>  [67] "heart"                  "heart"                  "heart"                 
#>  [70] "heart"                  "heart"                  "heart"                 
#>  [73] "heart"                  "heart"                  "heart"                 
#>  [76] "heart"                  "heart"                  "heart"                 
#>  [79] "heart"                  "heart"                  "heart"                 
#>  [82] "heart"                  "heart"                  "heart"                 
#>  [85] "heart"                  "heart"                  "heart"                 
#>  [88] "heart"                  "heart"                  "heart"                 
#>  [91] "heart"                  "heart"                  "heart"                 
#>  [94] "heart"                  "heart"                  "heart"                 
#>  [97] "heart"                  "heart"                  "adult mammalian kidney"
#> [100] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [103] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [106] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [109] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [112] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [115] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [118] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [121] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [124] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [127] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [130] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [133] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [136] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [139] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [142] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [145] "adult mammalian kidney" "heart"                  "heart"                 
#> [148] "heart"                  "heart"                  "heart"                 
#> [151] "heart"                  "heart"                  "heart"                 
#> [154] "heart"                  "heart"                  "heart"                 
#> [157] "heart"                  "heart"                  "heart"                 
#> [160] "heart"                  "heart"                  "heart"                 
#> [163] "heart"                  "heart"                  "heart"                 
#> [166] "heart"                  "heart"                  "heart"                 
#> [169] "heart"                  "heart"                  "heart"                 
#> [172] "heart"                  "heart"                  "heart"                 
#> [175] "heart"                  "heart"                  "heart"                 
#> [178] "heart"                  "heart"                  "heart"                 
#> [181] "heart"                  "heart"                  "heart"                 
#> [184] "heart"                  "heart"                  "heart"                 
#> [187] "heart"                  "heart"                  "heart"                 
#> [190] "heart"                  "heart"                  "heart"                 
#> [193] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [196] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [199] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [202] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [205] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [208] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [211] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [214] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [217] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [220] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [223] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [226] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [229] "adult mammalian kidney" "adult mammalian kidney" "adult mammalian kidney"
#> [232] "adult mammalian kidney" "adult mammalian kidney" "heart"                 
#> [235] "heart"                  "heart"                  "heart"                 
#> [238] "heart"                  "heart"                  "heart"                 
#> [241] "heart"                  "heart"                  "heart"                 
#> [244] "heart"                  "heart"                  "heart"                 
#> [247] "heart"                  "heart"                  "heart"                 
#> [250] "heart"                  "heart"                  "heart"                 
#> [253] "heart"                  "heart"                  "heart"                 
#> [256] "heart"                  "heart"                  "heart"                 
#> [259] "heart"                  "heart"                  "heart"                 
#> [262] "heart"                  "heart"                  "heart"                 
#> [265] "heart"                  "heart"                  "heart"                 
#> [268] "heart"                  "heart"                  "heart"                 
#> [271] "heart"                  "heart"                  "heart"                 
#> [274] "heart"

These data can be visualized with plotSpeciesGEx to plot expression of a single gene in a single tissue across species or plotTissueGEx to plot expression of a single gene in a single species across tissues.

Here we are plotting gene expression for the TACO1 gene in kidney tissue for human, mouse, and rat.

CoSIAn_Obj_gexplot <- CoSIA::plotSpeciesGEx(CoSIAn_Obj_gex, "adult mammalian kidney", "ENSG00000136463")

CoSIAn_Obj_gexplot

Figure 2. Gene Expression of TACO1 in Kidney Across Selected Species

CoSIA produces an interactive plot of expression values for TACO1 in kidney for human mouse and rat. Hovering over the plot displays sample-specific VST read count values. For file size compliance, we have included a static plot for this output. NOTE: Expression values are not meant to be compared across species in this plot. The next two use cases demonstrate appropriate methods for comparing gene expression patterns across species.


1.3.3 Use Case #3: Gene expression variability across species for kidney tissue by calculating and visualizing median-based Coefficient of Variation (CV)

Calculating and visualizing median-based coefficient of variation allows for a relative comparison of gene expression variability between species. In CoSIA, CV is calculated as the standard deviation over the median using VST read count values. In the section 1.2.4, we set metric_type= "CV_Species" to calculate CV for the monogenic kidney gene set across human, mouse and rat.


CoSIAn_Obj_CV <- CoSIA::CoSIAn(
    gene_set = unique(monogenic_kid_sample$Gene),
    i_species = "h_sapiens",
    o_species = c(
        "h_sapiens",
        "m_musculus",
        "r_norvegicus"
    ),
    input_id = "Symbol",
    output_ids = "Ensembl_id",
    map_species = c(
        "h_sapiens",
        "m_musculus",
        "r_norvegicus"
    ),
    map_tissues = c(
        "adult mammalian kidney",
        "heart"
    ),
    mapping_tool = "annotationDBI",
    ortholog_database = "HomoloGene",
    metric_type = "CV_Species"
)

CoSIAn_Obj_CV <- CoSIA::getConversion(CoSIAn_Obj_CV)

CoSIAn_Obj_CV <- CoSIA::getGExMetrics(CoSIAn_Obj_CV)

CoSIAn_Obj_CVplot <- CoSIA::plotCVGEx(CoSIAn_Obj_CV)
Gene Expression Variability Across Species in Kidney Tissue

Figure 1: Gene Expression Variability Across Species in Kidney Tissue


CoSIAn_Obj_CVplot
#> $rect
#> $rect$w
#> [1] 0.4182897
#> 
#> $rect$h
#> [1] 3.082437
#> 
#> $rect$left
#> [1] 0.7257103
#> 
#> $rect$top
#> [1] 43
#> 
#> 
#> $text
#> $text$x
#> [1] 0.8005842 0.8005842 0.8005842
#> 
#> $text$y
#> [1] 42.22939 41.45878 40.68817

Here we see relatively high variability in gene expression of multiple genes in mouse relative to rat and human.metric_type= "CV_Tissue" displays the variability of gene expression for the monogenic gene set across selected, shared tissues.


1.3.4 Use Case #4: Gene expression diversity and specificity across tissues and species for monogenic kidney-disease associated genes

Diversity and specificity metrics are also suitable for comparing gene expression patterns across species. In CoSIA, diversity and specificity (based on Shannon’s entropy) are calculated using min-max scaled median VST values generated each gene in a tissue- and species-specific manner. Values are used to calculate diversity and specificity as in Martínez & Reyes-Valdés, 2008.

In the final use case, we are calculating and visualizing diversity and specificity for kidney and heart tissue across the monogenic kidney gene set by setting metric_type= "DS_Tissue". There are additional metric_types for the CoSIAn objects, view @ref(tab:Table2.)

CoSIAn_Obj_DS <- CoSIA::CoSIAn(
    gene_set = unique(monogenic_kid_sample$Gene),
    i_species = "h_sapiens",
    o_species = c("h_sapiens", "m_musculus", "r_norvegicus"),
    input_id = "Symbol",
    output_ids = "Ensembl_id",
    map_species = c("h_sapiens", "m_musculus", "r_norvegicus"),
    map_tissues = c("adult mammalian kidney", "heart"),
    mapping_tool = "annotationDBI",
    ortholog_database = "HomoloGene",
    metric_type = "DS_Tissue"
)

CoSIAn_Obj_DS <- CoSIA::getConversion(CoSIAn_Obj_DS)

CoSIAn_Obj_DS <- CoSIA::getGExMetrics(CoSIAn_Obj_DS)

CoSIAn_Obj_DSplot <- CoSIA::plotDSGEx(CoSIAn_Obj_DS)

CoSIAn_Obj_DSplot

There is low specificity in kidney tissue, indicating there are more genes from the set that are expressed in kidney. We see higher specificity in heart tissue, indicating that there are fewer genes from the set that are expressed in heart. This pattern is seen for all three species.

(#tab:Table2.) CoSIA Metric Type options.
Metric Type Function
DS_Gene calculates diversity and specificity across genes in gene_set in the tissues listed in map_tissue
DS_Gene_all calculates diversity and specificity across genes in gene_set in the all the available tissues in a species
DS_Tissue calculates diversity and specificity across tissues listed in map_tissue in the genes in gene_set
DS_Tissue_all calculates diversity and specificity across tissues listed in map_tissue in the all the genes in a species

Session 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] stats     graphics  grDevices utils     datasets  methods   base     
#> 
#> other attached packages:
#> [1] CoSIAdata_1.1.0      CoSIA_1.2.0          ExperimentHub_2.10.0
#> [4] AnnotationHub_3.10.0 BiocFileCache_2.10.0 dbplyr_2.3.4        
#> [7] BiocGenerics_0.48.0  BiocStyle_2.30.0    
#> 
#> loaded via a namespace (and not attached):
#>  [1] tidyselect_1.2.0              farver_2.1.1                 
#>  [3] dplyr_1.1.3                   blob_1.2.4                   
#>  [5] filelock_1.0.2                Biostrings_2.70.0            
#>  [7] bitops_1.0-7                  fastmap_1.1.1                
#>  [9] RCurl_1.98-1.12               homologene_1.4.68.19.3.27    
#> [11] promises_1.2.1                digest_0.6.33                
#> [13] mime_0.12                     lifecycle_1.0.3              
#> [15] ellipsis_0.3.2                KEGGREST_1.42.0              
#> [17] interactiveDisplayBase_1.40.0 RSQLite_2.3.1                
#> [19] magrittr_2.0.3                compiler_4.3.1               
#> [21] rlang_1.1.1                   annotationTools_1.76.0       
#> [23] sass_0.4.7                    tools_4.3.1                  
#> [25] utf8_1.2.4                    yaml_2.3.7                   
#> [27] knitr_1.44                    labeling_0.4.3               
#> [29] bit_4.0.5                     curl_5.1.0                   
#> [31] withr_2.5.1                   purrr_1.0.2                  
#> [33] grid_4.3.1                    stats4_4.3.1                 
#> [35] fansi_1.0.5                   colorspace_2.1-0             
#> [37] xtable_1.8-4                  ggplot2_3.4.4                
#> [39] scales_1.2.1                  cli_3.6.1                    
#> [41] rmarkdown_2.25                crayon_1.5.2                 
#> [43] generics_0.1.3                httr_1.4.7                   
#> [45] DBI_1.1.3                     cachem_1.0.8                 
#> [47] stringr_1.5.0                 zlibbioc_1.48.0              
#> [49] AnnotationDbi_1.64.0          BiocManager_1.30.22          
#> [51] XVector_0.42.0                vctrs_0.6.4                  
#> [53] jsonlite_1.8.7                bookdown_0.36                
#> [55] IRanges_2.36.0                S4Vectors_0.40.0             
#> [57] bit64_4.0.5                   org.Rn.eg.db_3.18.0          
#> [59] magick_2.8.1                  jquerylib_0.1.4              
#> [61] tidyr_1.3.0                   glue_1.6.2                   
#> [63] org.Mm.eg.db_3.18.0           gtable_0.3.4                 
#> [65] stringi_1.7.12                BiocVersion_3.18.0           
#> [67] later_1.3.1                   GenomeInfoDb_1.38.0          
#> [69] munsell_0.5.0                 tibble_3.2.1                 
#> [71] pillar_1.9.0                  rappdirs_0.3.3               
#> [73] htmltools_0.5.6.1             GenomeInfoDbData_1.2.11      
#> [75] R6_2.5.1                      evaluate_0.22                
#> [77] shiny_1.7.5.1                 Biobase_2.62.0               
#> [79] png_0.1-8                     memoise_2.0.1                
#> [81] httpuv_1.6.12                 bslib_0.5.1                  
#> [83] Rcpp_1.0.11                   org.Hs.eg.db_3.18.0          
#> [85] xfun_0.40                     pkgconfig_2.0.3