首页 | 本学科首页   官方微博 | 高级检索  
相似文献
 共查询到20条相似文献,搜索用时 31 毫秒
1.
In this paper we investigate the online hypergraph coloring problem. In this online problem the algorithm receives the vertices of the hypergraph in some order v1,…,vn and it must color vi by only looking at the subhypergraph Hi=(Vi,Ei) where Vi={v1,…,vi} and Ei contains the edges of the hypergraph which are subsets of Vi. We show that there exists no online hypergraph coloring algorithm with sublinear competitive ratio. Furthermore we investigate some particular classes of hypergraphs (k-uniform hypergraphs, hypergraphs with bounded matching number, projective planes), we analyse the online algorithm FF and give matching lower bounds for these classes.  相似文献   

2.
Given an undirected multigraph G=(V,E), a family $\mathcal{W}Given an undirected multigraph G=(V,E), a family W\mathcal{W} of areas WV, and a target connectivity k≥1, we consider the problem of augmenting G by the smallest number of new edges so that the resulting graph has at least k edge-disjoint paths between v and W for every pair of a vertex vV and an area W ? WW\in \mathcal{W} . So far this problem was shown to be NP-complete in the case of k=1 and polynomially solvable in the case of k=2. In this paper, we show that the problem for k≥3 can be solved in O(m+n(k 3+n 2)(p+kn+nlog n)log k+pkn 3log (n/k)) time, where n=|V|, m=|{{u,v}|(u,v)∈E}|, and p=|W|p=|\mathcal{W}| .  相似文献   

3.
Xue  -H. Lin  -Z. Du 《Algorithmica》2008,31(4):479-500
Abstract. Let P = {p 1 , p 2 , \ldots, p n } be a set of n {\lilsf terminal points} in the Euclidean plane, where point p i has a {\lilsf service request of grade} g(p i ) ∈ {1, 2, \ldots, n} . Let 0 < c(1) < c(2) < ⋅s < c(n) be n real numbers. The {\lilsf Grade of Service Steiner Minimum Tree (GOSST)} problem asks for a minimum cost network interconnecting point set P and some {\lilsf Steiner points} with a service request of grade 0 such that (1) between each pair of terminal points p i and p j there is a path whose minimum grade of service is at least as large as \min(g(p i ), g(p j )) ; and (2) the cost of the network is minimum among all interconnecting networks satisfying (1), where the cost of an edge with service of grade g is the product of the Euclidean length of the edge with c(g) . The GOSST problem is a generalization of the Euclidean Steiner minimum tree problem where all terminal points have the same grade of service request. When there are only two (three, respectively) different grades of service request by the terminal points, we present a polynomial time approximation algorithm with performance ratio \frac 4 3 ρ (((5+4\sqrt 2 )/7)ρ , respectively), where ρ is the performance ratio achieved by an approximation algorithm for the Euclidean Steiner minimum tree problem. For the general case, we prove that there exists a GOSST that is the minimum cost network under a full Steiner topology or its degeneracies. A powerful interior-point algorithm is used to find a (1+ε) -approximation to the minimum cost network under a given topology or its degeneracies in O(n 1.5 (log n + log (1/ε))) time. We also prove a lower bound theorem which enables effective pruning in a branch-and-bound method that partially enumerates the full Steiner topologies in search for a GOSST. We then present a k -optimal heuristic algorithm to compute good solutions when the problem size is too large for the branch-and-bound algorithm. Preliminary computational results are presented.  相似文献   

4.
The min-sum k -clustering problem is to partition a metric space (P,d) into k clusters C 1,…,C k ?P such that $\sum_{i=1}^{k}\sum_{p,q\in C_{i}}d(p,q)The min-sum k -clustering problem is to partition a metric space (P,d) into k clusters C 1,…,C k P such that ?i=1k?p,q ? Cid(p,q)\sum_{i=1}^{k}\sum_{p,q\in C_{i}}d(p,q) is minimized. We show the first efficient construction of a coreset for this problem. Our coreset construction is based on a new adaptive sampling algorithm. With our construction of coresets we obtain two main algorithmic results.  相似文献   

