Skip to main content

Estimating population size via line graph reconstruction

Abstract

Background

We propose a novel graph theoretic method to estimate haplotype population size from genotype data. The method considers only the potential sharing of haplotypes between individuals and is based on transforming the graph of potential haplotype sharing into a line graph using a minimum number of edge and vertex deletions.

Results

We show that the resulting line graph deletion problems are NP complete and provide exact integer programming solutions for them. We test our approach using extensive simulations of multiple population evolution and genotypes sampling scenarios. Our results also indicate that the method may be useful in comparing populations and it may be used as a first step in a method for haplotype phasing.

Conclusions

Our computational experiments show that when most of the sharings are true sharings the problem can be solved very fast and the estimated size is very close to the true size; when many of the potential sharings do not stem from true haplotype sharing, our method gives reasonable lower bounds on the underlying number of haplotypes. In comparison, a naive approach of phasing the input genotypes provides trivial upper bounds of twice the number of genotypes.

Background

A fundamental problem in population studies is the estimation of the size of the underlying haplotype pool. In these studies, such as genomewide association studies, a number of individuals are genotyped at some single nucleotide polymorphism (SNP) locations. Since we cannot observe the haplotypes of an individual, a common approach to the size estimation problem is to phase the genotype data, i.e., computationally predict the underlying haplotypes. However, haplotype phasing is a notoriously difficult problem [1] and can be optimally solved for small instances only [2].

Here we propose a novel approach that does not require the phasing of the haplotypes. It is based on starting from the easy-to-compute information on potential haplotype sharing between individuals. Specifically, we can test if two individuals have the potential to share a haplotype by checking if their genotypes are consistent with such sharing (i.e., whenever one of the genotypes is homozygous at a certain site, the other is homozygous to the same allele or heterozygous). This information can be encoded in a graph, known as the Clark consistency (CC) graph [3], where each individual (genotype) is represented by a node and an edge is added between two individuals if they can share a haplotype.

The line graph of a graph, is a new graph that has nodes for each edge in the root (original) graph and an edge between two nodes of the line graph if the corresponding edges are adjacent in the root graph. If data were perfect, i.e., the only observed potential sharings were true sharings, then the resulting CC graph would be a line graph whose root graph has haplotypes as nodes and edges connect pairs of haplotypes corresponding to the observed genotypes. The reconstruction of this root graph would then enable us to compute the haplotype population size. In practice, the graph is only close to being a line graph and contains “extra” edges that do not represent true sharing. These extra edges are due to the fact that the genotypes are consistent with each other while there is no common shared haplotypes. For reasonable population structure (as reflected in the simulations presented below), we expect such sharing of genotypes to be rare. Thus, our goal is to find a smallest number of edge deletions that will make the CC graph a line graph. Once we arrive at a line graph we can reconstruct its root graph, thereby getting an estimate of the number of underlying haplotypes, as well as predictions of which individuals share a haplotype (those pairs that remain connected by an edge). We also consider a variant of the line graph deletion problem where node deletions are allowed; those correspond to cases where there are significant genotyping errors or missing data in one of the individuals or genotype pools.

CC graphs may also be determined from data generated using other technologies or experimental protocols, including pooled sequencing [4]. In pooled sequencing, pools of DNA are constructed, each containing the DNA of multiple individuals with each individual typically belonging to multiple pools. Each pool is then genotyped and a conflated genotype for all the individuals in the pool is constructed. To create a CC graph we add an edge between two individuals if they can share a haplotype, that is, if for every pair of pools containing these individuals, one in each pool, the two pools are consistent with sharing a haplotype.

We study the complexity of the resulting line graph modification problems. We observe that both problems (edge- and vertex-deletion) are NP-complete and provide polynomial integer programming formulations to solve them. We also show how the method can be used as a first step in an iterative algorithm for haplotype phasing. We test our approach using extensive simulations of multiple population evolution and genotypes sampling scenarios and on data from the International HapMap Consortium [5]. Our computational experiments show that when most of the sharings are true sharings the problem can be solved very fast and the estimated size is very close to the true size. In cases where many of the potential sharings do not stem from true haplotype sharing, due to spurious edge or node insertions, our method gives reasonable lower bounds on the underlying number of haplotypes. In comparison, a naive approach of phasing the input genotypes provides trivial upper bounds of twice the number of genotypes.

