Abstract

Summary

HLA*LA implements a new graph alignment model for human leukocyte antigen (HLA) type inference, based on the projection of linear alignments onto a variation graph. It enables accurate HLA type inference from whole-genome (99% accuracy) and whole-exome (93% accuracy) Illumina data; from long-read Oxford Nanopore and Pacific Biosciences data (98% accuracy for whole-genome and targeted data) and from genome assemblies. Computational requirements for a typical sample vary between 0.7 and 14 CPU hours per sample.

Availability and implementation

HLA*LA is implemented in C++ and Perl and freely available as a bioconda package or from https://github.com/DiltheyLab/HLA-LA (GPL v3).

Supplementary information

Supplementary data are available at Bioinformatics online.

1 Introduction

Genetic variation at the human leukocyte antigen (HLA) loci is associated with many important phenotypes and biological conditions, including autoimmune and infectious disease risk, transplant rejection, and the repertoire of immune-presented peptides (Trowsdale and Knight, 2013). With the growing availability of whole-exome and whole-genome sequencing (WGS) data, the ability to accurately determine the allelic state of the HLA genes (‘HLA typing’) from these data types is becoming increasingly important. The accuracy of standard sequencing data analysis methods in the HLA region is limited by hyperpolymorphism and reference divergence (Dilthey et al., 2015). Specialized HLA analysis methods, however, have been developed (Bai et al., 2014; Dilthey et al., 2016; Huang et al., 2015; Lee and Kourami, 2018; Wittig et al., 2015; Xie et al., 2017); these typically rely on variation-aware alignment approaches, e.g. genome graphs or collections of linear reference sequences. When applied to high-coverage WGS data, the accuracy of these methods can approach that of gold-standard HLA typing assays like sequence-based typing (SBT). HLA type inference from exome or low-coverage WGS data, however, remains more challenging, and most tools do not support long-read data.

We present HLA*LA (‘linear alignments’), a graph-based method with high accuracy on exome and low-coverage WGS data, full support for assembled and unassembled long-read data and a new projection-based approach to graph alignment. Briefly, the alignment process starts with the identification of linear alignments between the input reads and the reference haplotypes that the graph was constructed from; these are projected onto the graph, an approach also used by Lee and Kourami, 2018, and optimized in a stepwise process specific to Population Reference Graphs (PRGs; Dilthey et al., 2015). The intuition behind this is that the (projected) original linear alignment will often be a close approximation to the best graph alignment, except for reads that switch between divergent reference haplotypes. In HLA*LA, these are identified heuristically and trigger a switch into full graph alignment mode. Its hybrid approach enables HLA*LA to often avoid—potentially costly—full graph alignment, to leverage the performance of highly optimized linear alignment algorithms and to carry out graph alignment for both short and long reads in a unified framework.

2 Materials and methods

HLA*LA employs a PRG of 13 491 sequences, representing the eight GRCh38 (Schneider et al., 2017) MHC haplotypes and the IMGT exonic and genomic sequences (Robinson et al., 2015). Linear alignments are obtained by aligning input reads against a modified reference genome (GRCh38 plus the eight MHC haplotypes and IMGT genomic sequences) with BWA-MEM (Li, 2013).

Alignments from regions covered by the PRG are projected onto the graph and undergo a three-stage optimization process that draws on the fact that PRGs have, like multiple sequence alignments, a well-defined column structure (‘levels’). We can distinguish between two types of alignment errors: bases aligned to an edge at the wrong level of the graph or bases that are aligned to the right level but the wrong edge. During the first step of the optimization process (‘inspection’), we heuristically identify and remove from the alignment bases which might be aligned to the wrong level of the graph, based on an examination of the alignment’s local gap structure. During the second step (‘polishing’), we efficiently find the highest-scoring graph traversal within the existing level structure of the remaining alignment using dynamic programming. During a final step (‘extension’), the alignment is extended to the complete length of the read in full graph alignment mode; the computational advantage of HLA*LA derives mainly from the fact that this step can be skipped for most reads. For long reads with increased INDEL rates, gaps in the projected alignment are not indicative of potential misalignments; we consequently omit the base removal (during inspection) and re-integration (alignment extension) steps. A full description of alignment projection and optimization for short and long reads is given in Supplementary Note S1.

For HLA type inference, we employ the likelihood model of HLA*PRG (Dilthey et al., 2016). Briefly, at each locus, we maximize Paligned readsa1,a2) over all pairs (a1,a2) of possible HLA alleles. For long reads, we increase INDEL rates in the underlying alignment likelihood (Supplementary Note S1).

