Abstract

Motivation

When different lineages of organisms independently adapt to similar environments, selection often acts repeatedly upon the same genes, leading to signatures of convergent evolutionary rate shifts at these genes. With the increasing availability of genome sequences for organisms displaying a variety of convergent traits, the ability to identify genes with such convergent rate signatures would enable new insights into the molecular basis of these traits.

Results

Here we present the R package RERconverge, which tests for association between relative evolutionary rates of genes and the evolution of traits across a phylogeny. RERconverge can perform associations with binary and continuous traits, and it contains tools for visualization and enrichment analyses of association results.

Availability and implementation

RERconverge source code, documentation and a detailed usage walk-through are freely available at https://github.com/nclark-lab/RERconverge. Datasets for mammals, Drosophila and yeast are available at https://bit.ly/2J2QBnj.

Supplementary information

Supplementary data are available at Bioinformatics online.

1 Introduction

A major motivation in evolutionary biology is to determine which genetic changes underlie phenotypic adaptations. Convergent evolution, in which the same phenotype arises independently in distinct evolutionary lineages, provides natural replicates of phenotypic adaptation that aid researchers in linking phenotypes to their underlying genetic changes. Selection repeatedly targets the same genes in several known cases of phenotypic convergence, including Prestin in echolocation in bats and marine mammals (Li et al., 2010), Mc1r in reduced pigmentation in multiple vertebrate species (Kronforst et al., 2012) and Nav 1.4 in toxin resistance in snakes (Feldman et al., 2012). This pattern leads to the prediction that genes responding selectively to a convergent environmental or phenotypic transition may show convergent shifts in evolutionary rates (i.e. number of nucleotide or amino acid substitutions per unit time), due to reduced or increased selective constraints on those genes. For example, both genes and non-coding elements involved in eye function lose selective constraint in subterranean mammals, and the corresponding rate shift signal can be used genome-wide to identify candidate regions with eye-specific function (Partha et al., 2017). Thus, evolutionary rates provide a rich source of genome-wide molecular data that, in combination with convergent phenotypes, can be used to infer targets of convergent selection.

Several research groups have developed methods to identify patterns of convergent evolutionary rate shifts associated with convergent changes in traits or environment, including Coevol (Lartillot and Poujol, 2011), Forward Genomics (Hiller et al., 2012; Prudent et al., 2016) and PhyloAcc (Hu et al., 2018). However, existing methods to identify these patterns still have several areas for improvement, including support for both binary and continuous traits, compute times that enable genome-wide analyses, robust statistical treatment (Partha et al., 2019) and ease of visualization and downstream analyses. To address these issues, here we present RERconverge, a software package that implements tests of association between evolutionary rates of genetic loci and convergent phenotypic traits, both binary and continuous (pipeline illustrated in Fig. 1). RERconverge incorporates and corrects for known phylogenetic relationships among included species, performs rapid analyses of genome-scale data and implements appropriate statistical techniques to reduce the effect of outliers and correct for multiple testing. This easy-to-implement software represents a major advance in comparative genomic methods because it enables biologists with extensive organismal knowledge to apply computational techniques to quickly link molecular data with phenotypes.

Fig. 1.

Schematic of the RERconverge pipeline focusing on the example discussed in the case study. Light blue text indicates user-provided input. Far right figure shows RER for olfactory receptor OR9Q2, a top hit for marine-specific acceleration. For additional details of the methods (boxes in arrows), see Partha et al. (2019)

2 Description and implementation

2.1 Basic usage of RERconverge

The RERconverge package runs within an installation of the R software (R Core Team, 2018) on any platform (Linux, Windows and Mac OS). The user provides the following data as input:

  • A set of phylogenetic trees, all with the same topology, with branch lengths for each tree calculated from alignments of that ‘gene’ sequence (these can also represent non-coding sequences such as enhancers) using software such as PAML (Yang, 2007).

  • Values for a trait of interest for extant species/tips of the tree. RERconverge can infer values for internal branches of the tree, or the user can provide these values via a single tree or by using RERconverge interactive branch selection to select foreground branches.

Detailed instructions for RERconverge are available within the Supplementary Material to this article or at https://github.com/nclark-lab/RERconverge/wiki/Vignettes.