In the remainder of the paper, we start by presenting the background for this paper, the definition of our optimization problems and an analysis of their complexity. We then present five different integer programming formulations to solve our optimization problems. Finally, we perform computational experiments on both simulated data and on data from the International HapMap Consortium.

Preliminaries

Let G = (V,E) be a graph with a set V of n vertices and a set E of m edges. The line graph of G, denoted by L(G), is constructed by having a node in L(G) for each edge in G and an edge between two nodes of L(G) if the corresponding edges are adjacent in G.

Line graph and CC graphs

If L(G) is the line graph of G, we refer to G as the root graph of L(G). Line graphs have been studied by a number of authors. Whitney [6] showed that, apart from a single exception, the root graph of a line graph is unique. Lehot [7] and Roussopoulos [8] have independently given linear-time algorithms for detecting whether a graph is a line graph and outputting its root graph. Van Rooij and Wilf [9] gave a characterization of line graphs in terms of nine forbidden subgraphs. The characterization can be stated as follows; A triangle in a graph is even if every other node is adjacent to 0 or 2 nodes in the triangle; it is odd otherwise. A graph is a line graph iff it contains no two odd triangles that share an edge is claw-free (a claw is a node connected to three nodes not connected to each other). This characterization can also be stated as a list of nine distinct subgraphs that are forbidden from the line graph. Each one of the nine different subgraphs has at most six nodes and ten edges.

A key component of our approach is the graph of potential sharing of haplotypes between individuals. This graph, called the Clark consistency (CC) graph, was first suggested in the context of a method for haplotype phasing by Andrew Clark [10]. Given the genotypes of a set of individuals, the CC graph has one node for each individual and an edge between two individuals if their genotypes are consistent with sharing a haplotype, i.e., if for every site where one of the individuals is homozygous, the other individual is either homozygous for the same allele or heterozygous. As the haplotypes of individuals that are homozygous for the whole region being considered are easily determined, we assume that every given individual has two different haplotypes (i.e., it is heterozygous for at least one of the genotyped markers) and no two individuals have the same pair of haplotypes.

As we show below, CC graphs and line graphs are closely related. Let H be the CC graph of a given set of genotypes. We say that H is allelable if there is an assignment of pairs of colors to its nodes so that every two adjacent nodes share exactly one color and every two non-adjacent nodes have distinct color sets. Under this assignment every color represents a haplotype or an allele in the population. The number of colors is the estimated number of genotypes. The following observation stands at the basis of our computational approach.

Lemma 2.1.

Lemma 2.1.H is allelable iff it is a line graph.

Proof

 If H is allelable then construct a graph G in which every allele of H represents a node and edges connect alleles that are paired together in the nodes of H. It is easy to see that H is the line graph of G.

Conversely, if H = L(G) is a line graph then one can assign distinct labels to the nodes of the corresponding root graph G and use these labels to label the edges of G and, hence, the nodes of H. This assignment clearly shows that H is allelable. □

Lemma 2.1 implies that a set of haplotypes providing a valid phasing of genotypes will always form a line graph. The converse, however, need not be true as the SNP data of the original genotypes are not encoded in our formulation.

Problem definition and its complexity

As the input data may have more edges than the underlying line graph, we do not expect real data to yield line graphs. Rather it is desirable to transform a given CC graph into a line graph using a minimum number of node and edge deletions. In the following we formulate three versions of the problem.

Problem 2.1.

 Given a graph G = (V,E), find a line graph G =(V, E ) such that E E and E- E is minimized.

Problem 2.2.

 Given a graph G = (V,E), find a line graph G =( V ,E) such that V V and V- V is minimized.

We also consider a combined problem where both nodes and edges may be removed from a graph:

Problem 2.3.

 Given a graph G = (V,E) and a constant α, find a line graph G =( V , E ) such that E E, V V and E- E +αV- V is minimized.