5.
寻找无向图中回路的并行算法   总被引:3,自引:0,他引:3  
对无向简单图=(V,E),||=,||=,给出对下述问题的NC算法:(1)寻找中最短回路;(2)寻找G中最短偶(奇)长度回路;(3)求解,k=3,4,这里表示G中长度为的回路.  相似文献   

6.
Let G be a graph which is k -outconnected from a specified root node r , that is, G has k openly disjoint paths between r and v for every node v . We give necessary and sufficient conditions for the existence of a pair rv,rw of edges for which replacing these edges by a new edge vw gives a graph that is k -outconnected from r . This generalizes a theorem of Bienstock et al. on splitting off edges while preserving k -node-connectivity. We also prove that if C is a cycle in G such that each edge in C is critical with respect to k -outconnectivity from r , then C has a node v , distinct from r , which has degree k . This result is the rooted counterpart of a theorem due to Mader. We apply the above results to design approximation algorithms for the following problem: given a graph with nonnegative edge weights and node requirements c u for each node u , find a minimum-weight subgraph that contains max {c u ,c v } openly disjoint paths between every pair of nodes u,v . For metric weights, our approximation guarantee is 3 . For uniform weights, our approximation guarantee is \min{ 2, (k+2q-1)/k} . Here k is the maximum node requirement, and q is the number of positive node requirements. Received September 15, 1998; revised March 10, 2000, and April 17, 2000.  相似文献   

7.
Bazzi  Mitter 《Algorithmica》2008,36(1):41-57
Abstract. Linear probabilistic divide-and-conquer recurrence relations arise when analyzing the running time of divide-and-conquer randomized algorithms. We consider first the problem of finding the expected value of the random process T(x) , described as the output of a randomized recursive algorithm T . On input x , T generates a sample (h 1 ,···,h k ) from a given probability distribution on [0,1] k and recurses by returning g(x) + Σ i=1 k c i T(h i x) until a constant is returned when x becomes less than a given number. Under some minor assumptions on the problem parameters, we present a closed-form asymptotic solution of the expected value of T(x) . We show that E[T(x)] = Θ( x p + x p ∈t 1 x (g(u)/ u p+1 ) du) , where p is the nonnegative unique solution of the equation Σ i=1 k c i E[h i p ] = 1 . This generalizes the result in [1] where we considered the deterministic version of the recurrence. Then, following [2], we argue that the solution holds under a broad class of perturbations including floors and ceilings that usually accompany the recurrences that arise when analyzing randomized divide-and-conquer algorithms.  相似文献   

8.
J. Katajainen 《Computing》1988,40(2):147-161
The following geometrical proximity concepts are discussed: relative closeness and geographic closeness. Consider a setV={v 1,v 2, ...,v n } of distinct points in atwo-dimensional space. The pointv j is said to be arelative neighbour ofv i ifd p (v i ,v j )≤max{d p (v j ,v k ),d p (v j ,v k )} for allv k V, whered p denotes the distance in theL p metric, 1≤p≤∞. After dividing the space around the pointv i into eight sectors (regions) of equal size, a closest point tov i in some region is called anoctant (region, orgeographic) neighbour ofv i. For anyL p metric, a relative neighbour ofv i is always an octant neighbour in some region atv i. This gives a direct method for computing all relative neighbours, i.e. for establishing therelative neighbourhood graph ofV. For every pointv i ofV, first search for the octant neighbours ofv i in each region, and then for each octant neighbourv j found check whether the pointv j is also a relative neighbour ofv i. In theL p metric, 1<p<∞, the total number of octant neighbours is shown to be θ(n) for any set ofn points; hence, even a straightforward implementation of the above method runs in θn 2) time. In theL 1 andL metrics the method can be refined to a θ(n logn+m) algorithm, wherem is the number of relative neighbours in the output,n-1≤mn(n-1). TheL 1 (L ) algorithm is optimal within a constant factor.  相似文献   

