Abstract
The detection of “signatures of selection” is now possible on a genome-wide scale in many plant and animal species, and can be performed in a population-specific manner due to the wealth of per-population genome-wide genotype data that is available. With genomic regions that exhibit evidence of having been under selection shown to also be enriched for genes associated with biologically important traits, detection of evidence of selective pressure is emerging as an additional approach for identifying novel gene-trait associations. While high-density genotype data is now relatively easy to obtain, for many researchers it is not immediately obvious how to go about identifying signatures of selection in these data sets. Here we describe a basic workflow, constructed from open source tools, for detecting and examining evidence of selection in genomic data. Code to install and implement the pipeline components, and instructions to run a basic analysis using the workflow described here, can be downloaded from our public GitHub repository: http://www.github.com/smilefreak/selectionTools/
Keywords: signatures of selection, genomics, genome-wide, analysis pipeline
Introduction
With the increased availability of whole-genome genotype data, it is possible to identify regions of the genome that exhibit evidence of having been subjected to selective pressure (e.g., Sabeti et al., 2002, 2007). While these “signatures of selection” can help to shed light on the evolutionary pressures experienced throughout history, they have also been shown to be associated with regions of the genome that are enriched for genes involved in cultural differentiation and complex disease in humans (Laland et al., 2010; Lappalainen et al., 2010) and traits of adaptive and/or commercial significance in plant and animal species. Examples include forest trees (see reviews by Gonzalez-Martinez et al., 2011; Neale and Kremer, 2011), wheat (Cavanagh et al., 2013), horses (Gu et al., 2009), sheep (Moradi et al., 2012), and domesticated dairy cattle (e.g., Qanbari et al., 2011). As a result, methods for detecting evidence of selection also provide a mechanism for highlighting genomic regions that may be associated with biologically important traits.
Recently Pybus et al. (2014) described the “Selection Browser 1.0,” a web-based tool for investigating selection in the human genome, based on a subset of data available from the 1000 Genomes Project (The 1000 Genomes Project Consortium, 2010). This resource delivers easy and intuitive access to pre-computed results from a number of tests for selection, applied to the available data, and thus provides an excellent example of the type of selection-specific information that can be extracted from low-coverage resequencing studies. For researchers wishing to investigate selection in other human cohorts or populations (or other organisms), however, a non-trivial amount of data manipulation and subsequent computation is required in order to extract this type of information from the available data.
Although detection of putative selective pressure offers a useful approach for identifying regions of interest in the genome, a number of steps are required to move from genome-wide (re)sequence or genotype data (e.g., as can easily be obtained using high-throughput microarray-based or sequencing technologies) to identifying specific genomic regions that exhibit evidence of having been under selection. The steps required reflect to some extent the series of advances that have been made in genomics technologies in recent years, with traditional file formats and software requiring manipulation and translation as part of the analysis workflow. While the process is not complex, for researchers unfamiliar with the required tools and data formats, the path from genotypes to signatures of selection can be a difficult one.
Here we provide a brief overview of a relatively simple workflow for taking high-density genotype data, and using it to identify evidence of selective pressure in regions of the genome. This pipeline is applicable to any diploid species where genome-wide (re)sequence and/or genotypic data are available (e.g., genomic/transcriptomic sequencing, whole genome SNP arrays), along with an ancestral reference genome and either a genetic or physical map.
Methods for detecting evidence of selection
The tools used to detect evidence of selection are dependent on the nature of the selective signature being investigated, which itself depends on the time scale over which the selection occurred (Sabeti et al., 2006). Traditionally the FST statistic has been a popular choice for investigating selection, utilizing differences in allele frequency between populations to infer selective pressure in one population relative to the other, and allowing detection of potential selection occurring in the range 50,000 to 75,000 years prior for human populations (Sabeti et al., 2006), equivalent to approximately 2000 to 3000 generations. A thorough review of the use of the FST statistic is provided by Holsinger and Weir (2009), with recent modifications able to account for genotypic uncertainty associated with more modern technologies (Fumagalli et al., 2013). Differences in FST estimates have been discussed by Bhatia et al. (2013), who examined the effect of choosing different estimation methods and SNP sets on estimates of FST. Both of these aspects were found to impact FST estimates, and the authors recommend that care be taken in the choice of both the estimators, and the SNPs being used.
Analysis of the reduction in genetic diversity provides another approach to examining selection, allowing the detection of possible “selective sweeps” which have resulted in regions where an allele conferring a selective advantage has risen in frequency in a population, carrying other variants in linkage disequilibrium to similarly increased frequencies, and thus reduced levels of diversity at that genomic locus. Tajima's D statistic (Tajima, 1989) provides a popular method for identifying such regions (see reviews by Sabeti et al., 2006; Barrett and Hoekstra, 2011; Iskow et al., 2012). More recently, modified methods have been developed to account for ascertainment bias in SNP microarrays (Ramírez-Soriano and Nielsen, 2009). Tajima's D is suitable for detecting evidence of positive selection in human populations occurring within the past 250,000 years (Sabeti et al., 2006) or approximately 10,000 generations, and operates by identifying an excess of low-to-intermediate frequency variants. Another commonly used measure is Fay and Wu's H (Fay and Wu, 2000) which is useful for detecting evidence of more recent positive selection (<80,000 years: Sabeti et al., 2006, or approximately 3000 generations), particularly for intermediate-high frequency variants, and thus complements Tajima's D and other methods (see Fay and Wu, 2000).
The advent of genome-wide genotyping technologies has facilitated the creation of whole genome haplotype maps, exemplified by the efforts of the HapMap Consortium (International HapMap Consortium, 2003) for studying natural variation in humans, and with more recent initiatives extending this approach to other species including bovine (The Bovine HapMap Consortium, 2009), maize (Gore et al., 2009), and rice (Huang et al., 2010). Analysis of haplotypes provides another mechanism for identifying evidence of selection, with a number of methods utilizing the Extended Haplotype Homozygosity (EHH) concept (Sabeti et al., 2002). One of the more popular of these approaches is the Integrated Haplotype Homozygosity Score (iHS) methodology, which provides a standardized measure of the decay in EHH around a point (e.g., a SNP) from the derived allele relative to the ancestral allele (Voight et al., 2006). Regions of slowly decaying haplotype homozygosity in the derived allele (i.e., longer than expected haplotypes, relative to the ancestral allele) are thus indicative of selection at that locus.
Underlying all of these tools are a number of demographic assumptions about the population(s) of interest, which must be considered when attempting to detect evidence of selection. In particular, for each method it is assumed that the existence of selective pressure is the most likely explanation for the generation of a statistically significant result. If present, other potential modifiers of variant frequency in a population can cause these tests to generate significant results, even in the absence of selection. Specific examples include: random drift, population bottlenecks, and population expansion, all of which can modify variant and haplotype frequencies in ways similar to selection. Some knowledge of the evolutionary history of the populations under study is therefore essential when considering the results generated when testing for evidence of selection.
Applying selection tools to genomic data
A number of software tools exist which implement the various methods described above for detecting evidence of selection. In order to use a specific tool, however, the data in question must be in an appropriate format. Both the FST statistic, and Tajima's D, can be calculated using standard genotype data (e.g., SNP genotypes per individual). The iHS methodology, however, requires the use of haplotypes, and thus genotype data obtained from heterozgoygous populations must be phased prior to calculation of iHS. Various software applications exist for phasing genotype data (e.g., see Browning and Browning, 2011), although large differences in accuracy and speed exist between the various algorithms (Williams et al., 2012). Traditionally the Beagle algorithm has been a popular choice for phasing (Browning and Browning, 2007), although a number of recently developed algorithms are offering increased speed and accuracy (Williams et al., 2012; Delaneau et al., 2013).
Once phasing is complete, the rehh package (Gautier and Vitalis, 2012) provides a relatively simple interface for implementing various EHH-based analyses (including iHS) within the R computing environment (R Core Team, 2014). Additionally, rehh provides tools for visualizing loci under selection, such as haplotype bifurcation plots (Sabeti et al., 2002).
Bioinformatics workflow
In order to simplify the process of analysing genomewide genotype data to identify selection signatures, we have developed a collection of scripts that implement the various tools described above. These scripts are publicly available via GitHub, and include instructions for installation and usage, as well as a detailed manual containing a worked example using a downloadable data set. The following sections describe the analytical processes implemented in the workflow.
Data processing and analysis via command line tools
The analysis pipeline described here runs within a standard Linux operating system (in our case, Ubuntu 13.04, although almost any Linux-based system would be suitable), and requires the installation of a relatively small number of software tools (Table 1). The starting point of the analysis is a variant call format (VCF) file of the genotype data of interest (Danecek et al., 2011). This is a text file containing (at a minimum) information about variant positions, reference and alternative bases, and genotypes per sample. In order to permit calculation of measures comparing selection between multiple populations (e.g., FST), samples from at least two populations are required to be present in the VCF file. Additionally, a file listing the subject identifiers for each population is also required, along with a genetic map of the chromosome(s) of interest in either SHAPEIT (Delaneau et al., 2013) or PLINK (Purcell et al., 2007) format. As a genetic map may not contain distances for all markers present in the VCF file, the genetic distance is inferred by linear interpolation (Nievergelt et al., 2004). If a genetic map is not available for the organism under study, a physical map (e.g., a reference genome) can be substituted, an approach that has recently been used in cattle (Gautier and Naves, 2011). Alternatively, if a representative sample of the species of interest is available, the LDHat software (McVean, 2014) can be used to generate recombination rate estimates, allowing conversion of physical distance to genetic distance, as was done in a recent analysis in Arabidopsis (Meijón et al., 2013).
Table 1.
Application and version | Use in workflow | Website |
---|---|---|
R ≥ v3.0 | rehh | http://www.r-project.org |
Perl ≥ v5.0 | Vcftools modules vcf-subset and vcf-merge | http://www.perl.org/ |
Python ≥ v2.6 | Running pipeline, haps file filtering and ancestral allele annotation | https://www.python.org/ |
rehh v1.11 | Calculating iHS (and other EHH-based measures) | http://cran.r-project.org/package=rehh |
vcftools v1.11 | Conversion of VCF genotype data to PLINK format, and calculation of FST and Tajima's D | http://vcftools.sourceforge.net |
SHAPEIT v2.r790 | Phasing the PLINK formatted data to produce phased haplotype file | http://www.shapeit.fr |
Beagle v4 r1274 | Phasing un-phased VCF data to produce phased haplotype file | http://faculty.washington.edu/browning/beagle/beagle.html |
PLINK v1.07 | Remove SNPs with too many genotypes missing, filter on HWE and MAF | http://pngu.mgh.harvard.edu/~purcell/plink |
tabix/bgzip v0.2.5 | Required to get VCF into compressed and indexed format for vcftools | http://samtools.sourceforge.net/tabix.shtml |
Multicore v0.1-7 | R multicore package used to parallelise rehh runs | http://cran.r-project.org/web/packages/multicore/index.html |
impute2 v2.3.1 | Imputing genotypes from phased haplotype data | http://mathgen.stats.ox.ac.uk/impute/impute_v2.html |
Pyfasta v0.5.2 | Required to process ancestral fasta files | https://github.com/brentp/pyfasta |
PyVcf v0.6.0 | Required to process VCF files in python scripts | https://github.com/jamescasbon/PyVCF |
Variscan v2.0.3 | Calculation of Fay and Wu's H | http://www.ub.edu/softevol/variscan/ |
Analysis of a single population
For a population VCF file that contains phase information, indels are first removed using the vcftools software (Danecek et al., 2011), as ancestral allele data are only available for SNP genotypes. The VCF is then converted to the Haps format (phased haplotypes: SNP genotypes per haplotype, per individual).
For a population VCF file without phased information, the file is converted to PLINK format (ped/map files) using vcftools. The Ped file contains relatedness information (if any) between subjects, affection status (e.g., for human case/control studies), and genotype data, while the “Map” file contains the genomic location of each variant (e.g., SNPs). PLINK is then used to filter the data based on multiple criteria (missingness, minor allele frequency, Hardy Weinberg Equilibrium, indels), and phasing is performed via SHAPEIT v2 (Delaneau et al., 2013) to produce a “Haps” file of phased haplotypes (SNP genotypes per haplotype, per individual) and a “Sample” file (genotype-specific information). Alternatively (or if a physical map is used), Beagle can be used to phase the data (Browning and Browning, 2007). If imputation is required, then impute2 (Howie et al., 2009) is used, followed by a second round of indel filtering (to remove any indels introduced by the imputation process).
The phased data are annotated with ancestral allele information (via a custom Python script). These data are then analyzed in R (R Core Team, 2014) where the R package rehh (Gautier and Vitalis, 2012) is used to calculate EHH, and integrated EHH (iES).
Analysis of multiple populations
If genotype data from multiple populations are available, then the data from the VCF file are used to calculate FST between each pair of populations using vcftools. FST is calculated using both the method of Weir and Cockerham (1984), and the method developed as part of the HapMap project (International HapMap Consortium, 2005). The genotype data are then split into per-population VCF files, and the analysis of each population proceeds as described above (“Analysis of a single population”), producing filtered phased data, and EHH and iHS values. Calculation of iHS requires knowledge of the ancestral allele relating to the SNP of interest. For human data, this information was traditionally generated through direct comparison of DNA to that of a close phylogenetic relative, such as the chimpanzee. More recently, however, phylogenetic trees have been used to derive ancestral alleles in humans, based on DNA sequence data from related species. The ancestral information used here comes from the ancestral FASTA files provided by the 1000 Genomes Project and derived 6-way Enredo-Pecan-Ortheus (EPO) alignment (Paten et al., 2008a,b) from the Ensembl Compara 59 database (Flicek et al., 2012). For non-human species, a FASTA file containing ancestral allele information is required. These are also available via Ensembl for some animal species (along with the 6-way EPO alignment for humans) from: http://www.ensembl.org/info/genome/compara/analyses.html
Alternatively, the EPO pipeline can be used locally to generate an ancestral reference, or a two-way alignment can be performed between the genome of interest, and that of a species with which a recent common ancestor is shared. This approach has previously been applied to human and chimpanzee by Voight et al. (2006) and to Arabidopsis thaliana and A. lyrata by Meijón et al. (2013). The script used here can annotate either a phased haps file or a phased VCF file using the ancestral allele information. Finally, for each pair of populations, Rsb (the standardized ratio of iES from two populations) is calculated using the rehh package in R (Voight et al., 2006; Tang et al., 2007).
Visualizing the outputs—investigating selection at the human lactase gene locus as an example
Once the various measures of selection have been calculated in a genotype data set from one or more populations, it is helpful to visualize the results. As mentioned above, the public GitHub repository for the pipeline includes a worked example of running the code on a human data set. The data set used relates to a subset of genotype data from chromosome 2 of the human genome, derived from data downloaded from the 1000 Genomes Project. Of interest is the region around the gene encoding lactase (LCT - HG19 chr2: 136,545,410–136,594,750), which has shown evidence of selection over the past 5000–10,000 years (Bersaglieri et al., 2004). The CEU (European) and YRI (Yoruban) populations were used for the analysis here, comprising 85 and 88 samples respectively.
The analysis pipeline produced results for the following statistics: FST, Rsb, iHS, Fay and Wu's H, and Tajima's D. A window size of 30 Kbp was used for calculating FST and Fay and Wu's H (with a sliding window of 3 Kbp for the latter), and a 3 Kbp window was used for Tajima's D. Figure 1 contains plots of Rsb and iHS for the CEU and YRI populations (chromosome-wide, and zoomed-in around the LCT gene), generated in R using the ggplot2 package (Wickham, 2009). The plots show clear evidence for differing degrees of selective pressure in the LCT gene between the CEU and YRI populations (i.e., selection in the CEU population), supporting previous observations in the literature (e.g., Bersaglieri et al., 2004). Not all of the measures of selection generated by the pipeline support this conclusion, however, with similar plots for FST (Figure S1), Tajima's D (Figure S2), and Fay and Wu's H (Figure S3), providing little evidence of selection in this region. These results (which agree with those for LCT available via the “Selection Browser 1.0” application of Pybus et al., 2014) highlight the importance of utilizing multiple measures for investigating selection, with different methodologies producing quite different results when applied to the same data. This again reinforces the fact that the various methods are utilizing different patterns of genetic variation to identify evidence of selection.
Discussion
Here we present a simple workflow, and an associated collection of shell and R scripts, for identifying signatures of selection in diploid organisms. The workflow allows researchers to start from a collection of genome-wide genotype data for multiple individuals, and use a collection of freely available software tools to identify regions that exhibit evidence of having undergone selection. A range of tools have been developed for specific analyses of smaller data sets (e.g., Librado and Rozas, 2009; Delport et al., 2010), however the workflow presented here has the ability to analyze large data sets using multiple analytical methods to detect evidence of selection. An additional benefit of this tool set is our incorporation of parallelization capability into some of the tools to speed up analyses. These include rehh, vcf-subset, SHAPEIT, and IMPUTE2. We have also included a version of rehh which invokes the R multicore package (Urbanek, 2011) to allow utilization of multiple CPU cores. Other tools could potentially be parallelized should they become bottlenecks in analytical performance in larger data sets. The example analysis of chromosome two presented here required approximately 12.5 h of computation, running on 10 cores of a recent multicore linux server.
The methods described here fall broadly into three categories: frequency-based methods (Tajima's D and Fay and Wu's H), linkage disequilibrium-based methods (Rsb and iHS), and population differentiation-based methods (FST), as reviewed by Vitti et al. (2013). By using each of these approaches, the differing characteristics of each method provide users with the ability to identify patterns of selective pressure arising in distinct contexts. As noted earlier, the time scale over which selection has occurred has a major impact on the ability of each method to detect evidence of its presence, with the frequency-based and population differentiation-based methods best suited to detecting events occurring further in the past. This is because these methods rely on the accumulation of additional mutations around the causal variant. In situations where the fitness advantage of the selected variant is small (particularly if it is recessive), then the time taken for the selected variant to rise to a detectable frequency in the population will be much longer, thus reducing the power of these methods. In situations where a new mutation (or a previously neutral variant encountering an environment of altered selective pressure) provides a fitness advantage and rises in frequency in the population without achieving fixation, linkage disequilibrium-based approaches provide increased power for detecting evidence of selection (Ferrer-Admetlla et al., 2014).
The differences in the results produced here for the human LCT example reflect the underlying methods of detection employed by each of the approaches, with time scale likely having a major impact. The three methods which found no evidence to support selection (FST, Tajima's D, and Fay and Wu's H) are all better placed to detect evidence of selection in the more distant past, well before the time at which the LCT gene was subjected to selective pressure. It is perhaps not surprising, therefore, that only the linkage disequilibrium-based methods (iHS and Rsb) provide any evidence of selection in this region.
As part of providing access to this computational workflow, it is important to mention the caveats associated with performing selection analyses. Reviews by Nielsen (2005) and Vitti et al. (2013) provide an excellent overview of these and other issues associated with the detection of evidence of selection using genetic data. All of the tools implemented in this pipeline are designed to elucidate patterns of genotypic variation that are consistent with the presence of selective pressure at some time in the past. However, even when such patterns are identified, there is no guarantee that they are the result of selection, rather than other unrelated ancestral events. For example, Tajima's D is known to be sensitive to population growth (Simonsen et al., 1995), whereas methods that assess changes in linkage disequilibrium and/or haplotype frequencies can be influenced by differences in recombination rates across the genome (Nielsen, 2005). Even in the case where selective pressure has led to changes in haplotype frequencies, it may not be possible to identify the type of selection involved. For example, positive selection (e.g., via hard or soft sweeps) may leave a genomic footprint that is indistinguishable from that created by background selection against deleterious mutations (Vitti et al., 2013).
There are a number of improvements that could be made to this workflow. In terms of the various measures of selection that we have employed, we note that calculation of the FST statistic is dependent on window size and step size, while calculation of Tajima's D statistic is dependent on window size. Ongoing work will examine how best to implement these methods on multiple scales, and allow the results to be combined. Incorporating a measure of the statistical significance of the FST statistic would also be an improvement, along with appropriate adjustment for multiple hypothesis testing. Similarly, our pipeline could be extended to incorporate probabilistic measures of genotype, particularly relevant for modern genotyping-by-sequencing (GBS) technologies (e.g., Elshire et al., 2011; Majewski et al., 2011) where there is uncertainty in genotype calls (Li, 2011; Li et al., 2011), and for situations where SNP selection methods result in ascertainment bias (Ramírez-Soriano and Nielsen, 2009).
In addition to improving the algorithmic aspects of the pipeline, additional benefit could be gained through the inclusion of support for indel variants. Currently calculation of Fay and Wu's H, iHS and Tajima's D are not carried out for indels. Adding support for this feature would be difficult for human analyses involving iHS and Fay and Wu's H, as the available ancestral FASTA files do not contain any indel information. The inclusion of indels in the Tajima's D calculations is possible, however, and would require a reorganization of the pipeline to ensure indels are preserved until the point at which the D statistic is generated.
The pipeline is also flexible regarding input data types and biological contexts. The entrée into this pipeline is via VCF formatted files, and it can therefore be used to analyse whole genome (re)sequence, transcriptome-derived data, exomes or specific gene candidates of interest on very large samples. More recently, several more computationally-intensive analytical methods have been developed (e.g., Grossman et al., 2010; Ronen et al., 2013) which could potentially be integrated into workflows such as those presented here.
Despite the potential for ongoing enhancement, we believe that in its current state this workflow provides researchers with a valuable tool for investigating selection within a collection of individuals for which high-density genotype data are available, and we hope that the research community is able to make good use of these tools. To that end we have made the pipeline software publicly available as a GitHub repository at: https://github.com/smilefreak/selectionTools
The repository includes an automated installation script, and a detailed manual containing an example analysis that can be followed by new users. The pipeline version corresponding to this publication is 1.0. As additions and refinements are made, these changes will be versioned and commented. However, using the functionality of GitHub, researchers will always be able to access the original published versions of the scripts that are referred to here.
Conflict of interest statement
The authors declare that the research was conducted in the absence of any commercial or financial relationships that could be construed as a potential conflict of interest.
Acknowledgments
The Virtual Institute of Statistical Genetics (www.visg.co.nz) is thanked for funding this research, including the PhD stipend of HTN. VISG is supported by a contract (C04X0804) from the Ministry of Business, Employment and Innovation. Computational resources from the New Zealand eScience Infrastructure (NeSI) were utilized for some of the analyses presented here (www.nesi.org.nz). We also thank Dr. John McCallum for discussions in the early phases of this project, and the reviewers of our manuscript for their constructive comments and helpful suggestions.
Supplementary material
The Supplementary Material for this article can be found online at: http://www.frontiersin.org/journal/10.3389/fgene.2014.00293/abstract
References
- Barrett R. D. H., Hoekstra H. E. (2011). Molecular spandrels: tests of adaptation at the genetic level. Nat. Rev. Genet. 12, 767–780 10.1038/nrg3015 [DOI] [PubMed] [Google Scholar]
- Bersaglieri T., Sabeti P. C., Patterson N., Vanderploeg T., Schaffner S. F., Drake J. A., et al. (2004). Genetic signatures of strong recent positive selection at the lactase gene. Am. J. Hum. Genet. 74, 1111–1120 10.1086/421051 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Bhatia G., Patterson N., Sankararaman S., Price A. L. (2013). Estimating and interpreting FST: the impact of rare variants. Genome Res. 23, 1514–1521 10.1101/gr.154831.113 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Browning S. R., Browning B. L. (2007). Rapid and accurate haplotype phasing and missing-data inference for whole-genome association studies by use of localized haplotype clustering. Am. J. Hum. Genet. 81, 1084–1097 10.1086/521987 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Browning S. R., Browning B. L. (2011). Haplotype phasing: existing methods and new developments. Nat. Rev. Genet. 12, 703–714 10.1038/nrg3054 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Cavanagh C. R., Chao S., Wang S., Huang B. E., Stephen S., Kiani S., et al. (2013). Genome-wide comparative diversity uncovers multiple targets of selection for improvement in hexaploid wheat landraces and cultivars. Proc. Nat. Acad. Sci. U.S.A. 110, 8057–8062 10.1073/pnas.1217133110 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Danecek P., Auton A., Abecasis G., Albers C. A., Banks E., DePristo M. A., et al. (2011). The variant call format and VCFtools. Bioinformatics 27, 2156–2158 10.1093/bioinformatics/btr330 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Delaneau O., Zagury J.-F., Marchini J. (2013). Improved whole-chromosome phasing for disease and population genetic studies. Nat. Methods 10, 5–6 10.1038/nmeth.2307 [DOI] [PubMed] [Google Scholar]
- Delport W., Poon A. F. Y., Frost S. D. W., Kosakovsky Pond S. L. (2010). Datamonkey 2010: a suite of phylogenetic analysis tools for evolutionary biology. Bioinformatics 26, 2455–2457 10.1093/bioinformatics/btq429 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Elshire R. J., Glaubitz J. C., Sun Q., Poland J. A., Kawamoto K., Bucker E. S., et al. (2011). A robust, simple Genotyping-by-Sequencing (GBS) approach for high diversity species. PLoS ONE 6:e19379 10.1371/journal.pone.0019379 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Fay J. C., Wu C.-I. (2000). Hitchhiking under positive darwinian selection. Genetics 155, 1405–1413 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ferrer-Admetlla A., Liang M., Korneliussen T., Nielsen R. (2014). On detecting incomplete soft or hard selective sweeps using haplotype structure. Mol. Biol. Evol. 31, 1275–1291 10.1093/molbev/msu077 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Flicek P., Amode M. R., Barrell D., Beal K., Brent S., Carvalho-Silva D., et al. (2012). Ensembl 2012. Nucleic Acids Res. 40, D84–D90 10.1093/nar/gkr991 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Fumagalli M., Vieira F. G., Korneliussen T. S., Linderoth T., Huerta-Sánchez E., Albrechtsen A., et al. (2013). quantifying population genetic differentiation from next-generation sequencing data. Genetics 195, 979–992 10.1534/genetics.113.154740 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Gautier M., Naves M. (2011). Footprints of selection in the ancestral admixture of a New World Creole cattle breed. Mol. Ecol. 20, 3128–3143 10.1111/j.1365-294X.2011.05163.x [DOI] [PubMed] [Google Scholar]
- Gautier M., Vitalis R. (2012). rehh: an R package to detect footprints of selection in genome-wide SNP data from haplotype structure. Bioinformatics 28, 1176–1177 10.1093/bioinformatics/bts115 [DOI] [PubMed] [Google Scholar]
- Gonzalez-Martinez S. C., Dillon S. K., Garnier-Géré P. H., Krutovskii K. V., Alia R., Burgarella C., et al. (2011). Patterns of nucleotide diversity and association mapping, in Genetics, Genomics and Breeding of Conifers, eds Plomion C., Bousquet J., Kole C. (St Helier: Science Publishers; ), 239–275 [Google Scholar]
- Gore M. A., Chia J. M., Elshire R. J., Sun Q., Ersoz E. S., Hurwitz B. L., et al. (2009). A first-generation haplotype map of maize. Science 326, 1115–1117 10.1126/science.1177837 [DOI] [PubMed] [Google Scholar]
- Grossman S. R., Shylakhter I., Karlsson E. K., Byrne E. H., Morales S., Frieden G., et al. (2010). A composite of multiple signals distinguishes causal variants in regions of positive selection. Science 327, 883–886 10.1126/science.1183863 [DOI] [PubMed] [Google Scholar]
- Gu J., Orr N., Park S., Katz L., Sulimova G., MacHugh D., et al. (2009). A genome scan for positive selection in thoroughbred horses. PLoS ONE 4:e5767 10.1371/journal.pone.0005767 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Holsinger K. E., Weir B. S. (2009). Genetics in geographically structured populations: defining, estimating and interpreting F(ST). Nat. Rev. Genet. 10, 639–650 10.1038/nrg2611 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Howie B. N., Donnelly P., Marchini J. (2009). A flexible and accurate genotype imputation method for the next generation of genome-wide association studies. PLoS Genet. 5:e1000529 10.1371/journal.pgen.1000529 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Huang X., Wei X., Sang T., Zhao Q., Feng Q., Zhao Y., et al. (2010). Genome-wide association studies of 14 agronomic traits in rice landraces. Nat. Genet. 42, 961–967 10.1038/ng.695 [DOI] [PubMed] [Google Scholar]
- Iskow R. C., Gokcumen O., Lee C. (2012). Exploring the role of copy number variants in human adaptation. Trends Genet. 28, 245–257 10.1016/j.tig.2012.03.002 [DOI] [PMC free article] [PubMed] [Google Scholar]
- International HapMap Consortium. (2003). The International HapMap Project. Nature 426, 789–796 10.1038/nature02168 [DOI] [PubMed] [Google Scholar]
- International HapMap Consortium. (2005). A haplotype map of the human genome. Nature 437, 1299–1320 10.1038/nature04226 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Laland K. N., Odling-Smee J., Myles S. (2010). How culture shaped the human genome: bringing genetics and the human sciences together. Nat. Rev. Genet. 11, 137–148 10.1038/nrg2734 [DOI] [PubMed] [Google Scholar]
- Lappalainen T., Salmela E., Andersen P. M., Dahlman-Wright K., Sistonen P., Savontaus M.-L., et al. (2010). Genomic landscape of positive natural selection in Northern European populations. Eur. J. Hum. Genet. 18, 471–478 10.1038/ejhg.2009.184 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Li H. (2011). A statistical framework for SNP calling, mutation discovery, association mapping and population genetical parameter estimation from sequencing data. Bioinformatics 27, 2987–2993 10.1093/bioinformatics/btr509 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Li Y., Sidore C., Kang H. M., Boehnke M., Abecasis G. R. (2011). Low-coverage sequencing: implications for design of complex trait association studies. Genome Res. 21, 940–951 10.1101/gr.117259.110 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Librado P., Rozas J. (2009). DnaSP v5: a software for comprehensive analysis of DNA polymorphism data. Bioinformatics 25, 1451–1452 10.1093/bioinformatics/btp187 [DOI] [PubMed] [Google Scholar]
- Majewski J., Schwartzentruber J., Lalonde E., Montpetit A., Jabado N. (2011). What can exome sequencing do for you? J. Med. Genet. 48, 580–589 10.1136/jmedgenet-2011-100223 [DOI] [PubMed] [Google Scholar]
- McVean G. (2014). LDHat. Available online at: http://ldhat.sourceforge.net
- Meijón M., Satbhai S. B., Tsuchimatsu T., Busch W. (2013). Genome-wide association study using cellular traits identifies a new regulator of root development in Arabidopsis. Nat. Genet. 46, 77–81 10.1038/ng.2824 [DOI] [PubMed] [Google Scholar]
- Moradi M. H., Nejati-Javaremi A., Moradi-Shahrbabak M., Dodds K., McEwan J. (2012). Genomic scan of selective sweeps in thin and fat tail sheep breeds for identifying of candidate regions associated with fat deposition. BMC Genet. 13:10 10.1186/1471-2156-13-10 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Neale D. B., Kremer A. (2011). Forest tree genomics: growing resources and applications. Nat. Rev. Genet. 12, 111–122 10.1038/nrg2931 [DOI] [PubMed] [Google Scholar]
- Nielsen R. (2005). Molecular signatures of natural selection. Annu. Rev. Genet. 39, 197–218 10.1146/annurev.genet.39.073003.112420 [DOI] [PubMed] [Google Scholar]
- Nievergelt C. M., Smith D. W., Kohlenberg J. B., Schork N. J. (2004). Large-scale integration of human genetic and physical maps. Genome Res. 14, 1199–1205 10.1101/gr.1475304 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Paten B., Herrero J., Beal K., Fitzgerald S., Birney E. (2008a). Enredo and Pecan: genome-wide mammalian consistency-based multiple alignment with paralogs. Genome Res. 18, 1814–1828 10.1101/gr.076554.108 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Paten B., Herrero J., Fitzgerald S., Beal K., Flicek P., Holmes I., et al. (2008b). Genome-wide nucleotide-level mammalian ancestor reconstruction. Genome Res. 18, 1829–1843 10.1101/gr.076521.108 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Purcell S., Neale B., Todd-Brown K., Thomas L., Ferreira M. A. R., Bender D., et al. (2007). PLINK: a toolset for whole-genome association and population-based linkage analysis. Am. J. Hum. Genet. 81, 559–575 10.1086/519795 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Pybus M., Dall'Olio G. M., Luisi P., Uzkudun M., Carreño-Torres A., Pavlidis P., et al. (2014). 1000 Genomes Selection Browser 1.0: a genome browser dedicated to signatures of natural selection in modern humans. Nucleic Acids Res. 42, D903–D909 10.1093/nar/gkt1188 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Qanbari S., Gianola D., Hayes B., Schenkel F., Miller S., Moore S., et al. (2011). Application of site and haplotype-frequency based approaches for detecting selection signatures in cattle. BMC Genomics 12:318 10.1186/1471-2164-12-318 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ramírez-Soriano A., Nielsen R. (2009). Correcting estimators of θ and tajima's D for ascertainment biases caused by the single-nucleotide polymorphism discovery process. Genetics 181, 701–710 10.1534/genetics.108.094060 [DOI] [PMC free article] [PubMed] [Google Scholar]
- R Core Team. (2014). R: A Language and Environment for Statistical Computing. Vienna: R Foundation for Statistical Computing; Available online at: http://www.R-project.org/ [Google Scholar]
- Ronen R., Udpa N., Halperin E., Bafna V. (2013). Learning natural selection from the site frequency spectrum. Genetics 195, 181–193 10.1534/genetics.113.152587 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Sabeti P. C., Reich D. E., Higgins J. M., Levine H. Z. P., Richter D. J., Schaffner S. F., et al. (2002). Detecting recent positive selection in the human genome from haplotype structure. Nature 419, 832–837 10.1038/nature01140 [DOI] [PubMed] [Google Scholar]
- Sabeti P. C., Schaffner S. F., Fry B., Lohmueller J., Varilly P., Shamovsky O., et al. (2006). Positive natural selection in the human lineage. Science 312, 1614–1620 10.1126/science.1124309 [DOI] [PubMed] [Google Scholar]
- Sabeti P. C., Varilly P., Fry B., Lohmueller J., Hostetter E., Cotsapas C., et al. (2007). Genome-wide detection and characterization of positive selection in human populations. Nature 449, 913–918 10.1038/nature06250 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Simonsen K. L., Churchill G. A., Aquadro C. F. (1995). Properties of statistical tests of neutrality for DNA polymorphism data. Genetics 141, 413–429 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Tajima F. (1989). Statistical method for testing the neutral mutation hypothesis by DNA polymorphism. Genetics 123, 585–595 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Tang K., Thornton K. R., Stoneking M. (2007). A new approach for using genome scans to detect recent positive selection in the human genome. PLoS Biol. 5:e171 10.1371/journal.pbio.0050171 [DOI] [PMC free article] [PubMed] [Google Scholar]
- The Bovine HapMap Consortium. (2009). Genome-wide survey of SNP variation uncovers the genetic structure of cattle breeds. Science 324, 528–532 10.1126/science.1167936 [DOI] [PMC free article] [PubMed] [Google Scholar]
- The 1000 Genomes Project Consortium. (2010). A map of human genome variation from population-scale sequencing. Nature 467, 1061–1073 10.1038/nature09534 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Urbanek S. (2011). multicore: Parallel Processing of R Code on Machines with Multiple Cores or CPUs. R Package Version 0.1–7. Available online at: http://cran.r-project.org/package=multicore
- Vitti J. J., Grossman S. R., Sabeti P. C. (2013). Detecting natural selection in genomic data. Annu. Rev. Genet. 47, 97–120 10.1146/annurev-genet-111212-133526 [DOI] [PubMed] [Google Scholar]
- Voight B. F., Kudaravalli S., Wen X., Pritchard J. K. (2006). A map of recent positive selection in the human genome. PLoS Biol. 4:e72 10.1371/journal.pbio.0040072 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Weir B. S., Cockerham C. C. (1984). Estimating F-statistics for the analysis of population structure. Evolution 38, 1358–1370 10.2307/2408641 [DOI] [PubMed] [Google Scholar]
- Wickham H. (2009). ggplot2: Elegant Graphics for Data Analysis. New York, NY: Springer [Google Scholar]
- Williams A. L., Patterson N., Glessner J., Hakonarson H., Reich D. (2012). Phasing of many thousands of genotyped samples. Am. J. Hum. Genet. 91, 238–251 10.1016/j.ajhg.2012.06.013 [DOI] [PMC free article] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.