Yannakakis [11] has shown that the problems of deleting a minimum number of edges or nodes of a graph in order to make it into a line graph are both NP-hard.

As the problems can be formulated as a problem of avoiding particular subgraphs which have at most 6 nodes and 10 edges, by [12] both problems are fixed parameter tractable and can be solved in time max{m,n}O(10i) and max{m,n}O(6j), respectively, where i (resp., j) is the minimum number of edges (resp., vertices) that need to be deleted. Using the techniques of Niedermeier and Rossmanith [13], the node deletion variant can be solved in max{m,n}O(5.19j) time.

Problem 2.2 can be formulated as a hitting set problem, where all the sets that need to be hit are of size 4,5 or 6. Trevisan [14] showed that the hitting set problem, when the size of the input sets is bounded by B ≥ 2 (B = 6 in our case), is hard to approximate to within B - 1 19 . The fact that all sets are of size at most six also implies a 6-approximation algorithm for the line graph node deletion problem [15].

Integer programming formulation

Here we provide integer programming formulations for Problems 2.1, 2.2 and 2.3. The formulations rely on the characterization given in Lemma 2.1. We let [i,j] represent {i,i + 1,...,j}.

Edge deletions

Let G = (V,E) be the input CC graph. Our basic program has the following sets of binary variables: (i) A variable d e  for every edge eE, where d e  = 1 iff e is deleted. (ii) A variable xv,j for every node vV and every possible allele j [1,2n], where xv,j = 1 iff individual v has allele j. (iii) A variable se,j for every edge eE and every possible allele j [1,2n], where se,j = 1 iff the two endpoints of e share allele j. It is formulated as follows:

min e d e s.t. j = 1 2 n x v , j = 2 v V x v , j + x u , j 1 ( u , v ) E , j [ 1 , 2 n ] j = 1 2 n s e , j = 1 - d e e E x u , j + x v , j - 1 s e , j e = ( v , u ) E , j [ 1 , 2 n ] s e , j x u , j j [ 1 , 2 n ] , u e d e , x v , j , s e , j { 0 , 1 } e E , v V , j [ 1 , 2 n ]

In this formulation, the first constraint ensures that each node is assigned two distinct colors; the next two constraints ensure that non-adjacent nodes (before or after edge deletion) do not share a color; and the fourth and fifth constraints ensure that the edge sharing variables are consistent with the node coloring variables. A potential problem with the formulation, however, is that different permutations of the colors yield equivalent solutions. To tackle this problem, we use the symmetry breaking techniques of [16]. Specifically, we start by ordering the nodes from 1 through n. Each node “owns” two colors: node i owns colors (2i - 1) and 2i. The fact that xv,j = 1, where j = 2v - 1 or j = 2v means that v is the first node to use color j. v is required to use color 2v - 1 before it uses color 2v.

Overall, node v has access to colors 1,2,…,2v and can use some of the previously used colors or be the first ordered node to use new colors. These restrictions can be represented by the following additional constraints:

x v , 2 v x v , 2 v - 1 v [ 1 , n ] x j , 2 i - 1 x i , 2 i - 1 j [ i + 1 , n ] x j , 2 i x i , 2 i j [ i + 1 , n ]

We observe that a number of the variables in the above formulation can be automatically set to 0 and removed from the formulation. In particular, if (i,j) E,i < j then xj,2i = xj,2i - 1 = 0, as j and i cannot share a color when they do not share an edge. If e = (u,v), we also note that se,j = 0 unless both u,v can be colored with color j, that is if (v, j + 1 2 ),(u, j + 1 2 )E.

Node deletions

If a graph does not contain one of the forbidden substructures then the graph is allelable. Otherwise, a vertex has to be removed from each of the forbidden subgraphs. Our algorithm relies on listing all occurrences of the forbidden substructures and then solving the hitting set problem on the set of forbidden substructures.

