Abstract
Long-read sequencing technology has enabled variant detection in difficult-to-map regions of the genome and enabled rapid genetic diagnosis in clinical settings. Rapidly evolving third-generation sequencing platforms like Pacific Biosciences (PacBio) and Oxford Nanopore Technologies (ONT) are introducing newer platforms and data types. It has been demonstrated that variant calling methods based on deep neural networks can use local haplotyping information with long-reads to improve the genotyping accuracy. However, using local haplotype information creates an overhead as variant calling needs to be performed multiple times which ultimately makes it difficult to extend to new data types and platforms as they get introduced. In this work, we have developed a local haplotype approximate method that enables state-of-the-art variant calling performance with multiple sequencing platforms including PacBio Revio system, ONT R10.4 simplex and duplex data. This addition of local haplotype approximation simplifies long-read variant calling with DeepVariant.
Subject terms: Machine learning, Software
DNA variant calling methods based on deep neural networks can use local haplotyping information with long-reads to improve genotyping accuracy, however this increases computational complexity. Here the authors develop an approximate haplotagging method that simplifies the process and enables state-of-the-art variant calling performance with multiple sequencing platforms.
Introduction
Long-read sequencing technology can reach low-mappability regions where short-reads have difficulty in mapping correctly1–5. Long-read sequencing has helped to generate highly contiguous genome assemblies6–8, extend variant benchmarking to complex regions9,10 and has improved the quality and completeness of reference genomes11–14.
Variant detection with long-reads takes advantage of the high mappability of long reads to reach difficult-to-map regions of the genome1,15,16. Long-read sequencing technology have lower base-level accuracy compared to short read technologies1,17–20. However, variant callers based on deep neural networks (DNN) can produce highly accurate variant calls with long-reads16,21,22. Recently, high-throughput long-read sequencing paired with accurate variant calling has demonstrated fastest genetic diagnosis in clinical setting23–25. Also, accurate long-reads show a higher diagnosis rate among individuals who were previously undiagnosed26,27. Long-read sequencing paired with methods based on machine learning for variant detection shows promise to have a far reaching impact in healthcare28.
DNN-based variant callers not only take advantage of the mappability of the long reads, it also uses local haplotyping information to inform the neural network for accurate genotyping16,21. Previously29, we have shown that using local haplotype information to determine the genotype of a variant improves the accuracy of variant detection with PacBio long-reads. In this three-step approach, a first round of variant detection is performed using DeepVariant30 without haplotag information in the reads. Then, WhatsHap31 is used to haplotag the reads. Finally, we run DeepVariant with the haplotag information to produce higher quality variants. A similar approach was taken for PEPPER-Margin-DeepVariant16 pipeline for nanopore long-reads where Margin is used to haplotag the reads.
Other Long-read germline variant callers such as Clair321 and Medaka32 use local haplotagging information from haplotagging methods like WhatsHap31, Margin33 or LongPhase34. Although the previously described three-step approach for variant detection provides accurate variants, it is difficult to tune three separate methods for each new datatype or platform introduced for long-reads. The long-read platforms like Pacific Biosciences (PacBio), and Oxford Nanopore Technologies (ONT) are rapidly evolving1,35–37 and a simpler variant calling approach that can enable accurate variant calling across different platforms is desirable.
Pacific Biosciences (PacBio) is a single-molecule real-time (SMRT) sequencing platform that uses circular consensus sequencing29. Recently, PacBio introduced a high-throughput machine called Revio38 that uses transformer-based consensus sequence correction method DeepConsensus39 on the instrument to generate highly accurate (99.9%) reads with length between 15kb and 20kb. The PacBio Revio machine can generate 30x human genome with one SMRT cell compared to 8x per SMRT cell with the previous Sequel-II machine which lowers the overall cost and turnaround time40–42.
Oxford Nanopore Technologies (ONT) introduced R10.4 chemistry with two read types simplex and duplex43. Compared to R9.4.1 chemistry, R10.4 provides better resolution for homopolymer detection43,44. The simplex sequencing mode shows average read quality of 98% and duplex reads with 99.9% accuracy44. The nanopore long reads can be 100kb+ which makes it suitable for high-quality assemblies7.
In this work, we introduce an approximate haplotagging method that can locally haplotag long reads without having to generate variant calls. Our approach uses local candidates to haplotag the reads and then the deep neural network model uses the haplotag approximation to generate high-quality variants. This approach eliminates the requirement for having the first two steps for haplotagging the reads and reduces the overhead for extending support to newer platforms and chemistries. We show that approximate haplotagging with candidate variants has comparable accuracy to haplotagging with WhatsHap. We report comparable or higher variant calling accuracy compared to DeepVariant-WhatsHap-DeepVariant approach with PacBio HiFi data. We demonstrate that extending support to the PacBio Revio machine can achieve high INDEL and SNP accuracy (SNP F1-score of 0.9993 and INDEL F1-score of 0.993). We also report support for ONT R10.4 simplex and duplex dataset with requiring PEPPER-Margin upstream of DeepVariant. We demonstrate INDEL F1-score of 0.84 and SNP F1-score of 0.9976 for nanopore simplex data and INDEL F1-socre of 0.90 and SNP F1-score of 0.999 for duplex data which is to our knowledge the highest variant calling accuracy achieved with nanopore long-reads.
Results
Local haplotype approximation method for genotyping with DeepVariant
DeepVariant performs variant calling in three stages: make_examples, call_variants and postprocess_variants. Previously, we have described each stage in detail16,29,30. Here, we briefly summarize each stage:
make_examples: This stage identifies candidate variants and creates a multichannel tensor representation (also known as an “example”) for each candidate based on the read pileup at the candidate position. Each example encodes features such as read bases, read quality, mapping quality, read support for candidates, and read strands.
call_variants: Examples are then given to a Convolutional Neural Network (CNN) that determines the genotype likelihood for the candidate variant represented in each example.
postprocess_variants: Finally, we take the likelihoods from the CNN and report variants with their assigned genotype.
Achieving accurate variant calling using long-read sequencing data requires calling variants twice often in a three-step process16,29 (Fig. 1a, DeepVariant-WhatsHap-DeepVariant):
First round variant calling: First, we run DeepVariant on non-haplotagged alignment file to derive a set of variants.
Haplotagging: Using the variants from the non-haplotagged alignment file a secondary method WhatsHap is applied to haplotag the reads.
Second round variant calling: Finally, the haplotagged read is given to DeepVariant where DeepVariant uses extra features as haplotype channel to generate higher-quality variant calls.
The multi-step variant calling process of DeepVariant-WhatsHap-DeepVariant (Fig. 1a) introduces overhead to extend support to newer long-read data types as multiple steps need to be optimized. In this work, we implement an approximate local haplotagging method within DeepVariant to locally haplotag the reads to avoid having to run an external haplotagging method or to have to reperform variant calling following initial haplotagging (Fig. 1b). A description of the local haplotagging method is described here.
DeepVariant processes input by dividing it into 25,000-base pair windows and processes the windows in parallel to create examples30. The haplotagging algorithm is integrated into the make_examples step, utilizing raw candidate data to calculate local haplotagging for each 25,000-base pair window. For each window, DeepVariant generates candidate variants by identifying positions that differ from the reference genome. The haplotagging process ensures that only potential heterozygous SNP candidates are selected. This involves excluding all candidates that have only one alternate allele, and the reference allele is supported by fewer than three reads. Additionally, any candidates featuring alternate alleles that are not SNPs are also eliminated. Reads are then dynamically updated with haplotagging information. The haplotagging algorithm employs dynamic programming to determine the best haplotagging score for each possible haplotag assignment at each variant position within the window. A set of reads that overlap both the previous putative heterozygous variant location and the target location are used to calculate this score. The optimal allele haplotagging is determined by backtracking from the best score for the last variant position. After all alleles are assigned haplotags, read haplotags are assigned based on the majority of alleles that the read overlaps.
We use a graph to store read-support information, where each vertex represents an allele (either an alternate allele or the reference allele). This graph is constructed from candidates identified within a 25,000-base pair window. Only candidates that have sufficient evidence to be considered heterozygous and contain only SNP alleles are used. At each position, vertices are created for each SNP allele. Additionally, a vertex is created for the reference allele if there is adequate read support for it. It is possible to create more than two vertices at some positions if there is substantial support for both the reference and multiple alternate alleles. Edges are then created to connect consecutive vertices if a read overlaps these alleles.
We assume that the score representing each possible haplotagging at a given position can be extended to the next position. Haplotagging is performed locally for every 25,000-base pair window. The score is calculated for each possible haplotagging at each genomic position where putative heterozygous candidates are created. The score is extended from the first position to the last. If there are no incoming edges for any of the vertices representing a genomic position, haplotagging cannot be extended, and we must reinitialize the scores. In cases where one of the vertices at a genomic position lacks incoming edges, yet a path exists from other vertices at the same position, artificial edges are created. These artificial edges fully connect the vertex with all preceding vertices.
Here is a brief step-by-step description of the algorithm:
Graph is built where each vertex is an allele (alt or ref). Edges are created to connect consecutive vertices if there is a read overlapping these alleles.
Initial scores are calculated for all possible haplotagging for the first genomic position.
Scores are calculated at each position using best scores calculated for previous vertices.
The best score is backtracked from the last position. Each pair of alleles are assigned haplotags.
Reads are assigned haplotags based on a set of alleles reads overlap.
The outcome of the local approximate haplotagging is a set of reads with haplotype association of haplotype-1, haplotype-2 or non-haplotagged reads for each 25kb chunk. Then for each candidate variant observed in the chunk, we generate examples through the make_examples step of DeepVariant that creates a multi-channel representation of the pileup surrounding the candidate variant. The haplotype information is encoded in the haplotype channel and reads are also sorted based on the local haplotype association of reads. The examples are provided to a Convolutional Neural Network (CNN) to provide genotype likelihood of homozygous to reference, heterozygous or homozygous alternate. Finally, in postprocessing step we take the output from the CNN and report the variant with a genotype and a likelihood of the genotype in Variant Call Format (VCF) file. A detailed description of the haplotagging algorithm with an example is provided in the online “methods” section.
PacBio HiFi haplotype approximation and variant calling performance
DeepVariant haplotags long reads to improve genotyping accuracy during variant calling. We trained DeepVariant models with no haplotagging information, haplotagging information from DeepVariant-WhatsHap bam, and the approximate haplotagging method. We trained the model on six Genome-In-A-Bottle (GIAB) samples (HG001, HG002, HG004, HG005, HG006, HG007) and kept HG003 as a hold out sample, we also holdout chromosome 20 as hold out. We then compared the variant calling performance on HG003 sample at different coverages.
In the variant calling performance analysis (Fig. 2a and Supplementary Table 1), we observe that DeepVariant model that uses no haplotagging information has lower variant calling performance at all coverages. The variant calling performance for SNPs with no haplotagging information can be considered comparable (F1-score at 15x: 0.9960, 35x: 0.9990) to the performance of variant calling with haplotagging information (F1-score at 15x: 0.996312, 35x: 0.999292). However, the INDEL performance of variant calling without haplotag information (F1-score at 15x: 0.9529, 35x: 0.9906) trails behind the performance of variant calling with haplotag information (F1-score at 15x: 0.9701, 35x: 0.9945) showing the importance of using haplotag information during variant calling with PacBio HiFi long reads.
We also observe that the variant calling performance of DeepVariant that uses approximate haplotagging built within the variant calling process is comparable to the previously used WhatsHap-based pipeline. The DeepVariant model trained with haplotag information using approximate haplotagging (F1-score 15x: 0.9963, 35x: 0.9992) outperforms the WhatsHap-based DeepVariant model (F1-score 15x: 0.9961, 35x: 0.9947). For INDEL performance, we see that the performance of the model trained with approximate haplotagging (F1-score 15x: 0.9701, 35x: 0.9945) is comparable to the WhatsHap-based model (F1-score 15x: 0.9705, 35x: 0.9947). Overall, we see that the model that operates with haplotag information from approximate haplotagging has comparable or better variant calling performance than the WhatsHap-based method that requires running the entire variant calling process multiple times.
We compared the approximate haplotagging performance of DeepVariant against WhatsHap-based haplotagging accuracy on HG002 chr20. We took GIAB trio-phased variant calls and haplotagged the PacBio HiFi reads using WhatsHap and used that as the truth set for haplotype association for reads. For WhatsHap-based haplotagging we used DeepVariant to initially identify variants from unphased bam and then used WhatsHap haplotag to assign haplotags to reads. For approximate haplotagging with DeepVariant, we reported the read haplotype association of each chunk and merged them. Finally, we compared the read haplotagging accuracy against GIAB-based haplotagging.
Figure 2b shows DeepVariant approximate haplotagging accuracy of 99.14 is comparable to WhatsHap-based haplotagging accuracy of 99.26. Notably, DeepVariant-based haplotagging is performed on 25kbp chunks and merged at the end whereas WhatsHap operates on entire chromosome with high-quality variants from DeepVariant. We also observe the haplotagging partitions are comparably consistent between WhatsHap-based haplotagging and DeepVariant approximate haplotagging. Overall, the approximate haplotagging method shows improved variant calling accuracy compared to non-haplotagged model (Fig. 2a, b). However, we observe slightly lower INDEL accuracy compared to WhatsHap-based method but improved SNP accuracy with approximate haplotagging method. We also compared the variant calling and approximate haplotagging accuracy for Oxford Nanopore data in Supplementary Fig. 1.
PacBio Revio vs Sequel-II variant calling performance
PacBio has announced a new sequencing instrument called Revio. Revio is high-throughput than previous Sequel-II. We analyzed the variant calling performance of DeepVariant with approximate haplotagging on PacBio Revio and Sequel-II instruments. The model is trained on a dataset consisting of sequencing data coming from both PacBio Revio and Sequel-II instruments. We trained the model on GIAB samples of HG001-HG007 while holding out HG003 for evaluation. We analyzed the performance of DeepVariant at different coverages at various coverage between 5x to 30x coverage.
In Fig. 3a, we see the read length distribution of Revio is much wider compared to Sequel-II method as the library preparation for Sequel-II used a more precise gel-based method for read size selection. We used Phred Quality Score as Quality Value (QV) to estimate the quality of the reads. The empirical QV of both Revio and Sequel-II data are comparable.
The variant calling performance of DeepVariant with Sequel-II and Revio are shown in Fig. 3b and Supplementary Table 2. Here we see the SNP calling performance of DeepVariant is comparable between Sequel-II and Revio platforms. The SNP variant calling performance (F1-scores of Sequel-II and Revio respectively, 5x: 0.8539 vs 0.8535, 10x: 0.9803 vs 0.9793, 15x: 0.9963 vs 0.9960, 20x: 0.9985 vs 0.9985, 25x: 0.9990 vs 0.9991, 30x: 0.9992 vs 0.9993) are very similar between two platforms at any given coverage. We also compared the variant calling performance against LongShot22 and NanoCaller45 in Supplementary Fig. 2.
The INDEL performance of DeepVariant at different coverages shows some difference (F1-scores of Sequel-II and Revio respectively, 5x: 0.740798 vs 0.718782, 10x: 0.92547 vs 0.908092, 15x: 0.970101 vs 0.960039, 20x: 0.984227 vs 0.978443, 25x: 0.990044 vs 0.986717, 30x: 0.993007 vs 0.990944). We observed the INDEL variant calling performance of DeepVariant with Sequel-II is higher compared to Revio at coverages between 5x to 25x. Whereas, at the suggested coverage of 30x, the variant calling performance with Revio is comparable to Sequel-II. The difference in the variant calling performance could be attributed to the read length distribution difference between the two datasets. However, Revio is high-throughput and the overall resources required to generate 30x data are much fewer compared to Sequel-II which makes Revio more practical for large-scale studies.
Oxford nanopore simplex variant calling performance
Oxford Nanopore Technologies (ONT) introduced an updated and more accurate chemistry known as R10.4 which improves on homopolymer errors in nanopore reads. The error rate of ONT R9.4.1 data requires pre-processing methods PEPPER-Margin to find candidates and haplotag the reads before variant calling with DeepVariant. However, with the improved sequencing quality from ONT R10.4 chemistry and approximate haplotagging method in DeepVariant, we are now able to train a model for ONT R10.4 that can call variants directly with DeepVariant without requiring complex preprocessing of PEPPER-Margin. We trained the DeepVariant ONT model on a combined dataset of R10.4 simplex and duplex data on GIAB samples where we held out HG003 for evaluation.
In Fig. 4a and Supplementary Tables 3 and 4, we compared the variant calling performance of ONT R10.4 data with three available variant callers, PEPPER, Clair3 and DeepVariant. Here, PEPPER refers to the PEPPER-Margin-DeepVariant pipeline and DeepVariant refers to DeepVariant with approximate haplotagging. In our comparison, we observe that DeepVariant with haplotagging has comparable SNP variant calling performance at all coverages (SNP F1-score, 15x: DeepVariant: 0.9903, PEPPER: 0.9875, Clair3: 0.9880, 30x: DeepVariant: 0.9968, PEPPER: 0.9962, Clair3: 0.9957, 65x: DeepVariant: 0.9976, PEPPER: 0.9977, Clair3: 0.9976). On the other hand, the INDEL variant calling performance of DeepVariant is higher compared to Clair3 and PEPPER at high and low coverages (INDEL F1-score, 15x: DeepVariant: 0.7121, PEPPER: 0.7013, Clair3: 0.6902, 30x: DeepVariant: 0.8412, PEPPER: 0.8345, Clair3: 0.8400, 65x: DeepVariant: 0.8976, PEPPER: 0.8830, Clair3: 0.8800). Overall, the DeepVariant with approximate haplotagging shows it can derive high-quality variants from ONT R10.4 sequencing data.
Figure 4b and Supplementary Tables 5 and 6 show the variant calling performance improvement between R9.4.1 and R10.4 chemistry. We observe that the SNP variant calling performance is comparable between R9.4.1 and R10.4 between 40x and 65x (SNP F1-score 40x: R9: 0.9971, R10: 0.9969, 65x: R9: 0.9976, R10: 0.9974) coverage but R10.4 shows improvements between 10x and 35x coverage where the most improvement comes at lower coverage between 10x and 25x (SNP F1-score 10x: R10: 0.9645, R9: 0.9371, 25x: R10: 0.9962, R9: 0.9948). The INDEL variant calling is highly improved with R10.4 chemistry at all coverages showing the improved data quality with the updated chemistry (INDEL F1-score 15x: R10: 0.7725, R9: 0.6666, 30x: R10: 0.8412, R9: 0.7712, 65x: R9: 0.8472, R10: 0.8976). Overall, the variant calling improvements we observe between R9.4.1 and R10.4 chemistry is due to the improvements in nanopore chemistry.
Improved variant calling with Oxford nanopore duplex sequencing
With the introduction of newer R10.4 chemistry, Oxford Nanopore also announced a new data type called duplex. We assessed the variant calling performance of DeepVariant on duplex and simplex data types of R10.4 chemistry. For this analysis, we trained a model with R10.4 simplex and duplex data combined, where we had only HG002 available for duplex data. For each sample, we trained the model from chr1-chr19 and tuned on chr21-chr22 which left chr20 for evaluation. For evaluation, we compared the variant calling performance on chr20 of HG002 sample at different coverages.
Figure 5a shows the empirical QV vs read length distribution between simplex and duplex datasets. The simplex reads have a read length distribution that goes beyond 100kbp+ length reads. Although duplex read length is between 10kbp-50kbp, we observe major improvements in empirical QV with duplex data where the empirical QV reaches nearly Q30 whereas with simplex the empirical QV ranges between Q17 to Q20. With the improvements of empirical QV, duplex data is expected to deliver high-quality variant calls.
The variant calling performance comparison between simplex and duplex datatype with DeepVariant shows duplex data improves variant calling performance for both SNP and INDEL (Fig. 5b and Supplementary Table 7) at all coverages. The SNP variant calling performance at lower coverages with duplex data is improved compared to simplex data (SNP F1-score 10x: Duplex: 0.9661, Simplex: 0.9540, 20x: Duplex: 0.9981, Simplex: 0.9958, 30x: Duplex: 0.9989, Simplex: 0.9981). At high coverage between 40x-65x, simplex and duplex data shows comparable SNP variant calling performance (SNP F1-score 40x: Duplex: 0.99911, Simplex: 0.9984, 50x: Duplex: 0.99918, Simplex: 0.9985). For INDEL variant calling, duplex shows improvements at all coverages compared to simplex data (F1-score 10x: Duplex: 0.7432, Simplex: 0.6892, 30x: Duplex: 0.8652, Simplex: 0.8326, 50x: Duplex: 0.9032, Simplex: 0.8720). Overall, the duplex datatype shows improvements in variant calling in all aspects.
Discussion
The rapid improvement in long-read sequencing technology has shown its utility from high-quality genome assembly to rare disease diagnosis11,13,46,47. Most variant calling methods that are tuned toward short-read sequencing technologies48,49 fail to derive and utilize the linkage information long-reads can provide during variant calling. Currently, most long-read variant callers require haplotagging to be done by an external method like WhatsHap31 or Margin16 which creates a complex multi-step variant calling process29. Besides inference, training and iteration on these models become difficult. In this work, we introduce an approximate local haplotagging method that can haplotag reads in 25kb chunks and improves the variant calling accuracy over non-haplotagged mode with PacBio HiFi data. We also extended the support to Oxford Nanopore Technologies R10.4 chemistry showing that it is possible to directly call variants from ONT data without multi-step PEPPER-Margin-DeepVariant setup.
The approximate haplotagging method we developed works efficiently on 25kb chunks of the genome and haplotags reads with comparable accuracy to WhatsHap. We show that the approximate haplotagging method achieves 99.14% correct haplotag ratio compared to 99.26% correct haplotag ratio of WhatsHap. We also show that models trained with haplotagging information from approximate haplotagging method has comparable INDEL accuracy and higher SNP accuracy than models trained with haplotagging information with WhatsHap or with no-haplotagging information.
We show the variant calling performance on two PacBio platforms, Revio and Sequel-II. We show that the newer high-throuhput Revio’s variant calling performance with DeepVariant is comparable to Sequel-II platform at each coverage. At 30x coverage the performance of Sequel-II (F1-Score INDEL: 0.993, SNP: 0.9992) is comparable to Revio (F1-Score INDEL: 0.990, SNP: 0.9993). The performance difference at lower coverages between Revio and Sequel-II is suspected to be caused by the read length distribution difference between the two datasets. We observed Sequel-II to have a tighter band around 15kb read length, whereas Revio had a wider read length distribution from 5kb to 25kb.
We extended DeepVariant to ONT R10.4 chemistry that has higher read-quality compared to R9.4.1 chemistry. We first show DeepVariant on R10.4 simplex data has the highest quality variant calls compared to PEPPER and Clair3. Then we show that DeepVariant with R10.4 is more accurate than PEPPER with R9.4.1 data. We show that with R10.4 chemistry it is possible to produce high-quality variants at lower coverages compared to R9.4.1 with demonstrable improvements in INDEL accuracy.
We also show that DeepVariant works seamlessly with R10.4 simplex and duplex data types. The duplex data has higher average read quality (average QV27) compared to simplex (average QV20) and produces even higher quality variant calls compared to simplex only data type. We show with R9.4.1 it is possible to achieve SNP F1-score of 0.999 at 30x Duplex coverage whereas 65x Simplex data achieves 0.997 SNP F1-score. For ONT INDEL performance, we see a noticeable improvement from R9.4.1 (INDEL F1-score 0.84), R10.4 simplex (INDEL F1-score 0.897) and R10.4 duplex (INDEL F1-Score 0.903). Although the INDEL improvements between platforms are on the positive side, we believe further iteration on the chemistry and data quality improvements would demonstrate further accuracy improvements in the future.
As we demonstrate a more generalized framework for long-read variant calling that uses haplotagging information, we believe future iterations of incorporating more long-read specific features would improve the variant calling accuracy further. For example, both PacBio and ONT can now produce methylation information50,51. The newer methods can provide epigenetic profiles as well as canonical base calls52,53. We believe incorporating methylation information in the variant calling framework would further improve the accuracy.
Methods
Approximate haplotagging
In this section, we describe the approximate haplotagging algorithm in detail. The approximate haplotagging is applied on 25kb windows indepedently and all described methods work on the 25kb window only. We utilize a graph data structure to facilitate the haplotagging of reads. In the graph G, a set of vertices V represents alleles at locations where a set of reads R overlaps these vertices. Our objective is to assign a haplotag of 1, 2, or 0 to all vertices, ensuring that this assignment corresponds to the maximum read support. Haplotag 1 is assigned to reads overlapping a majority of the alleles of haplotype 1 in the local 25kb window, while haplotag 2 is assigned to those overlapping a majority of alleles of haplotype 2 in the same window. Haplotag 0 is designated for reads that cannot be conclusively assigned to either of the two haplotypes.
For a genomic position n, we look at all possible tuples of vertices (i, j) from the set of vertices at this position. We use a similar approach to the score calculation for each pair at the same position while calculating scores for a pair of vertices at different variant positions. The score calculation for pair of vertices at different variant positions is described in ”How scores are calculated between positions” section. The best score S(Vn,i, Vn,j) is calculated for each tuple where the first vertex is assigned a haplotag 1 and the second vertex is assigned a haplotag 2. The set of supporting reads R(Vn,i), R(Vn,j) are stored for each possible haplotag assignment. Set of reads supporting the assignment R(Vn,i) is calculated as a set of reads overlapping vertex Vn,i and preceding vertex Vn−1,k joined with a set of reads that overlap Vn,i and start after position n − 1.
At each step of the dynamic programming algorithm, we extend the best haplotag assignment calculated for the previous position. Final assignment is calculated by backtracking from the best score for the last genomic position.
Below, we present a brief definition of variables we used to describe the approximate haplotagging algorithm:
Vn,j be a vertex j at position n.
S(Vn,i, Vn,j) be a score for vertices i, j at genomic position n so that vertex i is haplotag 1 and vertex j is haplotag 2. It is possible that i and j are the same vertex;
Vn be a set of vertices at position n;
R(V) be a set of reads overlapping vertex V;
R(V1, V2) be a set of reads overlapping vertices V1, V2;
R*(Vn,j) be a set of “new” reads that start after position (n − 1) and overlap vertex Vn,j;
Initialization
The two steps, initialization and recursion used are described below. The first genomic position of an interval (n = 1), we initialize the score as:
Initialization happens at the beginning of an interval or when the haplotagging cannot be extended from the previous position.
Recursion
During recursion, we calculate scores at each position n for all vertex pairs (Vn,i, Vn,j) based on the previously observed vertex Vn−1,k and Vn−1,l where edges E(Vn−1,k, Vn,i) and E(Vn−1,l, Vn,j) exist in the graph connecting previous position n − 1 and current position n. The score is calculated as:
for all pairs (Vn−1,k) and (Vn−1,l) where edges E(Vn−1,k, Vn,i) and E(Vn−1,l, Vn,j) exist in the graph.
Backtracking and haplotag assignment
After scores have been calculated for each vertex, we backtrack from the last position to determine the best scores, and subsequently, each pair of alleles is assigned haplotags. Now that all alleles are haplotagged, we assign reads with haplotags based on the set of haplotagged alleles the read overlaps. This assignment is accomplished by enumerating all the alleles a read overlaps and then counting how many of these alleles belong to haplotype 0, haplotype 1, and haplotype 2. Ideally, a read should overlap only alleles from the same haplotype. If a read overlaps alleles from different haplotypes then the haplotag is assigned by majority. If the number of alleles from haplotype 1 and haplotype 2 are equal, the read is assigned a haplotag 0.
Example of the approximate haplotagging algorithm
In Fig. 6, we illustrate a graph constructed for approximate haplotagging. In this graph each vertex represents an allele An,m where n is the genomic position and m is the allele. The alleles (m) are numbered for this demonstration. Set of reads overlapping each allele is shown next to it denoted as read1 to read11. The reads are placed as such it represents the alleles it supports in the graph.
In the first step, we initialize the scores for the genomic position n = 1:
Then we calculate the scores of each pair of vertices based on the previously observed vertices:
Then we calculate the best score at the last position. The best score for the last position is 19 where allele A2,1 is assigned to haplotag-1 and allele A2,1 is assigned to haplotag-2. Previous pair of alleles for this score is A1,1 with haplotag-1 and A1,2 with haplotag-2.
Using the best score, we assign haplotags to the vertices and haplotags to the reads. From the previous step we have alleles A1,1, A2,1 assigned to haplotag-1 and alleles A2,1, A2,2 assigned to haplotag-2. Reads: read1, read2, read3 overlap alleles A1,1, A2,1 both of which are haplotag-1. Therefore read1, read2, read3 are assigned haplotag-1.
Reads: read4, read5 overlap alleles A1,1, A2,2 are consecutively haplotag-1 and haplotag-2. In that case read4, and read5 cannot be haplotagged. Following the same logic reads: read7, read8, read9, read10, read11 are assigned haplotag-2, and read6 cannot be haplotagged.
Finally, these haplotag associations of the reads are used in the examples we generate for each candidate and the DNN model uses the information to generate accurate genotypes.
How scores are calculated between positions
The haplotagging algorithm iterates through all tuples of edges and stores the best score for each pair of vertices. We describe three cases with examples below.
Simple Case (for 2 positions with two edges)
In the simple case, we have two vertices per position and only two edges connecting two positions each without overlaps like in Fig. 7. In Fig. 7, vertex A1,1 means vertex 1 in position 1 and A1,2 means vertex 2 in position 1. So here, we would have 4 possible tuples of edges: (A1,1 − A2,1, A1,1 − A2,1), (A1,2 − A2,2, A1,2 − A2,2), (A1,1 − A2,1, A1,2 − A2,2), (A1,2 − A2,2, A1,1 − A2,1). The score is calculated for each tuple of edges. We calculate best scores for the four pairs of vertices: S(A2,1, A2,1), S(A2,2, A2,2), S(A2,1, A2,2), S(A2,2, A2,1).
Complex case (for 2 positions with four edges)
In the worst case with four vertices for two positions, we have edges that connect all four vertices shown in Fig. 8. In this case, we will calculate scores for all 16 possible tuples of edges and we store best scores for 4 possible pairs of vertices: S(A2,1, A2,1), S(A2,2, A2,2), S(A2,1, A2,2), S(A2,2, A2,1).
Case of 3 vertices
In the case of three vertices, where we have reference and two alternate alleles. Similar to the previous two cases, we calculate 9 best scores for each possible pair of vertices. Depending on the number of edges, we have to calculate the scores for all possible tuples of edges to get the scores for each possible pair of vertices.
Analysis methods
Read alignment and subsampling
We used pbmm2 version 1.10 and minimap254 version 2.24-r1122 to align reads to the reference genome. We used samtools55 version 1.15 for sampling alignment files at different coverages.
Variant calling and haplotagging
We used PEPPER-Margin-DeepVariant16 version r0.8, Clair321 version v1.0.0 for variant calling, for DeepVariant-WhatsHap-DeepVariant pipeline we used v1.2.0 version of DeepVariant. For haplotagging with WhatsHap, we used WhatsHap version v1.7.
Benchmarking variant calls
For benchmarking variant calls, we used hap.py56 version v0.3.12. The hap.py is available through jmcdani20/hap.py:v0.3.12 in dockerhub. For we used GIAB v4.2.1 truth set9 against GRCh38 reference for all samples.
Haplotagging accuracy and natural switch determination
We used https://github.com/tpesout/genomics_scripts/haplotagging_stats.py to calculate the haplotagging accuracy16.
Read accuracy estimation
We used Best57 version v0.1.0 for read accuracy analysis. For the analysis, we used GRCh38 as the reference to derive the empirical QV for each read.
Reporting summary
Further information on research design is available in the Nature Portfolio Reporting Summary linked to this article.
Supplementary information
Acknowledgements
This study was supported by Google LLC (A.K., P.C., K.S., D.C., M.N., A.C.). B.P. was supported by the National Institutes of Health under award numbers R01HG010485, U24HG010262, U24HG011853, OT3HL142481, U01HG010961, and OT2OD033761. K.H.M. was supported by grants U01HG010971 and R01HG011274. We thank Trevor Pesout for the support of generating haplotag comparison plots. The content is solely the responsibility of the authors and does not necessarily represent the official views of Google LLC and the National Institutes of Health.
Author contributions
K.S., P.C. and A.C. conceived of the study and executed it. A.K. refined and implemented an approximate haplotagging algorithm. D.C. implemented haplotype channel. M.N. implemented alignment methods that improve long-read variant calling. K.S. performed the analysis and extended it to ONT variant calling. A.C., P.C., A.K., D.C., M.N., L.B. and K.S. are core contributors and developers of DeepVariant. L.B. helped in writing the manuscript. B.M. and M.J. performed nanopore sequencing and initial analysis of the data quality. J.G. and S.G. provided analysis feedback. K.H.M., B.P. and E.A. provided guidance on the overall study and results. All authors approve of the final manuscript.
Peer review
Peer review information
Nature Communications thanks Qian Liu and the other, anonymous, reviewer(s) for their contribution to the peer review of this work. A peer review file is available.
Data availability
We have made all data including input BAMs, output VCF and analysis files publicly available: https://console.cloud.google.com/storage/browser/brain-genomics-public/publications/kolesnikov2023_dv_haplotagging/evaluation/. Moreover, all data collected and used for this study are publicly available though the HPRC consortium: https://s3-us-west-2.amazonaws.com/human-pangenomics/index.html. The data policy and details of the data can be found in https://humanpangenome.org/data/and https://www.ncbi.nlm.nih.gov/bioproject/730823.
Code availability
Approximate haplotagging was introduced in DeepVariant r1.4.0 in release note: https://github.com/google/deepvariant/releases/tag/v1.4.0 and it runs by default with run_deepvariant without having to set any parameters explicitly to enable it for PacBio and ONT long read sequencing data. The latest versions, including r1.5.0, r1.6.0 and r1.6.1 use this feature by default similar to r1.4.0. Methods described here is publicly available through https://github.com/google/deepvariant where the haplotagging method can be found in https://github.com/google/deepvariant/blob/r1.6.1/deepvariant/direct_phasing.cc. The implementation of graph building method for approximate haplotagging can be found in: https://github.com/google/deepvariant/blob/r1.6.1/deepvariant/direct_phasing.cc#L481C24-L481C24. The implementation of scoring method for approximate haplotagging can be found in: https://github.com/google/deepvariant/blob/r1.6.1/deepvariant/direct_phasing.cc#L282. We have also made all input and output files publicly available. Please see the Supplementary Notes for access link.
Competing interests
A.K., P.C., K.S., D.C., M.N., A.C. and L.B. are employees of Google LLC and own Alphabet stock as part of the standard compensation package. E.A. is the founder of Personalis Inc. and Deepcell Inc., advisor to Pacific Biosciences, SequenceBio. E.A. has received support from Illumina, Oxford Nanopore, and Pacific Biosciences. Stockholder Pacific Biosciences, Oxford Nanopore. K.H.M. is a science advisory board member of Centaura; K.H.M. has received travel funds to speak at events hosted by Oxford Nanopore Technologies. J.G. holds stock in ONT and PacBIo. J.G., K.S., and S.G. have accepted bursaries to attend and speak at conferences on behalf of ONT. The remaining authors declare no competing interests.
Footnotes
Publisher’s note Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.
Contributor Information
Andrew Carroll, Email: awcarroll@google.com.
Kishwar Shafin, Email: shafin@google.com.
Supplementary information
The online version contains supplementary material available at 10.1038/s41467-024-50079-5.
References
- 1.Logsdon GA, Vollger MR, Eichler EE. Long-read human genome sequencing and its applications. Nat. Rev. Genet. 2020;21:597–614. doi: 10.1038/s41576-020-0236-x. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 2.Olson, N. D. et al. Precisionfda truth challenge v2: Calling variants from short and long reads in difficult-to-map regions. Cell Genomics2, 100129 (2022). [DOI] [PMC free article] [PubMed]
- 3.Zook JM, et al. An open resource for accurately benchmarking small variant and reference calls. Nat. Biotechnol. 2019;37:561–566. doi: 10.1038/s41587-019-0074-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 4.Olson ND, et al. Variant calling and benchmarking in an era of complete human genome sequences. Nat. Rev. Genet. 2023;24:464–483. doi: 10.1038/s41576-023-00590-0. [DOI] [PubMed] [Google Scholar]
- 5.Li W, Freudenberg J. Mappability and read length. Front. Genet. 2014;5:381. doi: 10.3389/fgene.2014.00381. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 6.Cheng H, Concepcion GT, Feng X, Zhang H, Li H. Haplotype-resolved de novo assembly using phased assembly graphs with hifiasm. Nat. methods. 2021;18:170–175. doi: 10.1038/s41592-020-01056-5. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 7.Rautiainen M, et al. Telomere-to-telomere assembly of diploid chromosomes with verkko. Nat. Biotechnol. 2023;41:1474–1482. doi: 10.1038/s41587-023-01662-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 8.Shafin K, et al. Nanopore sequencing and the shasta toolkit enable efficient de novo assembly of eleven human genomes. Nat. Biotechnol. 2020;38:1044–1053. doi: 10.1038/s41587-020-0503-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 9.Wagner, J. et al. Benchmarking challenging small variants with linked and long reads. Cell Genom.2, 100128 (2022). [DOI] [PMC free article] [PubMed]
- 10.Wagner J, et al. Curated variation benchmarks for challenging medically relevant autosomal genes. Nat. Biotechnol. 2022;40:672–680. doi: 10.1038/s41587-021-01158-1. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11.Nurk S, et al. The complete sequence of a human genome. Science. 2022;376:44–53. doi: 10.1126/science.abj6987. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 12.Jarvis ED, et al. Semi-automated assembly of high-quality diploid human reference genomes. Nature. 2022;611:519–531. doi: 10.1038/s41586-022-05325-5. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 13.Rhie, A. et al. The complete sequence of a human Y chromosome. Nature621, 344–354 (2023). [DOI] [PMC free article] [PubMed]
- 14.Liao W-W, et al. A draft human pangenome reference. Nature. 2023;617:312–324. doi: 10.1038/s41586-023-05896-x. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15.De Coster W, Weissensteiner MH, Sedlazeck FJ. Towards population-scale long-read sequencing. Nat. Rev. Genet. 2021;22:572–587. doi: 10.1038/s41576-021-00367-3. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16.Shafin K, et al. Haplotype-aware variant calling with pepper-margin-deepvariant enables high accuracy in nanopore long-reads. Nat. methods. 2021;18:1322–1332. doi: 10.1038/s41592-021-01299-w. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 17.Chaisson MJ, et al. Multi-platform discovery of haplotype-resolved structural variation in human genomes. Nat. Commun. 2019;10:1784. doi: 10.1038/s41467-018-08148-z. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 18.Mc Cartney AM, et al. Chasing perfection: validation and polishing strategies for telomere-to-telomere genome assemblies. Nat. methods. 2022;19:687–695. doi: 10.1038/s41592-022-01440-3. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 19.Rang FJ, Kloosterman WP, de Ridder J. From squiggle to basepair: computational approaches for improving nanopore sequencing read accuracy. Genome Biol. 2018;19:90. doi: 10.1186/s13059-018-1462-9. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 20.Jain M, et al. Nanopore sequencing and assembly of a human genome with ultra-long reads. Nat. Biotechnol. 2018;36:338–345. doi: 10.1038/nbt.4060. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 21.Zheng Z, et al. Symphonizing pileup and full-alignment for deep learning-based long-read variant calling. Nat. Computational Sci. 2022;2:797–803. doi: 10.1038/s43588-022-00387-x. [DOI] [PubMed] [Google Scholar]
- 22.Edge P, Bansal V. Longshot enables accurate variant calling in diploid genomes from single-molecule long read sequencing. Nat. Commun. 2019;10:4660. doi: 10.1038/s41467-019-12493-y. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 23.Gorzynski JE, et al. Ultrarapid nanopore genome sequencing in a critical care setting. N. Engl. J. Med. 2022;386:700–702. doi: 10.1056/NEJMc2112090. [DOI] [PubMed] [Google Scholar]
- 24.Goenka SD, et al. Accelerated identification of disease-causing variants with ultra-rapid nanopore genome sequencing. Nat. Biotechnol. 2022;40:1035–1041. doi: 10.1038/s41587-022-01221-5. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 25.Galey, M. et al. 3-hour genome sequencing and targeted analysis to rapidly assess genetic risk. medRxiv2, 101833 (2022).
- 26.Cohen AS, et al. Genomic answers for children: Dynamic analyses of¿ 1000 pediatric rare disease genomes. Genet. Med. 2022;24:1336–1348. doi: 10.1016/j.gim.2022.02.007. [DOI] [PubMed] [Google Scholar]
- 27.Kucuk E, et al. Comprehensive de novo mutation discovery with hifi long-read sequencing. Genome Med. 2023;15:1–15. doi: 10.1186/s13073-023-01183-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 28.Gomes B, Ashley EA. Artificial intelligence in molecular medicine. N. Engl. J. Med. 2023;388:2456–2465. doi: 10.1056/NEJMra2204787. [DOI] [PubMed] [Google Scholar]
- 29.Wenger AM, et al. Accurate circular consensus long-read sequencing improves variant detection and assembly of a human genome. Nat. Biotechnol. 2019;37:1155–1162. doi: 10.1038/s41587-019-0217-9. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 30.Poplin R, et al. A universal snp and small-indel variant caller using deep neural networks. Nat. Biotechnol. 2018;36:983–987. doi: 10.1038/nbt.4235. [DOI] [PubMed] [Google Scholar]
- 31.Patterson M, et al. Whatshap: weighted haplotype assembly for future-generation sequencing reads. J. Computational Biol. 2015;22:498–509. doi: 10.1089/cmb.2014.0157. [DOI] [PubMed] [Google Scholar]
- 32.Medaka, https://github.com/nanoporetech/medaka.
- 33.Ebler J, Haukness M, Pesout T, Marschall T, Paten B. Haplotype-aware diplotyping from noisy long reads. Genome Biol. 2019;20:1–16. doi: 10.1186/s13059-019-1709-0. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 34.Lin J-H, Chen L-C, Yu S-C, Huang Y-T. Longphase: an ultra-fast chromosome-scale phasing algorithm for small and large variants. Bioinformatics. 2022;38:1816–1822. doi: 10.1093/bioinformatics/btac058. [DOI] [PubMed] [Google Scholar]
- 35.Hu T, Chitnis N, Monos D, Dinh A. Next-generation sequencing technologies: an overview. Hum. Immunol. 2021;82:801–811. doi: 10.1016/j.humimm.2021.02.012. [DOI] [PubMed] [Google Scholar]
- 36.Mantere T, Kersten S, Hoischen A. Long-read sequencing emerging in medical genetics. Front. Genet. 2019;10:426. doi: 10.3389/fgene.2019.00426. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 37.Amarasinghe SL, et al. Opportunities and challenges in long-read sequencing data analysis. Genome Biol. 2020;21:1–16. doi: 10.1186/s13059-020-1935-5. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 38.Pacific Biosciences of California. Revio. https://www.pacb.com/press_releases/pacbio-announces-revio-a-revolutionary-new-long-read-sequencing-system-designed-to-provide-15-times-more-hifi-data-and-human-genomes-at-scale-for-under-1000/.
- 39.Baid G, et al. Deepconsensus improves the accuracy of sequences with a gap-aware sequence transformer. Nat. Biotechnol. 2023;41:232–238. doi: 10.1038/s41587-022-01435-7. [DOI] [PubMed] [Google Scholar]
- 40.Manuel, J. G. et al. High coverage highly accurate long-read sequencing of a mouse neuronal cell line using the pacbio revio sequencer. Preprint at bioRxiv10.1101/2023.06.06.543940 (2023).
- 41.Mahmoud, M. et al. Utility of long-read sequencing for All of Us. Nat. Commun.15, 837 (2024). [DOI] [PMC free article] [PubMed]
- 42.Harvey, W. T. et al. Whole-genome long-read sequencing downsampling and its effect on variant-calling precision and recall. Genome Res.33, 2029–2040 (2023). [DOI] [PMC free article] [PubMed]
- 43.Sereika M, et al. Oxford nanopore r10. 4 long-read sequencing enables the generation of near-finished bacterial genomes from pure cultures and metagenomes without short-read or reference polishing. Nat. methods. 2022;19:823–826. doi: 10.1038/s41592-022-01539-7. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 44.Ni Y, Liu X, Simeneh ZM, Yang M, Li R. Benchmarking of nanopore r10. 4 and r9. 4.1 flow cells in single-cell whole-genome amplification and whole-genome shotgun sequencing. Computational Struct. Biotechnol. J. 2023;21:2352–2364. doi: 10.1016/j.csbj.2023.03.038. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 45.Ahsan MU, Liu Q, Fang L, Wang K. Nanocaller for accurate detection of snps and indels in difficult-to-map regions from long-read sequencing by haplotype-aware deep neural networks. Genome Biol. 2021;22:1–33. doi: 10.1186/s13059-021-02472-2. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 46.Manickam K, et al. Genet. Med. 2021;23:2029–2037. doi: 10.1038/s41436-021-01242-6. [DOI] [PubMed] [Google Scholar]
- 47.Miller DE, et al. Targeted long-read sequencing identifies a retrotransposon insertion as a cause of altered gnas exon a/b methylation in a family with autosomal dominant pseudohypoparathyroidism type 1b (php1b) J. Bone Miner. Res. 2022;37:1711–1719. doi: 10.1002/jbmr.4647. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 48.McKenna A, et al. The genome analysis toolkit: a mapreduce framework for analyzing next-generation dna sequencing data. Genome Res. 2010;20:1297–1303. doi: 10.1101/gr.107524.110. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 49.Garrison, E. & Marth, G. Haplotype-based variant detection from short-read sequencing. Preprint at arXiv https://arxiv.org/abs/1207.3907 (2012).
- 50.Ewing AD, et al. Nanopore sequencing enables comprehensive transposable element epigenomic profiling. Mol. Cell. 2020;80:915–928. doi: 10.1016/j.molcel.2020.10.024. [DOI] [PubMed] [Google Scholar]
- 51.Rhoads A, Au KF. Pacbio sequencing and its applications. Genomics, Proteom. Bioinforma. 2015;13:278–289. doi: 10.1016/j.gpb.2015.08.002. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 52.Liu Y, et al. Dna methylation-calling tools for oxford nanopore sequencing: a survey and human epigenome-wide evaluation. Genome Biol. 2021;22:1–33. doi: 10.1186/s13059-021-02510-z. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 53.Chen J, et al. Whole-genome long-read taps deciphers DNA methylation patterns at base resolution using pacbio smrt sequencing technology. Nucleic Acids Res. 2022;50:e104. doi: 10.1093/nar/gkac612. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 54.Li H. Minimap2: pairwise alignment for nucleotide sequences. Bioinformatics. 2018;34:3094–3100. doi: 10.1093/bioinformatics/bty191. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 55.Li H, et al. The sequence alignment/map format and samtools. Bioinformatics. 2009;25:2078–2079. doi: 10.1093/bioinformatics/btp352. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 56.Krusche P, et al. Best practices for benchmarking germline small-variant calls in human genomes. Nat. Biotechnol. 2019;37:555–560. doi: 10.1038/s41587-019-0054-x. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 57.Liu, D. et al. Best: A tool for characterizing sequencing errors. Preprint at bioRxiv10.1101/2022.12.22.521488 (2022).
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Data Availability Statement
We have made all data including input BAMs, output VCF and analysis files publicly available: https://console.cloud.google.com/storage/browser/brain-genomics-public/publications/kolesnikov2023_dv_haplotagging/evaluation/. Moreover, all data collected and used for this study are publicly available though the HPRC consortium: https://s3-us-west-2.amazonaws.com/human-pangenomics/index.html. The data policy and details of the data can be found in https://humanpangenome.org/data/and https://www.ncbi.nlm.nih.gov/bioproject/730823.
Approximate haplotagging was introduced in DeepVariant r1.4.0 in release note: https://github.com/google/deepvariant/releases/tag/v1.4.0 and it runs by default with run_deepvariant without having to set any parameters explicitly to enable it for PacBio and ONT long read sequencing data. The latest versions, including r1.5.0, r1.6.0 and r1.6.1 use this feature by default similar to r1.4.0. Methods described here is publicly available through https://github.com/google/deepvariant where the haplotagging method can be found in https://github.com/google/deepvariant/blob/r1.6.1/deepvariant/direct_phasing.cc. The implementation of graph building method for approximate haplotagging can be found in: https://github.com/google/deepvariant/blob/r1.6.1/deepvariant/direct_phasing.cc#L481C24-L481C24. The implementation of scoring method for approximate haplotagging can be found in: https://github.com/google/deepvariant/blob/r1.6.1/deepvariant/direct_phasing.cc#L282. We have also made all input and output files publicly available. Please see the Supplementary Notes for access link.