9.
LetC be a binary code of lengthn (i.e., a subset of {0, 1} n ). TheCovering Radius of C is the smallest integerr such that each vector in {0, 1} n is at a distance at mostr from some code word. Our main result is that the decision problem associated with the Covering Radius of arbitrary binary codes is NP-complete. This result is established as follows. TheRadius of a binary codeC is the smallest integerr such thatC is contained in a radius-r ball of the Hamming metric space 〈{0, 1} n ,d〉. It is known [K] that the problems of computing the Radius and the Covering Radius are equivalent. We show that the 3SAT problem is polynomially reducible to the Radius decision problem. A central tool in our reduction is a metrical characterization of the set ofdoubled vectors of length 2n: {v=(v 1 v 2v 2n ) | ∀i:v 2i =v 2i−1}. We show that there is a setY ⊂ {0, 1}2n such that for everyv ε {0, 1}2n :v is doubled iffY is contained in the radius-n ball centered atv; moreover,Y can be constructed in time polynomial inn.  相似文献   

10.
Abstract

Two separation indices are considered for partitions P = {X1, …, Xk} of a finite data set X in a general inner product space. Both indices increase as the pairwise distances between the subsets Xi become large compared to the diameters of Xi Maximally separated partitions p' are defined and it is shown that as the indices of p' increase without bound, the characteristic functions of Xi' in P' are approximated more and more closely by the membership functions in fuzzy partitions which minimize certain fuzzy extensions of the k-means squared error criterion function.  相似文献   