We observe that the deletion of a node will not create a new forbidden substructure. The node deletion problem can thus be formulated as an integer program by listing all forbidden substructures and removing one node from each one of them. We let t n  be a binary variable representing whether node i is removed and denote by F the set of all forbidden induced subgraphs of a line graph. Then the program is formulated as follows:

min n t n n F t n 1 F F t n { 0 , 1 } n V

Edge and node deletions

In real data, both genotype errors and spurious sharing relations may happen at the same time, leading to a combined node- and edge-deletion problem. We define d,x, s and t as before. We define the variable r e  as a boolean variable representing that an edge has been removed, which occurs when either one of its adjacent nodes or the edge itself is deleted. We let α be the relative cost of node deletion with respect to edge deletion. The combined program is as follows:

min e d e + α n t n s.t. j = 1 2 n x v , j = 2 - 2 t v v V x v , j + x u , j 1 ( u , v ) E , j [ 1 , 2 n ] j = 1 2 n s e , j = 1 - r e e E x u , j + x v , j - 1 s e , j e = ( v , u ) E , j [ 1 , 2 n ] s e , j x u , j j [ 1 , 2 n ] , u e r e t v + t u + d e e = ( u , v ) E d e r e e E t u r e u e , e E d e , t v , x v , j , s e , j , r e { 0 , 1 } e E , v V , j [ 1 , 2 n ]

We further augment this integer program with the symmetry breaking techniques described in Section ‘Edge deletions’.

Edge deletions with errors

The model described in the previous sections does not deal with noise due to genotype miscalls. Genotyping errors may lead to haplotypes not sharing an edge when they in fact should. There are two ways in which this problem can be handled by our framework. The first method that we suggest is to add edges when the genotypes are compatible in all but a fixed number of error locations, our formulation would then be to remove the minimum number of edges, possibly with weights related to the number of errors in the edges.

The second allows for edge insertions, possibly with weights related to the number genotyping errors that are needed to have occurred for there to be an edge between the two nodes. We describe below an extension of our integer programming formulation to allow for such edge insertions, solving the more general problem of editing a graph (by edge insertions and deletions) to form a line graph.

As before, we let G = (V,E) be a graph which we would like to make allelable with n = V and m = E. We introduce b e  as an indicator for an edge b e  = 1 if eG and b e  = 0 if eG. We introduce a variable c e  for every edge eG, we let c e =1 if e is inserted and c e  = 0 if e is not inserted. We let w e  denote a weight associated with each edge that can be deleted or inserted. We let the variables xv,jvand d e  have the same interpretation as before. The variables se,j also have the same interpretation as before, except that e can now be any pair e = (u,v) V × V,u ≠ v.

min e E w e d e + e V × V - E w e c e s.t. j = 1 2 n x v , j = 2 v V x v , j + x u , j 1 + b e - c e ( u , v ) V × V , v u , j [ 1 , 2 n ] j = 1 2 n s e , j = b e + c e - d e e V × V x u , j + x v , j - 1 s e , j e = ( v , u ) V × V , v u , j [ 1 , 2 n ] s e , j x u , j j [ 1 , 2 n ] , u e c e , d e , x v , j , s e , j { 0 , 1 } v V , e E , j [ 1 , 2 n ]

This formulation can be extended to capture both the symmetry breaking constraints and the node deletion case, described earlier.

Haplotype phasing under the parsimony criteria

Researchers are frequently interested in knowing not only the number of haplotypes for a particular instance but also the haplotypes themselves. While the main purpose of the paper is not to present a method for haplotype phasing, we will show how the method presented here can be used as a first step in a constraint generation approach for haplotype phasing.

In order to determine the minimum number of haplotypes we would start by solving a modified version of our integer program for edge deletions. We exploit the symmetry breaking constraints to count and minimize the number of haplotypes used to explain the line graph.

