The Great Genotyper: A Graph-Based Method for Population Genotyping of Small and Structural Variants ==================================================================================================== * Moustafa Shokrof * Mohamed Abuelanin * C.Titus Brown * Tamer A. Mansour ## 1 Abstract Long-read sequencing (LRS) enables variant calling of high-quality structural variants (SVs). Genotypers of SVs utilize these precise call sets to increase the recall and precision of genotyping in short-read sequencing (SRS) samples. With the extensive growth in availabilty of SRS datasets in recent years, we should be able to calculate accurate population allele frequencies of SV. However, reprocessing hundreds of terabytes of raw SRS data to genotype new variants is impractical for population-scale studies, a computational challenge known as the N+1 problem. Solving this computational bottleneck is necessary to analyze new SVs from the growing number of pangenomes in many species, public genomic databases, and pathogenic variant discovery studies. To address the N+1 problem, we propose The Great Genotyper, a population genotyping workflow. Applied to a human dataset, the workflow begins by preprocessing 4.2K short-read samples of a total of 183TB raw data to create an 867GB Counting Colored De Bruijn Graph (CCDG). The Great Genotyper uses this CCDG to genotype a list of phased or unphased variants, leveraging the CCDG population information to increase both precision and recall. The Great Genotyper offers the same accuracy as the state-of-the-art genotypers with the addition of unprecedented performance. It took 100 hours to genotype 4.5M variants in the 4.2K samples using one server with 32 cores and 145GB of memory. A similar task would take months or even years using single-sample genotypers. The Great Genotyper opens the door to new ways to study SVs. We demonstrate its application in finding pathogenic variants by calculating accurate allele frequency for novel SVs. Also, a premade index is used to create a 4K reference panel by genotyping variants from the Human Pangenome Reference Consortium (HPRC). The new reference panel allows for SV imputation from genotyping microarrays. Moreover, we genotype the GWAS catalog and merge its variants with the 4K reference panel. We show 6.2K events of high linkage between the HPRC’s SVs and nearby GWAS SNPs, which can help in interpreting the effect of these SVs on gene functions. This analysis uncovers the detailed haplotype structure of the human fibrinogen locus and revives the pathogenic association of a 28 bp insertion in the FGA gene with thromboembolic disorders. ## 2 Introduction Maya Angelou eloquently stated, “In diversity, there is beauty and there is strength.” This principle is particularly relevant to genomics studies, emphasizing the importance of exploring genetic diversity across large cohorts and populations. Such research is crucial for advancing our understanding of evolution [1, 2], genetic adaptations [3], and gene-disease associations [4, 5]. Genetic diversity originates from various mutations, including single nucleotide variants (SNVs), small insertions and deletions (less than 50 base pairs), and structural variants (greater than 50 base pairs). Notably, structural variants (SVs) enhance genomic diversity fifteen times more than SNVs [6] and significantly affect gene function [7]. However, SVs are understudied compared to smaller variants due to the limitations of short-read sequencing (SRS), which often yields high false positive rates and inconsistent recall, varying from 10% to 70% [8]. In contrast, long-read sequencing (LRS) provides more reliable precision and recall rates [8] and is used in both mapping [9, 10, 11] and assembly-based approaches [12], the latter of which helps mitigate mapping biases to a linear genome reference. Despite its advantages, LRS remains prohibitively expensive for comprehensive population-scale analysis, and the volume of LRS data available still pales in comparison to that of SRS. As a result, there is a pressing need to develop computational techniques that utilize the precise variant discovery capabilities of LRS while maximizing the extensive data produced by SRS. To address the shortcomings of SV callers from short-read sequencing, specialized genotypers analyze the presence and genotype of SVs, whether identified through variant calling from SRS or LRS, in SRS samples [13, 14, 15, 16, 17]. Tools such as Paragraph [14] and Graphtyper2 [16] realign reads to a variation-aware graph, minimizing mapping bias and determining genotypes from this realignment. Pangenie [17] uses k-mers specific to all potential alleles to genotype phased variants from pangenomes, minimizing mapping bias. Furthermore, Pangenie integrates genotyping and imputation, utilizing the phasing information from the pangenome to infer genotypes in regions lacking coverage, thereby achieving superior performance compared to other SV genotypers. Unlike these single-sample genotypers, muCNV utilizes population data to refine genotyping by modeling read mapping statistics across multiple samples, enhancing genotyping accuracy [15]. SV genotypers generally achieve higher recall and precision compared to direct variant calling in SRS samples. For instance, Huddleston et al. [18] used LRS to analyze SVs in two human genomes and found that 90% of these SVs were missing in the 1000 Genomes call set, yet 61% could still be genotyped using SRS. Recent population-scale studies have therefore adopted a combined approach of variant calling and genotyping: initially, variants are identified from a few LRS samples or numerous SRS samples, and then the identified SVs are merged and genotyped in a larger SRS cohort [19]. For instance, Kirsche et al. [20] used Paragraph [14] to genotype variants from 31 LRS samples in a cohort of 1.3k SRS samples from the 1000 Genome Project (1kGP) [21]. Similarly, Graphtyper2 was employed to build graphs from SVs detected in 50k Icelandic SRS samples [16] or 2k dog SRS samples [22], which were then re-genotyped using the same SRS samples to improve recall. With the same concept in mind, the Human Pangenome Reference Consortium (HPRC) [23] applied Pangenie to genotype the pangenome variants in 3.2k SRS samples from 1kGP [21]. Similarly, Goo Jun et al. [59] used MuCNV to jointly genotype TopMed SVs in 139k SRS samples. These genotypers enable large-scale population genotyping of gene catalogs, pangenomes, and candidate disease-associating variants. The current SV genotypers, while fast and scalable, face significant challenges at the population level. These genotypers require downloading and reprocessing all the raw SRS data to genotype even a single new variant, a demand that is increasingly impractical. This issue exemplifies a computational challenge known as the N+1 problem [67]. In today’s era of extensive sequencing, new lists of variants emerge daily, and a reliable estimation of their allele frequencies is important for interpretation. For instance, the number of pangenomes for humans [23, 24] as well as numerous other species [25, 26, 27, 28] is increasing. Similarly, databases like dbVar [29], genomeAD [60], TopMed [30], and ClinVar [31] are constantly expanding their variant collections. The N+1 challenge also affects disease gene discovery studies in probands [32]. LRS can produce phased, high-quality SVs, and identifying pathogenic variants involves filtering out common variants and focusing on rare ones. However, matching these variants in public databases poses challenges, and the reliability of allele frequencies in SV catalogs is dubious when calculated in small or distinct subpopulations or when using methods with low recall. Therefore, solving this computational bottleneck is crucial to optimize the usage of genomic data for advancing precision medicine and enhancing our understanding of genetic diversity. We therefore introduce “The Great Genotyper,” an alignment-free population genotyping pipeline for both structural and small variants. This pipeline can accurately genotype four thousand human WGS samples in just hours, bypassing the need for 183TB of raw sequence data. Instead, it utilizes an 867GB Counting Colored Debruijn Graph (CCDG), which is constructed once from the population’s raw sequences by extracting k-mers and their counts. The CCDG provides a viable solution to the N+1 problem as it can be reused to genotype any new variant list for this population. In addition, it utilizes population-derived information to improve the quality of genotyping, creating an imputation panel for SVs using a pangenome, and annotating SVs by their linkage to nearby GWAS SNPs. ## 3 Result ### 3.1 The Great Genotyper: A Workflow for Genotyping Small and Structural Variants in Thousands of Short-Read Samples The Great Genotyper solves the N+1 problem by deploying two independent workflows. The first is an indexing workflow that creates a CCDG using SRS to represent the population (Figure 1A). Once created, the CCDG can be reused by a population genotyping workflow (Figure 1B) to genotype a pangenome, phased variants, or unphased variants in the cohort of SRS samples. ![Figure 1:](http://medrxiv.org/https://www.medrxiv.org/content/medrxiv/early/2024/07/05/2024.07.04.24309921/F1.medium.gif) [Figure 1:](http://medrxiv.org/content/early/2024/07/05/2024.07.04.24309921/F1) Figure 1: The Great Genotyper workflows The indexing workflow (A) depicts the high-level pipeline for creating Population CCDGs. The workflow downloads and computes the unitigs of each sample individually (A1). A sourmash signature is calculated for each sample to be used for alignment-free quality control and sample partitioning (A2). Lastly, a subgraph is created for each partition of samples (A3). The genotyping workflow (B) describes three population genotyping workflows illustrated with a different color of arrows: The HMM workflow (red) genotypes and imputes phased variants using a high-quality HMM model, the k-mer-based workflow (green) rapidly genotypes unphased variants, and the two-pass workflow (blue) enhances the recall of the k-mer-based workflow by genotyping its output phased variants using the HMM workflow. For human populations, we download 4.2K high-coverage (30x) whole genome sequencing (WGS) samples from three projects: 1KGP [21], HGDP [33], and SGDP [34]. This data represents 140 populations worldwide (Figure 1A and Supplementary Figure 1). While CCDGs are much smaller than raw sequences, creating a single CCDG for thousands of samples would result in a complex and memory-intensive structure. Therefore, the indexing workflow partitions closely related samples into separate groups, creating individual CCDGs for each (Figure 1A.2). This workflow starts by downsampling raw sequences into representative summaries (i.e. FracMinHash sketches calculated by sourmash [66]. These sketches are used for quality control including estimate calculation of sequencing depth, genome coverage, possible contamination, and sex prediction [61]. For example, this analysis reveals samples with unexpectedly low coverage of the human genome as well as four discrepancies from the sex provided in the metadata (Supplementary Figures 2 and 3). After that, a pairwise comparison of sourmash signatures enables the creation of a dendrogram (Figure 1A.2). Based on this dendrogram, 29 partitions of closely related samples are identified (Figure 1A.3). Finally, Metagraph [62] is used to create a CCDG for each partition, resulting in individual files ranging from 16-68 GB with a total size of 867 GB. ![Figure 2:](http://medrxiv.org/https://www.medrxiv.org/content/medrxiv/early/2024/07/05/2024.07.04.24309921/F2.medium.gif) [Figure 2:](http://medrxiv.org/content/early/2024/07/05/2024.07.04.24309921/F2) Figure 2: The Great Genotyper provides unparalleled performance compared to the state of the art, with no compromise on accuracy. **Panel A** shows the running time and memory usage of different tools used to genotype 4.5 million phased variants (including structural variants and small variants). The Great Genotyper is currently genotyping 4,200 samples at 30x coverage, while the other genotypers are handling 10 to 100 samples. **Panel B1** illustrates the F-scores of different genotyping methods for different classes of variants. **Panel B2** illustrates the effect of coverage on the F-scores of different genotyping methods for small and structural variants. In both Panels B1 and B2, the variants are categorized based on the complexity of the genomic loci into variants located in repeated (shown as bars) and non-repeated regions (shown as circles) ![Figure 3:](http://medrxiv.org/https://www.medrxiv.org/content/medrxiv/early/2024/07/05/2024.07.04.24309921/F3.medium.gif) [Figure 3:](http://medrxiv.org/content/early/2024/07/05/2024.07.04.24309921/F3) Figure 3: Applications of The Great Genotyper: We used the Great Genotyper to genotype all ClinVar and HPRC pangenome variants in 4k human samples. **Panel A** is a box plot of the distinctive distributions of population allele frequencies for ClinVar variants when stratified by the pathogenicity of the variants (outliers are not displayed). **Panel B** is a plot of the first two principal components from a PCA for the genotypes of the HPRC pangenome variants; the 4k samples are colored by their ancestry. **Panel C** is an LD heatmap that highlights the associations of an insertion (dbSNP: rs148317511) and multiple GWAS SNPs including rs6050-C; a peak associating SNP in a GWAS study of the circulating fibrinogen. **Panel D** shows the precision and recall of small and structural variant imputation using the 4k reference panel in comparison to small variant imputation using the 1000 Genome panel and calling SVs using Manta. **Panel E** presents a Sankey plot summarizing 6.2K linkage associations between SVs from the HPRC pangenome and the GWAS catalog. The columns stratify linkages based on various traits of both SVs and GWAS: SV size, GWAS SNP impact on coding regions, SV impact on coding regions, and SV-induced frameshifts. Building upon the CCDGs created in the indexing workflow, the genotyping workflow (Figure 1B) empowers the analysis of any variant list across all samples without requiring raw reads or mapping. It begins with three key inputs: a list of pre-generated CCDGs, a reference genome and a variant list (phased or unphased). Depending on needs, three different workflows can be chosen: A) k-mer-based workflow: Efficiently genotypes unphased variants. B) Hidden Markov model (HMM) workflow: Handles both genotyping and imputation for phased variants. C) Two-pass workflow: Genotypes and imputes unphased variants, leveraging population information to determine their phase and impute missing data. Both the k-mer-based and HMM workflows start by extracting k-mers unique to the variant regions and querying their count data for all samples within the CCDGs (Figure 1B). The k-mer-based workflow determines initial genotypes by comparing the counts of unique k-mers to the average sample coverage for each sample. This identifies variants present in each sample without relying on phasing information. In contrast, the HMM workflow tackles phased variants by genotyping and imputing them using the Hidden Markov Model (HMM) implemented in Pangenie [17]. This enables the imputation of genotypes in regions with low coverage or complexity. Following initial genotyping, both workflows undergo a two-step refinement. The first step is to filter low-quality genotypes after comparing the genotype qualities for each variant across all samples. The second step utilizes Beagle [35, 36] to statistically impute low-confidence genotypes and phase the resulting variants. The third workflow is a pipeline to genotype and impute unphased variants. It starts by running the k-mer-based workflow to create a reference panel using the input variants and samples in the CCDGs. This reference panel is then used to phase the input variants. After that, the HMM workflow is employed on the phased variants to obtain more precise genotypes in indexed population. ### 3.2 Achieving Population Genotyping in a Matter of Hours with no Decrease in Accuracy The performance of the Great Genotyper was evaluated for the k-mer-based workflow (for unphased variants) and HMM workflow (for phased variants). The Great Genotyper could genotype 4.5 million variants across 4.2K WGS samples in approximately 100 hours, utilizing 32 cores and 145 GB of memory, as depicted in Figure 2A. To put this performance into context, Pangenie and GraphTyper2 required nearly an hour and 12 hours, respectively, to genotype the same 4.5 million variants in a single sample using the same machine. Extrapolating this duration, Pangenie would take approximately six months to complete genotyping of the same dataset, while GraphTyper2 needs six years to finish. This underscores the efficiency of the Great Genotyper in both operational modes. For benchmarking of precision and recall of the Great Genotyper with other state-of-the-art genotypers, we genotyped SVs and small variants derived from the NA12878 haploid-resolved assemblies using the 30x SRS of HG00731 (See Methods and Supplementary Figure 4 for the design of benchmarking and Figure 2 for the detailed results). The Great Genotyper’s HMM and Pangenie exhibit superior F-scores for phased SVs, achieving 0.91 in non-repetitive regions. Paragraph and the k-mer-based workflow follow closely with F-scores of 0.88 and 0.87 for unphased SVs. Intriguingly, the two-pass workflow accurately predicts the phasing information, boosting the F-score back to 0.91. In contrast, Graphtyper trails with an F-score of 0.80. The challenges increase in repetitive regions, where variability in results is more pronounced. Here, Pangenie and the HMM workflow score 0.63 and 0.61, respectively, followed by Paragraph and the k-mer-based workflow at 0.55. However, the two-pass workflow enhances the k-mer-based approach’s F-score to 0.6, while Graphtyper lags with an F-score of 0.48. For small variants, GATK leads, achieving F-scores of 0.97 and 0.70 in non-repetitive and repetitive regions, respectively. The Great Genotyper’s HMM and Pangenie are close behind with F-scores of 0.95 in non-repetitive areas. The k-mer-based workflow scores 0.93, improving slightly to 0.94 with the two-pass workflow. In repetitive regions, Pangenie matches GATK’s 0.70 F-score, while the HMM workflow slightly trails at 0.69. The k-mer-based workflow struggles in these regions and scores 0.6 but is improved to 0.65 by the two-pass workflow. Overall, the Great Genotyper consistently demonstrates competitive genotyping accuracy compared to Pangenie across most scenarios, and it represents the most accurate option for genotyping unphased SVs with the two-pass workflow. Sequencing depth impacts the genotyping accuracy, as depicted in Figure 2B2. Notably, all genotypers exhibit reduced accuracy at sequencing depths of 10x and 5x. Genotypers that incorporate phasing information, such as The Great Genotyper’s HMM and two-pass workflows, as well as Pangenie, show the smallest decrease in accuracy. For instance, the accuracy of SV genotyping by The Great Genotyper’s HMM and Pangenie at 5x coverage drops by 8% and 9% in non-repetitive regions, and 7% and 5% in repetitive regions, respectively. The k-mer-based workflow experiences a decrease of 14% and 9%, which the two-pass model returns to 7% and 5% in non-repetitive and repetitive regions, respectively. Last, Graphtyper’s accuracy diminishes by 12% and 22% in non-repetitive and repetitive regions, respectively. The reduction in sequencing depth from 30x to 5x similarly affects the accuracy of small variant genotyping in both non-repetitive and repetitive regions. Pangenie exhibits the smallest accuracy decline, by 7% and 5%, followed by The Great Genotyper’s HMM with 11% and 7%, and GATK with 8% and 17%. The k-mer-only model suffers a significant drop of 22% and 11%, but this is mitigated by the two-pass model to 10% and 7% in non-repetitive and repetitive regions, respectively. ### 3.3 Facilitating Population Studies for Small and Structural Variants #### 3.3.1 The Great Genotyper can help to find pathogenic variants Filtering common variants is a widely used strategy in disease association studies. ClinVar, a public database, catalogs genomic variations in humans and their impact on health [31]. As a proof of concept, the k-mer-based workflow is applied to genotype the ClinVar database variants in the 4k samples of the CCDG index. Consistent with expectations, almost all pathogenic variants exhibit zero allele frequency in this healthy population, whereas benign variants display a broader range of frequencies (Figure 3A). This demonstrates that calculating allele frequencies for a list of suspected variants in this indexed cohort is a reliable metric for prioritizing rare variants in studies of their pathogenic potential. #### 3.3.2 Generation of 4k reference panel by Genotyping HPRC Variants in 4K Samples The current HPRC pangenome comprises 88 haplotypes (Citation). As previously described [23], decomposing the pangenome yields a phased VCF containing 26.8 M variants (See Supplementary Table 1 for the summary count per variant type). The HMM workflow is used to genotype these variants in the prebuilt CCDG. The resulting output is a phased VCF of the HPRC variants in the indexed 4K samples, creating a new 4K reference panel. Principal Component Analysis (PCA) on the genetic variation within this 4k reference panel confirms the expected distribution of populations studied in the 1kGP, paving the way to generate cost-efficient similar panels for several other species (Figure 3B). Subsequent sections will explore how this panel can facilitate various genomic applications. #### 3.3.3 Impute SV by using the 4k reference panel Genotype imputation is a statistical method that predicts unobserved genotypes using reference sequences, thereby enhancing the density and scope of genetic analyses at reduced costs. This technique is especially valuable in increasing the power and consistency of genetic studies, including genome-wide association studies (GWAS) and fine-mapping efforts [37]. The 4k reference panel may replace the panel generated by the 1kGP project [21] while enabling the imputation of structural variants (SVs). In this section, we demonstrate the precision and recall of imputing both small and structural variants using the 4k reference panel. Initially, pseudo-microarray variant calls are generated using the HG002 sample from the Genome in a Bottle (GIAB) project [38] by extracting variants at sites used in the Illumina Infinium OmniExpress-24, simulating microarray genotyping. The 4k reference panel is then employed to impute both small and structural variants. For benchmarking purposes, the 1kGP reference panel is used exclusively for imputing small variants, with no similar panel available for SVs. Instead, SV calling from 30x SRS using Manta serves as an alternative. The output VCFs are compared against gold standard GIAB datasets using hap.py (v0.3.12) [39] for small variants, and truvari (v3.5.0) [63] for SVs. The 4k reference panel exhibits commendable precision and recall for the imputation of both types of variants, as depicted in figure 3D. When compared to the 1kG reference panel, it displayed some reduced precision compensated by an increase in recall for SNPs and indel imputation. Conversely, the 4k reference panel shows remarkable results in imputing common SVs, achieving an impressive recall of 86%. This imputation recall surpasses the recall of SV calling from 30x SRS using Manta. These results highlight how the 4k reference panel can be leveraged to augment microarray genotypes with common SVs. #### 3.3.4 Fine Mapping of GWAS SNPS using SVs from the 4k reference panel The 4k reference panel provides detailed insights into the structure of common haplotypes composed of small and structural variants. In particular, it allows the exploration of linkage disequilibrium (LD) between SVs and neigh-boring variants known to be associated with phenotypic changes. We initiate our investigation by annotating the SVs in the 4k reference panel using AnnotSV (v3.3.6) [40]. This reveals that approximately 463K SVs affect gene structures. Proceeding further, we compute the pairwise LD for each of these variants with all the variants located within a 1MB window surrounding them. Our analysis indicates that 91K SVs exhibit a strong association with a neighboring variant, having an r2 value greater than 0.8. We utilize the identified associations to illuminate potential causal variants in GWAS studies. Among the 91K SVs, 3,744 are found in strong linkage with GWAS SNPs. We compiled a table that includes these SVs, their annotations, associated GWAS SNPs, and other relevant metadata (see the ‘Data and Code Availability’ section). This table should be a valuable resource elucidating the phenotypic effects of common SVs and help pinpoint some causal variants of the traits examined in these GWAS studies. Figure 3E summarizes of the associations found in the table. Notably, 722 of these SVs impact the coding regions of genes, with 415 causing frameshift mutations. We explore a specific example from our list in figure 3C, focusing on the Human fibrinogen locus on chromosome 4. This 50-kilobase region includes three fibrinogen genes: the central FGA gene encodes the alpha chain, flanked by FGB and FGG encoding the beta and gamma chains, respectively [41]. Our reference panel shows an insertion of 28 bp at chr4:154584089 (dbSNP: rs148317511; ClinVar: RCV000247066) in a high linkage (r2=0.98) with rs6050-C; a missense mutation in FGA associating with venous thromboembolism [42, 43, 44, 45, 44] and chronic thromboembolic pulmonary hypertension [45, 46]. The insertion is reported in ClinVar as a benign variant. Surprisingly, further digging in the literature shows that the variant was once known as the Taq I polymorphism because it created an additional restriction site for Taq I [47]. The allele was found to enhance the stability of FGA mRNA in vitro [43]. This was explained by the ability of the insertion to oppose the suppressive effect of has-miR-759 on the 3 UTR of FGA [46]. These findings suggest that the ClinVar information on the variant should be revised. Interestingly, our panel is able to capture the haplotype structure of the fibrinogen locus and shows how the 28bp insertion fits in. For example, rs6050 is known to be in high linkage with rs7681423; SNP upstream to FGG and a peak of association with *γ**′* Fibrinogen. Both SNPs are known to have no significant association with total fibrinogen levels and no linkage with rs1800789; SNP in FGB shows the strongest association with total fibrinogen level, but not with *γ**′* fibrinogen [48]. The panel confirms these relationships between the three SNPs and shows that the insertion allele has some linkages (r2=76) to rs7681423 and no linkage to rs1800789. Also, the panel shows a unique haplotype (r2=96) of the insertion and rs2070011-A; an allele of CFA’s promoter causing higher expression of the gene. This haplotype is different from the haplotype of rs6050 and rs7681423. ## 4 Discussion The Great Genotyper serves as a practical solution for population genotyping at massive scales. It provides the ability to genotype a new set of variants, whether small or structural, in thousands of SRS samples in just a matter of hours. More importantly, it provides a novel solution for the chronic N+l problem by eliminating the need to download and process terabytes of raw sequencing data. Instead, the Great Genotyper operates using a prebuilt CCDG, effectively decoupling intensive data preprocessing from the actual genotyping process. In terms of input, the Great Genotyper is versatile; it accepts any set of phased or unphased variants, along with the reference genome. The outcome is the phased genotypes of all input variants in the indexed samples. In this manuscript, 183 TB of SRA files for 4K human SRS samples are indexed to generate an 867 GB CCDG to enable unprecedented efficiency in calculating allele frequencies of any list variants in the human population. As a proof of concept, the index is used to genotype the HPRC pangenome variants as an example for phased variants as well as genotyping all unphased ClinVar variants. The Great Genotyper does not sacrifice quality for scalability. On the contrary, the scalability empowers the Great Genotyper to jointly genotype thousands of samples, which, in turn, enhances the genotyping quality even more. K-mer-based genotypers such as Nebula and Pangenie have previously demonstrated the potential of k-mers for precise genotyping. They leverage the specificity of variant-specific k-mers, using shifts in the counts of these k-mers as indicators to genotype the variants. The Great Genotyper reinforces this approach, considering the counts of these k-mers across an entire population of samples. This innovation facilitates the calculation of a confidence measure for each genotype based on the collective population data. Furthermore, the tool is equipped to impute missed genotypes through a two-tiered approach. Initially, imputation is rooted in the phasing information of the variants, either provided as input or derived from the large cohort genotypes. Subsequently, the Great Genotyper integrates Beagle, leveraging the high-confidence genotypes within the population to further impute genotypes. This dual-phase imputation process ensures that the Great Genotyper can deliver performance on par with Pangenie, even if some data is compromised during the k-mer count preprocessing while indexing to enable better data compression as described in Supplementary Figure 7. The enhanced accuracy and scalability of the Great Genotyper paves the way for valuable downstream applications in genomics. For instance, accurate allele frequencies can now be directly derived from sequences rather than merging information from sparse studies or variation databases that rely on variant calling in SRS studies. Such accurate determination of allele frequencies can play a pivotal role in pinpointing causal variants in disease-gene discovery studies. Furthermore, simultaneous genotyping and phasing of common variants enables dramatically improved resolution for understanding the haplotype structure within and across populations. As an example, genotyping the HPRC pangenome variants in 4k samples produces what we call “the 4k reference panel (4kRP)”. We show how the 4kRP can be used to impute common SVs with a recall rate that surpasses some short-read callers like Manta. Taking our analysis further, we explore the 4kRP for SVs in high LD with known GWAS SNPs. We limit our focus to 91K SV variants impacting gene structures. Intriguingly, we discover that approximately half of these SVs exhibit strong associations with at least one GWAS SNP. We are optimistic that our findings will contribute to a deeper comprehension of the relationship between genotype and phenotype concerning these structural variants. Although the Great Genotyper is effective in generating high-quality genotypes for both small and structural variants, it does have certain limitations. First, some variants cannot produce specific k-mers because the k-mers from the alternate sequences may also be present in other parts of the genome. Such variants cannot be genotyped precisely by k-mer-based approaches. This limitation, however, is partially offset through imputation. Furthermore, genotyping copy number variants is beyond the capabilities of the current version of the Great Genotyper. While it is not an insurmountable challenge, it requires development of a dedicated genotyping model. Another constraint is that the Great Genotyper utilizes two separate imputation models, as they are implemented in two distinct tools, Pangenie and Beagle. A unified model tailored specifically for imputing genotypes using the k-mers in the CCDG could both enhance the accuracy as well as boost performance. The Great Genotyper opens many doors for future genomic applications. Creating more CCDGs to represent specific subpopulations or individuals exhibiting specific traits, like autism, is crucial for understanding the role of genomics in these cohorts. Moreover, while most population studies have been conducted on humans [49], this approach is applicable to man y other organisms. The Sequence Read Archive (SRA) [50] is a vast reservoir of short-read samples for non-human organisms. Generating CCDGs for these samples will facilitate population-scale studies for other species. The current CCDG for the human population, and the additional CCDGs to be created for other cohorts, are invaluable resources with potential applications that extend beyond genotyping. For instance, variants can be directly called from the graph using methods such as Corticall [51]. Additionally, it can aid in subsetting pangenomes by selecting segments of the pangenome that have k-mers present in a specific population, thereby creating a more streamlined pangenome tailored to that population. We encourage the community to explore and uncover more ways to harness the extensive genomic diversity revealed by the CCDG. ## 5 Conclusion The Great Genotyper can transform population genotyping into a routine task using a flexible CCDG representation of populations. Its scalability allows the improvement of genotyping quality by using population information. The tool’s practicality aids in expanding variant lists into broader dimensions, revealing complex genomic details. We demonstrate its potential in applications such as creating SV imputation panels, finding SV associations with variants from databases like the GWAS catalog, and accurately calculating population allele frequencies. The CCDG, comprising 4,000 human samples, contains a vast genomic variation spectrum, accessible through The Great Genotyper or other methods, leading to enhanced genomic insights. Producing more CCDGs for additional cohorts or species will further optimize the use of existing SRS samples. ## 6 Data and Code Availability The code for The Great Genotyper is publicly available on GitHub at the following URL: [https://github.com/dib-lab/TheGreatGenotyper](https://github.com/dib-lab/TheGreatGenotyper). The benchmarking code used in our study can also be found on GitHub at this URL: [https://github.com/dib-lab/TheGreatGenotyper\_benchmark](https://github.com/dib-lab/TheGreatGenotyper\_benchmark). The indexes used in our project are hosted on our server and can be accessed at this URL: [https://farm.cse.ucdavis.edu/∼tahmed/GG\_index/](https://farm.cse.ucdavis.edu/%E2%88%BCtahmed/GG\_index/). We have also provided several use cases which can be found at this URL: [https://github.com/dib-lab/TheGreatGenotyper\_usecases](https://github.com/dib-lab/TheGreatGenotyper\_usecases). The genotyped pangenomes are available at this URL: [https://farm.cse.ucdavis.edu/∼mshokrof/4k\_reference\_panel/](https://farm.cse.ucdavis.edu/%E2%88%BCmshokrof/4k\_reference\_panel/). The LD list and the GWAS SV Associations can be found at this URL: [https://farm.cse.ucdavis.edu/∼mshokrof/GWAS\_associations/](https://farm.cse.ucdavis.edu/%E2%88%BCmshokrof/GWAS\_associations/). Lastly, the ClinVar genotyped data can be accessed at this URL: [https://farm.cse.ucdavis.edu/∼mshokrof/The\_great\_genotyper\_clinvar/](https://farm.cse.ucdavis.edu/%E2%88%BCmshokrof/The_great_genotyper_clinvar/). ## 7 Methods ### 7.1 Short Read Samples Preprocessing and Clustering Upon the download of each sample, kmc [52] was used for k-mer counting with a minimum count of 3 to filter out singletons and doubletons, which are likely sequencing errors. In addition, Metagraph [62] was utilized to identify the unitigs and retain only the average k-mer count per unitig, thus smoothing k-mer counts. This smoothing reduced the size of the k-mer counts to one-tenth while maintaining high genotyping accuracy (see below). Subsequently, alignment-free quality control was done using Snipe [61]. In brief, a sourmash sketch was created for each sample using a k size of 51 and a subsampling scale of 10k, which entails keeping a single hash for every 10,000 k-mers. A similar sketch at the same scale was created for the GRCh38 reference genome. Intersection of both signatures enabled approximate estimation of the genome coverage and sequencing depth as well as sex confirmation (Supplementary Figures 2 and 3). Subsequently, kSpider [64] calculated pairwise similarities between all samples based on their sourmash sketches. To alleviate skew from the sex chromosomes, the sketch of chrY was subtracted from all samples. Hierarchical clustering was employed using the Scipy library [65] to construct a dendrogram visualized in Supplementary Figure 6 by iTOL [53]. From the dendrogram, twenty-nine clusters were extracted and subsequently refined manually to ensure each encompasses between 100-350 samples. ### 7.2 Determining The Best Indexing Parameters We investigated the influence of sample preprocessing on genotyping accuracy to determine the best parameters for optimal results. Multiple CCDGs were generated from sub-samples of the HG00731 SRS at sequencing depths of 5x, 10x, 20x, and 30x. Each CCDG was constructed using a different set of parameters, which are summarized in Supplementary Table 2, along with the final sizes of the CCDGs. Benchmarking was done as described in Supplementary Figure 4 and later in the methods. Results in Supplementary Figure 7 and Table 2 indicate that preprocessing methods do not impact samples with coverage exceeding 20x. For coverages of 10x and 5x, logging the counts is the most influential, significantly decreasing both the F-score and the final CCDG size. On the other hand, smoothing leads to a nominal drop in the F-score but notably reduces the CCDG size. Cleaning had a moderate impact on the F-score and caused a slight reduction in the CCDG size. These findings are instrumental in guiding our final decision to use smoothing of k-mer counts as the only preprocessing for input samples. ### 7.3 Genotyping Workflow The Great Genotyper adopts the genotyping model from Pangenie [17] to implement two genotyping workflows; one for genotyping unphased variants using k-mer counts, and another for genotyping and imputing phased variants using k-mer counts and phasing information. For the phased variants, the Great Genotyper employs the Pangenine HMM model, which is based on the Li-Stephen model [54]. For the unphased variants, we rely solely on emission probabilities to determine the most probable genotype for each variant. The genotyping models yield a confidence measure for the output genotypes, deducing the likelihoods of all possible genotypes and selecting the one with the highest probability. The confidence level is derived from the difference between the highest probability and the other probabilities. Therefore, a larger difference correlates to higher confidence. The components driving these confidence probabilities can primarily be distilled into two factors: the number of unique k-mers discovered for each variant haplotype and the count of these k-mers in the sample. The first factor is a constant across all samples since it is determined only from the reference genome and the variant to be genotyped. However, the second factor varies per sample. Some samples may present robust evidence for a particular genotype, while others may not due to either low coverage of the region in the sample or the exhibition of a different haplotype not present in the input haplotypes. The Great Genotyper leverages the power of having a large population in the CCDGS to filter low-quality genotypes. In this step, the median of genotype confidences is calculated for each genotype then the genotypes falling below this median are discarded. This approach allows the Great Genotyper to establish a variable threshold calculated using the results from all the samples, providing a balanced way to sift through the variants. For variants abundant in unique k-mers, this threshold will be high, while more challenging variants will have a lower threshold, accommodating the varying levels of confidence in different scenarios. The final output of this step is a reference panel comprised of the high-confidence genotypes. Finally, Beagle [35, 36] is employed to statistically impute the filtered, low confidence genotypes using this reference panel, simultaneously phasing the resultant variants, thereby yielding phased genotypes for all samples. It is crucial to note that Beagle employs a different HMM model, albeit very similar to the one used in the HMM workflow. In Beagle, linkage disequilibrium is computed statistically from the high-confidence genotypes within the created reference panel. In contrast, the model in the HMM workflow utilizes the phasing information provided by the user in the input variants. The synergy between these two imputation methods does not only enhance the results of genotyping but also broadens the application scope for the higher quality HMM model, enabling its usage when phasing information is absent in the input VCF, as described in the two-pass workflow in Figure 1B. ### 7.4 Benchmark Experiment Design This section outlines the experimental design for the benchmarking experiments conducted to compare the accuracy of The Great Genotyper with the state-of-the-art genotyping tools: Pangenie, GraphTyper2, Paragraph, and GATK as described previously [17]. This experiment is structured into two components. The first component involves creating a truth variant set and a query variant set. The truth set comprised of small and structural variants is created by aligning each haplotype-resolved assembly of HG00731 against the reference genome using minimap2 [55] and identifying the variants using PAV tools [56]. The resulting two VCFs are merged using bcftools [57]. The analysis is confined to a confidence region on the reference genome, ensuring that only one segment from the assembly maps to it to avert the regions difficult to assemble. Variants within this confidence region are deemed suitable to represent the full truth in these regions. Similarly, the query VCF is created from the haplotype-resolved assemblies of NA12878 downloaded from GIAB [58]. The shared variants between the truth and query sets are categorized as true positives while those found only in the query set as true negatives. The second component is running the genotypers and benchmarking them. Subsequently, different genotypers are executed on the query variants obtained from NA12878 and the SRS from the HG00731 sample. The genotyping results are then compared against the truth set. The benchmarking outcomes are stratified based on whether the variant is located in a repeat region or not and are also classified by type and size: SNP, Indel(*<* 50bp), Insertions/deletions(*>* 50bp), and complex Insertions/Deletions, where “complex” denotes that the variation generates more than one breakpoint. ## Supporting information Supplementary Materials [[supplements/309921_file02.docx]](pending:yes) ## Data Availability All data produced in the present work are contained in the manuscript ## 8 Author Contributions M.S. and T.M. conceptualized the study, interpreted the results, and wrote the main draft. M.S. was responsible for the implementation of the software. T.M. supervised the work and participated in the data analysis. M.A. contributed to the experiment on reference-free QC. T.B. provided valuable feedback on the study design and reviewed the manuscript. * Received July 4, 2024. * Revision received July 4, 2024. * Accepted July 5, 2024. * © 2024, Posted by Cold Spring Harbor Laboratory This pre-print is available under a Creative Commons License (Attribution-NonCommercial-NoDerivs 4.0 International), CC BY-NC-ND 4.0, as described at [http://creativecommons.org/licenses/by-nc-nd/4.0/](http://creativecommons.org/licenses/by-nc-nd/4.0/) ## References 1. [1].Lewin, H. A. et al. Earth BioGenome Project: Sequencing life for the future of life 115, 4325–4333. URL doi:10.1073/pnas.1720115115. [Abstract/FREE Full Text](http://medrxiv.org/lookup/ijlink/YTozOntzOjQ6InBhdGgiO3M6MTQ6Ii9sb29rdXAvaWpsaW5rIjtzOjU6InF1ZXJ5IjthOjQ6e3M6ODoibGlua1R5cGUiO3M6NDoiQUJTVCI7czoxMToiam91cm5hbENvZGUiO3M6NDoicG5hcyI7czo1OiJyZXNpZCI7czoxMToiMTE1LzE3LzQzMjUiO3M6NDoiYXRvbSI7czo1MDoiL21lZHJ4aXYvZWFybHkvMjAyNC8wNy8wNS8yMDI0LjA3LjA0LjI0MzA5OTIxLmF0b20iO31zOjg6ImZyYWdtZW50IjtzOjA6IiI7fQ==) 2. [2].Koepfli, K.-P. & Paten, B. The Genome 10K Project: A Way Forward 3, 57–111. URL doi:10.1146/annurev-animal-090414-014900.25689317. [CrossRef](http://medrxiv.org/lookup/external-ref?access_num=10.1146/annurev-animal-090414-014900.25689317&link_type=DOI) 3. [3].Quan, C. et al. Characterization of structural variation in Tibetans reveals new evidence of high-altitude adaptation and introgression 22, 159. URL doi:10.1186/s13059-021-02382-3. [CrossRef](http://medrxiv.org/lookup/external-ref?access_num=10.1186/s13059-021-02382-3&link_type=DOI) 4. [4].Fujinami, K. et al. Detailed genetic characteristics of an international large cohort of patients with Stargardt disease: ProgStar study report 8 103, 390–397. 29925512. 5. [5].Mostafavi, H. et al. Identifying genetic variants that affect viability in large cohorts 15, e2002458. URL [https://journals.plos.org/plosbiology/article?id=10.1371/journal.pbio.2002458](https://journals.plos.org/plosbiology/article?id=10.1371/journal.pbio.2002458). 6. [6].Pang, A. W. et al. Towards a comprehensive structural variation map of an individual human genome 11, R52. URL doi:10.1186/gb-2010-11-5-r52. [CrossRef](http://medrxiv.org/lookup/external-ref?access_num=10.1186/gb-2010-11-5-r52&link_type=DOI) [PubMed](http://medrxiv.org/lookup/external-ref?access_num=20482838&link_type=MED&atom=%2Fmedrxiv%2Fearly%2F2024%2F07%2F05%2F2024.07.04.24309921.atom) 7. [7].Chiang, C. et al. The impact of structural variation on human gene expression 49, 692–699. URL [https://www.nature.com/articles/ng.3834](https://www.nature.com/articles/ng.3834). 8. [8].Mahmoud, M. et al. Structural variant calling: The long and the short of it 20, 246. URL [https://genomebiology.biomedcentral.com/articles/10.1186/s13059-019-1828-7](https://genomebiology.biomedcentral.com/articles/10.1186/s13059-019-1828-7). 9. [9].Sedlazeck, F. J. et al. Accurate detection of complex structural variations using single-molecule sequencing 15, 461–468. URL [https://pmc/articles/PMC5990442/?report=abstract](https://pmc/articles/PMC5990442/?report=abstract). 29713083. 10. [10].Cleal, K. & Baird, D. M. Dysgu: Efficient structural variant calling using short or long reads 50, e53. URL [https://www.ncbi.nlm.nih.gov/pmc/articles/PMC9122538/](https://www.ncbi.nlm.nih.gov/pmc/articles/PMC9122538/). 35100420. 11. [11].Mahmoud, M., Doddapaneni, H., Timp, W. & Sedlazeck, F. J. PRINCESS: Comprehensive detection of haplotype resolved SNVs, SVs, and methylation 22, 268. URL doi:10.1186/s13059-021-02486-w. [CrossRef](http://medrxiv.org/lookup/external-ref?access_num=10.1186/s13059-021-02486-w&link_type=DOI) 12. [12].Cheng, H., Concepcion, G. T., Feng, X., Zhang, H. & Li, H. Haplotype-resolved de novo assembly using phased assembly graphs with hifiasm 18, 170–175. URL [https://www.nature.com/articles/s41592-020-01056-5](https://www.nature.com/articles/s41592-020-01056-5). 13. [13].Khorsand, P. & Hormozdiari, F. Nebula: Ultra-efficient mapping-free structural variant genotyper 49, e47. URL doi:10.1093/nar/gkab025. [CrossRef](http://medrxiv.org/lookup/external-ref?access_num=10.1093/nar/gkab025&link_type=DOI) 14. [14].Chen, S. et al. Paragraph: A graph-based structural variant genotyper for short-read sequence data 20. 31856913. 15. [15].Jun, G. et al. muCNV: Genotyping structural variants for population-level sequencing 37, 2055–2057. URL doi:10.1093/bioinformatics/btab199. [CrossRef](http://medrxiv.org/lookup/external-ref?access_num=10.1093/bioinformatics/btab199&link_type=DOI) 16. [16].Eggertsson, H. P. et al. GraphTyper2 enables population-scale genotyping of structural variation using pangenome graphs 10, 1–8. URL doi:10.1038/s41467-019-13341-9.31776332. [CrossRef](http://medrxiv.org/lookup/external-ref?access_num=10.1038/s41467-019-13341-9.31776332&link_type=DOI) 17. [17].Ebler, J. et al. Pangenome-based genome inference allows efficient and accurate genotyping across a wide spectrum of variant classes 54, 518–525. URL [https://www.nature.com/articles/s41588-022-01043-w](https://www.nature.com/articles/s41588-022-01043-w). 18. [18].Huddleston, J. et al. Discovery and genotyping of structural variation from long-read haploid genome sequence data 27, 677–685. URL [https://genome.cshlp.org/content/27/5/677](https://genome.cshlp.org/content/27/5/677). 27895111. 19. [19].Quan, C., Lu, H., Lu, Y. & Zhou, G. Population-scale genotyping of structural variation in the era of long-read sequencing 20, 2639–2647. URL [https://www.sciencedirect.com/science/article/pii/S2001037022002033](https://www.sciencedirect.com/science/article/pii/S2001037022002033). 20. [20].Kirsche, M. et al. Jasmine and Iris: Population-scale structural variant comparison and analysis 20, 408–417. URL [https://www.nature.com/articles/s41592-022-01753-3](https://www.nature.com/articles/s41592-022-01753-3). 21. [21].1000 Genomes Project Consortium et al. A global reference for human genetic variation 526, 68–74. 26432245. 22. [22].Meadows, J. R. S. et al. Genome sequencing of 2000 canids by the Dog10K consortium advances the understanding of demography, genome function and architecture 24, 187. URL doi:10.1186/s13059-023-03023-7. [CrossRef](http://medrxiv.org/lookup/external-ref?access_num=10.1186/s13059-023-03023-7&link_type=DOI) 23. [23].Liao, W.-W. et al. A draft human pangenome reference 617, 312–324. URL [https://www.nature.com/articles/s41586-023-05896-x](https://www.nature.com/articles/s41586-023-05896-x). 24. [24].Gao, Y. et al. A pangenome reference of 36 Chinese populations 619, 112–121. URL [https://www.nature.com/articles/s41586-023-06173-7](https://www.nature.com/articles/s41586-023-06173-7). 25. [25].Dai, X. et al. A Chinese indicine pangenome reveals a wealth of novel structural variants introgressed from other Bos species 33, 1284–1298. URL [https://genome.cshlp.org/content/33/8/1284](https://genome.cshlp.org/content/33/8/1284). 37714713. 26. [26].Zhou, Y. et al. Assembly of a pangenome for global cattle reveals missing sequences and novel structural variations, providing new insights into their diversity and evolutionary history 32, 1585–1601. URL [https://genome.cshlp.org/content/32/8/1585](https://genome.cshlp.org/content/32/8/1585). 35977842. 27. [27].Li, R. et al. A sheep pangenome reveals the spectrum of structural variations and their effects on tail phenotypes 33, 463–477. URL [https://genome.cshlp.org/content/33/3/463](https://genome.cshlp.org/content/33/3/463). 37310928. 28. [28].Huang, Y. et al. Pangenome analysis provides insight into the evolution of the orange subfamily and a key gene for citric acid accumulation in citrus fruits 1–12. URL [https://www.nature.com/articles/s41588-023-01516-6](https://www.nature.com/articles/s41588-023-01516-6). 29. [29].Lappalainen, I. et al. DbVar and DGVa: Public archives for genomic structural variation 41. 30. [30].Taliun, D. et al. Sequencing of 53,831 diverse genomes from the NHLBI TOPMed Program 590, 290–299. URL [https://www.nature.com/articles/s41586-021-03205-y](https://www.nature.com/articles/s41586-021-03205-y). 31. [31].Landrum, M. J. et al. ClinVar: Public archive of relationships among sequence variation and human phenotype 42, D980–D985. URL [https://www.ncbi.nlm.nih.gov/pmc/articles/PMC3965032/](https://www.ncbi.nlm.nih.gov/pmc/articles/PMC3965032/). 24234437. 32. [32].Mastrorosa, F. K., Miller, D. E. & Eichler, E. E. Applications of long-read sequencing to Mendelian genetics 15, 42. URL doi:10.1186/s13073-023-01194-3. [CrossRef](http://medrxiv.org/lookup/external-ref?access_num=10.1186/s13073-023-01194-3&link_type=DOI) 33. [33].Bergström, A. et al. Insights into human genetic variation and population history from 929 diverse genomes 367, eaay5012. URL [https://www.science.org/doi/10.1126/science.aay5012](https://www.science.org/doi/10.1126/science.aay5012). 34. [34].Mallick, S. et al. The Simons Genome Diversity Project: 300 genomes from 142 diverse populations 538, 201–206. URL [https://www.nature.com/articles/nature18964](https://www.nature.com/articles/nature18964). 35. [35].Browning, B. L., Zhou, Y. & Browning, S. R. A One-Penny Imputed Genome from Next-Generation Reference Panels 103, 338–348. URL [https://www.cell.com/ajhg/abstract/S0002-9297(18)30242-8](https://www.cell.com/ajhg/abstract/S0002-9297(18)30242-8). 30100085. 36. [36].Browning, B. L., Tian, X., Zhou, Y. & Browning, S. R. Fast two-stage phasing of large-scale sequence data 108, 1880–1890. URL [https://www.cell.com/ajhg/abstract/S0002-9297(21)00304-9](https://www.cell.com/ajhg/abstract/S0002-9297(21)00304-9). 34478634. 37. [37].Wang, Q. S. & Huang, H. Methods for statistical fine-mapping and their applications to auto-immune diseases 44, 101–113. URL [https://www.ncbi.nlm.nih.gov/pmc/articles/PMC8837575/](https://www.ncbi.nlm.nih.gov/pmc/articles/PMC8837575/). 35041074. 38. [38].Zook, J. M. et al. A robust benchmark for detection of germline large deletions and insertions 38, 1347–1355. URL [https://www.nature.com/articles/s41587-020-0538-8](https://www.nature.com/articles/s41587-020-0538-8). 39. [39].Krusche, P. et al. Best practices for benchmarking germline small-variant calls in human genomes 37, 555–560. URL [https://www.nature.com/articles/s41587-019-0054-x](https://www.nature.com/articles/s41587-019-0054-x). 40. [40].Geoffroy, V. et al. AnnotSV: An integrated tool for structural variations annotation 34, 3572–3574. URL doi:10.1093/bioinformatics/bty304. [CrossRef](http://medrxiv.org/lookup/external-ref?access_num=10.1093/bioinformatics/bty304&link_type=DOI) 41. [41].Kant, J. A. et al. Evolution and organization of the fibrinogen locus on chromosome 4: Gene duplication accompanied by transposition and inversion 82, 2344–2348. 2986113. 42. [42].Carter, A. M. et al. Alpha-fibrinogen Thr312Ala polymorphism and venous thromboembolism 96, 1177–1179. 10910940. 43. [43].Ko, Y.-L. et al. Functional polymorphisms of FGA, encoding alpha fibrinogen, are associated with susceptibility to venous thromboembolism in a Taiwanese population 119, 84–91. 16362348. 44. [44].Rasmussen-Torvik, L. J. et al. The association of alpha-fibrinogen Thr312Ala polymorphism and venous thromboembolism in the LITE study 121, 1–7. 17433418. 45. [45].Le Gal, G. et al. Fibrinogen Aalpha-Thr312Ala and factor XIII-A Val34Leu polymorphisms in idiopathic venous thromboembolism 121, 333–338. 17568659. 46. [46].Chen, Z. et al. Susceptibility to chronic thromboembolic pulmonary hypertension may be conferred by miR-759 via its targeted interaction with polymorphic fibrinogen alpha gene 128, 443–452. 20677013. 47. [47].Remijn, J. A., van Wijk, R., de Groot, P. G. & van Solinge, W. W. Nature of the fibrinogen aα gene taqi polymorphism. Thrombosis and Haemostasis 86, 935 –936 (2001). URL [https://api.semanticscholar.org/CorpusID:257235398](https://api.semanticscholar.org/CorpusID:257235398). [PubMed](http://medrxiv.org/lookup/external-ref?access_num=11583334&link_type=MED&atom=%2Fmedrxiv%2Fearly%2F2024%2F07%2F05%2F2024.07.04.24309921.atom) 48. [48].Lovely, R. S. et al. Assessment of genetic determinants of the association of γ′ fibrinogen in relation to cardiovascular disease 31, 2345–2352. 21757653. 49. [49].Pokrovac, I. & Pezer, Z. Recent advances and current challenges in population genomics of structural variation in animals and plants 13. URL [https://www.frontiersin.org/articles/10.3389/fgene.2022.1060898](https://www.frontiersin.org/articles/10.3389/fgene.2022.1060898). 50. [50].Leinonen, R., Sugawara, H. & Shumway, M. The Sequence Read Archive 39, D19–D21. URL [https://www.ncbi.nlm.nih.gov/pmc/articles/PMC3013647/](https://www.ncbi.nlm.nih.gov/pmc/articles/PMC3013647/). 21062823. 51. [51].Garimella, K. V. et al. Detection of simple and complex de novo mutations with multiple reference sequences 30, 1154–1169. URL [https://genome.cshlp.org/content/30/8/1154.full](https://genome.cshlp.org/content/30/8/1154.full). 32817236. 52. [52].Kokot, M., Dlugosz, M. & Deorowicz, S. KMC 3: Counting and manipulating k-mer statistics 33, 2759–2761. URL [http://sun.aei.polsl.pl/REFRESH/kmc.28472236](http://sun.aei.polsl.pl/REFRESH/kmc.28472236). 53. [53].Letunic, I. & Bork, P. Interactive Tree Of Life (iTOL) v5: An online tool for phylogenetic tree display and annotation 49, W293–W296. URL doi:10.1093/nar/gkab301. [CrossRef](http://medrxiv.org/lookup/external-ref?access_num=10.1093/nar/gkab301&link_type=DOI) [PubMed](http://medrxiv.org/lookup/external-ref?access_num=33885785&link_type=MED&atom=%2Fmedrxiv%2Fearly%2F2024%2F07%2F05%2F2024.07.04.24309921.atom) 54. [54].Li, N. & Stephens, M. Modeling Linkage Disequilibrium and Identifying Recombination Hotspots Using Single-Nucleotide Polymorphism Data 165, 2213–2233. URL doi:10.1093/genetics/165.4.2213. [Abstract/FREE Full Text](http://medrxiv.org/lookup/ijlink/YTozOntzOjQ6InBhdGgiO3M6MTQ6Ii9sb29rdXAvaWpsaW5rIjtzOjU6InF1ZXJ5IjthOjQ6e3M6ODoibGlua1R5cGUiO3M6NDoiQUJTVCI7czoxMToiam91cm5hbENvZGUiO3M6ODoiZ2VuZXRpY3MiO3M6NToicmVzaWQiO3M6MTA6IjE2NS80LzIyMTMiO3M6NDoiYXRvbSI7czo1MDoiL21lZHJ4aXYvZWFybHkvMjAyNC8wNy8wNS8yMDI0LjA3LjA0LjI0MzA5OTIxLmF0b20iO31zOjg6ImZyYWdtZW50IjtzOjA6IiI7fQ==) 55. [55].Li, H. Minimap2: Pairwise alignment for nucleotide sequences 34, 3094–3100. URL [https://github.com/ruanjue/smartdenovo](https://github.com/ruanjue/smartdenovo);. 29750242. 56. [56].Ebert, P. et al. Haplotype-resolved diverse human genomes and integrated analysis of structural variation 372, eabf7117. URL [https://www.science.org/doi/10.1126/science.abf7117](https://www.science.org/doi/10.1126/science.abf7117). 57. [57].Danecek, P. et al. Twelve years of SAMtools and BCFtools 10, giab008. URL doi:10.1093/gigascience/giab008. [CrossRef](http://medrxiv.org/lookup/external-ref?access_num=10.1093/gigascience/giab008&link_type=DOI) [PubMed](http://medrxiv.org/lookup/external-ref?access_num=33590861&link_type=MED&atom=%2Fmedrxiv%2Fearly%2F2024%2F07%2F05%2F2024.07.04.24309921.atom) 58. [58].Zook, J. M. & Salit, M. Genomes in a bottle: Creating standard reference materials for genomic variation—why, what and how? 12. URL doi:10.1186/gb-2011-12-s1-p31. [CrossRef](http://medrxiv.org/lookup/external-ref?access_num=10.1186/gb-2011-12-s1-p31&link_type=DOI) 59. [59].Jun, G. et al. Structural variation across 138,134 samples in the TOPMed consortium. URL [https://www.biorxiv.org/content/10.1101/2023.01.25.525428v1](https://www.biorxiv.org/content/10.1101/2023.01.25.525428v1). 60. [60].Chen, S. et al. A genome-wide mutational constraint map quantified from variation in 76,156 human genomes. URL [https://www.biorxiv.org/content/10.1101/2022.03.20.485034v2](https://www.biorxiv.org/content/10.1101/2022.03.20.485034v2). 61. [61].Abuelanin, M. & Mansour, T. Snipe. URL [https://zenodo.org/records/11170191](https://zenodo.org/records/11170191). 62. [62].Karasikov, M. et al. MetaGraph: Indexing and Analysing Nucleotide Archives at Petabase-scale. URL [https://www.biorxiv.org/content/10.1101/2020.10.01.322164v2](https://www.biorxiv.org/content/10.1101/2020.10.01.322164v2). 63. [63].English, A. C., Menon, V. K., Gibbs, R., Metcalf, G. A. & Sedlazeck, F. J. Truvari: Refined Structural Variant Comparison Preserves Allelic Diversity. URL [https://www.biorxiv.org/content/10.1101/2022.02.21.481353v1](https://www.biorxiv.org/content/10.1101/2022.02.21.481353v1). 64. [64].kSpider. URL [https://dib-lab.github.io/kSpider/](https://dib-lab.github.io/kSpider/). 65. [65].SciPy documentation — SciPy v1.11.3 Manual. URL [https://docs.scipy.org/doc/scipy/index.html](https://docs.scipy.org/doc/scipy/index.html). 66. [66].Brown, C. T. & Irber, L. Sourmash: A library for MinHash sketching of DNA 1, 27. URL [https://joss.theoj.org/papers/10.21105/joss.00027](https://joss.theoj.org/papers/10.21105/joss.00027). 67. [67].Bauer, C. & King, G. Java Persistence with Hibernate (Manning Publications Co.).