Skip to main content

Evaluating genome architecture of a complex region via generalized bipartite matching

Abstract

With the remarkable development in inexpensive sequencing technologies and supporting computational tools, we have the promise of medicine being personalized by knowledge of the individual genome. Current technologies provide high throughput, but short reads. Reconstruction of the donor genome is based either on de novo assembly of the (short) reads, or on mapping donor reads to a standard reference. While such techniques demonstrate high success rates for inferring 'simple' genomic segments, they are confounded by segments with complex duplication patterns, including regions of direct medical relevance, like the HLA and the KIR regions.

In this work, we address this problem with a method for assessing the quality of a predicted genome sequence for complex regions of the genome. This method combines two natural types of evidence: sequence similarity of the mapped reads to the predicted donor genome, and distribution of reads across the predicted genome. We define a new scoring function for read-to-genome matchings, which penalizes for sequence dissimilarities and deviations from expected read location distribution, and present an efficient algorithm for finding matchings that minimize the penalty. The algorithm is based on a formal problem, first defined in this paper, called C overage S ensitive many-to-many min-cost bipartite M atching (CSM). This new problem variant generalizes the standard (one-to-one) weighted bipartite matching problem, and can be solved using network flows. The resulting Java-based tool, called SAGE (S coring function for A ssembled GE nomes), is freely available upon request. We demonstrate over simulated data that SAGE can be used to infer correct haplotypes of the highly repetitive KIR region on the Human chromosome 19.

Introduction

The inexorable drop in costs and rise in throughput of DNA sequencing is driving a future in which every individual person will have their genome sequenced, perhaps multiple times in their lifetimes [1]. Current high throughput technologies produce sequenced read fragments from donor genomes, which are then used for inferring the complete genomic sequence. The main algorithmic approaches for inferring a donor genome from a set of its sequenced reads are either based on de novo assembly [2, 3], i.e. producing a parsimonious super-string that approximately contains most reads as its substrings, or based on mapping approaches [4–6], in which the algorithm takes the read set and a previously sequenced reference genome (or a set of reference genomes), maps the reads to the reference, and uses the identified similarities and variations in order to predict the donor genome.

While the accuracies of sequencing technologies keep improving and their usage costs keep decreasing, many of them still produce reads of relatively short lengths. Reconstruction of repetitive genomic regions using the mentioned approaches is considered more challenging, due to the fact that short reads may be de-novo assembled, or mapped to the reference, in multiple ambiguous manners. The difficulty even increases for diploid genomes, limiting the investigation of many important genomic regions, such as the killer cell immunoglobulin like receptor (KIR) region (located in humans within the 1Mb Leucocyte Receptor Complex 19q13.4, see Figure 1b), the 3.6Mbp Human Leucocyte Antigen (HLA) region and others, which exhibit highly repetitive sequences and extensive polymorphisms.

Figure 1
figure 1

KIR region. (a) Variability of gene architecture in KIR haplotypes (derived from Hsu [10]). (b) Complex repeat structure in a KIR haplotype, as observed by a dot-plot of FH05A against FH05A. The different genes all show significant sequence similarity. Dot-plot prepared using Gepard [22].

Here, we address the problem of assessing the quality of a donor genome prediction given the set of its sequenced reads, confronting difficulties related to genomic regions of repetitive nature. We present a prediction quality measure a prediction quality measure which is independent of the approach used for generating the prediction. It combines scoring penalties related to both (a) imperfect alignments of the reads to the predicted region, and (b) deviations between the expected and actual read coverage of segments of the region. Our tool differs from previous ones which compare predictions to a known reference. For example, tools that evaluate the quality of de-novo assemblies [7] rely on comparing assembled genomes to known references. Mapping tools [8, 9] can be used to provide a naive scoring function comparable to SAGE by summing up the best alignment score of each read. This naive scoring function only optimizes the alignment of the reads and does not take into account read coverage. Our results show the advantage of simultaneously optimizing the combined alignment and coverage score by comparing our tool to the naive approach.

In order to evaluate the new cost function, we applied it to the KIR, a hyper-variable region known to be important for the immediate immune response in humans and higher mammals [10]. The KIR region is challenging to reconstruct from sequence read fragments due to its variable gene architecture (Figure 1a) and repetitive nature (Figure 1b). We show that our scoring function allows us to correctly identify KIR haplotype templates in diploid genomes, differentiating correct predictions form incorrect ones based on their computed score, while the naive approach fails in many cases to predict the correct template.

Our cost function for evaluating donor genome predictions is based on a new variant of a bipartite matching problem, entitled Coverage Sensitive many-to-many min-cost bipartite Matching (CSM), which is a many-to-many generalization of the classical min-cost (or max-weight) bipartite matching problem [11, 12]. The formal definition of the CSM problem is given in the next section. While in general CSM is NP-Hard (see Additional File 1), we show a special "convexed" case for which CSM can be efficiently solved by reducing it to a network flow problem, similar to many other variants of bipartite matching problems [12]. Optimal matching/flow algorithms were recently used by several related works to predict structural variations between genomes. Examples to such works include [13], in which min-cost flow was used to call copy number variations between a reference and a donor genome, [14], which used maximum-weight matching in order to reconstruct breakpoint sequences in long genomic insertions, and [15], which used maximum-flow in order to apply a post-process refinement of simultaneous detection of structural variations in multiple genomes.