min v V x v , 2 v - 1 + x v , 2 v s.t. j = 1 2 v x v , j = 2 v V x v , j + x u , j 1 ( u , v ) E , j [ 1 , 2 n ] j = 1 2 n s e , j 1 e E x u , j + x v , j - 1 s e , j e = ( v , u ) E , j [ 1 , 2 n ] s e , j x u , j j [ 1 , 2 n ] , u e x v , 2 v x v , 2 v - 1 v [ 1 , n ] x j , 2 i - 1 x i , 2 i - 1 i [ 1 , n ] , j [ i + 1 , n ] x j , 2 i x i , 2 i i [ 1 , n ] , j [ i + 1 , n ] x v , j { 0 , 1 } v V , j [ 1 , 2 v ] s e , j { 0 , 1 } e E , j [ 1 , 2 n ]

We note that as there is no cost associated with deleting edges we no longer have a need for the d e variables.

We note that the line graph minimizing the number of haplotypes will always provide a lower bound on the number of haplotypes. There however may be other constraints provided by the genotypes that will not be fulfilled by the above optimization formalization. The next step in our algorithm is to search for sets of haplotype sharings inconsistent with the solution found by the integer program.

We let I be the solution of the integer program and let eI denote that in I there exists a color j such that se,j=1 We start by initializing a set S with the two nodes of an edge eI. We then perform a partial phasing of the genotypes of these individuals. In the partial phasing we consider each SNP where one of the individuals is homozygote and the other is heterozygote; the shared haplotype must then contain the allele of the heterozygote.

We then grow S by selecting a neighbor, v to one of the nodes in S and add v to S. If no such neighbor exists then we have a valid partial phasing for the nodes of S and the nodes in S need not be considered further. If such a neighbor does exist, then we use S to partially phase the genotype of v. As we describe below, such a phasing of v may not always be possible, if it is we update the haplotypes in S and iterate the growth of S. If such a phasing does not exist we conclude that not all of the neigbor relations considered so far can hold simultaneously and we resolve the integer program with the added constraint:

e I j = 1 n s e , j { e e I S } - 1

We now describe how we use S to partially phase v. We let h u  (v) be the haplotype u shares with v. This haplotype is uniquely defined; At the time v is added to S, u has two partially phased haplotypes, at least one of which is shared with a neighbor wS. If I indicates that all three of u,v and w share a haplotype then the haplotype v shares with u is the haplotype u shares with w, if not u shares with v the haplotype it does not share with w. It is possible that h u  (v) has been phased for one allele of a SNP while v is homozygote for the other allele, in this case v cannot be phased consistently with the partial phasing of S. If not, we add constraints from v to the phasing of haplotypes of S; If h u  (v) is heterozygote for a SNP and v is homozygote then h u  (v) must at that SNP be assigned the allele of v and the other haplotype of u must be assigned the other allele. As the nodes of S are connected the fact that v is heterozygote for the SNP will affect the partial phasings of all nodes in S. Finally, we note that v may be connected to more than one node in S, we similarly consider whether v is consistent with the partial phasing of those nodes.

Experimental results

We comprehensively test our algorithm for deleting edges and vertices on data from the International HapMap Consortium [5] and under two simulated scenarios, corresponding to a bottleneck population isolate and a population that has continuously undergone recombination and mutation. For the population isolate we show that we can almost fully recover the haplotype structure from the sharing information alone. For the population that has undergone continuous recombination and mutation we get a bound on the number of haplotypes that is close to the true number of haplotypes in the population. Our experiments further reveal that the occurrence of genotypes showing a large degree of sharing does not materially affect our ability to estimate the number of haplotypes in the remaining population. The computational experiments were done using CPLEX 12, making use of a single CPU processor core with 4GB of memory.

Bottleneck population

Haplotypes that are shared across a long region are with high probability identical by descent, i.e. they are the result of the genetic material of a single forefather being passed to a number of his descendents. Some of the haplotypes, however, will be identical by state only, i.e., the haplotypes are the same but cannot be traced to a single common forefather. The probability of identical by state sharing decreases rapidly with the length of the haplotype being considered. The probability of identity by state sharing depends on the size of the ancestral population. We simulate graphs that might occur from the detection of identity by state sharing.