The complete inference approach of HLA*LA is illustrated in Supplementary Figure S1.

HLA typing of assemblies, which can be used if raw long reads are not available or as a metric of assembly quality, is based on a projection of the GRCh38 MHC reference haplotype annotations onto the assembly. Briefly, MHC-overlapping contigs are identified with nucmer (Delcher et al., 2002). For each identified contig and each reference haplotype (Schneider et al., 2017), a semi-global alignment is computed heuristically (see below); the annotations of the haplotype underlying the highest-scoring alignment are projected onto the contig; HLA gene and exon sequences are extracted based on the projected coordinates. HLA typing is carried out by IMGT database matching (minimum edit distance). The global alignment heuristic uses BWA-MEM for the identification of local alignments (‘diagonals’) between the input sequences; dynamic programming is used to identify the highest-scoring traversal of the global alignment matrix limited to the identified diagonals connected with horizontal or vertical jumps. This approach accounts for different MHC haplotype structures and ensures that each gene is used only once per contig.

3 Results

We carry out three experiments (Table 1) to assess the performance of HLA*LA. On high-coverage Illumina WGS data (1000 Genomes Project Consortium et al., 2012; Eberle et al., 2017), HLA*LA achieves a performance of 99.4% averaged over the six classical HLA genes. This is identical to the performance of Kourami and HLA*PRG. xHLA (Xie et al., 2017) achieves an accuracy of 100%, but does not produce calls for HLA-DQA1. The performance of HLA*LA under reduced coverage (15×) is relatively stable (90%) and comparable to that of xHLA (91%), where xHLA has higher performance on HLA class I (95% compared to 87%), and HLA*LA has higher performance on HLA class II (94% compared to 84%). Kourami is less stable under reduced coverage (average accuracy 69%). On whole-exome Illumina sequencing data (International HapMap, 2005), HLA*LA outperforms HLA*PRG (93% accuracy compared to 89%) and Kourami at matched call rates (95.3% at 88% call rate compared to 94.6% accuracy at 83% call rate). The overall accuracy of xHLA is 95%, with HLA-DQA1 remaining uncalled. On whole-genome and targeted PacBio and Nanopore sequencing data (Carapito et al., 2016; Jain et al., 2018; Steinberg et al., 2016), HLA*LA achieves an average accuracy of 98%. Of note, the majority (2034 alleles) of the long-read validation data consists of highly diverse South African samples. HLA*PRG, Kourami and xHLA do not support long-read data. Complete validation results by cohort, a description of the validation cohorts and accessions, and truth HLA types are given in Supplementary Table S1, Supplementary Note S2 and Supplementary Table S2. Computational requirements depend on sample type and coverage (0.65 CPU hours on average for exome samples; between 2.9 and 14 CPU hours for a typical WGS sample; Supplementary Table S3). Assembly typing was successfully applied to assess diploid MHC assembly quality and phasing accuracy in two recent de novo assembly projects (Jain et al., 2018; Koren et al., 2018).

Table 1.

Summary validation results

CohortLocusNHLA*PRG
Kourami
xHLA
HLA*LA
Call rateAccuracyCall rateAccuracyCall rateAccuracyCall rateAccuracy
Illumina WGSA281.001.001.000.961.001.001.001.00
B281.001.001.001.001.001.001.001.00
C281.001.001.001.001.001.001.001.00
DQA1181.001.001.001.000.00NA1.001.00
DQB1281.001.001.001.001.001.001.001.00
DRB1281.000.961.001.001.001.001.000.96
Illumina exomeA581.000.860.760.911.000.981.000.93
B481.000.850.630.871.000.881.000.92
C561.000.790.610.971.000.961.000.88
DQA1581.000.951.000.970.00NA1.000.97
DQB1581.000.980.970.961.000.951.000.98
DRB1581.000.911.000.971.000.981.000.91
Long-read WGSA6NANANA1.001.00
B61.001.00
C61.001.00
DQA161.001.00
DQB161.001.00
DRB161.000.83
Long-read targetedA360NANANA1.001.00
B3621.001.00
C3621.001.00
DQA13181.000.97
DQB13621.000.97
DRB12801.000.95
CohortLocusNHLA*PRG
Kourami
xHLA
HLA*LA
Call rateAccuracyCall rateAccuracyCall rateAccuracyCall rateAccuracy
Illumina WGSA281.001.001.000.961.001.001.001.00
B281.001.001.001.001.001.001.001.00
C281.001.001.001.001.001.001.001.00
DQA1181.001.001.001.000.00NA1.001.00
DQB1281.001.001.001.001.001.001.001.00
DRB1281.000.961.001.001.001.001.000.96
Illumina exomeA581.000.860.760.911.000.981.000.93
B481.000.850.630.871.000.881.000.92
C561.000.790.610.971.000.961.000.88
DQA1581.000.951.000.970.00NA1.000.97
DQB1581.000.980.970.961.000.951.000.98
DRB1581.000.911.000.971.000.981.000.91
Long-read WGSA6NANANA1.001.00
B61.001.00
C61.001.00
DQA161.001.00
DQB161.001.00
DRB161.000.83
Long-read targetedA360NANANA1.001.00
B3621.001.00
C3621.001.00
DQA13181.000.97
DQB13621.000.97
DRB12801.000.95
Table 1.

