orthogene
: Interspecies gene mappingorthogene
is an R package for easy mapping of orthologous genes across
hundreds of species. It pulls up-to-date gene ortholog mappings across
700+ organisms. It also provides various utility functions to
aggregate/expand common objects (e.g.Β data.frames, gene expression
matrices, lists) using 1:1, many:1, 1:many or many:many
gene mappings, both within- and between-species.
In brief, orthogene
lets you easily:
convert_orthologs
between any two
species.map_species
names onto standard taxonomic
ontologies. report_orthologs
between any two
species.map_genes
onto standard
ontologiesaggregate_mapped_genes
in a
matrix. all_genes
from any
species.infer_species
from gene
names. create_background
gene lists based one, two, or more
species. get_silhouettes
of each species from
phylopic. prepare_tree
with evolutionary divergence times across
>147,000
species.If you use orthogene
, please cite:
Brian M. Schilder, Nathan G. Skene (2022). orthogene: Interspecies gene mapping. R package version 1.4.0, https://doi.org/doi:10.18129/B9.bioc.orthogene
if (!requireNamespace("BiocManager", quietly = TRUE)) install.packages("BiocManager")
# orthogene is only available on Bioconductor>=3.14
if(BiocManager::version()<"3.14") BiocManager::install(update = TRUE, ask = FALSE)
BiocManager::install("orthogene")
orthogene
can also be installed via a
Docker
or
Singularity
container with Rstudio pre-installed. Further instructions provided
here.
library(orthogene)
data("exp_mouse")
# Setting to "homologene" for the purposes of quick demonstration.
# We generally recommend using method="gprofiler" (default).
method <- "homologene"
For most functions, orthogene
lets users choose between different
methods, each with complementary strengths and weaknesses:
"gprofiler"
, "homologene"
, and "babelgene"
In general, we recommend you use "gprofiler"
when possible, as it
tends to be more comprehensive.
While "babelgene"
contains less species, it queries a wide variety of
orthology databases and can return a column βsupport_nβ that tells you
how many databases support each ortholog gene mapping. This can be
helpful when you need a semi-quantitative measure of mapping quality.
Itβs also worth noting that for smaller gene sets, the speed difference between these methods becomes negligible.
gprofiler | homologene | babelgene | |
---|---|---|---|
Reference organisms | 700+ | 20+ | 19 (but cannot convert between pairs of non-human species) |
Gene mappings | More comprehensive | Less comprehensive | More comprehensive |
Updates | Frequent | Less frequent | Less frequent |
Orthology databases | Ensembl, HomoloGene, WormBase | HomoloGene | HGNC Comparison of Orthology Predictions (HCOP), which includes predictions from eggNOG, Ensembl Compara, HGNC, HomoloGene, Inparanoid, NCBI Gene Orthology, OMA, OrthoDB, OrthoMCL, Panther, PhylomeDB, TreeFam and ZFIN |
Data location | Remote | Local | Local |
Internet connection | Required | Not required | Not required |
Speed | Slower | Faster | Medium |
convert_orthologs
is very flexible with what users can supply as gene_df
, and can take a
data.frame
/data.table
/tibble
, (sparse) matrix
, or
list
/vector
containing genes.
Genes, transcripts, proteins, SNPs, or genomic ranges will be recognised in most formats (HGNC, Ensembl, RefSeq, UniProt, etc.) and can even be a mixture of different formats.
All genes will be mapped to gene symbols, unless specified otherwise
with the ...
arguments (see ?orthogene::convert_orthologs
or
here
for details).
A key feature of
convert_orthologs
is that it handles the issue of genes with many-to-many mappings across
species. This can occur due to evolutionary divergence, and the function
of these genes tend to be less conserved and less translatable. Users
can address this using different strategies via non121_strategy=
.
gene_df <- orthogene::convert_orthologs(gene_df = exp_mouse,
gene_input = "rownames",
gene_output = "rownames",
input_species = "mouse",
output_species = "human",
non121_strategy = "drop_both_species",
method = method)
## Preparing gene_df.
## sparseMatrix format detected.
## Extracting genes from rownames.
## 15,259 genes extracted.
## Converting mouse ==> human orthologs using: homologene
## Retrieving all organisms available in homologene.
## Mapping species name: mouse
## Common name mapping found for mouse
## 1 organism identified from search: 10090
## Retrieving all organisms available in homologene.
## Mapping species name: human
## Common name mapping found for human
## 1 organism identified from search: 9606
## Checking for genes without orthologs in human.
## Extracting genes from input_gene.
## 13,416 genes extracted.
## Extracting genes from ortholog_gene.
## 13,416 genes extracted.
## Checking for genes without 1:1 orthologs.
## Dropping 46 genes that have multiple input_gene per ortholog_gene (many:1).
## Dropping 56 genes that have multiple ortholog_gene per input_gene (1:many).
## Filtering gene_df with gene_map
## Setting ortholog_gene to rownames.
##
## =========== REPORT SUMMARY ===========
## Total genes dropped after convert_orthologs :
## 2,016 / 15,259 (13%)
## Total genes remaining after convert_orthologs :
## 13,243 / 15,259 (87%)
knitr::kable(as.matrix(head(gene_df)))
astrocytes_ependymal | endothelial-mural | interneurons | microglia | oligodendrocytes | pyramidal CA1 | pyramidal SS | |
---|---|---|---|---|---|---|---|
TSPAN12 | 0.3303571 | 0.5872340 | 0.6413793 | 0.1428571 | 0.1207317 | 0.2864750 | 0.1453634 |
TSHZ1 | 0.4285714 | 0.4468085 | 1.1551724 | 0.4387755 | 0.3621951 | 0.0692226 | 0.8320802 |
ADAMTS15 | 0.0089286 | 0.0978723 | 0.2206897 | 0.0000000 | 0.0231707 | 0.0117146 | 0.0375940 |
CLDN12 | 0.2232143 | 0.1148936 | 0.5517241 | 0.0510204 | 0.2609756 | 0.4376997 | 0.6842105 |
RXFP1 | 0.0000000 | 0.0127660 | 0.2551724 | 0.0000000 | 0.0158537 | 0.0511182 | 0.0751880 |
SEMA3C | 0.1964286 | 0.9957447 | 8.6379310 | 0.2040816 | 0.1853659 | 0.1608094 | 0.2280702 |
convert_orthologs
is just one of the many useful functions in
orthogene
. Please see the documentation
website
for the full vignette.
gprofiler2
:
orthogene
uses this package. gprofiler2::gorth()
pulls from many
orthology mapping
databases.
homologene
: orthogene
uses
this package. Provides API access to NCBI
HomoloGene database.
babelgene
:
orthogene
uses this package. babelgene::orthologs()
pulls from
many orthology mapping
databases.
annotationTools
:
For interspecies microarray data.
orthology
:
R package for ortholog mapping (deprecated?).
hpgltools::load_biomart_orthologs()
:
Helper function to get orthologs from biomart.
JustOrthologs
:
Ortholog inference from multi-species genomic sequences.
orthologr
: Ortholog
inference from multi-species genomic sequences.
OrthoFinder
: Gene
duplication event inference from multi-species genomics.
HomoloGene: NCBI database that the R package homologene pulls from.
gProfiler: Web server for functional enrichment analysis and conversions of gene lists.
OrtholoGene: Compiled list of gene orthology resources.
UK Dementia Research Institute
Department of Brain Sciences
Faculty of Medicine
Imperial College London
GitHub
DockerHub