We use Hudson’s ms simulator [17] to simulate realistic genotype populations. We assume that there is an initial small bottleneck population that then rapidly expanded. We simulate genotypes for the initial population and then generate the current population as a random sample with replacement from this initial population. The parameters for the simulation are chosen such as to sample approximately a 5 cM locus, or 3027 SNPs, a size for which it is reasonable to expect that no recombinations would take place in the region between two individuals being studied. We consider two sets of experiments for this scenario. In the first experiment we vary the size of the population but keep the number of times that each haplotype is sampled on expectation fixed. In the second experiment we vary the expected number of times that each haplotype is sampled and keep the size of the population fixed.

In Table 1 we fix the expected number of times that a haplotype is sampled as 1 and we vary the size of the population, which we present as the number of haplotypes in the ancestral population. It can be seen that the number of edges grows roughly linearly with the size of the population being sample. Our simulations show that the number of estimated haplotypes is in close agreement with the true number of haplotypes in the sample. As some of the haplotypes are sampled multiple times the number of haplotypes in the sample is typically smaller than the actual population size. Notably, all instances are solved very fast (less than a second).

Table 1 Effect of increasing population size

In Table 2 we look at an initial bottleneck population of 100 haplotypes while varying the number of genotypes sampled from this population from 25 to 125. This implies that each haplotype in the ancestral population is sampled between 0.5 and 2.5 times (on average). As the sample size increases, our estimate of the number of haplotypes tightly follows the true number of haplotypes sampled from the population, with both approaching the actual population size of 100. We observe that the number of edges in the graph grows roughly as the square of the sample size. The CPU time used for all these instances is minimal.

Table 2 Effect of increasing coverage

Recombinant population

The second scenario that we simulate is a population that is undergoing mutation and recombination. We fix mutation rate at 10-9 per generation and recombination rate between two adjacent base pairs at 10-8 per generation. In all of our experiments we simulate a 1MB region, varying the number of individuals in the ancestral population (N0) and the number of individuals sampled in the current population.

First, we vary the size of the initial population, while leaving the number of individuals considered mostly constant (see Table 3). We observe that when the size of the initial population grows the probability that two individuals can share a haplotype decreases rapidly. Many of the edges observed in these graphs are due to sharing between genotypes that are not due to the sharing of haplotypes. The graphs being considered are therefore far from being line graphs and many edges need to be removed in order to make them into ones. Nevertheless, we are able to give estimates of the number of haplotypes in a population even in this setting.

Table 3 Effect of population size in a recombinant population

The quality of our estimate is, not surprisingly, dependent on the number of edges that need to be removed to create a line graph. Our estimated number of haplotypes is consistently smaller than the true number of haplotypes, but the number of estimated haplotypes is never below 57% of the true number of haplotypes. Similar conclusions can be drawn from the second set of experiments in which we fix the size of the initial population and vary the size of the sample that we draw from that population (see Table 4).

Table 4 Effect of increasing coverage in a recombinant population

Combined node and edge deletions

We simulate a scenario in which there are genotypes showing a high degree of excess sharing of haplotypes. To this end, we focus on the data set of 50 genotypes presented in Table 4, and designate increasing subsets of the genotypes as being partially observed, i.e., only a subset of their markers is observed supposedly due to failure or otherwise missing data.

In more detail, in Table 5 we modify a graph consisting of 50 genotypes, consisting of 38 edges where 5 edges have to be removed to transform the graph into a line graph. We let 5,10 or 15 of the genotypes be partially observed, i.e., genotyped at only at 30% of their markers. We show the number of edges added to the graph due to these partial observations. Next, we apply our combined node and edge deletion algorithm and use two settings for the alpha parameter controlling the relative penalty of node vs. edge deletion. The first value that we use, α = 1.5, prefers a node deletion whenever more than one of the node’s adjacent edges has to be deleted. The second value of 4 allows up to 4 edge deletions before the node deletion is preferred. In each setting we provide the the number of edges and genotypes removed and the number of removed genotypes that were partially observed. We evaluate the size estimate given by the algorithm against the true number of haplotypes in the data set without counting the haplotypes in the partially observed genotypes.

Table 5 Partial genotypes