Summary validation results

CohortLocusNHLA*PRG
Kourami
xHLA
HLA*LA
Call rateAccuracyCall rateAccuracyCall rateAccuracyCall rateAccuracy
Illumina WGSA281.001.001.000.961.001.001.001.00
B281.001.001.001.001.001.001.001.00
C281.001.001.001.001.001.001.001.00
DQA1181.001.001.001.000.00NA1.001.00
DQB1281.001.001.001.001.001.001.001.00
DRB1281.000.961.001.001.001.001.000.96
Illumina exomeA581.000.860.760.911.000.981.000.93
B481.000.850.630.871.000.881.000.92
C561.000.790.610.971.000.961.000.88
DQA1581.000.951.000.970.00NA1.000.97
DQB1581.000.980.970.961.000.951.000.98
DRB1581.000.911.000.971.000.981.000.91
Long-read WGSA6NANANA1.001.00
B61.001.00
C61.001.00
DQA161.001.00
DQB161.001.00
DRB161.000.83
Long-read targetedA360NANANA1.001.00
B3621.001.00
C3621.001.00
DQA13181.000.97
DQB13621.000.97
DRB12801.000.95
CohortLocusNHLA*PRG
Kourami
xHLA
HLA*LA
Call rateAccuracyCall rateAccuracyCall rateAccuracyCall rateAccuracy
Illumina WGSA281.001.001.000.961.001.001.001.00
B281.001.001.001.001.001.001.001.00
C281.001.001.001.001.001.001.001.00
DQA1181.001.001.001.000.00NA1.001.00
DQB1281.001.001.001.001.001.001.001.00
DRB1281.000.961.001.001.001.001.000.96
Illumina exomeA581.000.860.760.911.000.981.000.93
B481.000.850.630.871.000.881.000.92
C561.000.790.610.971.000.961.000.88
DQA1581.000.951.000.970.00NA1.000.97
DQB1581.000.980.970.961.000.951.000.98
DRB1581.000.911.000.971.000.981.000.91
Long-read WGSA6NANANA1.001.00
B61.001.00
C61.001.00
DQA161.001.00
DQB161.001.00
DRB161.000.83
Long-read targetedA360NANANA1.001.00
B3621.001.00
C3621.001.00
DQA13181.000.97
DQB13621.000.97
DRB12801.000.95

4 Conclusion

In summary, HLA*LA improves upon the accuracy of its predecessor HLA*PRG, while being 3–10 times faster and extending HLA typing functionality to long reads and assemblies. HLA*LA is freely available from GitHub and as a bioconda package (Gruning et al., 2018). Generalization of projection-based graph alignment beyond the HLA is a topic for future research.

Acknowledgements

We thank Tina Graves Lindsay and Washington University in St. Louis for public release of the PacBio NA12878 data. We would also like to thank Adrian V Hill, Manjinder Sandhu and others in his group (Cristina Pomilla) and the study participants and the clinic, laboratory, statistical and support staff at RMPRU for providing the South African data available for this study and for their helpful comments during manuscript preparation. We are grateful to all staff at Histogenetics for their involvement in PacBio and Miseq exon-targeted SBT of the South African samples.

Funding

This work was supported by the Intramural Research Program of the National Human Genome Research Institute, National Institutes of Health; the Jürgen Manchot Foundation, the Agence Nationale de la Recherche (ANR-11-LABX-0070_TRANSPLANTEX to S.B.); the INTERREG V European regional development fund (European Union) program (project 3.2 TRIDIAG to R.C., S.B.); a Wellcome Trust Fellowship (106289/Z/14/Z to A.J.M.); a European Research Council Advanced Grant (294557 to Adrian Hill); the Korean Visiting Scientist Training Award through the Korea Health Industry Development Institute, funded by the Ministry of Health & Welfare, Republic of Korea (HI17C2098 to A.R.).