Coverage Sensitive many-to-many min-cost bipartite Matching (CSM)

The CSM problem is a many-to-many generalization of the classical min-cost bipartite matching problem [12]. We describe the problem in an abstract setting, and cast it to a read alignment problem in the next section.

Consider arbitrary sets X and Y. A many-to-many matching (henceforth a matching) between X and Y is a set M of pairs {(x, y) ∈ X × Y} (see Figure 2, (a), (b), (c). The coverage of an element x ∈ X with respect to a matching M is c M (x) = |{y : (x, y) ∈ M}|. Symmetrically, c M (y) = |{x : (x, y) ∈ M}| for y ∈ Y .

Figure 2
figure 2

Matching instance and its reduction to a cost flow network. (a) A bipartite graph corresponding to sets X and Y. In our particular application, X represents a set of reads and Y represents a set of genomic segments, where the expected coverage of each read is one and segments are expected to be uniformly covered. Each read x ∈ X potentially maps to multiple segments, illustrated by the edges in the graph. An edge (x, y) has the weight w m (x, y), reflecting the best similarity between read x and a substring of of the genome starting at segment y. (b) and (c) depict two possible matchings. In (b), one of the y segments is covered by four reads, while the other two segments are covered by one read each. In (c), each segment is covered by two reads. It is possible that the matching in (b) is better in terms of sequence similarity, though is unrealistic in terms of segment coverage, which would make the matching in (c) preferable. (d) The corresponding network. Each pair of consecutive layers is a bipartite graph with capacities c and costs w' as described.

A coverage sensitive matching cost function (henceforth a cost function) w for X and Y assigns matching costs w m (x, y) for every pair (x, y) ∈ X × Y , and coverage costs w c (z, i) for every z ∈ X ∪ Y and every integer i ≥ 0. The cost of a matching M between X and Y with respect to w is given by

w ( M ) = ∑ ( x , y ) ∈ M w m ( x , y ) + ∑ z ∈ X ∪ Y w c ( z , c M ( z ) )
(1)

The CSM problem

Input: A Matching Instance (X, Y, w) consisting of sets X, Y, and cost function w.

Output: Compute CSM ( X , Y , w ) = min M ⊆ X × Y w ( M ) .

Note that CSM is a generalization of classical problems in combinatorics. For example, consider the problem of finding a maximum (partial one-to-one) matching on a bipartite graph G with vertex shores X, Y, and an edge set E. This problem can be solved by solving CSM on the input X, Y using the following costs: set w c (z, 0) = w c (z, 1) = 0, and w c (z, i) = ∞ for all z ∈ X ∪ Y, i > 1; set w m (x, y) = -1 for (x, y) ∈ E and otherwise set w m (x, y) = ∞. Similarly, CSM can also be used for solving the minimum/maximum weight variants of the bipartite matching problem. However, CSM is NP-hard in general (see Additional File 1), and therefore we do not expect to solve the general instance efficiently.

CSM with convex coverage costs

Let (X, Y, w) be a matching instance. We say that w has convex coverage costs if for every element z ∈ X ∪ Y and every integer i > 0, w c ( z , i ) ≤ w c ( z , i - 1 ) + w c ( z , i + 1 ) 2 . We show here that CSM with convex coverage costs can be reduced to the poly-time solvable min-cost integer flow problem [11].

For x ∈ X, denote d x = |{y : w m (x, y) <∞}|, and similarly d y = |{x : w m (x, y) <∞}| for y ∈ Y . Denote d X = max x ∈ X d x and d Y = max y ∈ Y d y . The reduction builds the flow network N = (G, s, t, c, w'), where G is the network graph, s and t are the source and sink nodes respectively, and c and w' are the edge capacity and cost functions respectively. The graph G = (V, E) is defined as follows (Figure 2d).

  • ♦ V = X ∪ Y ∪ CX∪ CY∪ {s, t}, where the sets C X = { c 1 X , c 2 X , . . . , c d X X } , C Y = { c 1 Y , c 2 Y , . . . , c d Y Y } , and {s, t} contain unique nodes different from all nodes in X and Y . Note that we use the same notations for elements in X and Y and their corresponding nodes in V, where ambiguity can be resolved by the context.

  • ♦ E = E1 ∪ E2 ∪ E3 ∪ E4 ∪ E5, where

    • E 1 = { ( s , c i X ) : c i X ∈ C X } ,

    • E 2 = { ( c i X , x ) : c i X ∈ C X , x ∈ X , d x ≤ i } ,

    • E 3 = { ( x , y ) : x ∈ X , y ∈ Y , w m ( x , y ) < ∞ } ,

    • E 4 = { ( y , c i Y ) : y ∈ Y , c i Y ∈ C Y , d y ≤ i } ,

    and

    • E 5 = { ( c i Y , t ) : c i Y ∈ C Y } .

The capacity function c assigns infinity capacities to all edges in E1 and E5 and unit capacities to all edges in E2, E3 and E4. The cost function w' assigns zero costs to edges in E1 and E5, costs w c (x, i) - w c (x, i - 1) to edges ( c i X , x ) ∈ E 2 , costs w c (y, i) - w c (y, i - 1) to edges ( y , c i Y ) ∈ E 4 , and costs w m (x, y) to edges (x, y) ∈ E3. For E' ⊆ E, denote w ' ( E ′ ) = ∑ e ∈ E ′ w ' ( e ) . An integer flow in N is a function f : E → {0, 1, 2, . . .}, satisfying that f(e) ≤ c(e) for every e ∈ E (capacity constraints), and ∑ u : ( u , v ) ∈ E f ( u , v ) = ∑ u : ( u , v ) ∈ E f ( v , u ) for every v ∈ V \ {s, t} (flow conservation constraints). The cost of a flow f in N is defined by w ' f = ∑ e ∈ E f ( e ) w ' ( e ) .

In what follows, let (X, Y, w) be a matching instance where w has convex coverage costs, and let N be its corresponding network. Due to the convexity requirement, for every x ∈ X and every integer i > 0, w ' ( c i + 1 X , x ) - w ' ( c i X , x ) = ( w c ( x , i + 1 ) - w c ( x , i ) ) - ( w c ( x , i ) - w c ( x , i - 1 ) ) = w c ( x , i + 1 ) + w c ( x , i - 1 ) - 2 w c ( x , i ) ≥ 0 . Similarly, for every y ∈ Y and every integer i > 0, w ' ( y , c i + 1 Y ) - w ' ( y , c i Y ) ≥ 0 , and we get the following observation:

Observation 1. Series of the form w' ( c 1 X , x ) ,w' ( c 2 X , x ) ,... and w' ( y , c 1 Y ) ,w' ( y , c 2 Y ) ,...are non-decreasing. Consequentially, for every E ′ ⊆ { ( c i X , x ) : x ∈ X , 1 ≤ i ≤ d x } and E ″ = { ( c i X , x ) : x ∈ X , 1 ≤ i ≤ | E ′ | } ,w' ( E ″ ) ≤w' ( E ′ ) , and similarly for E ′ ⊆ { ( y , c i Y ) : y ∈ Y , 1 ≤ i ≤ d y } and E ″ = { ( y , c i Y ) : y ∈ Y , 1 ≤ i ≤ | E ′ | } .

Given a flow f in N, define the matching M f = {(x, y) : (x, y) ∈ E3, f(x, y) = 1}. Denote E x f = { ( c i X , x ) : f ( c i X , x ) = 1 } and E y f = { ( y , c i Y ) : f ( y , c i Y ) = 1 } . Since for edges e ∈ E1 ∪ E5 we have that w'(e) = 0, and since for edges e ∈ E2 ∪ E3 ∪ E4 we have that f(e) ∈ {0, 1} (due to capacity constraints), we can write

w ' ( f ) = ∑ e ∈ E f ( e ) w ' ( e ) = ∑ e ∈ E 2 ∪ E 3 ∪ E 4 f ( e ) = 1 w ' ( e ) = w ' ( M f ) + ∑ x ∈ X w ' ( E x f ) + ∑ y ∈ Y w ' ( E y f ) .
(2)

Given a non-infinity cost matching M between X and Y, define the flow f M in N as follows:

  • ♦ For every (x, y) ∈ E3, f (x, y) = 1 if (x, y) ∈ M, and otherwise f(x, y) = 0;

  • ♦ For every ( c i X , x ) ∈ E 2 ,f ( c i X , x ) =1 if c M (x) ≤ i, and otherwise f ( c i X , x ) =0;

  • ♦ For every ( y , c i Y ) ∈ E 4 , f ( y , c i Y ) =1 if c M (y) ≤ i, and otherwise f ( y , c i Y ) =0;

  • ♦ For every ( s , c i X ) ∈ E 1 ,f ( s , c i X ) =| { x : f ( c i X , x ) = 1 } |;

  • ♦ For every ( c i Y , t ) ∈ E 5 ,f ( c i Y , t ) =| { y : f ( y , c i Y ) = 1 } |.

It is simple to assert that f M is a valid flow in N (satisfying all capacity and flow conservation constraints), and that M f M =M.

Claim 1. For every flow f in N, w' ( f M f ) ≤w' ( f ) .

Proof. From flow conservation constraints | E x f |=| E x f M f |= c M f ( x ) for every x ∈ X, where in particular by definition we have that E x f M f = { ( c i X , x ) : 1 ≤ i ≤ c M f ( x ) } Therefore, it follows from Observation 1 that w' ( E x f M f ) ≤w' ( E x f ) for every x ∈ X, and similarly it may be shown that w' ( E x f M f ) ≤w' ( E x f ) for every y ∈ Y. Hence,

w ' ( f M f ) = Eq . 2 w ' ( M f M f ) + ∑ x ∈ X w ' ( E x f M f ) + ∑ y ∈ Y w ' ( E y f M f ) ≤ w ' ( M f ) + ∑ x ∈ X w ' ( E x f ) + ∑ y ∈ Y w ' ( E y f ) = Eq . 2 w ' ( f ) .

â–¡

Denote Δ=Δ ( X , Y , w ) = ∑ z ∈ X ∪ Y w c ( z , 0 ) , and note that Δ depends only on the instance (X, Y, w) and not on any specific matching.

Claim 2. For every matching M between × and Y, w'(f M ) = w(M) - Δ.

Proof. For x ∈ X, we have that w ' ( E x f M ) = w ' ( c 1 X , x ) + w ' ( c 2 X , x ) + . . . + w ' ( c c M ( x ) X , x ) = ( w c ( x , 1 ) - w c ( x , 0 ) ) + ( w c ( x , 2 ) - w c ( x , 1 ) ) + . . . + ( w c ( x , c M ( x ) ) - w c ( x , c M ( x ) - 1 ) ) = w c ( x , c M ( x ) ) - w c ( x , 0 ) , and similarly w' ( E y f M ) = w c ( y , c M ( y ) ) - w c ( y , 0 ) for y ∈ Y. Therefore,

w ' ( f M ) = Eq . 2 w ' ( M ) + ∑ x ∈ X w ' ( E x f M ) + ∑ y ∈ Y w ' ( E y f M ) = w ' ( M ) + ∑ x ∈ X ( w c ( x , c M ( x ) ) - w c ( x , 0 ) ) + ∑ y ∈ Y ( w c ( y , c M ( y ) ) - w c ( y , 0 ) ) = ∑ ( x , y ) ∈ M w m ( x , y ) + ∑ z ∈ X ∪ Y w c ( z , c M ( z ) ) - ∑ z ∈ X ∪ Y w c ( z , 0 ) = Eq . 1 w ( M ) - Δ .

â–¡

Claim 3. Let f* be a minimum cost flow in N. Then, M f* is a minimum cost matching between X and Y, and CSM(X, Y, w) = w'(f*) + Δ.

Proof. Since f* is a minimum cost flow in N, w ' ( f * ) ≤ w ' ( f M f * ) ≤ Clm . 1 w ' ( f * ) , thus w' ( f * ) =w' ( f M f * ) . Let M be a matching between X and Y. Again, from the optimality of f*, w'(f*) ≤ w'(f M ) and so w ( M f * ) - Δ = C l m . 2 w ' ( f M f * ) = w ' ( f * ) ≤ w ' ( f M ) = C l m . 2 w ( M ) - Δ , and in particular w ( M f * ) ≤w ( M ) . Thus, M f * is a minimum cost matching for (X, Y, w), and so CSM ( X , Y , w ) =w ( M f * ) = C l m . 2 w' ( f * ) +Δ.

â–¡

Constructing CSM instance from read mapping data

Consider a set of reads and a prediction of the genomic sequence (henceforth, the "prediction") from which the reads were extracted. It is assumed that the sequencing procedure produces reads with some sequencing error probability, and that read extraction positions along the genome adhere to some expected distribution. The probability for extracting a read starting at a given position may depend on the sequential context at this position and its location along the genome. Given such probabilities, it is possible to compute for a given segment of the prediction an expected amount of extracted reads starting within this segment. Such an amount of expected reads will be referred to here as the expected coverage of the segment. Hence, we can argue that the reads well support the prediction in case it is possible to assign to each read a position within the prediction, from which it was presumably extracted, in a manner that (a) each read sequence approximately matches the substring of the prediction starting at the assigned position, and (b) for every segment of the prediction, the amount of reads assigned to positions within this segment does not deviate significantly from the expected coverage of the segment. On the other hand, when no such position assignment can be found, it is suggestive that the prediction exhibits some variation with respect to the true genome.

Given a predicted region, a mapping between the reads and the prediction is a function that assigns to each read a set of positions in the region from which it is possible to extract the read (with some allowed amount of sequencing errors). Software tools for producing such mappings exist (e.g. Bowtie [8]) and are widely used. Ideally, if the prediction is in fact the correct genomic sequence from which the reads were extracted, and this region is non-repetitive, it is expected that a mapping would assign to each read a unique position that is the true position from which it was extracted. Nevertheless, when the sequence contains repeats, and sequencing errors are not negligible, it is expected that some of the reads will be mapped to multiple positions (due to the repeats), while others may not be mapped to any position (due to sequencing errors). Given a mapping between the reads and the region, we define a read-to-genome matching as a function that selects for each read at most one corresponding position among its set of positions given by the mapping, from which it was presumably extracted. A read-to-genome matching better supports the prediction the more reads it matches to the genome, the higher the similarity is between reads and their matching positions, and the smaller the deviation is between the expected coverage and the coverage implied by the matching positions.

The quality of a read-to-genome matching can be naturally evaluated using the CSM formalism described in the previous section. A matching instance (X, Y, w) can be generated, choosing X to be the set of reads, and Y to be a partition of the prediction into segments (where each element in Y corresponds to a segment in the partition). For each read x ∈ X and each segment y ∈ Y, w m (x, y) is set to the best sequence similarity score between x and a substring of the prediction starting at y (such similarity scores may be generated by tools such as Bowtie [8]), or set to ∞ if no substring starting at y is similar to x. The coverage cost function for a read x ∈ X sets w c (x, 0) to some penalty added to the score in case x is unmatched, sets w c (x, 1) to 0 (no penalty is added when x participates in the matching), and w c (x, i) for i > 1 to ∞ (a matching in which a read is assigned to more than one position is illegal, and has an infinite cost). For a segment y ∈ Y, it is possible to compute the expected coverage c y of y, and generate a convex score function f(i) whose minimum point is at i = c y , and set w c (y, i) = f (i) for every nonnegative integer i. The cost of an optimal matching for this instance can then serve as a quality measure for the prediction.

Implementation

We implemented the CSM algorithm as a java based tool named SAGE, a S coring function for A ssembled GE nomes. The inputs to SAGE are a set of reads, R, mapped to a genomic template, G, in the BAM format [16] along with a parameter file containing alignment costs, unmatched read penalty, genome segmentation, expected segment coverage values, and a choice of coverage cost functions (currently linear and polynomial cost functions).

Results

We tested SAGE on the hypervariable KIR region. The KIR region, while variable, is tightly organized and contains between 8 and 14 genes, and 2 pseudo-genes (Figure 1a) [17]. The genes are organized into two adjacent regions, each bordered by two anchoring genes/pseudo-genes: KIR3DL3 and 3DP1 for the centromeric region; 2DL4 and 3DL2 for the telomeric region. Variability within KIR is expressed in the form of changing gene numbers, gene-copy numbers, and gene polymorphisms. There are two broad types of KIR haplotypes- Type A and Type B- that are distinguished by their gene content. Type A haplotypes are characterized by the absence of the following genes: {KIR-2DL5, -2DS1, -2DS2, -2DS3, -2DS5, -3DS1}, while Type B haplotypes contain one or more of these genes [18]. Type B haplotypes can be split further into different sub-types, characterized by the gene content on the centromeric-side and telomeric-side. The various (sub-)types of KIR haplotypes are denoted by {A, AB, BA1, BA2, BA2X, Bdel, B}. However, the typing is incompletely developed, and is likely to change as more data is acquired.

To test the effectiveness of SAGE on a variety of haplotype types, we simulated reads from 27 known KIR haplotypes using GemSIM [19] with an error model learned from paired-end (100 × 2)bp reads generated by Illumina GA IIx with TrueSeq SBS Kit v5-GA [19]. The 27 haplotype templates were taken from the IPD-KIR database [20]. The sequences of these templates were obtained experimentally by first separating the two haplotypes of an individual using fosmid-pools, determining the gene content and architecture of each haplotype using STS assays, and then finally sequencing the individual fosmids [21].

Before we ran SAGE, we mapped each read set, R, back to each template, G, using Bowtie. We ran Bowtie under the '-a' option with all other parameters set to the default, in order to obtain a set of all possible mapping locations and their corresponding alignment costs for each read, which was used as input into SAGE. The mapping position of a paired-end read was set to be the genomic index to which the first character of the first sub-read was aligned. The alignment cost for a complete (100 × 2)bp paired-end read varied between 0 and 180, with 0 corresponding to identity. When two paired-ends mapped in a concordant manner, the total alignment cost for the read was calculated by adding the alignment cost of both paired-ends. When a paired-end did not have a concordant mate, suggestive of incorrect architecture, the alignment cost was further penalized by adding a cost of 90, which is the maximum penalty for one paired-end. The unmatched read penalty was constant for all reads and set to 100. On the other side, the genome G was partitioned to segments of fixed length of 1000bp (except for the last segment which may be shorter), with expected coverage per segment given by λ = 1000 | R | | G | (with the appropriate adjustment for the last segment), where |R| and |G| denote the number of reads and the length of the genome, respectively. To allow for natural variation in coverage, the quadratic function, f(i) = (λ - i)2, was chosen as the segment coverage cost function.

To the best of our knowledge, SAGE is the first tool that scores templates given a set of reads. As there is no competing tool, we compared SAGE results against a naive approach that ignores coverage and sums up the best alignment score for each read to obtain a total score for each read set and template. The scores obtained by this approach will be referred to as the Bowtie scores below.

Haploid templates

As a first pass, we tested SAGE's ability to score haploid templates. We scored each of the 27 read sets against each of the 27 templates using SAGE. A visualization of the scores are shown in Figure 3, where the templates are organized by sequence similarity so that templates of the same type/sub-type are clustered together. Note that the matrix is not symmetric. Each row corresponds to the scores of a single read data set against a collection of haploid templates. As can be seen, SAGE always gets the top-score for the correct template. Moreover, the other templates from the same sub-type get progressively weaker scores. Major haplotypes fall within distinct blocks, but the scores also suggest a hierarchy within the subtypes that can be studied further.

Figure 3
figure 3

Scoring simulated reads against haploid templates using SAGE. Each row contains the color-coded percentage from the top-score of a read-set mapped against 27 genomic templates. Black: top-score; Red: within 5% of top-score; Orange: ≤ 10%; Yellow: ≤ 20%; White: > 20% below top-score. Sequences are ordered along the rows and columns so that sequences with the same (sub-)type are adjacent to each other. Templates of the same type are indicated by the blue boxes, and those of the same sub-type by light blue boxes.

Dipolid templates

To test scoring on more realistic templates, we simulated reads from 9 diploid individuals whose pair of haploid templates were obtained experimetally in Pyo et al. [21] and are in the IPD-KIR database [20]. The 9 diploid templates from this study fell into one of 6 combination of sub-types. We scored each of the 9 simulated read sets against each of the 9 diploid templates using SAGE. In all but one case, SAGE (Figure 4a) and Bowtie (Figure 4b) predicted the correct diploid template of the donor. Furthermore, SAGE is better at predicting the sub-type of the donor template than Bowtie. When the donor template is not in database, as is usually the case in practice, SAGE will give a better score to templates that are more similar to the donor while Bowtie may not. For example, row 3 of Figure 4(a, b) show the scores when the donor template is of type A and BA1. Both SAGE and Bowtie correctly gave the best score to the diploid template G085-A/BA1. However, the template with the next best SAGE score was also of sub-type A/BA1, while the template with the next best Bowtie score was of subtype A/BA2.

Figure 4
figure 4

Scoring simulated reads against diploid templates. Each row of a matrix represent scores from the same read sets mapped to different prediction templates. The scores are normalized so that the second best score in each row is equal to 1 and the worst score is equal to 0. We normalize with respect to the second best score since it would be used to predict the haplotype in the absence of the best scoring (and presumably correct) template. Furthermore, the entries are color-coded accordingly- Black: top-score; Red: second top-score; Orange: within 10% of second top-score; Light Orange: ≤ 20%; Yellow: ≤ 30%; White: > 30% below top-score. Both matrices are ordered according to template sub-types. Templates of the same type are indicated by the blue boxes. (a) SAGE scores (b) Bowtie scores.

In general, coverage plays an important role in determining the correct haplotype. Figure 5(b-e) show the coverage plots when reads from donor template G085-A/BA1 are mapped to a template of the same sub-type (F06-A/BA1) and a template of a different sub-type (FH13-A/BA2) using SAGE and Bowtie. When mapped to templates of the same sub-type (Figure 5(b, d)), the coverage plots for both SAGE and Bowtie show less variance when compared to the coverage plots of the other templates (Figure 5(c, e)). Bowtie does not take into account variance of coverage and scores the template of a different sub-type (FH13-A/BA2) higher than the template of the same sub-type (F06-A/BA1). On the contrary, SAGE penalizes for the variance in coverage, and correctly predicts the sub-type of the donor. Furthermore, if several possible mappings of a read are given, SAGE can be used to determine the best mapping. In Figure 5(b, c), we see less variability in the coverage plots from SAGE's matching compared against those of Bowtie's matching (Figure 5(d, e)). Therefore, even if Bowtie is able to determine the correct donor template, it may not output the correct mapping.

Figure 5
figure 5

Coverage plots for reads sampled from G085-A/BA1 templates. (a) genomic architecture of of G085-A/BA1, FH06-A/BA1, and FH13-A/BA2. SAGE coverage plots when reads are extracted from G085A/BA1 and mapped to (b) FH06-A/BA1 and (c) FH13 A/BA2. Bowtie coverage plots when reads are extracted from G085A/BA1 and mapped to (d) FH06-A/BA1 and (e) FH13-A/BA2.

Running time

For a data-set with n reads and a total of m read mapping locations, SAGE scales as O(nm + n2 log n). Thus, on our data-sets with haploid genomes of average length 166Kbp (166 1000bp-segments), and ~ 24,900 reads, SAGE ran in 21 seconds. The running time increased to 210 seconds for the average diploid genome (~ 332 1000bp-segments, ~ 49,800 reads). Running times were recorded using a 4 core Intel 2.66GHz processor with 9Gb of RAM.

Discussion and conclusions

To the best of our knowledge, SAGE is the first tool that scores predicted donor templates given a set of sequenced reads. Our results on the KIR region show that SAGE can be used to predict the sub-type of the donor KIR template, and can be directly used for haplotyping this region. Furthermore, SAGE scores the correct template higher than even templates of the same sub-type.

While we focused our attention on the KIR region, SAGE is general enough to be applied to any complex region. It is also possible to implement many different scoring functions, which would allow the user to obtain optimal matchings according to his own custom scores. For example, read unmatching penalties may be constant for all reads, or may be read-specific. A motivation for read specific costs is in the case where the sequencing phase produces some sequencing qualities for reads, and it is possible to "pay" less when not matching reads of lower sequencing quality. Similarly, it is possible to choose a segmentation of the prediction in which all segments are of the same length, and uniform coverage is assumed, or one with variable segment lengths and possibly different coverage cost functions for each segment. A motivation to such complex segmentation is e.g. in the case where one tries to identify a specific structural variation, such as a deletion of a segment of specific length around a specific region of the prediction. Setting lengths of segments in the examined region to the expected deletion length can increase the likelihood that an optimal matching would not add artifact matchings of reads to a long segment spanning the deleted segment, in order to compensate for low coverage of the deleted segment. Lastly, by using different coverage cost functions, it is possible to decide the rate in which penalty increases due to deviations of expected coverage, which may grow linearly, polynomially, exponentially, or based on other probabilistic models, as long as the function satisfies the convexity requirement.

Future work would involve extending the use of SAGE on real data. Some challenges in dealing with real data include obtaining the set of reads extracted from the region of interest (especially when sequencing data is likely taken from the whole genome) and providing the expected coverage. If we know the parameters of the sequencing run, we could use the target read coverage as the expected coverage; however, if that is unknown, we may be able to estimate the expected coverage from the number of reads we need to map to the region. For example, if we assume a uniform distribution of coverage, then the expected coverage per segment is simply the total length of the segment multiplied by | R | | G | .

Although haplotype analysis of the KIR region is medically relevant, the genomic complexity (i.e. repetitive nature and variable gene architecture) of this region makes it difficult to do a complete analysis. Indeed, the possible sub-types of this region have not been completely characterized. Thus, reconstruction of this region and other complex regions of the genome remain a worthwhile problem. SAGE takes the first step in reconstructing complex regions of the genome by providing a scoring function for predicted templates based on their similarity to the true donor. Therefore, it might be possible to obtain a complete reconstruction of the donor genome by iteratively refining predicted donor templates until SAGE scores are optimized. Furthermore, SAGE can also be applied for scoring de-novo assemblies and for comparing the accuracies of different assemblers.

Abbreviations

CSM:

Coverage Sensitive many-to-many min-cost Matching

SAGE:

Scoring function for Assembled Genomes

KIR:

Killer cell Immunoglobulin-like Receptor

HLA:

Human Leucocyte Antigen

References

  1. Hall Y: Coming Soon: Your Personal DNA Map?. National Geographic News. 2011

    Google Scholar 

  2. Li R, Zhu H, Ruan J, Qian W, Fang X, Shi Z, Li Y, Li S, Shan G, Kristiansen K, Li S, Yang H, Wang J, Wang J: De novo assembly of human genomes with massively parallel short read sequencing. Genome Research. 2010, 20 (2): 265-272. 10.1101/gr.097261.109.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  3. Pevzner PA, Tang H, Waterman MS: An Eulerian path approach to DNA fragment assembly. Proc Natl Acad Sci USA. 2001, 98 (17): 9748-9753. 10.1073/pnas.171285098.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  4. Havlak P, Chen R, Durbin KJ, Egan A, Ren Y, Song XZ, Weinstock GM, Gibbs RA: The Atlas genome assembly system. Genome Res. 2004, 14 (4): 721-732. 10.1101/gr.2264004.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  5. Kidd JM: Mapping and sequencing of structural variation from eight human genomes. Nature. 2008, 453: 56-64. 10.1038/nature06862.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  6. Mills RE: Mapping copy number variation by population-scale genome sequencing. Nature. 2011, 470: 59-65. 10.1038/nature09708.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  7. Salzberg SL, Phillippy AM, Zimin A, Puiu D, Magoc T, Koren S, Treangen TJ, Schatz MC, Delcher AL, Roberts M, Marcais G, Pop M, Yorke JA: GAGE: A critical evaluation of genome assemblies and assembly algorithms. Genome Res. 2012, 22 (3): 557-567. 10.1101/gr.131383.111.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  8. Langmead B, Salzberg S: Fast gapped-read alignment with Bowtie 2. Nature methods. 2012, 9 (4): 357-359. 10.1038/nmeth.1923.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  9. Li H, Durbin R: Fast and accurate long-read alignment with Burrows-Wheeler transform. Bioinformatics. 2010, 26 (5): 589-595. 10.1093/bioinformatics/btp698.

    Article  PubMed Central  PubMed  Google Scholar 

  10. Hsu KC, Chida S, Geraghty DE, Dupont B: The killer cell immunoglobulin-like receptor (KIR) genomic region: gene-order, haplotypes and allelic polymorphism. Immunol Rev. 2002, 190: 40-52. 10.1034/j.1600-065X.2002.19004.x.

    Article  CAS  PubMed  Google Scholar 

  11. Edmonds J, Karp R: Theoretical improvements in algorithmic efficiency for network flow problems. Journal of the ACM (JACM). 1972, 19 (2): 248-264. 10.1145/321694.321699.

    Article  Google Scholar 

  12. Lovász L, Plummer M: Matching Theory, Volume 29 of Annals of Discrete Mathematics. Amsterdam: North-Holland. 1986

    Google Scholar 

  13. Medvedev P, Fiume M, Dzamba M, Smith T, Brudno M: Detecting copy number variation with mated short reads. Genome research. 2010, 20 (11): 1613-1622. 10.1101/gr.106344.110.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  14. Hajirasouliha I, Hormozdiari F, Alkan C, Kidd J, Birol I, Eichler E, Sahinalp S: Detection and characterization of novel sequence insertions using paired-end next-generation sequencing. Bioinformatics. 2010, 26 (10): 1277-1283. 10.1093/bioinformatics/btq152.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  15. Hormozdiari F, Hajirasouliha I, McPherson A, Eichler E, Sahinalp S: Simultaneous structural variation discovery among multiple paired-end sequenced genomes. Genome research. 2011, 21 (12): 2203-2212. 10.1101/gr.120501.111.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  16. Li H, Handsaker B, Wysoker A, Fennell T, Ruan J, Homer N, Marth G, Abecasis G, Durbin R, Subgroup GPDP: The Sequence Alignment/Map format and SAM-tools. Bioinformatics. 2009, 25 (16): 2078-2079. 10.1093/bioinformatics/btp352.

    Article  PubMed Central  PubMed  Google Scholar 

  17. Middleton D, Gonzelez F: The extensive polymorphism of KIR genes. Immunology. 2010, 129: 8-19. 10.1111/j.1365-2567.2009.03208.x.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  18. Marsh SG, Parham P, Dupont B, Geraghty DE, Trows-dale J, Middleton D, Vilches C, Carrington M, Witt C, Guethlein LA, Shilling H, Garcia CA, Hsu KC, Wain H: Killer-cell immunoglobulin-like receptor (KIR) nomenclature report, 2002. Tissue Antigens. 2003, 62: 79-86. 10.1034/j.1399-0039.2003.00072.x.

    Article  CAS  PubMed  Google Scholar 

  19. McElroy KE, Luciani F, Thomas T: GemSIM: general, error-model based simulator of next-generation sequencing data. BMC Genomics. 2012, 13: 74-10.1186/1471-2164-13-74.

    Article  PubMed Central  PubMed  Google Scholar 

  20. Robinson J, Waller MJ, Stoehr P, Marsh SG: IPD-the Immuno Polymorphism Database. Nucleic Acids Res. 2005, 33: D523-526.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  21. Pyo CW, Guethlein LA, Vu Q, Wang R, Abi-Rached L, Norman PJ, Marsh SG, Miller JS, Parham P, Geraghty DE: Different patterns of evolution in the centromeric and telomeric regions of group A and B haplotypes of the human killer cell Ig-like receptor locus. PLoS ONE. 2010, 5 (12): e15115-10.1371/journal.pone.0015115.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  22. Krumsiek J, Arnold R, Rattei T: Gepard: a rapid and sensitive tool for creating dotplots on genome scale. Bioinformatics. 2007, 23 (8): 1026-1028. 10.1093/bioinformatics/btm039.

    Article  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

The research was supported by grants from the NIH (RO1-HG004962, U54 HL108460), and the NSF (CCF-1115206). CL was supported by an NSF graduate fellowship.

Declarations

Publication of this article was supported by NIH (RO1-HG004962, U54 HL108460) and NSF (CCF-1115206).

This article has been published as part of BMC Bioinformatics Volume 14 Supplement 5, 2013: Proceedings of the Third Annual RECOMB Satellite Workshop on Massively Parallel Sequencing (RECOMB-seq 2013). The full contents of the supplement are available online at http://www.biomedcentral.com/bmcbioinformatics/supplements/14/S5.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Christine Lo.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

SZ and CL developed and implemented the method. CL and SK designed the experiments. CL performed the experiments. CL, SZ, and VB wrote the manuscript. All authors read and approved the final manuscript.

Electronic supplementary material

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an open access article distributed under the terms of the Creative Commons Attribution License (http://creativecommons.org/licenses/by/2.0), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Lo, C., Kim, S., Zakov, S. et al. Evaluating genome architecture of a complex region via generalized bipartite matching. BMC Bioinformatics 14 (Suppl 5), S13 (2013). https://doi.org/10.1186/1471-2105-14-S5-S13

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-14-S5-S13

Keywords