We observe that the occurrence of the partial genotypes does not appear to materially affect our estimate of the number of haplotypes in the remaining population. We also observe that the largest number of nodes removed in each experiment are from the subset corresponding to the partially observed genotypes. When α = 1.5, 60 - - 90% of the partially observed genotypes are removed and less than 12% of the other genotypes. When α = 4, 30 - - 40% of the partial genotypes are removed and less than 3% of the other genotypes. All computations presented in Table 5 finished in under one second.

Comparison to a phasing-based estimation

Apart from the preprocessing, the complexity of our method does not depend on the number of genotyped markers. In contrast, many haplotype phasing methods are not able to handle the large number of markers dealt with in our approach [2]. We thus opted to compare our method to phasing-based estimates derived from the application of the BEAGLE phaser [18] to our data. Surprisingly, in all the simulated settings, the number of haplotypes estimated by BEAGLE was twice the number of genotypes, which is a trivial upper bound for the number of haplotypes in a population.

Number of alleles in HapMap populations

We use data from seven of the HapMap [5] populations (cf. Table 6), not considering those populations that contain trios, as sharing of haplotypes between trios is to be expected, which would skew our results. As the size of the populations is variable and in order to have comparable results between populations, we select a sample of 77 individuals from each of these populations. We select regions of sizes 200 and 400 SNPs and compute the haplotype sharings over those regions. We run ten different data sets for each population, selected as the first ten non-overlapping windows on chromosome 1, for a total of 140 data sets. Most of the computations finished in less than one second, a few however took considerable longer time to solve and six of the simulations were stopped after having run without producing an optimal solution after 24 hours. We present results for the remaining 134 instances in Tables 7 and 8.

Table 6 Hapmap populations
Table 7 Hapmap populations
Table 8 Hapmap populations

We run our edge deletion algorithm on each one of the populations to estimate the number of haplotypes. This estimate can be expected to correlate with the effective population size for the populations; Populations with a smaller effective populations size can be expected to have a higher number of haplotype sharings and fewere haplotypes in our samples.

We observe that the number of haplotype sharings is smaller in the two populations of African heritage (ASW and LWK) than the non-African populations. This indicates that these populations have higher genetic diversity and is consistent with the “out of Africa” theory. An exception to this rule is that when considering regions of 400 SNPs, the ASW populations has a higher average amount of haplotype sharings than some of the other populations. When looking more closely at the data we observed that this higher rate of haplotype sharing is in large part due the same pairs of individuals sharing haplotypes across all 10 datasets, indicating an identical by descent sharing among those pairs of individuals. We further observe that the ASW population has the fewest number of haplotypes when considering regions of 400 SNPs and that those solutions are found while deleting very few edges.

Conclusions

We show that the problem of assigning alleles to individuals when only information about the sharing of alleles between individuals is known is equivalent to the problem of determining whether a graph is a line graph. When sharing information is not perfect we give polynomial size integer programming algorithms for determining allele sharing. We show how this method can be used to estimate the genetic diversity of different populations. We suspect that the method proposed here may be useful in computing important parameters in population genetics such as the effective population size, however a careful analysis of its statistical properties is necessary.

We further show how this method can be extended to give an iterative optimization algorithm for haplotype phasing. We demonstrate that the first iteration in this algorithm can solve larger problem instances that can in general be solved using common implementations of the haplotype phasing algorithm. As we have not provided an implementation of a haplotype phasing algorithm it remains to be seen if our proposed algorithm is practical and effective.

