Fast b-matching via Sufficient Selection Belief Propagation

Size: px
Start display at page:

Download "Fast b-matching via Sufficient Selection Belief Propagation"

Transcription

1 Fast b-matching via Sufficient Seection Beief Propagation Bert Huang Computer Science Department Coumbia University New York, NY 127 Tony Jebara Computer Science Department Coumbia University New York, NY 127 Abstract This artice describes scaabiity enhancements to a previousy estabished beief propagation agorithm that soves bipartite maximum weight b-matching. The previous agorithm required O( V + E ) space and O( V E ) time, whereas we appy improvements to reduce the space to O( V ) and the time to O( V 2.5 ) in the expected case (though worst case time is sti O( V E )). The space improvement is most significant in cases where edge weights are determined by a function of node descriptors, such as a distance or kerne function. In practice, we demonstrate maximum weight b-matchings to be sovabe on graphs with hundreds of miions of edges in ony a few hours of compute time on a modern persona computer without paraeization, whereas neither the memory nor the time requirement of previousy known agorithms woud have aowed graphs of this scae. 1 INTRODUCTION The maximum weight perfect b-matching probem is a generaization of maximum weight matching in which the sover is given a weighted graph and a set of target degrees, and must output the maximum weight induced subgraph such that each node has its target number of neighbors. The probem is sovabe in O( V E ) time with min-cost fow methods (Fremuth- Paeger and Jungnicke, 1999). In probems with dense graphs, the running time for b-matching sovers is Appearing in Proceedings of the 14 th Internationa Conference on Artificia Inteigence and Statistics (AISTATS) 211, Fort Lauderdae, FL, USA. Voume 15 of JMLR: W&CP 15. Copyright 211 by the authors. O(N 3 ), where N = V. Huang and Jebara (27) introduced a beief propagation agorithm which has the same asymptotic running time guarantee O(N 3 ) but is ightweight and has much smaer constant factors on running time than other avaiabe sovers. In modern appications, however, the more obstructive botteneck is the O(N 2 ) space requirement to store messages from each node to each of its candidate neighbors. Whie it is possibe to wait for time-intensive jobs to run, a task that requires too much storage is further burdened by the need for compicated memory swapping strategies. This artice presents an improved agorithm for weighted b-matching that significanty reduces the memory cost and the running time for soving b- matching. Specificay, in probems where the edge weights are determined by a function of node descriptors, the space requirement is reduced to O(N) and the running time can be reduced to O(N 2.5 ) in some cases (but no worse than previous agorithms in adversaria cases). Both improvements are on each iteration of beief propagation, and the resuting agorithm computes the origina beief updates exacty, so any previous anaysis of the number of iterations necessary for convergence remains intact. The memory botteneck is reduced by unroing one eve of recursion in the beief updates such that the expicit beief need never be stored, and the running time improvement is achieved by a variant of the agorithm by McAuey and Caetano (21), in which speedups are avaiabe by decomposing a maximization procedure into the maximization of two components. Reated Work. This artice extends the beief propagation b-matching agorithm first introduced by Huang and Jebara (27), which is proven to converge in O( V ) iterations with a constant depending on the difference between the maximum weight edge and the minimum weight edge as we as the difference between the maximum weight b-matching and the second best b-matching. This agorithm was further anayzed by Sanghavi et a. (27) and Bayati et a. (27), who

2 Fast b-matching via Sufficient Seection Beief Propagation showed independenty that the agorithm is guaranteed to converge if and ony if the inear programming reaxation of the integer program formuation of b-matching is tight. This resut confirms the previous theorem that the agorithm converges on bipartite probems and further extends guaranteed convergence to some non-bipartite cases. The 1-matching with iid, random weights was further anayzed by Saez and Shah (29), where the surprising resut was proven that the agorithm converges with high probabiity in O(1) iterations and, thus, costs O( V 2 ) time overa, which is optima, as it is equivaent to the time needed to read the input edge weights. In addition to cassica optimization tasks, such as discrete resource aocation, weighted b-matching has been shown to be a usefu too for various machine earning tasks, incuding semi-supervised earning, spectra custering, graph embedding, and manifod earning (Jebara et a., 29; Jebara and Shchogoev, 26; Shaw and Jebara, 27, 29). Weighted b-matching sovers can aso be used as drivers for a maximum a posteriori estimation procedure for graph structure given edge ikeihoods and soft degree priors (Huang and Jebara, 29). The genera formuation aows for concave penaty functions on the degrees of nodes by constructing an augmented graph with auxiiary edges encoding the degree penaties. The augmented graph has at most doube the nodes of the origina graph, so the asymptotic running time of the agorithm is equivaent to the running time of the b-matching sover. For graphs restricted to nonnegative integer weights, the bipartite maximum weight 1-matching probem was shown to be sovabe in O( V E og( V )) time by Gabow and Tarjan (1989). An Õ( V ) randomized agorithm which succeeds with high probabiity was reveaed by Sankowski (29). A (1-ǫ) approximation agorithm for nonbipartite maximum weight matching with rea weights was given by Duan and Pettie (21), which runs in O( E ǫ 2 og 3 V ) time. Outine. The remainder of this paper is organized as foows. Section 2 describes the proposed agorithm in detai and provides anaysis. Section 3 describes empirica evauation of the proposed agorithm on synthetic and rea data, incuding comparisons with a state-of-the-art maximum weight matching sover. Finay, Section 4 concudes with a brief discussion. 2 ALGORITHM DESCRIPTION This section describes the proposed agorithm, which is derived from the previous beief propagation approaches for b-matching and incorporates some further improvements to improve scaabiity. First, we provide a forma definition of the probem; then we describe the agorithm. Finay, we provide some anaysis showing the correctness of the enhanced agorithm as we as the speed and space improvements. 2.1 Dense Maximum Weight b-matching The bipartite dense maximum weight perfect b- matching probem (abbreviated as b-matching) is, given a dense, bipartite graph, in which a pairs of points that cross bipartitions have candidate edges and a target degree for each node, to find the maximum weight induced subgraph such that the nodes in the subgraph have their target degrees. Formay, the sover is given node descriptors {x 1,..., x m+n } drawn from space Ω, a weight function W : (Ω, Ω) R, and a set of target degrees {b 1,..., b m+n }, where each b i N. The goa is to output a symmetric, binary adjacency matrix A B (m+n) (m+n) whose entries A ij = 1 for a matched edges (x i, x j ) and are otherwise zero. The optimization can aso be written as argmax A s.t. m m+n i=1 j=m+1 m+n j=1 A ij W(x i, x j ) A ij = b i, i, A ij = A ji, (i, j). In particuar, we consider the bipartite scenario, where edges may ony be matched between nodes {x 1,..., x m } and nodes {x m+1,...,x m+n } but not within each set. This can be impemented with abuse of notation by defining the weight function W to output for any edges within bipartitions. This same probem can be expressed in many other forms, incuding graph notations using node and edge sets, but when considering the dense bipartite form of the probem, it is convenient to use matrix notation. 2.2 Linear Memory b-matching Beief Propagation In this section, we describe the method to reduce memory usage of b-matching via beief propagation to O(N), where the tota number of nodes N = m + n. First, we review the resuts from previous work (Bayati et a., 25; Huang and Jebara, 27; Sanghavi et a., 27) defining a simpified update rue for message updates, which aows for the standard O(N 2 ) space and O(N 2 ) per-iteration running time. A key component of the simpified beief propagation agorithm is the seection operation. This is the operation that finds the k th argest eement of a set for some index k. For notationa convenience, denote the seection operation