11.
{In this paper we design and analyze a neural approximation algorithm for the Maximum Clique problem. This algorithm, having as input an arbitrary undirected graph G = \langle V, E\rangle , constructs a finite sequence of Hopfield networks such that the attractor of the last network in the sequence represents a maximal clique of G . We prove that D(G) ⋅ |E \rm c | , where D(G) = max {i,j}\notin E \min{d i , d j } , d i is the degree of the vertex i of G , and |E \rm c | denotes the cardinality of the set of edges in the complement graph, is an upper bound to the number of the networks in the sequence. Some experiments made on the second DIMACS benchmark and on random graphs show that: 1. The quality of the solutions found by the algorithm is satisfactory. 2. The theoretical upper bound D(G) ⋅ |E \rm c | is quite pessimistic. For random graphs we propose an empirical formula that gives a better estimate of the number of networks in the sequence. Moreover, thanks to the simplicity of the algorithm, we are able to design a uniform family of circuits of small size (\approx 10n 2 log 2 n ) that implements it. The circuit, which solves the problems for graphs of at most 32 vertices, has then been programmed on FPGAs (Field Programmable Gate Arrays). An analysis in terms of size and time complexity is given. Received November 10, 1998; revised December 2000.  相似文献   

12.
Let {ξ k } k=0 be a sequence of i.i.d. real-valued random variables, and let g(x) be a continuous positive function. Under rather general conditions, we prove results on sharp asymptotics of the probabilities $ P\left\{ {\frac{1} {n}\sum\limits_{k = 0}^{n - 1} {g\left( {\xi _k } \right) < d} } \right\} $ P\left\{ {\frac{1} {n}\sum\limits_{k = 0}^{n - 1} {g\left( {\xi _k } \right) < d} } \right\} , n → ∞, and also of their conditional versions. The results are obtained using a new method developed in the paper, namely, the Laplace method for sojourn times of discrete-time Markov chains. We consider two examples: standard Gaussian random variables with g(x) = |x| p , p > 0, and exponential random variables with g(x) = x for x ≥ 0.  相似文献   

13.
Let Γ be an arrangement of pseudo-lines, i.e., a collection of unbounded x -monotone curves in which each curve crosses each of the others exactly once. A pseudo-line graph (Γ, E) is a graph for which the vertices are the pseudo-lines of Γ and the edges are some unordered pairs of pseudo-lines of Γ . A diamond of a pseudo-line graph (Γ, E) is a pair of edges {p,q} , {p',q'}∈ E , {p,q}{p',q'}= , such that the crossing point of the pseudo-lines p and q lies vertically between p' and q' and the crossing point of p' and q' lies vertically between p and q . We show that a graph is planar if and only if it is isomorphic to a diamond-free pseudo-line graph. An immediate consequence of this theorem is that the O(k 1/3 n) upper bound on the k -level complexity of an arrangement of straight lines, which was very recently discovered by Dey, holds for an arrangement of pseudo-lines as well.  相似文献   

14.
Any stationary time-series can be decomposed by means of an optimization operator, called the ζ-optimator, into several components (the time-series){Y t i}, i =1,2,…, p, such that the first component {V t i} t = 1,2,…,v is a smooth process having a larger autocorrelation in comparison with the original process {Y t}, i.e. ρvi > ρy. Usually only a few such components are sufficient for approximating the time-series with good accuracy. The ζ-optimator involves a shape parameter a, so the decomposition is unique provided that a. is fixed. Since the component {V t 1} involves much of the useful information it can be used for computing predictors for control purposes. Thus, given the observations Yv, Yv-1, Yv-2,…, a predictor of Yv+1 is ρvi V v 1 (q) where, Vv 1(q) = qYv + q(1-q)2 Yv-2, …, the weights q(1-q)r, r=0,1,2,…, decreasing rapidly as q = q(α) ε (0,1) Further, one may choose q rather than choosing α, since q(α) is a one-one mapping. Once q is fixed, the predictor ρv1 V v 1(q) is obtained in a straightforward way by using the formula above. It is shown that ρv1 V v 1(q) converges to the best predictor as α → 0. Some examples are worked out, illustrating both the decomposition and the forecasting procedures.  相似文献   

15.
Given a parametric polynomial family p(s; Q) := {n k=0 ak (q)sk : q ] Q}, Q R m , the robust root locus of p(s; Q) is defined as the two-dimensional zero set p,Q := {s ] C:p(s; q) = 0 for some q ] Q}. In this paper we are concerned with the problem of generating robust root loci for the parametric polynomial family p(s; E) whose polynomial coefficients depend polynomially on elements of the parameter vector q ] E which lies in an m-dimensional ellipsoid E. More precisely, we present a computational technique for testing the zero inclusion/exclusion of the value set p(z; E) for a fixed point z in C, and then apply an integer-labelled pivoting procedure to generate the boundary of each subregion of the robust root locus p,E . The proposed zero inclusion/exclusion test algorithm is based on using some simple sufficient conditions for the zero inclusion and exclusion of the value set p(z,E) and subdividing the domain E iteratively. Furthermore, an interval method is incorporated in the algorithm to speed up the process of zero inclusion/exclusion test by reducing the number of zero inclusion test operations. To illustrate the effectiveness of the proposed algorithm for the generation of robust root locus, an example is provided.  相似文献   

16.
The problem of stabilizing a second-order SISO LTI system of the form , y=Cx with feedback of the form u(x)=v(x)Cx is considered, where v(x) is real-valued and has domain which is all of . It is shown that, when stabilization is possible, v(x) can be chosen to take on no more than two values throughout the entire state-space (i.e., v(x){k1,k2} for all x and for some k1,k2), and an algorithm for finding a specific choice of v(x) is presented. It is also shown that the classical root locus of the corresponding transfer function C(sI-A)-1B has a strong connection to this stabilization problem, and its utility is demonstrated through examples.  相似文献   

17.
We present a model for edge updates with restricted randomness in dynamic graph algorithms and a general technique for analyzing the expected running time of an update operation. This model is able to capture the average case in many applications, since (1) it allows restrictions on the set of edges which can be used for insertions and (2) the type (insertion or deletion) of each update operation is arbitrary, i.e., not random. We use our technique to analyze existing and new dynamic algorithms for the following problems: maximum cardinality matching, minimum spanning forest, connectivity, 2-edge connectivity, k -edge connectivity, k -vertex connectivity, and bipartiteness. Given a random graph G with m 0 edges and n vertices and a sequence of l update operations such that the graph contains m i edges after operation i , the expected time for performing the updates for any l is in the case of minimum spanning forests, connectivity, 2-edge connectivity, and bipartiteness. The expected time per update operation is O(n) in the case of maximum matching. We also give improved bounds for k -edge and k -vertex connectivity. Additionally we give an insertions-only algorithm for maximum cardinality matching with worst-case O(n) amortized time per insertion. Received June 11, 1995; revised March 8, 1996.  相似文献   