2.2 Rapid estimation and visualization of relative evolutionary rates (RER)

RERconverge offers efficient computation of gene-specific rates of evolution on branches of phylogenetic trees in genome-scale datasets. These gene-specific rates of evolution, termed relative evolutionary rates (RER), reflect the amount of sequence divergence on a particular branch after correcting for non-specific factors affecting divergence on the branch such as time since speciation and mutation rate. Additionally, using a combination of statistical approaches including data transformation and weighted linear regression, RERconverge provides estimates of RER that are robust to several factors introducing outliers in the dataset, such as the presence of distantly related species in the phylogeny (Partha et al., 2019). To accelerate the computations underlying RER calculations, key functions are written in C++ and integrated with the R code through the Rcpp package (Eddelbuettel and François, 2011).

2.3 Flexible specification of binary and continuous trait evolution

For binary traits, RERconverge provides multiple methods for users to specify which branches are in the ‘foreground’, meaning those that display the convergent trait of interest. Users can directly supply foreground branch assignments by providing a phylogenetic tree with appropriate branch lengths or by interactively selecting branches on a phylogeny. Alternatively, users can specify which extant species are foreground and allow the software to infer which internal branches to consider foreground under a variety of scenarios. These include whether to consider only branches at a transition to a convergent phenotype as foreground or to also consider subsequent branches that preserve the phenotype as foreground, whether the foreground trait can be lost or only gained, and whether each foreground branch should be weighted equally.

In addition to supporting analysis of binary traits, RERconverge can perform correlation analysis between evolutionary rates and continuous traits. Trait evolution is modeled on a trait tree constructed from user-provided phenotype values for extant species provided by the user and ancestral nodes inferred through a phylogenetic model. By default, trait tree branch lengths represent change in the trait between a species and its ancestor, which removes phylogenetic dependence between branches. For completeness, other options allow branch lengths to be calculated as the average or terminal trait value along a branch to represent the state of a trait rather than its change.

2.4 Genome-wide association between RER and traits, with correction for multiple testing

RERconverge rapidly computes the association between gene-specific RER and the user-specified traits for large sets of genes. The program estimates the correlation between gene tree branch lengths and the values for traits along those branches using (by default) Kendall’s Tau for binary traits and a Pearson linear correlation for continuous traits. Full gene lists are returned with correlation statistic values, the number of data points used for the correlations and adjusted P-values (FDR) derived using the Benjamini–Hochberg correction (Benjamini and Hochberg, 1995).

2.5 Assessing gene set enrichment in results

Further analysis of gene lists from correlation analyses can be performed using built-in RERconverge pathway enrichment functions. These functions perform a rank-based enrichment analysis by using a Wilcoxon Rank-Sum Test to detect distribution shifts between a subset of genes and all genes in annotated pathways. Enrichment results are returned with pathway names, enrichment statistics, Benjamini–Hochberg corrected P-values and ranked pathway genes.

3 Case study

We demonstrate the features of RERconverge using gene trees derived from the coding sequences of 19 149 genes for 62 mammal species, along with foreground branches that represent lineages of the mammalian phylogeny whose members live predominantly in marine aquatic environments (Chikina et al., 2016; Meyer et al., 2018; Partha et al., 2019). For this dataset, RERconverge ran in 1 h and 18 min on RStudio with R version 3.3.0 installed on a computer running Windows 10 with 16 GB of RAM and an Intel Core i7-6500U 2.50 GHz CPU. Top categories of functional enrichment included olfactory transduction (FDR<10e−10), GPCR signaling (FDR<10e−10) and immune functions (FDR = 5.4e−7), as in Chikina et al. (2016). We show the RERconverge workflow and visualization of RERs for a top olfactory receptor, OR9Q2, in Figure 1.

4 Summary

RERconverge is an easy-to-implement method that can quickly test for associations between genes’ RER and traits of interest on a phylogeny. This enables researchers studying a wide variety of questions to generate lists of candidate genes associated with evolutionarily important traits and to explore through enrichment analyses the biological functions showing the most evidence of molecular change in association with these traits.

Acknowledgements