3 Bert Huang, Tony Jebara over any set S as σ k (S) = s S where {t S t s} = k. Beief propagation maintains a beief vaue for each edge, which, in the dense case, is convenienty represented as a matrix B, where entry Bij t is the beief vaue for the edge between x i and x j at iteration t. The simpified update rue for each beief is Bij t = W(x i, x j ) σ bj ({B t 1 k i}). (1) In the above equation and for the remainder of this text, indices range from 1 to (m+n), uness otherwise noted, and are omitted for ceaniness. The key insight for reducing memory usage is that the fu beiefs never need to be stored (not even the compressed messages). Instead, by unroing one eve of recursion, a that need to be stored are the seected beiefs, because the seection operation in Equation (1) ony weaky depends on index i. That is, the seection operation is over a indices excuding i, which means the seected vaue wi be either the b j th or the b j + 1 th greatest eement, σ bj ({B t 1 k i}) {σ bj ({B t 1 k}), σ b j+1({b t 1 k})}. Thus, once each row of the beief matrix B is updated, these two seected vaues can be computed and stored, and the rest of the row can be deeted from memory. Any further reference to B is therefore abstract, as it wi never be fuy stored. Any entry of the beief matrix can be computed in an onine manner from the stored seected vaue. Let α j be the negation of the b j th seection and β j be that of the b j +1 th seection. Then the update rues for these parameters are α t j = σ bj ({B t 1 k}), βt j = σ bj+1({b t 1 k}), (2) and the resuting beief ookup rue is { Bij t α t j if A t ji = W(x i, x j ) + 1 βj t otherwise. After each iteration, the current estimate of A is { A t ij = 1 if B t 1 ij α t i otherwise, (3) which is computed when the α and β vaues are updated in Equation (2). When this estimate is a vaid b-matching, i.e., when the coumns of A ij sum to their target degrees, the agorithm has converged to the soution. The agorithm can be viewed as simpy computing each row of the beief matrix and performing the seections on that row and is summarized in Agorithm 1. Agorithm 1 Beief Propagation for b-matching. Computes the adjacency matrix of the maximum weight b-matching., j 1: α j, β j 2: A [] 3: t 1 4: whie not converged do 5: for a j {1,..., m + n} do 6: A t, k k}) {Agorithm 2} k}) 9: for a {k B t 1 α t j } do 1: A t 1 11: end for 12: end for 13: deete A t 1, α t 1 and β t 1 from memory 14: t t : end whie 7: α t j σ b j ({B t 1 8: βj t σ b j+1({b t Sufficient Seection This section describes the running time enhancement in the proposed agorithm, which is a variation of the faster beief propagation agorithm proposed by McAuey and Caetano (21). The enhancements aim to reduce the running time of each iteration by expoiting the nature of the quantities being seected. In particuar, the key observation is that each beief is a sum of two quantities: a weight and an α or β vaue. These quantities can be sorted in advance, outside of the inner (row-wise) oop of the agorithm, and the seection operation can be performed without searching over the entire row, significanty reducing the amount of work necessary. This is done by testing a stopping criterion that guarantees no further beief ookups are necessary. Some minor difficuties arise, however, when sorting each component, so the agorithm by McAuey and Caetano (21) does not directy appy as-is. First, the weights cannot aways be fuy sorted. In genera, storing fu order information for each weight between a pairs of nodes requires quadratic space, which is impossibe with arger data sets. Thus, the proposed agorithm instead stores a cache of the heaviest weights for each node. In some specia cases, such as when the weights are a function of Eucidean distance, data structures such as kd-trees can be used to impicity store the sorted weights. This construction can provide one possibe variant to our main agorithm. Second, the α-β vaues require carefu sorting, because the true beief updates mosty incude α t terms but a few β t terms. Specificay, the indices that index the greatest b j eements of the row shoud use β t. One way

4 Fast b-matching via Sufficient Seection Beief Propagation to hande this technicaity is to first compute the sortorder of the α t terms and, on each row, correct the ordering using a binary search-ike strategy for each index in the seected indices. This method is technicay a ogarithmic time procedure, but requires some extra indexing ogic that creates undesirabe constant time penaties. Another approach, which is much simper to impement and does not require extra indexing ogic, is to use the sort-order of the β t s and adjust the stopping criterion to account for the possibiity of unseen α t vaues. Since the weights do not change during beief propagation, at initiaization, the agorithm computes index cache I N (m+n) c of cache size c, which is a parameter set by the user, where entry I ik is the index of the k th argest weight connected to node x i and, for u = I ik, W(x i, x u ) = σ k ({W(x i, x j ) j}). At the end of each iteration, the β t vaues are simiary sorted and stored in index vector e N m+n, where, for v = e k, entry β t v = σ k (β t j j}). The seection operation from (2) is then computed by checking the beiefs corresponding to the sorted weight and β indices. At each step, maintain a set S of the greatest b j + 1 beiefs seen so far. These provide tight ower bounds on the true α β vaues. At each stage of this procedure, the current estimates for α t j and βt j are α t j σ bj (S), and β t j min(s). Incrementay scan the beiefs for both index ists (I) j and e, computing for incrementing index k, B iiik and B iek. Each of these computed beiefs is compared to the beiefs in set S and if any member of S is ess than the new beief, the new beief repaces the minimum vaue in S. 1 ). This maintains S as the set of the greatest b j + 1 eements seen so far. At each stage, we bound the greatest possibe unseen beief as the sum of the east weight seen so far from the sorted weight cache and the east β vaue so far from the β cache. Once the estimate β j t is ess than or equa to this sum, the agorithm can exit because further comparisons are unnecessary. Agorithm 2 summarizes the sufficient seection procedure. 1 A sma hash tabe for the indices wi indicate whether an index has been previousy visited in O(1) time per ookup. For sma vaues of b j where (b j << n + m), a inear scan through S to find the minimum is sufficienty fast, but a priority queue can be used to achieve sub-inear time insertion and repacement when b j is arge. Agorithm 2 Sufficient Seection. Given sort-order of β t vaues and partia sort-order of weights, seects the b j th and b j + 1 th greatest beiefs of row j. 1: k 1 2: bound 3: S 4: α j t 5: βj t 6: whie β t j < bound do 7: if k c then 8: u I 9: if (u is unvisited and (Bju t 1 1: S (S \ min(s)) B t 1 ju 11: end if 12: end if > min(s)) then 13: v e k 14: if (v is unvisited and (Bjv t 1 > min(s)) then 15: S (S \ min(s)) B t 1 jv 16: end if 17: bound W(x j, x u ) + βv t 1 18: α t j σ b j (S) 19: βt j σ bj+1(s) 2: k k : end whie 22: α t j αt j 23: β t j β t j 2.4 Impementation Detais The impementation of Agorithms 1 and 2 used in the experiments of Section 3 is in C. To perform the initia iteration, during which the weight cache is constructed, our program uses the Quick Seect agorithm, which features the same pivot-based partitioning strategy as Quick Sort to perform seection in (average case) O(N) time per node (Cormen et a., 21). For owdimensiona data and distance-based weights, we can run the same seection using a kd-tree and provide the index cache as an input to the program Anaysis In this section, we anayze the correctness, space and running time requirements of the proposed agorithm. First, we verify that the bound from the sufficient seection procedure hods even though it is computed using ony the βj t vaues, when many of the beiefs are actuay computed using α t j vaues. Caim 1. At each stage of the scan, where set S contains the b j + 1 greatest beiefs corresponding to the first through k th indices of (I) j and e, the foowing 2 A newer C++ version of the sover is avaiabe at

5 Bert Huang, Tony Jebara properties are invariant: the current estimates bound the true vaues from beow, α t j αt j, β j t βt j, and the greatest unexpored beief is no greater than the sum of the east cached weight and the east β t 1 j vaue, W(x j, x u ) + βv t 1 ({ }) max B t 1 j {e k+1,..., e m+n, (4) where u = I and v = e k. Proof. The first two inequaities foow from the fact that the agorithm is seecting from but has not necessariy seen the fu row yet. The third inequaity (4) is the resut of two bounds. First, the beiefs in the right-hand side can be expanded and bounded by ignoring the conditiona in the beief update rue and aways using β t 1 : W(x j, x ) + β t 1 B t 1 j. By definition α t 1 β t 1, since the former is the negation of a arger vaue than the atter. A sufficient condition to guarantee Inequaity (4) is then W(x j, x u ) + β t 1 v max({w(x j, x ) + β t 1 }), where is in the remaining unseen indices as in (4). Since each component on the eft-hand side has been expored in decreasing order, the maximization on the right can be reaxed into independent maximizations over each component, and neither can exceed the corresponding vaue on the eft. Thus, the agorithm wi never stop too eary. However, the running time of the seection operation depends on how eary the stopping criterion is detected. In the worst case, the process examines every entry of the row, with some overhead checking for repeat comparisons. McAuey and Caetano (29, 21) showed that for random orderings of each dimension (and no truncated cache size), the expected number of beief comparisons necessary is O( N) to find the maximum, where, in our case N = m + n = V. We show that seection is computabe with O( bn) expected comparisons. However, for probems where the orderings of each dimension are negativey correated, the running time can be worse. In the case of b-matching, the orderings of the beiefs and potentias are in fact negativey correated, but in a weak manner. We first estabish the expected performance of the sufficient seection agorithm under the assumption of randomy ordered β vaues. Theorem 1. Considering the eement-wise sum of two rea-vaued vectors w and β of ength N with independenty random sort orders, the expected number of eements that must be compared to compute the seection of the b th greatest entry σ b ({w i + β i i}) is bn. Proof. The sufficient seection agorithm can be equivaenty viewed as checking eement-wise sums in the sort orders of the w and β vectors, and growing a set of k indices that have been examined. The agorithm can stop once it has seen b entries that are in the first k of both sort orders. We first consider the agorithm once it has examined k indices of each vector, and derive the expected number of entries that wi be in both sets of k greatest entries. Since the sort orders of each set are random, the probem can be posed as a simpe samping scenario. Without oss of generaity, consider the set of indices that correspond to the greatest k entries in w. Examining the greatest k eements of β is then equivaent to randomy samping k indices from 1 to N without repacement. Thus, the probabiity of any of the k greatest entries of β being samped is k/n, and, since there are k of these, the expected number of samped entries that are in the greatest k entries of both vectors is k 2 /N. Finay, to determine the number of entries the agorithm must examine to have, in expectation, b entries in the top k, we simpy sove the equation b = k 2 /N for k, which yieds that when k = bn, the agorithm wi in the expected case observe b entries in the top k of both ists and therefore competes computation. Appying the estimated running time to anaysis of the fu agorithm provides the foowing coroary. Coroary 1. Assuming the β messages and the weight potentias are aways randomy, independenty ordered, and for constant b, the tota running time for each iteration of beief propagation for b-matching with sufficient seection is O(N 1.5 ), and the tota running time to sove b-matching is O(N 2.5 ). It is important to point out the differences between the assumptions in Theorem 1 and why they do not aways hod in rea data scenarios. When nodes represent actua objects or entities and the weights are determined by a function between nodes, the weight vaues have dependencies and are therefore not competey randomy ordered. Furthermore, the β vaues change during beief propagation according to rues that depend on the weights, and in some cases can cause the seection time to grow to O(N). Nevertheess, in many samping settings and rea data generating processes, the weights are random enough and the messages behave we enough that the agorithm yieds significant speed improvements. Section 3 contains synthetic and rea data experiments that demonstrate the significant speed improvement as we as a contrived, synthetic experiment where the speedup is ess significant due to a specia samping process.

6 Fast b-matching via Sufficient Seection Beief Propagation Finay, the space requirement for this agorithm has been reduced from the O(N 2 ) beiefs (or messages) of the previous beief propagation agorithm to O(N) storage for the α and β vaues of each row. Naturay, this improvement is most significant in settings where the weights are computabe from an efficient function, whereas if the weights are arbitrary, the input itsef requires O(N 2 ) memory, so the memory reduction ony aows the additiona storage to be inear. In most machine earning appications, however, the weights are computed from functions of node descriptor pairs, such as Eucidean distance between vectors or kerne vaues. In these appications, the agorithm needs ony to store the node descriptors, the α and β vaues and, during the computation of Agorithm 2, O(N) beiefs (which can be immediatey deeted before computing the next row). The weight cache adds O(cN) space, where we consider c a user-seected constant. The space reduction is aso significant for the purposes of paraeization. The computation of beief propagation is easy to paraeize, but the communication costs between processors can be prohibitive. With the proposed agorithm, each computer in a custer stores ony a copy of the node descriptors and the current α and β vaues. At each iteration, the custer must share the 2N updated α and β vaues. This is in contrast to previous formuations where O(N 2 ) messages or beiefs needed to be transmitted between computers at each iteration for fu paraeization. Thus, when it is possibe to provide each computer with a copy of the node descriptor data, an easy paraeization scheme is to spit the row updates between custer computers at each iteration. 3 EXPERIMENTS This section describes empirica resuts from synthetic tests, which provide usefu insight into the behavior of the agorithm, and a simpe test on the MNIST handwritten digits data set, which demonstrates that the performance improvements appy to rea data. 3.1 Synthetic Gaussian Data In these experiments, the running time of the proposed agorithm is measured and compared against two baseine methods: the standard beief propagation agorithm, which is equivaent to setting the proposed agorithm s cache size to zero, and the Bossom V code by Komogorov (29), which is considered to be a state-of-the-art maximum weight non-bipartite matching sover. For both experiments, node descriptors are samped from zero-mean, spherica Gaussian distributions with (beief ookups per iteration) (1/2) (seconds per iteration) (1/2) Averaged over 15 runs per size Averaged over 15 runs per size c =. c =.5 (m+n) c =.15 (m+n) c = 1. (m+n) c =. c =.5 (m+n) c =.15 (m+n) c = 1. (m+n) Figure 1: Running Time Measurements on Synthetic Gaussian Data. Top: Square root CPU time per iteration used to sove b-matching of varying sizes. The defaut beief propagation agorithm is equivaent to cache size c =, where the running time appears to grow quadraticay. Nonzero cache sizes are ceary sub-quadratic (sub-inear in the square root pot). Bottom: Count of beief ookups per iteration. The number of beief ookups serves as a surrogate measure of running time which is not affected by other processes running on the computer. variance 1., the weight function returns negative Eucidean distance, and we sampe bipartitions of equa size (m = n = N/2). In the first experiment, points are samped from R 2. Using different cache sizes, the running time of the agorithm is measured for varying point set sizes from 1 to 5. We set b i = 1, i. We measure the running time using actua CPU time as we as a count of beief ookups. The square roots of per-iteration running times are drawn in Figure 1. It is cear that for a cache size of zero, where the agorithm is defaut beief propagation, the running time per iteration scaes quadraticay and that for non-zero cache sizes, the running time scaes sub-quadraticay. This impies that, at east for random, iid, Gaussian data and Eucidean weights, the weights and β vaues are uncorreated enough to achieve the random permutation case speedup. For the second experiment, node descriptors are drawn from R 5, and we compare 1-matching performance between sufficient seection beief propagation, fu beief propagation and Komogorov s Bossom V code. For sufficient seection, we set the cache size to c = 2 m + n. In this case, there is no equivaent notion of per-iteration time for Bossom V, so we compare the fu soution time. Fu beief propagation and Bossom V seem to scae simiary, but sufficient se-

7 Bert Huang, Tony Jebara time (seconds) Averaged over 13 runs per size Sufficient BP Fu BP BossomV Figure 2: Comparison against Bossom V. Running times for soving varying sized bipartite 1-matching probems using Komogorov s Bossom V code, fu beief propagation and sufficient seection beief propagation. Node descriptors are samped from a spherica Gaussian in R 5 and weights are negative Eucidean distances. Fu beief propagation tends to run faster than Bossom V, but not aways. Beief propagation with sufficient seection is significanty faster for these random probems. ection improves the running time significanty. For this comparison, it is important to note some differences between the probem casses that the compared code sove: the agorithm behind Bossom V soves non-bipartite 1-matchings, whereas the proposed agorithm is speciaized for bipartite b-matchings. Nevertheess, in this comparison, a agorithms are given bipartite 1-matchings. These tests were run on a persona computer with an 8-core 3 GHz Inte Xeon processor (though each run was singe-threaded). 3.2 Synthetic Adversaria Exampe In this section, we present an experiment that is an adversaria exampe for the sufficient seection agorithm. We construct an iid samping scheme that generates data where the cached nearest neighbors of certain points wi not be the b-matched neighbors unti we cache Ω(N) neighbors. The data is generated by randomy samping points uniformy from the surfaces of two hyperspheres in high dimensiona space R 5, one with radius 1. and the other with radius.1. The resut is that, due to concentration, the points on the outer hypersphere are coser to a points on the inner sphere than any other points on the outer sphere, with high probabiity. Yet, the minimum distance b-matching wi connect points according to which sphere they were samped from. The distance between outer points to inner points wi be in the range [.9, 1.1], and the distance between outer points to other outer points wi concentrate around 2 when dimensionaity is much arger than N (because each vector is orthogona with high probabiity). A outer points wi rank the inner points as their nearest neighbors before any outer points, but due to b-matching constraints, not enough edges are avaiabe from the inner points. This is an exampe where, for beief propagation to find the best b-matching, the α and β vaues must be negativey correated with the weights. Using cache sizes from to m + n, where c = m + n aows the fu sufficient seection, running times are compared for different sized input. From the arguments above, the sufficient seection shoud fai to improve upon the asymptotic time of fu seection for a nodes on the outer hypersphere. Nevertheess, a constant time speedup is sti achieved by expoiting order information. This may simpy be because, sufficient seection speeds up performance for the points on the inner hypersphere but not for the adversariay arranged points on the outer hypersphere. (beief ookups per iteration) (1/2) (seconds per iteration) (1/2) Averaged over 15 runs per size Averaged over 15 runs per size c =. c =.1 (m+n) c =.25 (m+n) c = 1. (m+n) c =. c =.1 (m+n) c =.25 (m+n) c = 1. (m+n) Figure 3: High Dimensiona Two Hypersphere Running Times. Even for a fu cache size, the running time seems to sti scae quadraticay, abeit with a smaer constant factor. 3.3 Handwritten Digits We perform timing tests on the MNIST digits data set (LeCun et a., 21), which contains 6k training and 1k testing handwritten digit images. The images are centered, and represented as pixe grayscae images. We use principe components anaysis (PCA) to reduce the 784 pixe dimensions of each image to the top 1 principe eigenvector projections. We use negative Eucidean distance between PCA-projected digits as edge weights, and time sufficient seection beief propagation on a subsamped data set with varying cache sizes. In particuar, for this test, we sampe 1% of both the training and testing sets, resuting in 6 training and 1 testing digits. We generate feasibe b-matching constraints by setting the target degree {1,..., 5} for the training points and the

8 Fast b-matching via Sufficient Seection Beief Propagation target degree b te for testing points to b te = 6 (since there are six times as many training points). Since there are 6 miion candidate edges between training and testing exampes, any agorithm that stores and updates beiefs or states for each edge, such as the origina beief propagation agorithm described by Huang and Jebara (27) or the Bossom V agorithm by Komogorov (29) cannot be run on most computers without the use of expensive virtua memory swapping. Thus, we ony compare the running times of inear memory b-matching beief propagation as described in Section 2.2 using different cache sizes. These timing tests were run on a Mac Pro with an 8- core 3 GHz Inte Xeon processor, each b-matching job running on ony a singe core. The resuts show that for a cache size of 2, the soution time is reduced from around an hour to fewer than ten minutes. Interestingy, the running time for arger b vaues is ess, which is because beief propagation seems to converge in fewer iterations. For arger cache sizes, we achieve minima further improvement in running time; it seems that once the cache size is arge enough, the agorithm finishes seection before running out of cached weights. Finay, using a cache size of 35, finding the minimum distance matching for the fu MNIST data set, which contains six hundred miion candidate edges between training and testing exampes, took approximatey five hours for = 1 and = 4. The statistics from each run are summarized in Tabe 1. As in the synthetic exampes, we count the number of beief ookups during the entire run and can compare against the tota number that woud have been necessary had a standard seection agorithm been used (which is (m + n) 2 per iteration). The running time is approximatey 1 times faster than the estimated time for beief propagation with naive seection. Time (minutes) = 1, b te = 6 = 2, b te = 12 = 3, b te = 18 = 4, b te = 24 = 5, b te = Cache Size Figure 4: Minimum Eucidean Distance b-matching Subsamped MNIST Digit Running Times. Weighted b-matching is soved on a subset of the MNIST data set. Running times are measured for various target degrees and b te, as we as weight cache sizes. See Tabe 1 for running time measurements on the fu MNIST data set. Tabe 1: Running Time Statistics on Fu MNIST Data Set. Matching the fu MNIST training set to the testing set considers 7 nodes and 6 miion edges. The tabe coumns are, from eft to right, the target degrees and b te for training and testing nodes, raw running time for b-matching in minutes, the tota number of beief ookups during the entire run, and the percentage of the beief ookups that woud have been necessary using naive beief propagation (% Fu). b te Time (min.) Beief Lookups % Fu % % 4 DISCUSSION This artice presented an enhanced beief propagation agorithm that soves maximum weight b-matching. The enhancements yied significant improvements in space requirement and running time. The space requirement is reduced from quadratic to inear, and the running time is reduced from O(N 3 ) to O(N 2.5 ) under certain assumptions. Empirica performance is consistent with the theoretica anaysis, yet the theoretica anaysis needs restrictive assumptions, so reaxing these to more reaistic scenarios remains future work. Further speed and space improvements may be possibe by conceding exactness in favor of an approximation scheme. For exampe, node descriptors can be stored using hashing schemes that preserve the reconstruction of node distances (Karatzogou et a., 21). Additionay, the initia iteration requires essentiay a k-nearest neighbor computation, for which there are various approximate methods with speed tradeoffs. Extra anaysis is necessary, however, to provide the error bound for the resuting b-matching, as we as to ensure that beief propagation converges. Parae versions of the proposed agorithm are yet to be impemented, and, whie they seem theoreticay straightforward, exacty impementing the paraeization as efficienty as possibe remains future work. Finay, because of this agorithm, the cass of b-matching probems efficienty sovabe is now much arger, so appication of b-matching (and the agorithms that buid on b-matching) to arger scae data is a significant direction of future research. Acknowedgements The authors acknowedge support from DHS Contract N661-9-C-8 Privacy Preserving Sharing of Network Trace Data (PPSNTD) Program and thank Bake Shaw and Tiberio Caetano for hepfu discussions.

9 Bert Huang, Tony Jebara References M. Bayati, D. Shah, and M. Sharma. Maximum weight matching via max-product beief propagation. In Proc. of the IEEE Internationa Symposium on Information Theory, 25. M. Bayati, C. Borgs, J. T. Chayes, and R. Zecchina. Beief-propagation for weighted b-matchings on arbitrary graphs and its reation to inear programs with integer soutions. CoRR, abs/79.119, 27. T. Cormen, C. Leiserson, R. Rivest, and C. Stein. Introduction to agorithms. McGraw-Hi Book Company, Cambridge, London, 2 edition, 21. A. Danyuk, L. Bottou, and M. Littman, editors. Proceedings of the 26th Annua Internationa Conference on Machine Learning, ICML 29, Montrea, Quebec, Canada, June 14-18, 29, voume 382 of ACM Internationa Conference Proceeding Series, 29. ACM. ISBN R. Duan and S. Pettie. Approximating maximum weight matching in near-inear time. In Proceedings 51st IEEE Symposium on Foundations of Computer Science (FOCS), 21. C. Fremuth-Paeger and D. Jungnicke. Baanced network fows. i. a unifying framework for design and anaysis of matching agorithms. Networks, 33(1), H. N. Gabow and R. E. Tarjan. Faster scaing agorithms for network probems. SIAM J. Comput., 18(5): , B. Huang and T. Jebara. Loopy beief propagation for bipartite maximum weight b-matching. In M. Meia and X. Shen, editors, Proceedings of the 11th Internationa Conference on Artificia Inteigence and Statistics, voume 2 of JMLR: W&CP, March 27. B. Huang and T. Jebara. Exact graph structure estimation with degree priors. In M. Wani, M. Kantardzic, V. Paade, L. Kurgan, and Y. Qi, editors, ICMLA, pages IEEE Computer Society, 29. ISBN T. Jebara and V. Shchogoev. B-matching for spectra custering. In J. Fürnkranz, T. Scheffer, and M. Spiiopouou, editors, ECML, voume 4212 of Lecture Notes in Computer Science, pages Springer, 26. ISBN X. T. Jebara, J. Wang, and S.-F. Chang. Graph construction and b-matching for semi-supervised earning. In Danyuk et a. (29), page 56. ISBN A. Karatzogou, A. Smoa, and M. Weimer. Coaborative fitering on a budget. In Y. Teh and M. Titterington, editors, Proceedings of the Thirteenth Internationa Conference on Artificia Inteigence and Statistics (AISTATS), voume 9, pages , 21. V. Komogorov. Bossom v: a new impementation of a minimum cost perfect matching agorithm. Mathematica Programming Computation, 1:43 67, 29. ISSN URL /s Y. LeCun, L. Bottou, Y. Bengio, and P. Haffner. Gradientbased earning appied to document recognition. In Inteigent Signa Processing, pages IEEE Press, 21. J. McAuey and T. Caetano. Faster agorithms for maxproduct message-passing. CoRR, abs/91.331, 29. J. McAuey and T. Caetano. Expoiting data-independence for fast beief-propagation. In J. Fürnkranz and T. Joachims, editors, ICML, pages Omnipress, 21. J. Saez and D. Shah. Optimaity of beief propagation for random assignment probem. In C. Mathieu, editor, SODA, pages SIAM, 29. S. Sanghavi, D. Maioutov, and A. Wisky. Linear programming anaysis of oopy beief propagation for weighted matching. In J. Patt, D. Koer, Y. Singer, and S. Roweis, editors, Advances in Neura Information Processing Systems 2, pages , Cambridge, MA, 27. MIT Press. P. Sankowski. Maximum weight bipartite matching in matrix mutipication time. Theor. Comput. Sci., 41(44): , 29. B. Shaw and T. Jebara. Minimum voume embedding. In M. Meia and X. Shen, editors, Proceedings of the 11th Internationa Conference on Artificia Inteigence and Statistics, voume 2 of JMLR: W&CP, March 27. B. Shaw and T. Jebara. Structure preserving embedding. In Danyuk et a. (29), page 118. ISBN

Fast b-matching via Sufficient Selection Belief Propagation

Fast b-matching via Sufficient Selection Belief Propagation Bert Huang Computer Science Department Coumbia University New York, NY 127 bert@cs.coumbia.edu Tony Jebara Computer Science Department Coumbia University New York, NY 127 jebara@cs.coumbia.edu Abstract

More information

Language Identification for Texts Written in Transliteration

Language Identification for Texts Written in Transliteration Language Identification for Texts Written in Transiteration Andrey Chepovskiy, Sergey Gusev, Margarita Kurbatova Higher Schoo of Economics, Data Anaysis and Artificia Inteigence Department, Pokrovskiy

More information

Nearest Neighbor Learning

Nearest Neighbor Learning Nearest Neighbor Learning Cassify based on oca simiarity Ranges from simpe nearest neighbor to case-based and anaogica reasoning Use oca information near the current query instance to decide the cassification

More information

Outline. Parallel Numerical Algorithms. Forward Substitution. Triangular Matrices. Solving Triangular Systems. Back Substitution. Parallel Algorithm

Outline. Parallel Numerical Algorithms. Forward Substitution. Triangular Matrices. Solving Triangular Systems. Back Substitution. Parallel Algorithm Outine Parae Numerica Agorithms Chapter 8 Prof. Michae T. Heath Department of Computer Science University of Iinois at Urbana-Champaign CS 554 / CSE 512 1 2 3 4 Trianguar Matrices Michae T. Heath Parae

More information

Solutions to the Final Exam

Solutions to the Final Exam CS/Math 24: Intro to Discrete Math 5//2 Instructor: Dieter van Mekebeek Soutions to the Fina Exam Probem Let D be the set of a peope. From the definition of R we see that (x, y) R if and ony if x is a

More information

A Design Method for Optimal Truss Structures with Certain Redundancy Based on Combinatorial Rigidity Theory

A Design Method for Optimal Truss Structures with Certain Redundancy Based on Combinatorial Rigidity Theory 0 th Word Congress on Structura and Mutidiscipinary Optimization May 9 -, 03, Orando, Forida, USA A Design Method for Optima Truss Structures with Certain Redundancy Based on Combinatoria Rigidity Theory

More information

Solving Large Double Digestion Problems for DNA Restriction Mapping by Using Branch-and-Bound Integer Linear Programming

Solving Large Double Digestion Problems for DNA Restriction Mapping by Using Branch-and-Bound Integer Linear Programming The First Internationa Symposium on Optimization and Systems Bioogy (OSB 07) Beijing, China, August 8 10, 2007 Copyright 2007 ORSC & APORC pp. 267 279 Soving Large Doube Digestion Probems for DNA Restriction

More information

Searching, Sorting & Analysis

Searching, Sorting & Analysis Searching, Sorting & Anaysis Unit 2 Chapter 8 CS 2308 Fa 2018 Ji Seaman 1 Definitions of Search and Sort Search: find a given item in an array, return the index of the item, or -1 if not found. Sort: rearrange

More information

Load Balancing by MPLS in Differentiated Services Networks

Load Balancing by MPLS in Differentiated Services Networks Load Baancing by MPLS in Differentiated Services Networks Riikka Susitaiva, Jorma Virtamo, and Samui Aato Networking Laboratory, Hesinki University of Technoogy P.O.Box 3000, FIN-02015 HUT, Finand {riikka.susitaiva,

More information

AN EVOLUTIONARY APPROACH TO OPTIMIZATION OF A LAYOUT CHART

AN EVOLUTIONARY APPROACH TO OPTIMIZATION OF A LAYOUT CHART 13 AN EVOLUTIONARY APPROACH TO OPTIMIZATION OF A LAYOUT CHART Eva Vona University of Ostrava, 30th dubna st. 22, Ostrava, Czech Repubic e-mai: Eva.Vona@osu.cz Abstract: This artice presents the use of

More information

Lecture outline Graphics and Interaction Scan Converting Polygons and Lines. Inside or outside a polygon? Scan conversion.

Lecture outline Graphics and Interaction Scan Converting Polygons and Lines. Inside or outside a polygon? Scan conversion. Lecture outine 433-324 Graphics and Interaction Scan Converting Poygons and Lines Department of Computer Science and Software Engineering The Introduction Scan conversion Scan-ine agorithm Edge coherence

More information

University of Illinois at Urbana-Champaign, Urbana, IL 61801, /11/$ IEEE 162

University of Illinois at Urbana-Champaign, Urbana, IL 61801, /11/$ IEEE 162 oward Efficient Spatia Variation Decomposition via Sparse Regression Wangyang Zhang, Karthik Baakrishnan, Xin Li, Duane Boning and Rob Rutenbar 3 Carnegie Meon University, Pittsburgh, PA 53, wangyan@ece.cmu.edu,

More information

A Memory Grouping Method for Sharing Memory BIST Logic

A Memory Grouping Method for Sharing Memory BIST Logic A Memory Grouping Method for Sharing Memory BIST Logic Masahide Miyazai, Tomoazu Yoneda, and Hideo Fuiwara Graduate Schoo of Information Science, Nara Institute of Science and Technoogy (NAIST), 8916-5

More information

A Comparison of a Second-Order versus a Fourth- Order Laplacian Operator in the Multigrid Algorithm

A Comparison of a Second-Order versus a Fourth- Order Laplacian Operator in the Multigrid Algorithm A Comparison of a Second-Order versus a Fourth- Order Lapacian Operator in the Mutigrid Agorithm Kaushik Datta (kdatta@cs.berkeey.edu Math Project May 9, 003 Abstract In this paper, the mutigrid agorithm

More information

Alpha labelings of straight simple polyominal caterpillars

Alpha labelings of straight simple polyominal caterpillars Apha abeings of straight simpe poyomina caterpiars Daibor Froncek, O Nei Kingston, Kye Vezina Department of Mathematics and Statistics University of Minnesota Duuth University Drive Duuth, MN 82-3, U.S.A.

More information

Automatic Grouping for Social Networks CS229 Project Report

Automatic Grouping for Social Networks CS229 Project Report Automatic Grouping for Socia Networks CS229 Project Report Xiaoying Tian Ya Le Yangru Fang Abstract Socia networking sites aow users to manuay categorize their friends, but it is aborious to construct

More information

Lecture Notes for Chapter 4 Part III. Introduction to Data Mining

Lecture Notes for Chapter 4 Part III. Introduction to Data Mining Data Mining Cassification: Basic Concepts, Decision Trees, and Mode Evauation Lecture Notes for Chapter 4 Part III Introduction to Data Mining by Tan, Steinbach, Kumar Adapted by Qiang Yang (2010) Tan,Steinbach,

More information

Space-Time Trade-offs.

Space-Time Trade-offs. Space-Time Trade-offs. Chethan Kamath 03.07.2017 1 Motivation An important question in the study of computation is how to best use the registers in a CPU. In most cases, the amount of registers avaiabe

More information

Priority Queueing for Packets with Two Characteristics

Priority Queueing for Packets with Two Characteristics 1 Priority Queueing for Packets with Two Characteristics Pave Chuprikov, Sergey I. Nikoenko, Aex Davydow, Kiri Kogan Abstract Modern network eements are increasingy required to dea with heterogeneous traffic.

More information

ACTIVE LEARNING ON WEIGHTED GRAPHS USING ADAPTIVE AND NON-ADAPTIVE APPROACHES. Eyal En Gad, Akshay Gadde, A. Salman Avestimehr and Antonio Ortega

ACTIVE LEARNING ON WEIGHTED GRAPHS USING ADAPTIVE AND NON-ADAPTIVE APPROACHES. Eyal En Gad, Akshay Gadde, A. Salman Avestimehr and Antonio Ortega ACTIVE LEARNING ON WEIGHTED GRAPHS USING ADAPTIVE AND NON-ADAPTIVE APPROACHES Eya En Gad, Akshay Gadde, A. Saman Avestimehr and Antonio Ortega Department of Eectrica Engineering University of Southern

More information

An Exponential Time 2-Approximation Algorithm for Bandwidth

An Exponential Time 2-Approximation Algorithm for Bandwidth An Exponentia Time 2-Approximation Agorithm for Bandwidth Martin Fürer 1, Serge Gaspers 2, Shiva Prasad Kasiviswanathan 3 1 Computer Science and Engineering, Pennsyvania State University, furer@cse.psu.edu

More information

MULTIGRID REDUCTION IN TIME FOR NONLINEAR PARABOLIC PROBLEMS: A CASE STUDY

MULTIGRID REDUCTION IN TIME FOR NONLINEAR PARABOLIC PROBLEMS: A CASE STUDY MULTIGRID REDUCTION IN TIME FOR NONLINEAR PARABOLIC PROBLEMS: A CASE STUDY R.D. FALGOUT, T.A. MANTEUFFEL, B. O NEILL, AND J.B. SCHRODER Abstract. The need for paraeism in the time dimension is being driven

More information

Sensitivity Analysis of Hopfield Neural Network in Classifying Natural RGB Color Space

Sensitivity Analysis of Hopfield Neural Network in Classifying Natural RGB Color Space Sensitivity Anaysis of Hopfied Neura Network in Cassifying Natura RGB Coor Space Department of Computer Science University of Sharjah UAE rsammouda@sharjah.ac.ae Abstract: - This paper presents a study

More information

On Upper Bounds for Assortment Optimization under the Mixture of Multinomial Logit Models

On Upper Bounds for Assortment Optimization under the Mixture of Multinomial Logit Models On Upper Bounds for Assortment Optimization under the Mixture of Mutinomia Logit Modes Sumit Kunnumka September 30, 2014 Abstract The assortment optimization probem under the mixture of mutinomia ogit

More information

file://j:\macmillancomputerpublishing\chapters\in073.html 3/22/01

file://j:\macmillancomputerpublishing\chapters\in073.html 3/22/01 Page 1 of 15 Chapter 9 Chapter 9: Deveoping the Logica Data Mode The information requirements and business rues provide the information to produce the entities, attributes, and reationships in ogica mode.

More information

Mobile App Recommendation: Maximize the Total App Downloads

Mobile App Recommendation: Maximize the Total App Downloads Mobie App Recommendation: Maximize the Tota App Downoads Zhuohua Chen Schoo of Economics and Management Tsinghua University chenzhh3.12@sem.tsinghua.edu.cn Yinghui (Catherine) Yang Graduate Schoo of Management

More information

A METHOD FOR GRIDLESS ROUTING OF PRINTED CIRCUIT BOARDS. A. C. Finch, K. J. Mackenzie, G. J. Balsdon, G. Symonds

A METHOD FOR GRIDLESS ROUTING OF PRINTED CIRCUIT BOARDS. A. C. Finch, K. J. Mackenzie, G. J. Balsdon, G. Symonds A METHOD FOR GRIDLESS ROUTING OF PRINTED CIRCUIT BOARDS A C Finch K J Mackenzie G J Basdon G Symonds Raca-Redac Ltd Newtown Tewkesbury Gos Engand ABSTRACT The introduction of fine-ine technoogies to printed

More information

Joint disparity and motion eld estimation in. stereoscopic image sequences. Ioannis Patras, Nikos Alvertos and Georgios Tziritas y.

Joint disparity and motion eld estimation in. stereoscopic image sequences. Ioannis Patras, Nikos Alvertos and Georgios Tziritas y. FORTH-ICS / TR-157 December 1995 Joint disparity and motion ed estimation in stereoscopic image sequences Ioannis Patras, Nikos Avertos and Georgios Tziritas y Abstract This work aims at determining four

More information

A Petrel Plugin for Surface Modeling

A Petrel Plugin for Surface Modeling A Petre Pugin for Surface Modeing R. M. Hassanpour, S. H. Derakhshan and C. V. Deutsch Structure and thickness uncertainty are important components of any uncertainty study. The exact ocations of the geoogica

More information

Image Segmentation Using Semi-Supervised k-means

Image Segmentation Using Semi-Supervised k-means I J C T A, 9(34) 2016, pp. 595-601 Internationa Science Press Image Segmentation Using Semi-Supervised k-means Reza Monsefi * and Saeed Zahedi * ABSTRACT Extracting the region of interest is a very chaenging

More information

On-Chip CNN Accelerator for Image Super-Resolution

On-Chip CNN Accelerator for Image Super-Resolution On-Chip CNN Acceerator for Image Super-Resoution Jung-Woo Chang and Suk-Ju Kang Dept. of Eectronic Engineering, Sogang University, Seou, South Korea {zwzang91, sjkang}@sogang.ac.kr ABSTRACT To impement

More information

Neural Network Enhancement of the Los Alamos Force Deployment Estimator

Neural Network Enhancement of the Los Alamos Force Deployment Estimator Missouri University of Science and Technoogy Schoars' Mine Eectrica and Computer Engineering Facuty Research & Creative Works Eectrica and Computer Engineering 1-1-1994 Neura Network Enhancement of the

More information

Distance Weighted Discrimination and Second Order Cone Programming

Distance Weighted Discrimination and Second Order Cone Programming Distance Weighted Discrimination and Second Order Cone Programming Hanwen Huang, Xiaosun Lu, Yufeng Liu, J. S. Marron, Perry Haaand Apri 3, 2012 1 Introduction This vignette demonstrates the utiity and

More information

A Fast Block Matching Algorithm Based on the Winner-Update Strategy

A Fast Block Matching Algorithm Based on the Winner-Update Strategy In Proceedings of the Fourth Asian Conference on Computer Vision, Taipei, Taiwan, Jan. 000, Voume, pages 977 98 A Fast Bock Matching Agorithm Based on the Winner-Update Strategy Yong-Sheng Chenyz Yi-Ping

More information

A New Supervised Clustering Algorithm Based on Min-Max Modular Network with Gaussian-Zero-Crossing Functions

A New Supervised Clustering Algorithm Based on Min-Max Modular Network with Gaussian-Zero-Crossing Functions 2006 Internationa Joint Conference on Neura Networks Sheraton Vancouver Wa Centre Hote, Vancouver, BC, Canada Juy 16-21, 2006 A New Supervised Custering Agorithm Based on Min-Max Moduar Network with Gaussian-Zero-Crossing

More information

Replication of Virtual Network Functions: Optimizing Link Utilization and Resource Costs

Replication of Virtual Network Functions: Optimizing Link Utilization and Resource Costs Repication of Virtua Network Functions: Optimizing Link Utiization and Resource Costs Francisco Carpio, Wogang Bziuk and Admea Jukan Technische Universität Braunschweig, Germany Emai:{f.carpio, w.bziuk,

More information

Privacy Preserving Subgraph Matching on Large Graphs in Cloud

Privacy Preserving Subgraph Matching on Large Graphs in Cloud Privacy Preserving Subgraph Matching on Large Graphs in Coud Zhao Chang,#, Lei Zou, Feifei Li # Peing University, China; # University of Utah, USA; {changzhao,zouei}@pu.edu.cn; {zchang,ifeifei}@cs.utah.edu

More information

Fastest-Path Computation

Fastest-Path Computation Fastest-Path Computation DONGHUI ZHANG Coege of Computer & Information Science Northeastern University Synonyms fastest route; driving direction Definition In the United states, ony 9.% of the househods

More information

Extended Node-Arc Formulation for the K-Edge-Disjoint Hop-Constrained Network Design Problem

Extended Node-Arc Formulation for the K-Edge-Disjoint Hop-Constrained Network Design Problem Extended Node-Arc Formuation for the K-Edge-Disjoint Hop-Constrained Network Design Probem Quentin Botton Université cathoique de Louvain, Louvain Schoo of Management, (Begique) botton@poms.uc.ac.be Bernard

More information

Distinct Sampling on Streaming Data with Near-Duplicates*

Distinct Sampling on Streaming Data with Near-Duplicates* Distinct Samping on Streaming Data with Near-Dupicates* ABSTRACT Jiecao Chen Indiana University Boomington Boomington, IN, USA jiecchen@umai.iu.edu In this paper we study how to perform distinct samping

More information

Hiding secrete data in compressed images using histogram analysis

Hiding secrete data in compressed images using histogram analysis University of Woongong Research Onine University of Woongong in Dubai - Papers University of Woongong in Dubai 2 iding secrete data in compressed images using histogram anaysis Farhad Keissarian University

More information

An Introduction to Design Patterns

An Introduction to Design Patterns An Introduction to Design Patterns 1 Definitions A pattern is a recurring soution to a standard probem, in a context. Christopher Aexander, a professor of architecture Why woud what a prof of architecture

More information

Relative Positioning from Model Indexing

Relative Positioning from Model Indexing Reative Positioning from Mode Indexing Stefan Carsson Computationa Vision and Active Perception Laboratory (CVAP)* Roya Institute of Technoogy (KTH), Stockhom, Sweden Abstract We show how to determine

More information

l Tree: set of nodes and directed edges l Parent: source node of directed edge l Child: terminal node of directed edge

l Tree: set of nodes and directed edges l Parent: source node of directed edge l Child: terminal node of directed edge Trees & Heaps Week 12 Gaddis: 20 Weiss: 21.1-3 CS 5301 Fa 2016 Ji Seaman 1 Tree: non-recursive definition Tree: set of nodes and directed edges - root: one node is distinguished as the root - Every node

More information

CERIAS Tech Report Replicated Parallel I/O without Additional Scheduling Costs by Mikhail J. Atallah Center for Education and Research

CERIAS Tech Report Replicated Parallel I/O without Additional Scheduling Costs by Mikhail J. Atallah Center for Education and Research CERIAS Tech Report 2003-50 Repicated Parae I/O without Additiona Scheduing Costs by Mikhai J. Ataah Center for Education and Research Information Assurance and Security Purdue University, West Lafayette,

More information

A Local Optimal Method on DSA Guiding Template Assignment with Redundant/Dummy Via Insertion

A Local Optimal Method on DSA Guiding Template Assignment with Redundant/Dummy Via Insertion A Loca Optima Method on DSA Guiding Tempate Assignment with Redundant/Dummy Via Insertion Xingquan Li 1, Bei Yu 2, Jiani Chen 1, Wenxing Zhu 1, 24th Asia and South Pacific Design T h e p i c Automation

More information

Layer-Specific Adaptive Learning Rates for Deep Networks

Layer-Specific Adaptive Learning Rates for Deep Networks Layer-Specific Adaptive Learning Rates for Deep Networks arxiv:1510.04609v1 [cs.cv] 15 Oct 2015 Bharat Singh, Soham De, Yangmuzi Zhang, Thomas Godstein, and Gavin Tayor Department of Computer Science Department

More information

CLOUD RADIO ACCESS NETWORK WITH OPTIMIZED BASE-STATION CACHING

CLOUD RADIO ACCESS NETWORK WITH OPTIMIZED BASE-STATION CACHING CLOUD RADIO ACCESS NETWORK WITH OPTIMIZED BASE-STATION CACHING Binbin Dai and Wei Yu Ya-Feng Liu Department of Eectrica and Computer Engineering University of Toronto, Toronto ON, Canada M5S 3G4 Emais:

More information

Special Edition Using Microsoft Excel Selecting and Naming Cells and Ranges

Special Edition Using Microsoft Excel Selecting and Naming Cells and Ranges Specia Edition Using Microsoft Exce 2000 - Lesson 3 - Seecting and Naming Ces and.. Page 1 of 8 [Figures are not incuded in this sampe chapter] Specia Edition Using Microsoft Exce 2000-3 - Seecting and

More information

Succinct Indices for Path Minimum, with Applications to Path Reporting

Succinct Indices for Path Minimum, with Applications to Path Reporting Succinct Indices for Path Minimum, with Appications to Path Reporting Timothy M. Chan 1, Meng He 2, J. Ian Munro 1, and Gein Zhou 1 1 David R. Cheriton Schoo of Computer Science, University of Wateroo,

More information

Resource Optimization to Provision a Virtual Private Network Using the Hose Model

Resource Optimization to Provision a Virtual Private Network Using the Hose Model Resource Optimization to Provision a Virtua Private Network Using the Hose Mode Monia Ghobadi, Sudhakar Ganti, Ghoamai C. Shoja University of Victoria, Victoria C, Canada V8W 3P6 e-mai: {monia, sganti,

More information

MCSE Training Guide: Windows Architecture and Memory

MCSE Training Guide: Windows Architecture and Memory MCSE Training Guide: Windows 95 -- Ch 2 -- Architecture and Memory Page 1 of 13 MCSE Training Guide: Windows 95-2 - Architecture and Memory This chapter wi hep you prepare for the exam by covering the

More information

As Michi Henning and Steve Vinoski showed 1, calling a remote

As Michi Henning and Steve Vinoski showed 1, calling a remote Reducing CORBA Ca Latency by Caching and Prefetching Bernd Brügge and Christoph Vismeier Technische Universität München Method ca atency is a major probem in approaches based on object-oriented middeware

More information

A Method for Calculating Term Similarity on Large Document Collections

A Method for Calculating Term Similarity on Large Document Collections $ A Method for Cacuating Term Simiarity on Large Document Coections Wofgang W Bein Schoo of Computer Science University of Nevada Las Vegas, NV 915-019 bein@csunvedu Jeffrey S Coombs and Kazem Taghva Information

More information

Further Optimization of the Decoding Method for Shortened Binary Cyclic Fire Code

Further Optimization of the Decoding Method for Shortened Binary Cyclic Fire Code Further Optimization of the Decoding Method for Shortened Binary Cycic Fire Code Ch. Nanda Kishore Heosoft (India) Private Limited 8-2-703, Road No-12 Banjara His, Hyderabad, INDIA Phone: +91-040-3378222

More information

Alternative Decompositions for Distributed Maximization of Network Utility: Framework and Applications

Alternative Decompositions for Distributed Maximization of Network Utility: Framework and Applications Aternative Decompositions for Distributed Maximization of Network Utiity: Framework and Appications Danie P. Paomar and Mung Chiang Eectrica Engineering Department, Princeton University, NJ 08544, USA

More information

GPU Implementation of Parallel SVM as Applied to Intrusion Detection System

GPU Implementation of Parallel SVM as Applied to Intrusion Detection System GPU Impementation of Parae SVM as Appied to Intrusion Detection System Sudarshan Hiray Research Schoar, Department of Computer Engineering, Vishwakarma Institute of Technoogy, Pune, India sdhiray7@gmai.com

More information

Application of Intelligence Based Genetic Algorithm for Job Sequencing Problem on Parallel Mixed-Model Assembly Line

Application of Intelligence Based Genetic Algorithm for Job Sequencing Problem on Parallel Mixed-Model Assembly Line American J. of Engineering and Appied Sciences 3 (): 5-24, 200 ISSN 94-7020 200 Science Pubications Appication of Inteigence Based Genetic Agorithm for Job Sequencing Probem on Parae Mixed-Mode Assemby

More information

Utility-based Camera Assignment in a Video Network: A Game Theoretic Framework

Utility-based Camera Assignment in a Video Network: A Game Theoretic Framework This artice has been accepted for pubication in a future issue of this journa, but has not been fuy edited. Content may change prior to fina pubication. Y.LI AND B.BHANU CAMERA ASSIGNMENT: A GAME-THEORETIC

More information

Delay Budget Partitioning to Maximize Network Resource Usage Efficiency

Delay Budget Partitioning to Maximize Network Resource Usage Efficiency Deay Budget Partitioning to Maximize Network Resource Usage Efficiency Kartik Gopaan Tzi-cker Chiueh Yow-Jian Lin Forida State University Stony Brook University Tecordia Technoogies kartik@cs.fsu.edu chiueh@cs.sunysb.edu

More information

Automatic Hidden Web Database Classification

Automatic Hidden Web Database Classification Automatic idden Web atabase Cassification Zhiguo Gong, Jingbai Zhang, and Qian Liu Facuty of Science and Technoogy niversity of Macau Macao, PRC {fstzgg,ma46597,ma46620}@umac.mo Abstract. In this paper,

More information

JOINT IMAGE REGISTRATION AND EXAMPLE-BASED SUPER-RESOLUTION ALGORITHM

JOINT IMAGE REGISTRATION AND EXAMPLE-BASED SUPER-RESOLUTION ALGORITHM JOINT IMAGE REGISTRATION AND AMPLE-BASED SUPER-RESOLUTION ALGORITHM Hyo-Song Kim, Jeyong Shin, and Rae-Hong Park Department of Eectronic Engineering, Schoo of Engineering, Sogang University 35 Baekbeom-ro,

More information

PCT: Partial Co-Alignment of Social Networks

PCT: Partial Co-Alignment of Social Networks PCT: Partia Co-Aignment of Socia Networks Jiawei Zhang University of Iinois at Chicago Chicago, IL, USA jzhan9@uicedu Phiip S Yu University of Iinois at Chicago, IL, USA Institute for Data Science Tsinghua

More information

Semi-Supervised Learning with Sparse Distributed Representations

Semi-Supervised Learning with Sparse Distributed Representations Semi-Supervised Learning with Sparse Distributed Representations David Zieger dzieger@stanford.edu CS 229 Fina Project 1 Introduction For many machine earning appications, abeed data may be very difficut

More information

Binarized support vector machines

Binarized support vector machines Universidad Caros III de Madrid Repositorio instituciona e-archivo Departamento de Estadística http://e-archivo.uc3m.es DES - Working Papers. Statistics and Econometrics. WS 2007-11 Binarized support vector

More information

MACHINE learning techniques can, automatically,

MACHINE learning techniques can, automatically, Proceedings of Internationa Joint Conference on Neura Networks, Daas, Texas, USA, August 4-9, 203 High Leve Data Cassification Based on Network Entropy Fiipe Aves Neto and Liang Zhao Abstract Traditiona

More information

Analysis of Random. Processes via And-Or Tree Evaluation. Michael Mitzenmachert M. Amin Shokrollahiz

Analysis of Random. Processes via And-Or Tree Evaluation. Michael Mitzenmachert M. Amin Shokrollahiz Anaysis of Random Processes via And-Or Tree Evauation Michae G. Luby* Michae Mitzenmachert M. Amin Shokroahiz Abstract distributions not considered by previous anayses. We introduce a new set of probabiistic

More information

Understanding the Mixing Patterns of Social Networks: The Impact of Cores, Link Directions, and Dynamics

Understanding the Mixing Patterns of Social Networks: The Impact of Cores, Link Directions, and Dynamics Understanding the Mixing Patterns of Socia Networks: The Impact of Cores, Link Directions, and Dynamics [Last revised on May 22, 2011] Abedeaziz Mohaisen Huy Tran Nichoas Hopper Yongdae Kim University

More information

A NEW APPROACH FOR BLOCK BASED STEGANALYSIS USING A MULTI-CLASSIFIER

A NEW APPROACH FOR BLOCK BASED STEGANALYSIS USING A MULTI-CLASSIFIER Internationa Journa on Technica and Physica Probems of Engineering (IJTPE) Pubished by Internationa Organization of IOTPE ISSN 077-358 IJTPE Journa www.iotpe.com ijtpe@iotpe.com September 014 Issue 0 Voume

More information

An Indian Journal FULL PAPER ABSTRACT KEYWORDS. Trade Science Inc.

An Indian Journal FULL PAPER ABSTRACT KEYWORDS. Trade Science Inc. [Type text] [Type text] [Type text] ISSN : 0974-7435 Voume 10 Issue 16 BioTechnoogy 014 An Indian Journa FULL PAPER BTAIJ, 10(16), 014 [999-9307] Study on prediction of type- fuzzy ogic power system based

More information

Outerjoins, Constraints, Triggers

Outerjoins, Constraints, Triggers Outerjoins, Constraints, Triggers Lecture #13 Autumn, 2001 Fa, 2001, LRX #13 Outerjoins, Constraints, Triggers HUST,Wuhan,China 358 Outerjoin R S = R S with danging tupes padded with nus and incuded in

More information

DISTANCE TRANSFORMATION FOR NETWORK DESIGN PROBLEMS

DISTANCE TRANSFORMATION FOR NETWORK DESIGN PROBLEMS DISTANCE TRANSFORMATION FOR NETWORK DESIGN PROBLEMS A Ridha Mahjoub, Michae Poss, Luidi Simonetti, Eduardo Uchoa To cite this version: A Ridha Mahjoub, Michae Poss, Luidi Simonetti, Eduardo Uchoa. DISTANCE

More information

Further Concepts in Geometry

Further Concepts in Geometry ppendix F Further oncepts in Geometry F. Exporing ongruence and Simiarity Identifying ongruent Figures Identifying Simiar Figures Reading and Using Definitions ongruent Trianges assifying Trianges Identifying

More information

Fast Methods for Kernel-based Text Analysis

Fast Methods for Kernel-based Text Analysis Proceedings of the 41st Annua Meeting of the Association for Computationa Linguistics, Juy 2003, pp. 24-31. Fast Methods for Kerne-based Text Anaysis Taku Kudo and Yuji Matsumoto Graduate Schoo of Information

More information

Performance of data networks with random links

Performance of data networks with random links Performance of data networks with random inks arxiv:adap-org/9909006 v2 4 Jan 2001 Henryk Fukś and Anna T. Lawniczak Department of Mathematics and Statistics, University of Gueph, Gueph, Ontario N1G 2W1,

More information

arxiv: v1 [math.qa] 31 Aug 2018

arxiv: v1 [math.qa] 31 Aug 2018 arxiv:808.0575v [math.qa] 3 Aug 208 A new approach to the SL n spider Stephen Bigeow September 3, 208 Abstract The SL n spider gives adiagrammatic way toencode therepresentation category of the quantum

More information

Arithmetic Coding. Prof. Ja-Ling Wu. Department of Computer Science and Information Engineering National Taiwan University

Arithmetic Coding. Prof. Ja-Ling Wu. Department of Computer Science and Information Engineering National Taiwan University Arithmetic Coding Prof. Ja-Ling Wu Department of Computer Science and Information Engineering Nationa Taiwan University F(X) Shannon-Fano-Eias Coding W..o.g. we can take X={,,,m}. Assume p()>0 for a. The

More information

A Near-Optimal Distributed QoS Constrained Routing Algorithm for Multichannel Wireless Sensor Networks

A Near-Optimal Distributed QoS Constrained Routing Algorithm for Multichannel Wireless Sensor Networks Sensors 2013, 13, 16424-16450; doi:10.3390/s131216424 Artice OPEN ACCESS sensors ISSN 1424-8220 www.mdpi.com/journa/sensors A Near-Optima Distributed QoS Constrained Routing Agorithm for Mutichanne Wireess

More information

DETERMINING INTUITIONISTIC FUZZY DEGREE OF OVERLAPPING OF COMPUTATION AND COMMUNICATION IN PARALLEL APPLICATIONS USING GENERALIZED NETS

DETERMINING INTUITIONISTIC FUZZY DEGREE OF OVERLAPPING OF COMPUTATION AND COMMUNICATION IN PARALLEL APPLICATIONS USING GENERALIZED NETS DETERMINING INTUITIONISTIC FUZZY DEGREE OF OVERLAPPING OF COMPUTATION AND COMMUNICATION IN PARALLEL APPLICATIONS USING GENERALIZED NETS Pave Tchesmedjiev, Peter Vassiev Centre for Biomedica Engineering,

More information

THE PERCENTAGE OCCUPANCY HIT OR MISS TRANSFORM

THE PERCENTAGE OCCUPANCY HIT OR MISS TRANSFORM 17th European Signa Processing Conference (EUSIPCO 2009) Gasgow, Scotand, August 24-28, 2009 THE PERCENTAGE OCCUPANCY HIT OR MISS TRANSFORM P. Murray 1, S. Marsha 1, and E.Buinger 2 1 Dept. of Eectronic

More information

Dynamic Symbolic Execution of Distributed Concurrent Objects

Dynamic Symbolic Execution of Distributed Concurrent Objects Dynamic Symboic Execution of Distributed Concurrent Objects Andreas Griesmayer 1, Bernhard Aichernig 1,2, Einar Broch Johnsen 3, and Rudof Schatte 1,2 1 Internationa Institute for Software Technoogy, United

More information

Collinearity and Coplanarity Constraints for Structure from Motion

Collinearity and Coplanarity Constraints for Structure from Motion Coinearity and Copanarity Constraints for Structure from Motion Gang Liu 1, Reinhard Kette 2, and Bodo Rosenhahn 3 1 Institute of Information Sciences and Technoogy, Massey University, New Zeaand, Department

More information

Community-Aware Opportunistic Routing in Mobile Social Networks

Community-Aware Opportunistic Routing in Mobile Social Networks IEEE TRANSACTIONS ON COMPUTERS VOL:PP NO:99 YEAR 213 Community-Aware Opportunistic Routing in Mobie Socia Networks Mingjun Xiao, Member, IEEE Jie Wu, Feow, IEEE, and Liusheng Huang, Member, IEEE Abstract

More information

Optimization and Application of Support Vector Machine Based on SVM Algorithm Parameters

Optimization and Application of Support Vector Machine Based on SVM Algorithm Parameters Optimization and Appication of Support Vector Machine Based on SVM Agorithm Parameters YAN Hui-feng 1, WANG Wei-feng 1, LIU Jie 2 1 ChongQing University of Posts and Teecom 400065, China 2 Schoo Of Civi

More information

Bilevel Optimization based on Iterative Approximation of Multiple Mappings

Bilevel Optimization based on Iterative Approximation of Multiple Mappings Bieve Optimization based on Iterative Approximation of Mutipe Mappings arxiv:1702.03394v2 [math.oc] 5 May 2017 Ankur Sinha 1, Zhichao Lu 2, Kayanmoy Deb 2 and Pekka Mao 3 1 Production and Quantitative

More information

CSE120 Principles of Operating Systems. Prof Yuanyuan (YY) Zhou Scheduling

CSE120 Principles of Operating Systems. Prof Yuanyuan (YY) Zhou Scheduling CSE120 Principes of Operating Systems Prof Yuanyuan (YY) Zhou Scheduing Announcement Homework 2 due on October 25th Project 1 due on October 26th 2 CSE 120 Scheduing and Deadock Scheduing Overview In discussing

More information

Functions. 6.1 Modular Programming. 6.2 Defining and Calling Functions. Gaddis: 6.1-5,7-10,13,15-16 and 7.7

Functions. 6.1 Modular Programming. 6.2 Defining and Calling Functions. Gaddis: 6.1-5,7-10,13,15-16 and 7.7 Functions Unit 6 Gaddis: 6.1-5,7-10,13,15-16 and 7.7 CS 1428 Spring 2018 Ji Seaman 6.1 Moduar Programming Moduar programming: breaking a program up into smaer, manageabe components (modues) Function: a

More information

Computer Networks. College of Computing. Copyleft 2003~2018

Computer Networks. College of Computing.   Copyleft 2003~2018 Computer Networks Computer Networks Prof. Lin Weiguo Coege of Computing Copyeft 2003~2018 inwei@cuc.edu.cn http://icourse.cuc.edu.cn/computernetworks/ http://tc.cuc.edu.cn Attention The materias beow are

More information

Stereo. CS 510 May 2 nd, 2014

Stereo. CS 510 May 2 nd, 2014 Stereo CS 510 May 2 nd, 2014 Where are we? We are done! (essentiay) We covered image matching Correation & Correation Fiters Fourier Anaysis PCA We covered feature-based matching Bag of Features approach

More information

Distributed Approximation of k-service Assignment

Distributed Approximation of k-service Assignment Distributed Approximation of k-service Assignment Magnús M. Hadórsson, Sven Köher 2, and Dror Rawitz 3 Reykjavik University, Iceand, mmh@ru.is 2 University of Freiburg, koehers@informatik.uni-freiburg.de

More information

Polygonal Approximation of Point Sets

Polygonal Approximation of Point Sets Poygona Approximation of Point Sets Longin Jan Latecki 1, Rof Lakaemper 1, and Marc Sobe 2 1 CIS Dept., Tempe University, Phiadephia, PA 19122, USA, atecki@tempe.edu, akamper@tempe.edu 2 Statistics Dept.,

More information

Interpreting Individual Classifications of Hierarchical Networks

Interpreting Individual Classifications of Hierarchical Networks Interpreting Individua Cassifications of Hierarchica Networks Wi Landecker, Michae D. Thomure, Luís M. A. Bettencourt, Meanie Mitche, Garrett T. Kenyon, and Steven P. Brumby Department of Computer Science

More information

RDF Objects 1. Alex Barnell Information Infrastructure Laboratory HP Laboratories Bristol HPL November 27 th, 2002*

RDF Objects 1. Alex Barnell Information Infrastructure Laboratory HP Laboratories Bristol HPL November 27 th, 2002* RDF Objects 1 Aex Barne Information Infrastructure Laboratory HP Laboratories Bristo HPL-2002-315 November 27 th, 2002* E-mai: Andy_Seaborne@hp.hp.com RDF, semantic web, ontoogy, object-oriented datastructures

More information

Optimized Base-Station Cache Allocation for Cloud Radio Access Network with Multicast Backhaul

Optimized Base-Station Cache Allocation for Cloud Radio Access Network with Multicast Backhaul Optimized Base-Station Cache Aocation for Coud Radio Access Network with Muticast Backhau Binbin Dai, Student Member, IEEE, Ya-Feng Liu, Member, IEEE, and Wei Yu, Feow, IEEE arxiv:804.0730v [cs.it] 28

More information

Analysis and parallelization strategies for Ruge-Stüben AMG on many-core processors

Analysis and parallelization strategies for Ruge-Stüben AMG on many-core processors Anaysis and paraeization strategies for Ruge-Stüben AMG on many-core processors P. Zaspe Departement Mathematik und Informatik Preprint No. 217-6 Fachbereich Mathematik June 217 Universität Base CH-451

More information

PHASE retrieval has been an active research topic for decades [1], [2]. The underlying goal is to estimate an unknown

PHASE retrieval has been an active research topic for decades [1], [2]. The underlying goal is to estimate an unknown DOLPHIn Dictionary Learning for Phase Retrieva Andreas M. Timann, Yonina C. Edar, Feow, IEEE, and Juien Maira, Member, IEEE arxiv:60.063v [math.oc] 3 Aug 06 Abstract We propose a new agorithm to earn a

More information

Minimizing Resource Cost for Camera Stream Scheduling in Video Data Center

Minimizing Resource Cost for Camera Stream Scheduling in Video Data Center Gao YH, Ma HD, Liu W. Minimizing resource cost for camera stream scheduing in video data center. JOURNAL OF COMPUTER SCIENCE AND TECHNOLOGY 32(3): 555 570 May 2017. DOI 10.1007/s11390-017-1743-x Minimizing

More information

Automatic Program Inversion using Symbolic Transducers

Automatic Program Inversion using Symbolic Transducers Automatic Program Inversion using Symboic Transducers Qinheping Hu University of Wisconsin-Madison qhu8@wisc.edu Loris D Antoni University of Wisconsin-Madison oris@cs.wisc.edu Abstract We propose a fuy-automated

More information

No connection establishment Do not perform Flow control Error control Retransmission Suitable for small request/response scenario E.g.

No connection establishment Do not perform Flow control Error control Retransmission Suitable for small request/response scenario E.g. UDP & TCP 2018/3/26 UDP Header Characteristics of UDP No connection estabishment Do not perform Fow contro Error contro Retransmission Suitabe for sma request/response scenario E.g., DNS Remote Procedure

More information

Providing Hop-by-Hop Authentication and Source Privacy in Wireless Sensor Networks

Providing Hop-by-Hop Authentication and Source Privacy in Wireless Sensor Networks The 31st Annua IEEE Internationa Conference on Computer Communications: Mini-Conference Providing Hop-by-Hop Authentication and Source Privacy in Wireess Sensor Networks Yun Li Jian Li Jian Ren Department

More information