18.
Summary This paper studies the design and implementation of an approximation algorithm for the Steiner tree problem. Given any undirected distance graph G and a set of Steiner points S, the algorithm produces a Steiner tree with total weight on its edges no more than 2(1–1/L) times the total weight on the optimal Steiner tree, where L is the number of leaves in the optimal Steiner tree. Our implementation of the algorithm, in the worst case, makes it run in 0(¦E g¦+¦V gS¦log¦V gS¦+¦S¦log ¦S¦) time for general graph G and in 0(¦S¦ log¦S¦+M log (MV gS¦)) time for sparse graph G, where E g is the set of edges in G, Vg is the set of vertices in G, M = min {¦E g, (¦V gS¦–1)2/2} and (x,y) = min {i¦log(i) y x/y}.The implementation is not likely to be improved significantly without the improvement of the shortest paths algorithm and the minimum spanning tree algorithm as the algorithm essentially composes of the computation of the multiple sources shortest paths of a graph with ¦V g¦ vertices and ¦E g¦ edges and the minimum spanning tree of a graph with ¦V gS¦ vertices and M edges.  相似文献   

19.
In this paper we provide improved approximation algorithms for the Min-Max Tree Cover and Bounded Tree Cover problems. Given a graph G=(V,E) with weights w:E→?+, a set T 1,T 2,…,T k of subtrees of G is called a tree cover of G if $V=\bigcup_{i=1}^{k} V(T_{i})$ . In the Min-Max k-tree Cover problem we are given graph G and a positive integer k and the goal is to find a tree cover with k trees, such that the weight of the largest tree in the cover is minimized. We present a 3-approximation algorithm for this improving the two different approximation algorithms presented in Arkin et al. (J. Algorithms 59:1–18, 2006) and Even et al. (Oper. Res. Lett. 32(4):309–315, 2004) with ratio 4. The problem is known to have an APX-hardness lower bound of $\frac{3}{2}$ (Xu and Wen in Oper. Res. Lett. 38:169–173, 2010). In the Bounded Tree Cover problem we are given graph G and a bound λ and the goal is to find a tree cover with minimum number of trees such that each tree has weight at most λ. We present a 2.5-approximation algorithm for this, improving the 3-approximation bound in Arkin et al. (J. Algorithms 59:1–18, 2006).  相似文献   

20.
Dario Bini 《Calcolo》1985,22(1):209-228
The tensor rankA of the linear spaceA generated by the set of linearly independent matricesA 1, A2, …, Ap, is the least integert for wich there existt diadsu (r) v (r)τ, τ=1,2,...,t, such that . IfA=n+k,k≪n then some computational problems concerning matricesAA can be solyed fast. For example the parallel inversion of almost any nonsingular matrixAA costs 3 logn+0(log2 k) steps with max(n 2+p (n+k), k2 n+nk) processors, the evaluation of the determinant ofA can be performed by a parallel algorithm in logp+logn+0 (log2 k) parallel steps and by a sequential algorithm inn(1+k 2)+p (n+k)+0 (k 3) multiplications. Analogous results hold to accomplish one step of bisection method, Newton's iterations method and shifted inverse power method applied toA−λB in order to compute the (generalized) eigenvalues provided thatA, BA. The same results hold if tensor rank is replaced by border rank. Applications to the case of banded Toeplitz matrices are shown. Dedicated to Professor S. Faedo on his 70th birthday Part of the results of this paper has been presented at the Oberwolfach Conference on Komplexitatstheorie, November 1983  相似文献   

设为首页 | 免责声明 | 关于勤云 | 加入收藏

Copyright©北京勤云科技发展有限公司  京ICP备09084417号