References

  1. Halldórsson BV, Bafna V, Edwards N, Lippert R, Yooseph S, Istrail S: A survey of computational methods for determining haplotypes. Computational Methods for SNPs and Haplotype Inference (LNCS 2983). 2004, 26-47. 10.1.1.85.4196. [http://citeseerx.ist.psu.edu/viewdoc/summary?], Springer

    Chapter  Google Scholar 

  2. Catanzaro D, Godi A, Labbé M: A class representative model for pure Parsimony Haplotyping. INFORMS J Comput. 2009, 22 (2): 195-209.

    Article  Google Scholar 

  3. Halldórsson BV, Aguiar D, Tarpine R, Istrail S: The Clark Phaseable sample size problem: long-range phasing and loss of heterozygosity in GWAS. J Comput Biol. 2011, 18 (3): 323-333.

    Article  PubMed  Google Scholar 

  4. Prabhu S, Pe’er I: Overlapping pools for high-throughput targeted resequencing. Genome Res. 2009, 19: 1254-61.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  5. , : Integrating common and rare genetic variation in diverse human populations. Nature. 2010, 467: 52-58.

    Article  Google Scholar 

  6. Whitney H: Congruent graphs and the connectivity of graphs. Am J Math. 1932, 54: 150-162. 10.2307/2371086.

    Article  Google Scholar 

  7. Lehot PGH: An optimal algorithm to detect a line graph and output its root graph. J ACM. 1974, 21: 569-575. 10.1145/321850.321853.

    Article  Google Scholar 

  8. Roussopoulos N: A max(m, n) algorithm for determining the graph H from its line graph G. Inf Process Lett. 1974, 2: 108-112.

    Article  Google Scholar 

  9. Van Rooij A, Wilf H: The interchange graphs of a finite graph. Acta Math Acad Sci Hungar. 1965, 16: 263-269. 10.1007/BF01904834.

    Article  Google Scholar 

  10. Clark A: Inference of haplotypes from PCR-amplified samples of diploid populations. Mol Biol Evol. 1990, 7: 111-122.

    CAS  PubMed  Google Scholar 

  11. Yannakakis M: Node-and edge-deletion NP-complete problems. Proceedings of the tenth annual ACM symposium on Theory of computing, 10.1145/800133.804355. STOC ’78. New York: ACM, 1978:253-264.

  12. Cai L: Fixed-parameter tractability of graph modification problems for hereditary properties. Inf Process Lett. 1996, 58: 171-176. 10.1016/0020-0190(96)00050-6.

    Article  Google Scholar 

  13. Niedermeier R, Rossmanith P: An efficient fixed-parameter algorithm for 3-Hitting Set. J Discrete Algorithms. 2003, 1: 89-102. 10.1016/S1570-8667(03)00009-1.

    Article  Google Scholar 

  14. Trevisan L: Non-approximability results for optimization problems on bounded degree instances. Proceedings of the Thirty-Third Annual ACM Symposium on Theory of Computing. ACM, 2001, 453-461.

    Chapter  Google Scholar 

  15. Even S, Bar-Yehuda R: A linear-time approximation algorithm for the weighted vertex cover problem. J Algorithms. 1981, 2 (2): 198-203. 10.1016/0196-6774(81)90020-1.

    Article  Google Scholar 

  16. Campelo M, Campos V, Correa R: On the asymmetric representatives formulation for the vertex coloring problem. Discrete Appl Math. 2008, 156 (7): 1097-1111. 10.1016/j.dam.2007.05.058.

    Article  Google Scholar 

  17. Hudson RR: Generating samples under a Wright-Fisher neutral model of genetic variation. Bioinformatics. 2002, 18 (2): 337-338.

    Article  CAS  PubMed  Google Scholar 

  18. Browning BL, Browning SR: A unified approach to genotype imputation and haplotype-phase inference for large data sets of trios and unrelated individuals. Am J Human Genet. 2009, 84 (2): 210-223. 10.1016/j.ajhg.2009.01.005.

    Article  CAS  Google Scholar 

Download references

Acknowledgements

RS was supported by a research grant from the Israel Science Foundation (grant no. 241/11).

Author information

Authors and Affiliations

Authors

Corresponding authors

Correspondence to Bjarni V Halldórsson or Roded Sharan.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

Methodology was developed by BVH and RS. Experiments were run by DB. Manuscript was written by BVH, DB and RS. All authors read and approved the final manuscript.

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

Halldórsson, B.V., Blokh, D. & Sharan, R. Estimating population size via line graph reconstruction. Algorithms Mol Biol 8, 17 (2013). https://doi.org/10.1186/1748-7188-8-17

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1748-7188-8-17

Keywords