Skip to main content
Molecular Breeding : New Strategies in Plant Improvement logoLink to Molecular Breeding : New Strategies in Plant Improvement
. 2023 Mar 15;43(3):21. doi: 10.1007/s11032-023-01366-4

CandiHap: a haplotype analysis toolkit for natural variation study

Xukai Li 1,2,✉,#, Zhiyong Shi 2,#, Jianhua Gao 1,2, Xingchun Wang 1,2, Kai Guo 3,
PMCID: PMC10248607  PMID: 37313297

Abstract

Haplotype blocks greatly assist association-based mapping of casual candidate genes by significantly reducing genotyping effort. The gene haplotype could be used to evaluate variants of affected traits captured from the gene region. While there is a rising interest in gene haplotypes, much of the corresponding analysis was carried out manually. CandiHap allows rapid and robust haplotype analysis and candidate identification preselection of candidate causal single-nucleotide polymorphisms and InDels from Sanger or next-generation sequencing data. Investigators can use CandiHap to specify a gene or linkage sites based on genome-wide association studies and explore favorable haplotypes of candidate genes for target traits. CandiHap can be run on computers with Windows, Mac, or UNIX platforms in a graphical user interface or command line, and applied to any species, such as plant, animal, and microbial. The CandiHap software, user manual, and example datasets are freely available at BioCode (https://ngdc.cncb.ac.cn/biocode/tools/BT007080) or GitHub (https://github.com/xukaili/CandiHap).

Supplementary information

The online version contains supplementary material available at 10.1007/s11032-023-01366-4.

Keywords: CandiHap, Haplotype, GWAS, SNPs, InDels

Introduction

With the rapid development of next-generation sequencing (NGS) technologies, genome sequencing is becoming inexpensive, routine, and convenient to obtain large numbers of single-nucleotide polymorphisms (SNPs) (Goodwin et al. 2016). Whole-genome re-sequencing (WGRS), genotyping-by-sequencing (GBS), and restriction site-associated DNA (RAD) are essential strategies in medical, biological, and agricultural research to elucidate the genetic basis of phenotypic traits, such as disease or economically important features (Visscher et al. 2017, 2012; Patil et al. 2019; Thudi et al. 2016; Tinker et al. 2016; Miller et al. 2007). These strategies are based on sequencing of whole genomes, or representative genome fractions, across many individuals to determine loci with sequence variations. SNPs can alter the amino acid sequence of a protein directly (e.g., via non-synonymous SNPs, alterations of stop-codons, frameshift SNPs, or SNPs in splice sites) or can change gene expression patterns by affecting gene regulatory regions. Using many genome-wide variants, genome-wide association studies (GWAS) generally identify SNPs that are statistically associated with certain traits. Such SNPs provide the basis to understand mechanisms that drive a trait; however, a key challenge is to rapidly and robustly identify causal SNPs (McCarthy and Hirschhorn 2008).

In GWAS, millions of genetic variations are tested across numerous genomes to identify those statistically associated with a specific trait or disease. Interpreting these associations in a biological and genomic context is very difficult (Uffelmann et al. 2021). Due to linkage disequilibrium, previous GWAS have demonstrated that most traits are significantly correlated with both causal and non-causal variants that are physically close (Slatkin 2008). This limits the identification of causative variants without additional research (Uffelmann and Posthuma 2021). Based on observed patterns of linkage disequilibrium and association statistics, fine-mapping is an in silico procedure created to prioritize the set of variants within each genetic locus found by GWAS that are most likely to be causal to the target phenotype (Raychaudhuri 2011; Schaid et al. 2018). The fine-mapping approaches are based on stepwise conditional, such as GCTA-COJO (Yang et al. 2012) and Bayesian models, including CAVIAR (Hormozdiari et al. 2014), FINEMAP (Benner et al. 2016), PAINTOR (Kichaev et al. 2014), and SuSIE (Wang et al. 2018a). Prioritizing the likely affected gene is perhaps the most crucial part of the functional interpretation of GWAS. GWAS fine-mapped to coding variants, tools such as ANNOVAR (Wang et al. 2010) or SnpEff (Cingolani et al. 2012) can be used to infer their potential effect on genes and to determine the affected gene (Visscher et al. 2017). However, the vast majority of the tools used for these analyses are web-based or command lines implemented and mainly focused on human and rice traits, which severely limit wider applications. In fact, researchers would benefit from identifying candidate causal variants of the most significant SNPs from the species on which GWAS was conducted. The corresponding manual tasks are laborious, time consuming, and prone to errors and omission. To resolve these problems, we aimed to develop a software for fast identification of candidate causal variants or gene(s) from GWAS data.

Haplotype blocks greatly assist association-based mapping of casual candidate genes by significantly reducing the genotyping effort (Zhang et al. 2002a). Different definitions are used to define the haplotype block structure (Patil et al. 2001; Gabriel et al. 2002; Wang et al. 2002; Zhang et al. 2002b). Here, we refer to the haplotype not as the strong inter-marker LD, but rather the SNPs and indels within a gene region, including upstream, downstream, exonic, and intronic regions. We term this as the gene haplotype, which could be adopted to evaluate the variants of the affected traits captured from the gene region. While there is a rising interest in gene haplotypes, much of the corresponding analyses were carried out manually (Supplementary material). In addition, DnaSP is a software package for comprehensive analysis of DNA polymorphism data and also allow analysis on haplotype phasing (Rozas et al. 2017). HaplotypeMiner is an R package developed for exploring allelic diversity at genes of interest in a plant breeding context. The program minimally takes as input a dataset of SNP markers and the genomic position of a gene of interest, and outputs a set of possible haplotypes defined by the genotypes of a reduced number of neighboring SNPs (Tardivel et al. 2019). The RFGB (Rice Functional and Genomic Breeding) contains a set of core collection of about 3000 rice accessions (3 K rice genome). This dataset provides a base for the large-scale novel allele mining for important traits in rice with various bioinformatics and genetic approaches. It also contains Haplotype module, which was designed to fulfill the increasing demands of mining the associations between sequence variations within certain gene/region/SNP and target traits (Wang et al. 2020). However, a graphical haplotype analysis tool (no basic programming skill is required) that can handle any species is in urgent need.

Methods

Materials, genotyping, and annotation

A set of 398 accessions, including 360 foxtail millets and 38 S. viridis, was used to examine and calibrate our approach. These accessions have recently been analyzed via whole-genome sequencing (WGS) (Li et al. 2022). The clean reads were mapped onto the xiaomi reference genome (Yang et al. 2020). SNPs and InDels were detected using GATK (McKenna et al. 2010) (ver. 3.8.0). The SNPs and InDels were considered valid if they met the following requirements: (1) two alleles only; (2) excluding sites on the basis of the proportion of missing data > 0.9; (3) minor allele frequency ≥ 0.05; (4) mean depth values ≥ 5. SNPs that did not meet these four criteria were excluded from the study. We generated a final set of 4,158,075 filtered single-nucleotide polymorphisms (SNPs) and insertion-deletion polymorphisms (InDels) for further analysis. All identified SNPs that passed quality screening were further annotated with ANNOVAR (Wang et al. 2010) or SnpEff (Cingolani et al. 2012) based on the gene annotation of the reference genome (Wang et al. 2010). In practical application, users can adjust the above parameters. When a VCF file was submitted, ANNOVAR or SnpEff was computed to rapidly categorize the effects of variants in the reference genome sequence. ANNOVAR or SnpEff annotates variants based on their genomic locations (annotated genomic locations can be intronic, exonic, or intergenic) and predicts coding effects (mainly synonymous or non-synonymous amino-acid replacement). The process can be applied to any plant, animal, and bacteria species, by providing the genome file and its GFF (generic feature format) annotation file. The annotated vcf file was converted to HapMap using a Perl script vcf2hmp.pl, and this step would normally take several hours (~ 3 h for 4 million SNPs). Finally, a haplotypes.hmp file was generated for further haplotype analysis.

Put vcf2hmp.pl test.gff, test.vcf, and genome.fa files in the same directory, then run:graphic file with name 11032_2023_1366_Figa_HTML.jpg

Platforms and install

CandiHap was written in Perl 5 and R, which supported Windows, Mac, or UNIX platform computers in the graphical user interface (GUI) or command lines. Graphics were created by R. In addition to the GUI, users can also run CandiHap through command lines and install the R software environment (https://www.r-project.org). The code was compiled for the UNIX platforms and Windows 64-bit environment, and tested with CentOS 7, Windows 10/11 as well as Mac OS 10/13. For a given SNP that was found significantly in GWAS, the run time was about 1 min for a set of 398 samples with 4,158,075 marks. The CandiHap tool is open source, available on multiple platforms, and freely available online (https://github.com/xukaili/CandiHap or https://bigd.big.ac.cn/biocode/tools/BT007080).

A user-friendly graphical user interface software package of CandiHap, installable on Windows platforms, is implemented using electron development toolkit, which is freely available and not required for registration. For Windows users’ convenience, the installation package integrates Perl and R modules needed to run independently, meaning no more software installation is required. However, for the Mac Os or UNIX platform users, installation of the R software environment is required, followed by three packages by command install.packages (c("ggplot2","agricolae", "ggbeeswarm")) in R.

Parameter for CandiHap

Intergenic SNPs are SNPs that are located at least 5 kb up- or downstream of a gene. In general, they are not associated with a gene and not located in a known regulatory region. We set a default parameter in CandiHap, which limits the mapping SNPs to 2000 bp upstream and 500 bp downstream of a gene. The default settings ensure that the result is based on the association signals in gene(s) with statistical significance. Users may also adjust the parameter in “CandiHap.pl.” Using Perl and R, the analysis provided and displayed various statistical results for haplotypes such as annotation statistics, types of variation, number of varieties, variety ID and phenotypes, mean, SD (standard deviation) of phenotypes, and significant phenotype differences. A boxplot of the gene showed a significant difference in haplotype–phenotype association analysis. The least significant difference (LSD) test is used to determine whether or not the difference between or among group means is significant.

Put CandiHap.pl and Phenotype.txt, Your.hmp, and genome.gff files in the same directory, then run:graphic file with name 11032_2023_1366_Figb_HTML.jpg

Graphical user interface

In addition to the command-line environment, we also provide user-friendly graphical interface software package of CandiHap on Windows platforms. For the convenience of the Windows platform, the installation package integrates necessary Perl and R modules for running independently by PyInstaller (5.7.0, https://pyinstaller.org/en/stable/), meaning no more software installation required. The installation package also contains the test dataset as the default value of the GUI version.

Sanger data for haplotype analysis

The “sanger_CandiHap.sh” was written in Shell, Perl 5, and R (with sangerseqR), which only supported the UNIX platforms in command lines. We developed a Perl script “ab1-fastq.pl” for reading ABI Sanger sequencing trace file and simulating the primarySeq and secondarySeq to fastq reads by extracting 90-bp blocks from Sanger sequence and shifting 1 bp in turns. As an example, a 200-bp Sanger sequence would obtain 110 fastq reads within the length of 90 bp. Then, mapping the new fastq reads to reference gene sequence is transferred into a call SNP process for next-generation sequencing. Burrows–Wheeler aligner software (Li and Durbin 2010) (BWA mem, ver. 0.7.17) was used to map the fastq reads with default parameters onto the gene reference sequence of all samples. Mapped reads were converted into BAM files using SAMtools (ver. 1.7). The variants including SNPs and indels were detected using GATK (McKenna et al. 2010) (ver. 3.8.0). Hard filtering was applied to the raw variant set using GATK. The results are filtered to retain the homozygous mutation sites. It is an open source and freely available online (https://github.com/xukaili/CandiHap/tree/master/Sanger_ab1_Linux or https://ngdc.cncb.ac.cn/biocode/tools/7080/releases/v1.0.1).

Put sanger_CandiHap.sh, Gene_VCF2haplotypes.pl, ab1-fastq.pl, and all.ab1 files in the same directory (require R package “sangerseqR”), then run:graphic file with name 11032_2023_1366_Figc_HTML.jpg

Results

We developed a user-friendly software, CandiHap, that may be operated on a range of computer platforms. In CandiHap, users can identify polymorphisms based on the models of gene haplotypes within vcf file and to report results in a variety of formats, including tables and figures. CandiHap allows researchers to explore favorable haplotypes of candidate genes for target traits, providing a guide to study underlying genetic mechanisms. In addition, some researchers use Sanger sequences to detect the mutations that underlie a number of traits, yet it is challenging to determine heterozygotes from Sanger ab1 files and conduct haplotype analysis. The “Sanger_CandiHap.sh” in CandiHap allows fast identification of the haplotype from Sanger ab1 files.

An overview of the process is presented in Fig. 1. Starting from a VCF file as an entry point, CandiHap first annotates the variants using an annotated reference genome to produce a new VCF file. This new VCF file is then used to mine variants and genotyping data, and sent into a series of modules in charge of various processes. Users can then analyze variants ranging from genome to single gene levels. The GWAS results of genomic regions (Fig. 1a) and LD can be defined by entering the limits, and the application would loop and process all genes in the LD regions. The CandiHap implements a three-stage analysis (Fig. 1b): the first annotates the VCF file for GWAS by ANNOVAR (table_annovar.pl); the second converts the txt result of ANNOVAR to hapmap format (vcf2hmp.pl); and the third stage requires input data of hapmap file, GFF file of your reference genome, the phenotype data, the LD, and the most significant SNP position of GWAS result. If users need only to run one gene, the vcf, phenotype, gff, and gene ID need to be input. Besides the graphical user interface (GUI) software, users can run CandiHap through command lines on UNIX, Mac, or DOS platforms. The output includes a txt file of haplotypes with detailed information and three pdf files of figures (Fig. 1c–f). The results of haplotypes include references allele, alternative allele, allele frequency, SNP annotation, SNP positions, and haplotypes (Fig. 1d). The information for each haplotype also includes number of varieties, varieties ID and its phenotype, average, SD of phenotype, and significant difference (Fig. 1d). For the graphical user interface (GUI), CandiHap analytical pipeline is divided into three functional modules, vcf2hmp, CandiHap, and GWAS_LD2haplotypes, which correspond to the command line steps. First, the “txt” and “vcf” files of ANNOVAR results with genotype information are required as input for module vcf2hmp to convert the txt result of ANNOVAR to hapmap format. Then, CandiHap module can detect a single specific gene or GWAS_LD2haplotypes module for an LD region.

Fig. 1.

Fig. 1

Overview of the CandiHap process. a A GWAS result. b General scheme of the process. c The histogram of phenotype and Shapiro test to check whether the data is normally distributed data or not. d The statistics of haplotypes and significant differences haplotypes are highlighted by color boxes. e Gene structure and SNPs of a critical gene. f Boxplot of a critical gene’s haplotypes and the LSD test is used to determine whether or not the difference between or among group means is significant

To exemplify CandiHap, we performed a GWAS analysis of foxtail millet (Li et al. 2022). Approximately 3679 K SNPs were tested; of them, 531 SNPs passed the threshold of P-value < 9.42 × 10−7. The most significant SNP was located at chr9 at position of 54,583,294 with P-value = 1.23 × 10−8 (Fig. 1a), and CandiHap identified a candidate causal gene (Si9g49990) within 50 kb LD of this SNP. We have identified a signal at position 54,605,172 (P-value = 1.03 × 10−7), leading to stop gain of Si9g49990 (Fig. 1d). The boxplot of Si9g49990, for haplotype-phenotype association analysis, showed significant differences in the phenotype of each haplotype between Hap 1, 2, 6 and Hap 3, 4, 5, 7, 8, 9, with intuitive supporting evidence (Fig. 1f). Only the SNPs and haplotypes found in ≥ 2 accessions were used to construct the haplotype network for Si9g49990 (Supplementary Fig. 1).

To further test the universality of CandiHap in haplotype analysis, we analyzed the haplotypes of the ARE1 gene in rice (Wang et al. 2018b), and the same result was obtained except that five more SNPs and two errors were identified in our study (highlighted by blue and red boxes). The discrepancy is due to the fact that there are 276 more rice varieties used in our study, and authors analyze the haplotype of ARE1 gene manually (Fig. 2).

Fig. 2.

Fig. 2

Haplotype analysis of the ARE1 gene in rice compared with the results by Wang et al. (2018b). a Gene structure and SNPs of ARE1. b Major haplotypes of SNPs in the ARE1 coding region of 2747 rice varieties (from Wang’s article Fig. 5b, https://www.nature.com/articles/s41467-017-02781-w/figures/5). c The haplotype results of ARE1 coding region of 3023 rice varieties using CandiHap (SNPs data were downloaded from RFGB, http://www.rmbreeding.cn). Major SNP haplotypes and casual variations in the encoded amino acid residues are shown. The five more SNPs is due to the fact that there are 276 more rice varieties used in our study (highlighted by blue boxes), and two errors are highlighted by red boxes

In addition to NGS data, Sanger sequencing technology is also widely used in natural variation analysis. To meet this demand, “sanger_CandiHap.sh” was developed for process of Sanger sequencing data (Fig. 3). Starting from ab1 files as the entry point, the process first simulates ABI Sanger sequencing trace data to fastq reads and then maps the fastq reads to reference gene sequence as for re-sequencing program (Fig. 3a). The output is a txt file of haplotypes with detailed information, including references allele, alternative allele, SNP positions, and haplotypes. The information for each haplotype consists of the number of samples and sample ID (Fig. 3c). As an example, the PHYC gene has a mutation at 4475 and has homozygous samples (Fig. 3b). Runtime is ∼20 min for a set of 100 samples of Sanger sequences. The results are filtered to retain the homozygous mutation sites, allowing users to find the mutation easily (Fig. 3b, c). Moreover, the heterozygous mutation was also shown in the results (Fig. 3c). There are 57 wild types and 43 variations, and 40 homozygous samples showed wild-type phenotype (Fig. 3c). The test data files can be freely downloaded (https://github.com/xukaili/CandiHap/tree/master/Sanger_ab1 or https://ngdc.cncb.ac.cn/biocode/tools/7080/releases/v1.0.1/file/download?filename=sanger_CandiHap-1.0.1.zip).

Fig. 3.

Fig. 3

Overview of the sanger_CandiHap process. a General scheme of the process from Sanger ab1 files. b PeakTrace of ab1 images of three main genotypes. c The statistics of haplotypes

Discussion

We refer to the haplotype not as the strong inter-marker LD, but rather the SNPs and indels within a gene region, including upstream, downstream, exonic, and intronic regions. We term this as the gene haplotype, which specifically aims to select a collection of SNPs that are useful for defining SNP haplotypes around a target gene and could be adopted to evaluate the variants of the affected traits captured from the gene region. Also, all the individuals that share a given gene are systematically pooled into haplotypes. The CandiHap can be widely used for the investigations of natural variations. It should be noted that CandiHap is not intended to be used to predict true causal SNPs and gene(s) for complex traits. Therefore, CandiHap outputs are candidate causal SNPs and gene(s), which allows users to screen for useful ones. An essential application of the CandiHap results is to allow investigators to test “a priori” hypothesis by using candidate causal SNPs as a practical starting point.

In terms of other software, the DnaSP input data are required in FASTA format that is not suitable for analyzing large-scale population data, such as vcf (Rozas et al. 2017); the HaplotypeMiner is a command-line tool using parameters (Tardivel et al. 2019), and RFGB can only analyze the 3 K rice genome data (Wang et al. 2020). Due to the above limitations, the CandiHap is a graphical haplotype analysis tool (no basic programming skill is required) that can handle any species, which is in urgent need.

Several factors can affect the best settings for haplotype definition of a given gene; we have therefore allowed users to select the desired settings for some parameters: (1) the P-value of Wilcox test, (2) the LD threshold, (3) the length of gene upstream and downstream, and (4) the phenotype data. Collapsing SNPs to retain a single tag SNP by using a higher threshold (P-value of Wilcox test = 1) leads to no loss of information from the dataset but has the disadvantage of being sensitive to genotyping errors. On the contrary, a lower threshold, as was used here (P-value of Wilcox test = 0.01), will mask small genotyping errors but may also lead to the loss of haplotypes specific to rare alleles. The ability to capture informative markers in the vicinity of the gene is dependent on the density of genotyping. For this approach to work best, the genotyping should be sufficiently dense to deliver at least one marker at a gene. We successfully identified gene haplotypes offering a very good match with the allelic status at Si9g49990 and LOC_Os08g12780 (ARE1) genes under study. Because of manual analysis on ARE1 gene in rice, these five alleles were misidentified, and two errors were identified in Wang et al. (2018a, b) (Fig. 2).

Breeding aims to produce new lines that carry an array of alleles that jointly produce a superior phenotype. A key part of this work is to assess the allelic diversity present in germplasm collections and to identify individuals carrying favorable alleles at these genes. In this work, we demonstrate how our approach can provide accurate and essential information for breeding by delivering a quick and clear picture of the allelic diversity for a gene within a given germplasm collection. This approach was also found to be reproducible on two distinct genotypic datasets (next-generation sequencing and Sanger sequencing) with similar results. Ultimately, our approach for identification of gene haplotypes from large SNP datasets represents a promising approach to routinely assess allelic variation in a gene region. In the future, CandiHap will be regularly updated and expanded to perform more functions with more user-friendly options.

Supplementary information

Below is the link to the electronic supplementary material.

Acknowledgements

The authors thank the CandiHap users for helpful comments and discussions. We also thank Dr. Staffan Persson (University of Melbourne) and Dr. Yiwei Jiang (Purdue University) for their critical reading of the manuscript.

Author contribution

XL and KG supervised the study. XL, XW, and KG conceived of the study idea. JG carried out the sampling process and participated in the material preparation. XL and ZS performed most of the experiments. XL, ZS, and KG analyzed the data. XL drafted the manuscript. All of the authors discussed the results and commented on the manuscript.

Funding

This work has been supported by the National Key R&D Program of China (2022YFC3400300); the National Natural Science Foundation of China (32001608); the Major Special Science and Technology Projects in Shanxi Province (202101140601027); the National Laboratory of Minor Crops Germplasm Innovation and Molecular Breeding (in preparation) (202204010910001–02).

Data availability

The raw sequencing data reported in this paper have been deposited in the NCBI under BioProject accession no. PRJNA633413. This data is also available in the BIG Data Center under the accession number CRA002636. SNP data of ARE1 coding region of 3023 rice varieties were downloaded from RFGB (http://www.rmbreeding.cn). CandiHap code is available online (https://github.com/xukaili/CandiHap or https://ngdc.cncb.ac.cn/biocode/tools/BT007080).

Declarations

Conflict of interest

The authors declare no competing interests.

Footnotes

Publisher's note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Xukai Li and Zhiyong Shi contributed equally to this work.

Contributor Information

Xukai Li, Email: xukai_li@sxau.edu.cn.

Kai Guo, Email: kaiguo@umich.edu.

References

  1. Benner C, Spencer CC, Havulinna AS, Salomaa V, Ripatti S, Pirinen M. FINEMAP: efficient variable selection using summary data from genome-wide association studies. Bioinformatics. 2016;32(10):1493–1501. doi: 10.1093/bioinformatics/btw018. [DOI] [PMC free article] [PubMed] [Google Scholar]
  2. Cingolani P, Platts A, le Wang L, Coon M, Nguyen T, Wang L, Land SJ, Lu X, Ruden DM. A program for annotating and predicting the effects of single nucleotide polymorphisms, SnpEff: SNPs in the genome of Drosophila melanogaster strain w1118; iso-2; iso-3. Fly (austin) 2012;6(2):80–92. doi: 10.4161/fly.19695. [DOI] [PMC free article] [PubMed] [Google Scholar]
  3. Gabriel SB, Schaffner SF, Nguyen H, Moore JM, Roy J, Blumenstiel B, Higgins J, DeFelice M, Lochner A, Faggart M, Liu-Cordero SN, Rotimi C, Adeyemo A, Cooper R, Ward R, Lander ES, Daly MJ, Altshuler D. The structure of haplotype blocks in the human genome. Science. 2002;296(5576):2225–2229. doi: 10.1126/science.1069424. [DOI] [PubMed] [Google Scholar]
  4. Goodwin S, McPherson JD, McCombie WR. Coming of age: ten years of next-generation sequencing technologies. Nat Rev Genet. 2016;17(6):333–351. doi: 10.1038/nrg.2016.49. [DOI] [PMC free article] [PubMed] [Google Scholar]
  5. Hormozdiari F, Kostem E, Kang EY, Pasaniuc B, Eskin E. Identifying causal variants at loci with multiple signals of association. Genetics. 2014;198(2):497–508. doi: 10.1534/genetics.114.167908. [DOI] [PMC free article] [PubMed] [Google Scholar]
  6. Kichaev G, Yang WY, Lindstrom S, Hormozdiari F, Eskin E, Price AL, Kraft P, Pasaniuc B. Integrating functional data to prioritize causal variants in statistical fine-mapping studies. PLoS Genet. 2014;10(10):e1004722. doi: 10.1371/journal.pgen.1004722. [DOI] [PMC free article] [PubMed] [Google Scholar]
  7. Li H, Durbin R. Fast and accurate long-read alignment with Burrows-Wheeler transform. Bioinformatics. 2010;26(5):589–595. doi: 10.1093/bioinformatics/btp698. [DOI] [PMC free article] [PubMed] [Google Scholar]
  8. Li X, Gao J, Song J, Guo K, Hou S, Wang X, He Q, Zhang Y, Zhang Y, Yang Y, Tang J, Wang H, Persson S, Huang M, Xu L, Zhong L, Li D, Liu Y, Wu H, Diao X, Chen P, Wang X, Han Y. Multi-omics analyses of 398 foxtail millet accessions reveal genomic regions associated with domestication, metabolite traits, and anti-inflammatory effects. Mol Plant. 2022;15(8):1367–1383. doi: 10.1016/j.molp.2022.07.003. [DOI] [PubMed] [Google Scholar]
  9. McCarthy MI, Hirschhorn JN. Genome-wide association studies: potential next steps on a genetic journey. Hum Mol Genet. 2008;17(R2):R156–R165. doi: 10.1093/hmg/ddn289. [DOI] [PMC free article] [PubMed] [Google Scholar]
  10. McKenna A, Hanna M, Banks E, Sivachenko A, Cibulskis K, Kernytsky A, Garimella K, Altshuler D, Gabriel S, Daly M, DePristo MA. The genome analysis toolkit: a mapreduce framework for analyzing next-generation DNA sequencing data. Genome Res. 2010;20(9):1297–1303. doi: 10.1101/gr.107524.110. [DOI] [PMC free article] [PubMed] [Google Scholar]
  11. Miller MR, Dunham JP, Amores A, Cresko WA, Johnson EA. Rapid and cost-effective polymorphism identification and genotyping using restriction site associated DNA (RAD) markers. Genome Res. 2007;17(2):240–248. doi: 10.1101/gr.5681207. [DOI] [PMC free article] [PubMed] [Google Scholar]
  12. Patil N, Berno AJ, Hinds DA, Barrett WA, Doshi JM, Hacker CR, Kautzer CR, Lee DH, Marjoribanks C, McDonough DP, Nguyen BTN, Norris MC, Sheehan JB, Shen N, Stern D, Stokowski RP, Thomas DJ, Trulson MO, Vyas KR, Frazer KA, Fodor SPA, Cox DR. Blocks of limited haplotype diversity revealed by high-resolution scanning of human chromosome 21. Science. 2001;294(5547):1719–1723. doi: 10.1126/science.1065573. [DOI] [PubMed] [Google Scholar]
  13. Patil GB, Lakhssassi N, Wan J, Song L, Zhou Z, Klepadlo M, Vuong TD, Stec AO, Kahil SS, Colantonio V, Valliyodan B, Rice JH, Piya S, Hewezi T, Stupar RM, Meksem K, Nguyen HT. Whole-genome re-sequencing reveals the impact of the interaction of copy number variants of the rhg1 and Rhg4 genes on broad-based resistance to soybean cyst nematode. Plant Biotechnol J. 2019;17(8):1595–1611. doi: 10.1111/pbi.13086. [DOI] [PMC free article] [PubMed] [Google Scholar]
  14. Raychaudhuri S. Mapping rare and common causal alleles for complex human diseases. Cell. 2011;147(1):57–69. doi: 10.1016/j.cell.2011.09.011. [DOI] [PMC free article] [PubMed] [Google Scholar]
  15. Rozas J, Ferrer-Mata A, Sánchez-DelBarrio JC, Guirao-Rico S, Librado P, Ramos-Onsins SE, Sánchez-Gracia A. DnaSP 6: DNA sequence polymorphism analysis of large data sets. Mol Biol Evol. 2017;34(12):3299–3302. doi: 10.1093/molbev/msx248. [DOI] [PubMed] [Google Scholar]
  16. Schaid DJ, Chen W, Larson NB. From genome-wide associations to candidate causal variants by statistical fine-mapping. Nat Rev Genet. 2018;19(8):491–504. doi: 10.1038/s41576-018-0016-z. [DOI] [PMC free article] [PubMed] [Google Scholar]
  17. Slatkin M. Linkage disequilibrium—understanding the evolutionary past and mapping the medical future. Nat Rev Genet. 2008;9(6):477–485. doi: 10.1038/nrg2361. [DOI] [PMC free article] [PubMed] [Google Scholar]
  18. Tardivel A, Torkamaneh D, Lemay MA, Belzile F, O'Donoughue LS. A systematic gene-centric approach to define haplotypes and identify alleles on the basis of dense single nucleotide polymorphism datasets. Plant Genome. 2019;12(3):1–11. doi: 10.3835/plantgenome2018.08.0061. [DOI] [PubMed] [Google Scholar]
  19. Thudi M, Khan AW, Kumar V, Gaur PM, Katta K, Garg V, Roorkiwal M, Samineni S, Varshney RK (2016) Whole genome re-sequencing reveals genome-wide variations among parental lines of 16 mapping populations in chickpea (Cicer arietinum L.). BMC Plant Biol 16 Suppl 1 (Suppl 1):10–10 10.1186/s12870-015-0690-3 [DOI] [PMC free article] [PubMed]
  20. Tinker NA, Bekele WA, Hattori J (2016) Haplotag: software for haplotype-based genotyping-by-sequencing analysis. G3 6 (4):857–863 10.1534/g3.115.024596 [DOI] [PMC free article] [PubMed]
  21. Uffelmann E, Posthuma D. Emerging methods and resources for biological interrogation of neuropsychiatric polygenic signal. Biol Psychiatry. 2021;89(1):41–53. doi: 10.1016/j.biopsych.2020.05.022. [DOI] [PubMed] [Google Scholar]
  22. Uffelmann E, Huang QQ, Munung NS, de Vries J, Okada Y, Martin AR, Martin HC, Lappalainen T, Posthuma D. Genome-wide association studies. Nature Reviews Methods Primers. 2021;1(1):59. doi: 10.1038/s43586-021-00056-9. [DOI] [Google Scholar]
  23. Visscher PM, Brown MA, McCarthy MI, Yang J. Five years of GWAS discovery. Am J Hum Genet. 2012;90(1):7–24. doi: 10.1016/j.ajhg.2011.11.029. [DOI] [PMC free article] [PubMed] [Google Scholar]
  24. Visscher PM, Wray NR, Zhang Q, Sklar P, McCarthy MI, Brown MA, Yang J. 10 years of GWAS discovery: biology, function, and translation. Am J Hum Genet. 2017;101(1):5–22. doi: 10.1016/j.ajhg.2017.06.005. [DOI] [PMC free article] [PubMed] [Google Scholar]
  25. Wang N, Akey JM, Zhang K, Chakraborty R, Jin L. Distribution of recombination crossovers and the origin of haplotype blocks: the interplay of population history, recombination, and mutation. Am J Hum Genet. 2002;71(5):1227–1234. doi: 10.1086/344398. [DOI] [PMC free article] [PubMed] [Google Scholar]
  26. Wang K, Li M, Hakonarson H. ANNOVAR: functional annotation of genetic variants from high-throughput sequencing data. Nucleic Acids Res. 2010;38(16):e164–e164. doi: 10.1093/nar/gkq603. [DOI] [PMC free article] [PubMed] [Google Scholar]
  27. Wang Q, Nian J, Xie X, Yu H, Zhang J, Bai J, Dong G, Hu J, Bai B, Chen L, Xie Q, Feng J, Yang X, Peng J, Chen F, Qian Q, Li J, Zuo J. Genetic variations in ARE1 mediate grain yield by modulating nitrogen utilization in rice. Nat Commun. 2018;9(1):735. doi: 10.1038/s41467-017-02781-w. [DOI] [PMC free article] [PubMed] [Google Scholar]
  28. Wang G, Sarkar A, Carbonetto P, Stephens M (2018a) A simple new approach to variable selection in regression, with application to genetic fine-mapping. bioRxiv 10.1101/501114 [DOI] [PMC free article] [PubMed]
  29. Wang C-C, Yu H, Huang J, Wang W-S, Faruquee M, Zhang F, Zhao X-Q, Fu B-Y, Chen K, Zhang H-L, Tai S-S, Wei C, McNally KL, Alexandrov N, Gao X-Y, Li J, Li Z-K, Xu J-L, Zheng T-Q (2020) Towards a deeper haplotype mining of complex traits in rice with RFGB v2.0. Plant Biotechnol J 18 (1):14–16 10.1111/pbi.13215 [DOI] [PMC free article] [PubMed]
  30. Yang Z, Zhang H, Li X, Shen H, Gao J, Hou S, Zhang B, Mayes S, Bennett M, Ma J, Wu C, Sui Y, Han Y, Wang X. A mini foxtail millet with an Arabidopsis-like life cycle as a C4 model system. Nat Plants. 2020;6(9):1167–1178. doi: 10.1038/s41477-020-0747-7. [DOI] [PubMed] [Google Scholar]
  31. Yang J, Ferreira T, Morris AP, Medland SE, Madden PA, Heath AC, Martin NG, Montgomery GW, Weedon MN, Loos RJ, Frayling TM, McCarthy MI, Hirschhorn JN, Goddard ME, Visscher PM (2012) Conditional and joint multiple-SNP analysis of GWAS summary statistics identifies additional variants influencing complex traits. Nat Genet 44 (4):369–375, s361–363 10.1038/ng.2213 [DOI] [PMC free article] [PubMed]
  32. Zhang K, Calabrese P, Nordborg M, Sun F. Haplotype block structure and its applications to association studies: power and study designs. Am J Hum Genet. 2002;71(6):1386–1394. doi: 10.1086/344780. [DOI] [PMC free article] [PubMed] [Google Scholar]
  33. Zhang K, Deng M, Chen T, Waterman MS, Sun F. A dynamic programming algorithm for haplotype block partitioning. Proc Natl Acad Sci USA. 2002;99(11):7335–7339. doi: 10.1073/pnas.102186799. [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.

Supplementary Materials

Data Availability Statement

The raw sequencing data reported in this paper have been deposited in the NCBI under BioProject accession no. PRJNA633413. This data is also available in the BIG Data Center under the accession number CRA002636. SNP data of ARE1 coding region of 3023 rice varieties were downloaded from RFGB (http://www.rmbreeding.cn). CandiHap code is available online (https://github.com/xukaili/CandiHap or https://ngdc.cncb.ac.cn/biocode/tools/BT007080).


Articles from Molecular Breeding : New Strategies in Plant Improvement are provided here courtesy of Springer

RESOURCES