Abstract
Quadratic Unconstrained Binary Optimization (QUBO) problems concern the minimization of quadratic polynomials in n {0, 1}-valued variables. These problems are NP-complete, but prior work has identified a sequence of polynomial-time computable lower bounds on the minimum value, denoted by C2, C3, C4,…. It is known that C2 can be computed by solving a maximum-flow problem, whereas the only previously known algorithms for computing Ck (k > 2) require solving a linear program. In this paper we prove that C3 can be computed by solving a maximum multicommodity flow problem in a graph constructed from the quadratic function. In addition to providing a lower bound on the minimum value of the quadratic function on {0, 1}n, this multicommodity flow problem also provides some information about the coordinates of the point where this minimum is achieved. By looking at the edges that are never saturated in any maximum multicommodity flow, we can identify relational persistencies: pairs of variables that must have the same or different values in any minimizing assignment. We furthermore show that all of these persistencies can be detected by solving single-commodity flow problems in the same network.
1 Introduction
In this paper, we study the problem of Quadratic Unconstrained Binary Optimization (QUBO), which determines the minimum over {0, 1}n of quadratic pseudo-Boolean functions of the form
Many problems in the area of computer vision involve minimizing energy functions, and quadratic pseudo-Boolean functions are a common class of energy functions, which allows us to phrase vision problems as QUBO problems naturally. For a thorough survey of the applications of QUBO in computer vision, see [7]. Even in cases when the QUBO problem cannot be fully solved by an efficient algorithm, one can often extract useful information for the computer vision applications by discovering persistencies, i.e. partial assignments of the variables that must occur in an assignment that minimizes the function.
Although the QUBO problem is NP-hard, several approaches have been proposed to give good lower bounds on the minimum value. Many of these approaches involve rewriting the quadratic pseudo-Boolean function using posiforms, which we now define.
Let V = {x1, x2,…, xn} be the set of variables, and let V̄ = {x̄1, x̄2,…, x̄n} denote the set of negated variables, where x̄i = 1−xi. The elements of L = V ∪V̄ are called literals.
We can represent non-negative pseudo-Boolean functions as posiforms, i.e. multilinear polynomial expressions over all the literals with positive term coefficients
where Ω is a collection of subsets of L, and aT > 0 for all T ∈ Ω. Every posiform φ defines a unique pseudo-Boolean function f by substituting x̄i = 1 −xi, but a pseudo-Boolean function can have multiple posiform representations.
A particular lower bound called roof-dual, denoted by C2, is introduced in [8]. If f is a quadratic pseudo-Boolean function, then C2 is the maximum c such that f = c + φ, where φ is a posiform of degree two. It is shown in [5] that we can compute C2 by solving a maximum flow problem on a special graph called an implication network. The roof-dual value is then generalized to a family of lower bounds Ck. (See [2] for definitions.)
In this paper we will focus on the bound C3. Let be the cone of nonnegative quadratic pseudo-Boolean functions having a posiform of degree three. Then as defined in [3]
It is proved in [3] that C3 can be computed by solving an odd cycle packing problem, but due to the fact that C2 can be computed using maximum flow, we are interested in formulating C3 as the solution of a flow problem.
Among the set of all possible posiforms of a quadratic pseudo-Boolean function, we will work with the bi-form in particular, which is introduced in [6]. For variables x and y, we call xȳ + x̄y a positive bi-term, and a negative bi-term. If E denotes a collection of bi-terms such that no pair of variables is involved in more than one element of E, and αe > 0 for all e ∈ E, then we call φ = Σe∈E αee a bi-form. By introducing variable x0, we can write any quadratic psudo-Boolean function f in variables x1,…, xn uniquely as f(x1,…, xn) = cf + φf (1, x1,…, xn), where φf is bi-form in the variables x0, x1,…, xn. (See [4].)
Given a quadratic pseudo-Boolean function f = cf +φf, where φf is a bi-form, we define an undirected graph Gφf = (Vφf, Eφf) as follows. Vφf = L, where L is the set of literals of f. We associate two edges to each bi-term. For positive bi-term c(xix̄j + x̄ixj), we have edges (xi, xj) and (x̄i, x̄j), with weight . For negative bi-term c(xixj +x̄ix̄j), we have edges (xi, x̄j) and (x̄i, xj), with weight . Conversely, edge (u, v) with capacity δ in Gφf corresponds to the bi-term δ(uv̄ + ūv).
We prove in Section 3 that for any quadratic pseudo-Boolean function f, C3 is the sum of cf and the maximum multicommodity flow value of network Gφf with source-sink pairs {(x0, x̄0), (x1, x̄1)…, (xn, x̄n)}. (See Section 2 for definitions related to multicommodity flow.)
More than the numerical lower bound on the minimum value, it is also useful to obtain partial optimal assignments. The concept of persistency and autarky are defined in [5], and we can generalize the idea of persistency and autarky to relational persistency and relational autarky. Call a set of literals valid if it contains at most one of xi and x̄i for all i. Consider a valid subset U ∈ L. We will say U is a strong (respectively, weak) relational persistency if literals in U have the same value in all (respectively, some) optimal assignment.
For any assignment x = (x1,…, xn) and Boolean value b ∈ {0, 1}, let x[U → b] denote the assignment y = (y1,…, yn) specified by
We will call U a strong (respectively, weak) relational autarky if for all Boolean assignments x, there exists a value b ∈ {0, 1} such that f(x[U → b]) < f(x) (respectively, f(x[U → b]) ≤ f(x)), or x[U → b] = x. Relational persistencies and relational autarkies allow us to reduce the size of the optimization problem, since we can rewrite a posiform with a smaller variable set, while maintaining the same minimum value.
In Section 4, we focus on finding strong relational persistencies. When we push flow along a path in Gφf from xi to x̄i, it is equivalent to rewriting the bi-terms associated with edges on the path into a cubic posiform, and it turns out we can derive strong relational persistencies from the residual graph. In Theorem 2, we prove that if an edge (u, v) can never be saturated in a solution of our maximum multicommodity flow problem, literals u and v must have the same value in any minimizer of f. Then in Theorem 3, we consider the maximum flow problem on Gφf with single source-sink pair (xi, x̄i), and we show that in the residual graph, the set of literals in the connected component containing xi is a strong relational persistency. Furthermore, we show that if U is a strong relational persistency, and xi ∈ U, then there must be a maximum flow assignment for source-sink pair (xi, x̄i) such that U is a connected component in the residual graph.
Unsurprisingly, many techniques used in studying C3 generalize those used in studying C2. We introduce the variable x0 simply to make the posiform homogeneously quadratic, and we don’t treat x0 differently in computing C3 and deriving relational persistencies. Various known facts about C2 and its associated persistencies can be interpreted as a special case of the facts derived here, when we enforce the constraint x0 = 1. For example, [5] obtains strong relational autarkies from the residual graph of running a maximum flow computation for the source-sink pair (x0, x̄0). In Theorem 3, we use the same technique over all source-sink pairs (xi, x̄i).
2 Definitions and notations
In this section, we summarize some definitions and notations involving multicommodity flow problems and their relationship to quadratic Boolean formulas.
2.1 Weighted Signed Graphs, Odd Cycles
A weighted signed graph G is an undirected graph (V, E) together with a set of positive weights {αe|e ∈ E} and a partition {E+, E−} of the edge-set E. The edges in E+ are called positive, and those in E− are called negative. A cycle of G is called odd if it contains an odd number of negative edges. The set of odd cycles is denoted by .
2.2 Odd cycle Packing
Given weighted signed graph G, the odd cycle packing problem (CP) is:
(1) |
2.3 Multicommodity Flow
Given undirected graph G = (V, E) with edge capacities ce ≥ 0, and source-sink pairs (s1, t1), · · ·, (sk, tk), let Pi = {paths from si to ti}.1 The maximum multicommodity flow problem on G is:
(2) |
Any vector (ζp) satisfying the constraints in (2) is called a multicommodity flow, or simply a flow, regardless of whether it maximizes the objective function. For a thorough introduction to multicommodity flow theory, we refer the reader to [1].
2.4 The graphs Gf and Gφ
Given quadratic pseudo-boolean function f, we can write f uniquely as the sum of a constant and a bi-form:
We can construct a weighted signed graph Gf = (Vf, Ef) corresponding to bi-form φf as follows. The vertex set Vf is equal to {x0,…, xn}, the set of variables of φf. We associate an edge to each bi-term in φf. Edges have the same sign as their associated bi-terms, and the weights αe are the same as the coefficients of their associated bi-terms.
Recall that there is another graph associated to φf, namely the graph Gφf with vertex set {x1,…, xn, x̄1,…, x̄n} defined in Section 1. Henceforth we will use the notation Gφ rather than Gφf for convenience. In Section 3 we will relate the maximum multicommodity flow problem in Gφ to the odd cycle packing problem in Gf.
2.5 Symmetric flow
The graph Gφ has a two-fold symmetry given by a permutation ι: Vφ → Vφ. This permutation is defined by setting ι (xi) = x̄i and ι (x̄i) = xi. We can extend ι to edges in the obvious way: if u, v are literals and e = (u, v) is an edge of Gφ, then the definition of Gφ ensures that ē = (ū, v̄) is also an edge of Gφ and we can define ι (e) = ē. Similarly we can extend ι to sets of vertices — ι (S) = {u|ι (u) ∈ S} — and to paths: for a path p in Gφ, if p = v1 → · · · → vk then ι(p) = ι(vk) → ··· → ι (v1). (Note that ι reverses the direction of the path.) Finally we can extend ι to flows: if ζ is any flow, then ι (ζ) is defined by setting ι (ζ)p = ζι(p) for all paths p. Note that ι(ζ) is also a flow because the edge capacities are preserved by ι. A flow ζ is called symmetric if it satisfies ι (ζ) = ζ. Note that if ζ is any maximum multicommodity flow, then is also a maximum multicommodity flow, and it is symmetric. Thus, there is always at least one symmetric flow that optimizes (2).
3 Computing C3 reduces to multicommodity flow
Give quadratic pseudo-boolean function f, we can find its unique biform representation, f = cf + φf, then construct Gf and Gφ according to φf. Denote by v(CP) the optimal value of the cycle packing problem on Gf, and v(PP) the optimal value of the multicommodity flow problem on Gφ with source-sink pairs (x0, x̄0), (x1, x̄1),…, (xn, x̄n).
Lemma 1
For any quadratic pseudo-boolean function f, C3 = cf + v(CP).
Proof
See [3].
Lemma 2
For any quadratic pseudo-boolean function f, v(PP) = v(CP).
Proof
To prove Lemma 2, we will show that for every feasible solution ξ of the cycle packing problem, we can construct a feasible symmetric solution ζ of the multicommodity flow problem with the same objective function value, and vice versa.
ξ → ζ:
Given odd cycle C ∈ , starting from the variable with the lowest index, we can derive two paths pC and
in Gf where
For every path p in Gf, there is a unique path λ(p) = u0 → … → uk+1 in Gφ satisfying u0 = xc0, and ui ∈ {xci, x̄ci} for all i > 0. In fact λ(p) can be defined by letting p[1..i] denote the initial segment of p starting at xc0 and ending at xci, and setting
Note that uk+1 = x̄c0 when p is an odd cycle.
Given feasible CP solution ξ, we can construct solution ζ of the multicommodity flow problem:
It is clear to see ξ and ζ have the same objective function value, and ζ is symmetric. The flow ζ is also feasible, because if ζ violates the capacity constraint of edge (u, v) in PP, ξ must violate the corresponding constraint of the edge (var(u), var(v)) in CP. Here and henceforth, var denotes the function from literals to variables defined by var(xi) = var(x̄i) = xi.
ζ → ξ:
Give path p ∈ Pi in Gφ, we can write p as
Extending the function var to paths, we get paths in Gf
Consider Vφ as the union of two sets Vf and V̄f. An easy observation is that if an edge’s two endpoints are in the same set, its associated bi-term is positive, and if its endpoints are in different sets, it is associated to a negative bi-term. Since p goes from xi to x̄i, we know there are odd number of edges in p that are associated to negative bi-terms, so var(p) = C ∈ . Given a feasible solution ζ of the multicommodity flow problem, we can construct a solution ξ of the cycle packing problem:
ξ has the same objective function value as ζ. We can prove ξ is feasible by contradiction.
Suppose ξ violates the constraint
Each edge in Ef is associated with a bi-term, which correpsonds to two edges in Eφ, so for edge e0 there are two corresponding edges e1, e2 ∈ Eφ, where
From the correspondence between paths in Gφ and odd cycles in Gf, we know every path p with var(p) = C must use one of e1 and e2, so
We know at least one of the two constraints in multicommodity flow is violated, i.e.:
which contradicts the feasibility of ζ. Thus we know ξ must be feasible.
Since for every feasible solution ξ of cycle packing problem, we can construct a feasible solution ζ of the multicommodity flow problem with the same objective function value, and vice versa, v(CP) = v(PP).
Theorem 1
For any quadratic pseudo-boolean function f, C3 = cf + v(PP).
Proof
Theorem 1 is a direct result of Lemma 1 and Lemma 2.
4 Persistency and autarky results
Theorem 2
If e = (u, v) is an edge of Gφ such that e is not saturated in any symmetric maximum multicommodity flow, then {u, v} is a strong relational persistency for the corresponding pseudo-Boolean function f.
Proof
Notice that given a feasible solution ζ for the multicommodity flow problem on Gφ, we can express the graph’s edge capacity vector as the sum of two non-negative vectors, one for the flow value on edges, and the other for the remaining edge capacities. We refer to these vectors as “the flow layer” and “the remaining graph layer.” The flow layer can be directly derived from the flow assignments, and the remaining graph layer, Gφ,ζ = (Vφ,ζ, Eφ,ζ), where
Vφ,ζ = Vφ
Eφ,ζ = {e ∈ Eφ | ce > ΣiΣp∈Pi, P
e ζp}
For all e ∈ Eφ,ζ, the capacity is ce,ζ = ce − ΣiΣp∈Pi|P
e ζp.
We will make use of the following lemma from [3].
Lemma 3
Proof
Lemma 3 can be easily proven by induction. See [3] for a proof.
Using Lemma 3, we can transform a flow along path p: xi → u1 → u2 → … → uk → x̄i with value δ to the sum of a constant and a cubic posiform:
It follows that the flow layer can be written as the sum of a constant — which is equal to the flow value — and a homogeneous cubic Boolean function, while the remaining graph layer corresponds to a homogeneous quadratic Boolean function.
Suppose e = (u, v) is never saturated in any optimal symmetric multicommodity flow solution. Among all optimal solutions, consider those with the maximum number of vertices in the component containing v in the graph Gφ,ζ, and among these solutions, let ζ be the one with the minimum ce, ζ. By our assumption on ζ, if we maintain the same total flow value, it will be impossible to expand the connected component containing v, and it is also impossible to decrease ce, ζ without making the component containing v smaller. Suppose there exists an optimal assignment x* with u ≠ v. Without loss of generality, we can assume that x* assigns u = 0 and v = 1.
Define S to be the set of vertices of the connected component containing v in the subgraph induced by vertices with value 1 according to x* in Gφ, ζ. We will show that changing the values of literals in S to 0, and their negations to 1, will give an assignment x′ such that f(x′) < f(x*), thus contradicting the hypothesis that x* is an optimal assignment.
Write the pseudo-Boolean function f as the sum of constant, cubic terms corresponding to the flow solution ζ, and quadratic terms corresponding to Gφ, ζ. An easy observation is that setting the two endpoints of an edge to the same value will give the corresponding bi-term value 0. It is then easy to see x′ will decrease the value of quadratic terms by at least ce, ζ. Now if we can show changing from x* to x′ will not increase the value of cubic terms, then we know f(x′) will be strictly less than f(x*).
Lemma 4
Given symmetric flow assignment ζ1, for path p from xi to x̄i with flow value (ζ1)p > 0, and vertex xj ≠ xi, if xj or x̄j is on p, or there exists a simple path p′ in Gφ, ζ1 from xj or x̄j to any vertex on p, we can get a flow assignment ζ2 such that:
ζ1 and ζ2 have the same flow value
Eφ, ζ1 ⊆ Eφ, ζ2
if e′ = (u′, v′) belongs to p′ but not p, ζ2 puts more flow on e′ than ζ1 does, and ce′, ζ 2 < ce′,ζ1
if e′ = (u′, v′) is not in p, ce′, ζ 2 ≤ ce′, ζ 1
Proof
Since ζ1 is symmetric, a flow along path p = xi → u1 → … → uk → x̄i implies a flow along path ι(p) = xi → ūk → … → ū1 → x̄i with the same value. The two paths together will then form a generalized cycle, which we define to be a walk that starts and ends at the same vertex, but may traverse an edge more than once. If xj or x̄j is on p, we can cut the cycle into two possibly non-simple paths at xj and x̄j, then take some shortcuts to make the two paths simple. For example, consider
then redistributing the flow as from u2 to ū2 will give
Notice that the redistribution operation may increase some edges’ remaining capacities. In the above example, the remaining capacities of c(xi,u1), ζ and c(x̄i,ū1), ζ are increased. If an edge is not on p, then its remaining capacity will not be increased.
If there exists a simple path from xj or x̄j to some v′ on p, we only need to consider the first case, since by symmetry the second case will be equivalent to the first one if we switch p and ι(p). Without loss of generality, assume the path pe from xj to v′ uses no edge on p or ι(p); otherwise we can take a different v′ and get a shorter pe. We can first redistribute the flow as from v′ to v̄′ without increasing the remaining capacity of any edge on pe, then extend a small portion of the flow δ′ as from xj to x̄j using pe and ι(pe). If we make δ′ small enough, the redistribution will not saturate any edge on pe and ι(pe)
Lemma 5
All paths involving vertices in S with positive flow value must use the edge (u, v) or (ū, v̄).
Proof
Suppose there is flow along p passing v′ ∈ S without using (u, v) and (ū, v̄). Since there exist paths u → v → v′ and v̄′ → v̄ → ū in Gφ, ζ, we know from Lemma 4 that we can get another optimal flow assignment without shrinking the connected component containing v, but decrease c(u,v), ζ, which contradicts our assumption about ζ.
Lemma 5 implies that all flow involving the literals with different values in x′ and x* are along paths using the (undirected) edge (u, v) or (ū, v̄). Since p and ι(p) yield the same function terms, and p uses (ū, v̄) implies ι(p) uses (u, v), we only need to prove x′ will not increase the value of the cubic terms corresponding to flow along paths using (u, v). Since all such paths use vertex u, we can redistribute the flows as from u to ū. We will no longer assume the minimality of c(u,v), ζ, since the redistribution may increase c(u,v), ζ.
By Lemma 3, we know the cubic terms corresponding to these flow paths all have the form:
which can be further reduced to quadratic terms by the assumption u = 0:
Consider any specific flow path. When we change x* to x′, there are only two cases that the value of the above expression can be increased:
The first case is vℓ = 1 in x′, and vℓ+1 ∈ S. Then the term vℓv̄ℓ+1 has value 0 according to x*, but value 1 according to x′. The second case is the symmetric counterpart of the first case, namely vℓ ∈ ι(S), and vℓ+1 = 0 in x′. If we can prove the first case is impossible, by symmetry the second case is also impossible.
Suppose we have the first case in the flow along path p. By the fact that vℓ = 1 in x′, we know vℓ ∉ S. If vℓ ∈ ι(S), the edge (vℓ, vℓ+1) must be saturated, since otherwise there exists a path from u to ū in Gφ, ζ, contradicting our assumption that ζ is a maximum flow. If vℓ ∉ ι(S), vℓ = 1 in x*, and by the definition of S, vℓ ∉ S implies the edge (vℓ, vℓ+1) is saturated. Either way, (vℓ, vℓ+1) is saturated. Furthermore, since vℓ+1 is in S, there exists a path from v to vℓ+1 in Gφ, ζ that does not use edge (vℓ, vℓ+1). Hence we can reroute some small enough portion of the original flow to use the alternate path from v to vℓ+1, thus making the edge (vℓ, vℓ+1) unsaturated without changing the value of the flow solution. This will enlarge S to S ∪ {vℓ}, contradicting the maximality of S.
By the above discussion, we know x′ won’t increase the value of the cubic terms, and will decrease the value of quadratic terms by at least c(u,v), ζ. This contradicts the optimality of x*, so u and v must have the same value in any optimal assignment.
4.1 Persistencies and autarkies from single-commodity flows
Lemma 6
Any subset of a strong relational autarky is a strong relational persistency.
Proof
Suppose S is a subset of some strong relational autarky S′. Consider any optimal assignment x. Since it is not possible to have f(x[S′ → b]) < f(x), it must be the case that x assigns the same value to all literals in S′. Since S ⊆ S′, all literals in S have the same value in all optimal assignments, which makes S a strong relational persistency.
Consider any symmetric optimal solution ζ of the single commodity maximum flow problem with source xs and sink x̄s on Gφ. Using the same definition of Gφ, ζ as in the proof of Theorem 2, let S denote the connected component containing xs in Gφ, ζ.
Theorem 3
S is a strong relational persistency of the corresponding pseudo-Boolean function f. Conversely, if U is a strong relational persistency containing xi, then there exists a symmetric optimal assignment ζ of the single commodity flow problem with source-sink pair (xi, x̄i), such that U is completely contained in the connected component containing xi in Gφ,ζ.
Proof
We will start with the first part of the theorem. Notice that S contains at most one of xi and x̄i for all i, since otherwise symmetry implies a path from xs to x̄s in Gφ, ζ.
First consider the case when ζ is a maximum flow assignment such that the set S is maximal. If S has at most one element, then S is a strong relational autarky by definition. Otherwise, consider any assignment x, and assume that two literals in S have different value according to x. Let b = 0. We shall prove f(x[S → b]) < f(x), from which it follows that S is a strong relational autarky.
Let K = S ∪ ι(S). Write f as the sum of a constant, cubic terms corresponding to flow solution ζ, and quadratic terms corresponding to Gφ, ζ. We will show that in this expression for f, all terms involving literals in K will have value 0 according to x[S → b]. Consider any quadratic term involving literals in K. The term must correspond to edges in Gφ, ζ whose endpoints are both in S or both in ι(S), since there is no edge between S and Vφ, ζ \S. The term will vanish since the endpoints of its corrsponding edge are set to the same value in x[S → b].
For the cubic terms, since all flows are from xs to x̄s, using Lemma 3, we know the cubic terms all have the form:
We have xs = b = 0 in x[S → b], so the cubic terms can be reduced to:
Consider any term in the above formula involving variables in K. Similiar to the proof of Theorem 2, there are only two cases such that the term will not vanish. The first case is vℓ = 1, and vℓ+1 ∈ S. Then the term vℓv̄ℓ+1 has value 1 according to x[S → b]. The second case is the symmetric counterpart of the first case, namely vℓ ∈ ι(S), and vℓ+1 = 0. If we can prove the first case is impossible, by symmetry the second case is also impossible. Using the same argument in proof of Theorem 2, if the first case happens, we can expand S without changing the total flow value, thus contradicting the maximality of S. So all terms involving literals in K will vanish.
S is a strong relational autarky for the following reason. Terms not using literals in K will have the same value with respect to x and x[S → b], and all terms using literals in K will vanish under x[S → b]. Moreover, since there exist two literals in S that are assigned different values by x, and the two literals are connected in Gφ, ζ, at least one term using literals in K will not vanish under x, implying f(x[S → b]) < f(x).
Now consider an arbitrary maximum flow solution ζ without assuming S to be maximal. The only difference from the above case is that we can expand S by rerouting flows. It is clear to see that the new value of S after the expansion will be a superset of the former value of S. Thus starting from an arbitrary ζ and S, we can always get another maximum flow assignment ζ′ with a maximal S′, and S ⊆ S′, where S′ is a strong relational autarky. By Lemma 6, we know S is a strong relational persistency.
Now we prove the second part of the theorem. Let ζ be the maximum single commodity flow assignment with a maximal connected component containing xi, and denote the connected component by S. Recall that we assume U is a strong relational persistency containing xi.
The proof is by contradiction. Assuming U ⊈ S, we get a partition {U1,U2} of U where U2 = U\S, and U1 = U∩S. U2 is nonempty since U ⊈ S, and U1 is also nonempty since xi ∈ U1. By definition of strong relational persistency, literals in U1 and U2 must have the same value in all optimal assignments. Consider an optimal assignment x*. We can assume all literals in U1 and U2 have value 1 in x*, since the bi-form will have the same function value if we negate all variables’ values. By the discussion from the first part of the proof, we know x* [S → 0] must also be an optimal assignment, where literals in U1 have value 0, and literals in U2 have value 1. The optimality of x* [S → 0] contradicts the assumption that U is a strong relational persistency, thus U ⊆S.
Notice if U is a strong relational persistency, then ι(U) is also a strong relational persistency, and they are semantically equivalent, so a strong relational persistency containing x̄i implies an equivalent strong relational persistency containing xi. Theorem 3 then suggests that we can derive all strong relational persistencies by computing single commodity maximum flows in Gφ. The reverse direction of Theorem 3 also suggests that if S = {u, v} is derived from Theorem 2 as a strong relational persistency, then it can also be derived from Theorem 3 as a subset of a strong relational autarky.
Remark
The forward direction of Theorem 3 follows from remarks in [6], and the preprocessing code in [5] also applied the idea. The reverse direction is new, and guarantees that we can derive all strong relational persistencies by single commodity maximum flows.
Footnotes
Throughout this paper, we work with undirected graphs and make no distinction between a path and its reversal. In particular, a path from s to t is also a path from t to s.
Publisher's Disclaimer: This is a PDF file of an unedited manuscript that has been accepted for publication. As a service to our customers we are providing this early version of the manuscript. The manuscript will undergo copyediting, typesetting, and review of the resulting proof before it is published in its final citable form. Please note that during the production process errors may be discovered which could affect the content, and all legal disclaimers that apply to the journal pertain.
Contributor Information
Di Wang, Department of Computer Science Cornell University Ithaca, NY 14853 Telephone: 607-379-1538 Fax: 607-255-4428 Email: dw236@cornell.edu.
Robert D. Kleinberg, 4138 Upson Hall Department of Computer Science Cornell University Ithaca, NY 14853 Email: rdk@cs.cornell.edu
References
- 1.Ahuja RK, Magnanti TL, Orlin JB. Network Flows: Theory, Algorithms, and Applications. Prentice Hall; 1993. [Google Scholar]
- 2.Boros E, Crama Y, Hammer PL. Upper-bounds for quadratic 0–1 maximization. Operations Research Letters. 1990;9(2):73–79. [Google Scholar]
- 3.Boros E, Crama Y, Hammer PL. Chvatal cuts and odd cycle inequalities in quadratic 0–1 optimization. SIAM Journal on Discrete Mathematics. 1992;5(2):163–177. [Google Scholar]
- 4.Boros E, Hammer PL, Sun R, Tavares G. A max-flow approach to improved lower bounds for quadratic 0–1 minimization. Discrete Optimization. 2008;5(2):501–529. [Google Scholar]
- 5.Boros E, Hammer PL, Tavares G. Research Report 10, Rutgers Center for Operations Research. Rutgers University; New Brunswick, NJ: 2006. Preprocessing of unconstrained quadratic binary optimization. [Google Scholar]
- 6.Boros E, Hammer PL. Research Report 15, Rutgers Center for Operations Research. Rutgers University; New Brunswick, NJ: 1989. A max-flow approach to improved roof-duality in quadratic 0–1 minimization. [Google Scholar]
- 7.Felzenszwalb P, Zabih R. Discrete optimization methods in computer vision. Survey [Google Scholar]
- 8.Hammer PL, Hansen P, Simeone B. Roof duality, complementation and persistency in quadratic 0–1 optimization. Mathematical Programming. 1984;28(2):121–155. [Google Scholar]