Conflict of Interest: A.D. and G.M. are partners in Peptide Groove, LLP. G.M. is a cofounder of, holder of shares in, and consultant to Genomics, PLC. The other authors declare no competing financial interests.

References

1000 Genomes Project Consortium et al.  (

2012
)
An integrated map of genetic variation from 1,092 human genomes
.
Nature
,
491
,
56
65
.

Bai
 
Y.
 et al.  (
2014
)
Inference of high resolution HLA types using genome-wide RNA or DNA sequencing reads
.
BMC Genomics
,
15
,
325
.

Carapito
 
R.
 et al.  (
2016
)
Matching for the nonconventional MHC-I MICA gene significantly reduces the incidence of acute and chronic GVHD
.
Blood
,
128
,
1979
1986
.

Delcher
 
A.L.
 et al.  (
2002
)
Fast algorithms for large-scale genome alignment and comparison
.
Nucleic Acids Res
.,
30
,
2478
2483
.

Dilthey
 
A.
 et al.  (
2015
)
Improved genome inference in the MHC using a population reference graph
.
Nat. Genet
.,
47
,
682
688
.

Dilthey
 
A.T.
 et al.  (
2016
)
High-accuracy HLA type inference from whole-genome sequencing data using population reference graphs
.
PLoS Comput. Biol
.,
12
,
e1005151
.

Eberle
 
M.A.
 et al.  (
2017
)
A reference data set of 5.4 million phased human variants validated by genetic inheritance from sequencing a three-generation 17-member pedigree
.
Genome Res
.,
27
,
157
164
.

Gruning
 
B.
 et al.  (
2018
)
Bioconda: sustainable and comprehensive software distribution for the life sciences
.
Nat. Methods
,
15
,
475
476
.

Huang
 
Y.
 et al.  (
2015
)
HLAreporter: a tool for HLA typing from next generation sequencing data
.
Genome Med
.,
7
,
25
.

International HapMap, C. (

2005
)
A haplotype map of the human genome
.
Nature
,
437
,
1299
1320
.

Jain
 
M.
 et al.  (
2018
)
Nanopore sequencing and assembly of a human genome with ultra-long reads
.
Nat. Biotechnol
.,
36
,
338
345
.

Koren
 
S.
 et al.  (
2018
)
De novo assembly of haplotype-resolved genomes with trio binning
.
Nat. Biotechnol
.,
36
,
1174
1182
.

Lee
 
H.
,
Kourami
K.C.
(
2018
)
Graph-guided assembly for novel human leukocyte antigen allele discovery
.
Genome Biol
.,
19
,
16.

Li
 
H.
(
2013
)
Aligning sequence reads, clone sequences and assembly contigs with BWA-MEM
. https://arxiv.org/abs/1303.3997.

Robinson
 
J.
 et al.  (
2015
)
The IPD and IMGT/HLA database: allele variant databases
.
Nucleic Acids Res
.,
43
,
D423
D431
.

Schneider
 
V.A.
 et al.  (
2017
)
Evaluation of GRCh38 and de novo haploid genome assemblies demonstrates the enduring quality of the reference assembly
.
Genome Res
.,
27
,
849
864
.

Steinberg
 
K.M.
 et al.  (
2016
) High-quality assembly of an individual of yoruban descent. https://doi.org/10.1101/067447.

Trowsdale
 
J.
,
Knight
J.C.
(
2013
)
Major histocompatibility complex genomics and human disease
.
Annu. Rev. Genomics Hum. Genet
.,
14
,
301
323
.

Wittig
 
M.
 et al.  (
2015
)
Development of a high-resolution NGS-based HLA-typing and analysis pipeline
.
Nucleic Acids Res
.,
43
,
e70
.

Xie
 
C.
 et al.  (
2017
)
Fast and accurate HLA typing from short-read next-generation sequence data with xHLA
.
Proc. Natl. Acad. Sci. USA
,
114
,
8059
8064
.

This is an Open Access article distributed under the terms of the Creative Commons Attribution License (http://creativecommons.org/licenses/by/4.0/), which permits unrestricted reuse, distribution, and reproduction in any medium, provided the original work is properly cited.
Associate Editor: Bonnie Berger
Bonnie Berger
Associate Editor
Search for other works by this author on:

Supplementary data