We thank Andreas Pfenning, Qingyuan Zhao, Ben Rubin and Tim Sackton for feedback on earlier versions of this software, as well as all members of the Chikina, Clark and Kostka labs for helpful discussion.

Funding

This project was supported by the National Institutes of Health [R01 HG009299-01A1 to N.L.C. and M.C.]; and in part by the University of Pittsburgh Center for Research Computing through the resources provided. A.K. was supported by the National Institutes of Health T32 training grant [T32 EB009403] as part of the HHMI-NIBIB Interfaces Initiative.

Conflict of Interest: none declared.

References

Benjamini
 
Y.
,
Hochberg
Y.
(
1995
)
Controlling the false discovery rate: a practical and powerful approach to multiple testing
.
J. R. Stat. Soc. Series B Methodol
.,
57
,
289
300
.

Chikina
 
M.
 et al.  (
2016
)
Hundreds of genes experienced convergent shifts in selective pressure in marine mammals
.
Mol. Biol. Evol
.,
33
,
2182
2192
.

Eddelbuettel
 
D.
,
François
R.
(
2011
)
Rcpp: seamless R and C++ integration
.
J. Stat. Softw
.,
40
,
1
18
.

Feldman
 
C.R.
 et al.  (
2012
)
Constraint shapes convergence in tetrodotoxin-resistant sodium channels of snakes
.
Proc. Natl. Acad. Sci. USA
,
109
,
4556
4561
.

Hiller
 
M.
 et al.  (
2012
)
A “forward genomics” approach links genotype to phenotype using independent phenotypic losses among related species
.
Cell Rep
.,
2
,
817
823
.

Hu
 
Z.
 et al.  (
2018
)
Bayesian detection of convergent rate changes of conserved noncoding elements on phylogenetic trees
.
Mol. Biol. Evol
.,
36
,
1086
1100
.

Kronforst
 
M.R.
 et al.  (
2012
)
Unraveling the thread of nature’s tapestry: the genetics of diversity and convergence in animal pigmentation
.
Pigment Cell Melanoma Res
.,
25
,
411
433
.

Lartillot
 
N.
,
Poujol
R.
(
2011
)
A phylogenetic model for investigating correlated evolution of substitution rates and continuous phenotypic characters
.
Mol. Biol. Evol
.,
28
,
729
744
.

Li
 
Y.
 et al.  (
2010
)
The hearing gene Prestin unites echolocating bats and whales
.
Curr. Biol
.,
20
,
R55
R56
.

Meyer
 
W.K.
 et al.  (
2018
)
Ancient convergent losses of Paraoxonase 1 yield potential risks for modern marine mammals
.
Science
,
361
,
591
594
.

Partha
 
R.
 et al.  (
2017
)
Subterranean mammals show convergent regression in ocular genes and enhancers, along with adaptation to tunneling
.
Elife
,
6
,
e25884
.

Partha
 
R.
 et al.  (
2019
)
Robust methods for detecting convergent shifts in evolutionary rates
.
Mol. Biol. Evol
., doi: 10.1093/molbev/msz107.

Prudent
 
X.
 et al.  (
2016
)
Controlling for phylogenetic relatedness and evolutionary rates improves the discovery of associations between species’ phenotypic and genomic differences
.
Mol. Biol. Evol
.,
33
,
2135
2150
.

R Core Team (

2018
)
R: A Language and Environment for Statistical Computing
.
R Foundation for Statistical Computing
,
Vienna, Austria
. Available online at https://www.R-project.org/.

Yang
 
Z.
(
2007
)
PAML 4: phylogenetic analysis by maximum likelihood
.
Mol. Biol. Evol
.,
24
,
1586
1591
.

Author notes

The authors wish it to be known that, in their opinion, Amanda Kowalczyk, Wynn K. Meyer and Raghavendran Partha should be regarded as Joint First Authors.

This article is published and distributed under the terms of the Oxford University Press, Standard Journals Publication Model (https://academic.oup.com/journals/pages/open_access/funder_policies/chorus/standard_publication_model)
Associate Editor: Alfonso Valencia
Alfonso Valencia
Associate Editor
Search for other works by this author on:

Supplementary data