首页 | 本学科首页   官方微博 | 高级检索  
相似文献
 共查询到20条相似文献,搜索用时 31 毫秒
1.
Knödel graphs form a class of bipartite incident-graph of circulant digraphs. This class has been extensively studied for the purpose of fast communications in networks, and it has deserved a lot of attention in this context. In this paper, we show that there exists an O(n log5 n)-time algorithm to recognize Knödel graphs of order 2n. The algorithm is based on a characterization of the cycles of length six in these graphs (bipartite incident-graphs of circulant digraphs always have cycles of length six). A consequence of our result is that the circulant digraphs whose chords are the power of two minus one can be recognized in O(n log5 n) time.  相似文献   

2.
In a finite geometry of order q2 we define a (qmqr)-affine cap to be a set of cardinality qm which is a disjoint union ot qm affine subgeometrics AG(r,q). such that no three points are coliinear unless contained in the same AG(r,q).

Given a PG(n,q2), where n = 2t + 1 or 2t + 2, and an n + 1 by n + 1 Hermitian matrix H over Gh(q2) with minimal polynomial (x - λ)n + 1. we show that H induces a partition of the AG(n, q2) obtained by deleting a distinguished hyperplane from the PG, into (qn,ql + 1)-affine caps; these caps can be viewed as the "large points" of an AG (n,q) with a natural incidence relation. It is also shown that H induces another partition of AG(n,q2), into qn - l 1-caps, constituting the "large points" of an affine geometry AG(n + t + 1,q).

Also, the collineation C of PG(n, q2) given by xc = HTx induces collineations on the AG(n,q) and AG(n + t + 1,q).  相似文献   

3.
Given an n-vertex outer-planar graph G and a set P of n points in the plane, we present an O(nlog3n) time and O(n) space algorithm to compute a straight-line embedding of G in P, improving upon the algorithm in [8,12] that requires O(n2) time. Our algorithm is near-optimal as there is an Ω(nlogn) lower bound for the problem [4]. We present a simpler O(nd) time and O(n) space algorithm to compute a straight-line embedding of G in P where lognd2n is the length of the longest vertex disjoint path in the dual of G. Therefore, the time complexity of the simpler algorithm varies between O(nlogn) and O(n2) depending on the value of d. More efficient algorithms are presented for certain restricted cases. If the dual of G is a path, then an optimal Θ(nlogn) time algorithm is presented. If the given point set is in convex position then we show that O(n) time suffices.  相似文献   

4.
We consider the problems of constructing geometric spanners, possibly containing Steiner points, for a set of n input points in d-dimensional space , and constructing spanners and approximate shortest paths among a collection of polygonal obstacles on the plane. The complexities of these problems are shown to be Ω(n log n) in the algebraic computation tree model. Since O(n log n)-time algorithms are known for solving these problems, our lower bounds are tight up to a constant factor.  相似文献   

5.
Given an edge-weighted tree T and an integer p1, the minmax p-traveling salesmen problem on a tree T asks to find p tours such that the union of the p tours covers all the vertices. The objective is to minimize the maximum of length of the p tours. It is known that the problem is NP-hard and has a (2−2/(p+1))-approximation algorithm which runs in O(pp−1np−1) time for a tree with n vertices. In this paper, we consider an extension of the problem in which the set of vertices to be covered now can be chosen as a subset S of vertices and weights to process vertices in S are also introduced in the tour length. For the problem, we give an approximation algorithm that has the same performance guarantee, but runs in O((p−1)!·n) time.  相似文献   

6.
We give improved space and processor complexities for the problem of computing, in parallel, a data structure that supports queries about shortest rectilinear obstacle-avoiding paths in the plane, where the obstacles are disjoint rectangles. That is, a query specifies any source and destination in the plane, and the data structure enables efficient processing of the query. We now can build the data structure with O(n2/log n) CREW PRAM processors, as opposed to the previous O(n2), and with O(n2) space, as opposed to the previous O(n2(log n)2). The time complexity remains unchanged, at O((log n)2). As before, the data structure we compute enables a query to be processed in O(log n) time, by one processor for obtaining a path length, or by O(k/log n) processors for retrieving a shortest path itself, where k is the number of segments on that path. The new ideas that made our improvement possible include a new partitioning scheme of the recursion tree, which is used to schedule the computations performed on that tree. Since a number of other related shortest paths problems are solved using this technique as a subroutine our improvement translates into a similar improvement in the complexities of these problems as well.  相似文献   

7.
For a 1-dependent stationary sequence {Xn} we first show that if u satisfies p1=p1(u)=P(X1>u)0.025 and n>3 is such that 88np131, then
P{max(X1,…,Xn)u}=ν·μn+O{p13(88n(1+124np13)+561)}, n>3,
where
ν=1−p2+2p3−3p4+p12+6p22−6p1p2,μ=(1+p1p2+p3p4+2p12+3p22−5p1p2)−1
with
pk=pk(u)=P{min(X1,…,Xk)>u}, k1
and
|O(x)||x|.
From this result we deduce, for a stationary T-dependent process with a.s. continuous path {Ys}, a similar, in terms of P{max0skTYs<u}, k=1,2 formula for P{max0stYsu}, t>3T and apply this formula to the process Ys=W(s+1)−W(s), s0, where {W(s)} is the Wiener process. We then obtain numerical estimations of the above probabilities.  相似文献   

8.
We give an algorithm that constructs the Hasse diagram of the face lattice of a convex polytope P from its vertex-facet incidences in time O(min{n,m}··), where n is the number of vertices, m is the number of facets, is the number of vertex-facet incidences, and  is the total number of faces of P. This improves results of Fukuda and Rosta [Computational Geometry 4 (4) (1994) 191–198], who described an algorithm for enumerating all faces of a d-polytope in O(min{n,md·2) steps. For simple or simplicial d-polytopes our algorithm can be specialized to run in time O(d··). Furthermore, applications of the algorithm to other atomic lattices are discussed, e.g., to face lattices of oriented matroids.  相似文献   

9.
In this paper, we present a direct approach for routing a shortest rectilinear path between two points among a set of rectilinear obstacles in a two-layer interconnection model that is used for VLSI routing applications. The previously best known direct approach for this problem takes O(nlog2n) time and O(nlogn) space, where n is the total number of obstacle edges. By using integer data structures and an implicit graph representation scheme (i.e., a generalization of the distance table method), we improve the time bound to O(nlog3/2n) while still maintaining the O(nlogn) space bound. Comparing with the indirect approach for this problem, our algorithm is simpler to implement and is probably faster for a quite large range of input sizes.  相似文献   

10.
Let us denote ab=max(a,b) and ab=a+b for and extend this pair of operations to matrices and vectors in the same way as in linear algebra. We present an O(n2(m+n log n)) algorithm for finding all essential terms of the max-algebraic characteristic polynomial of an n×n matrix over with m finite elements. In the cases when all terms are essential, this algorithm also solves the following problem: Given an n×n matrix A and k{1,…,n}, find a k×k principal submatrix of A whose assignment problem value is maximum.  相似文献   

11.
Suppose given a realization of a Poisson process on the line: call the points ‘germs’ because at a given instant ‘grains’ start growing around every germ, stopping for any particular grain when it touches another grain. When all growth stops a fraction e−1 of the line remains uncovered. Let n germs be thrown uniformly and independently onto the circumference of a circle, and let grains grow under a similar protocol. Then the expected fraction of the circle remaining uncovered is the nth partial sum of the usual series for e−1. These results, which sharpen inequalities obtained earlier, have one-sided analogues: the grains on the positive axis alone do not cover the origin with probability e−1/2, and the conditional probability that the origin is uncovered by these positive grains, given that the germs n and n+1 coincide, is the nth partial sum of the series for e−1/2. Despite the close similarity of these results to the rencontre, or matching, problem, we have no inclusion–exclusion derivation of them. We give explicitly the distributions for the length of a contiguous block of grains and the number of grains in such a block, and for the length of a grain. The points of the line not covered by any grain constitute a Kingman-type regenerative phenomenon for which the associated p-function p(t) gives the conditional probability that a point at distance t from an uncovered point is also uncovered. These functions enable us to identify a continuous-time Markov chain on the integers for which p(t) is a diagonal transition probability.  相似文献   

12.
We consider a family of second-order elliptic operators {L_ε} in divergence form with rapidly oscillating and periodic coefficients in Lipschitz and convex domains in R~n. We are able to show that the uniform W~(1,p) estimate of second order elliptic systems holds for 2n/(n+1)-δ p 2n/(n-1)+ δ where δ 0 is independent of ε and the ranges are sharp for n = 2, 3. And for elliptic equations in Lipschitz domains, the W~(1,p) estimate is true for 3/2-δ p 3 + δ if n ≥ 4, similar estimate was extended to convex domains for 1 p ∞.  相似文献   

13.
《Discrete Mathematics》1999,200(1-3):137-147
We form squares from the product of integers in a short interval [n, n + tn], where we include n in the product. If p is prime, p|n, and (2p) > n, we prove that p is the minimum tn. If no such prime exists, we prove tn √5n when n> 32. If n = p(2p − 1) and both p and 2p − 1 are primes, then tn = 3p> 3 √n/2. For n(n + u) a square > n2, we conjecture that a and b exist where n < a < b < n + u and nab is a square (except n = 8 and N = 392). Let g2(n) be minimal such that a square can be formed as the product of distinct integers from [n, g2(n)] so that no pair of consecutive integers is omitted. We prove that g2(n) 3n − 3, and list or conjecture the values of g2(n) for all n. We describe the generalization to kth powers and conjecture the values for large n.  相似文献   

14.
We present a new data structure for a set of n convex simply-shaped fat objects in the plane, and use it to obtain efficient and rather simple solutions to several problems including (i) vertical ray shooting—preprocess a set of n non-intersecting convex simply-shaped flat objects in 3-space, whose xy-projections are fat, for efficient vertical ray shooting queries, (ii) point enclosure—preprocess a set C of n convex simply-shaped fat objects in the plane, so that the k objects containing a query point p can be reported efficiently, (iii) bounded-size range searching— preprocess a set C of n convex fat polygons, so that the k objects intersecting a “not-too-large” query polygon can be reported efficiently, and (iv) bounded-size segment shooting—preprocess a set C as in (iii), so that the first object (if exists) hit by a “not-too-long” oriented query segment can be found efficiently. For the first three problems we construct data structures of size O(λs(n)log3n), where s is the maximum number of intersections between the boundaries of the (xy-projections) of any pair of objects, and λs(n) is the maximum length of (n, s) Davenport-Schinzel sequences. The data structure for the fourth problem is of size O(λs(n)log2n). The query time in the first problem is O(log4n), the query time in the second and third problems is O(log3n + klog2n), and the query time in the fourth problem is O(log3n).

We also present a simple algorithm for computing a depth order for a set as in (i), that is based on the solution to the vertical ray shooting problem. (A depth order for , if exists, is a linear order of , such that, if K1, K2 and K1 lies vertically above K2, then K1 precedes K2.) Unlike the algorithm of Agarwal et al. (1995) that might output a false order when a depth order does not exist, the new algorithm is able to determine whether such an order exists, and it is often more efficient in practical situations than the former algorithm.  相似文献   


15.
The thermal equilibrium state of two oppositely charged gases confined to a bounded domain , m = 1,2 or m = 3, is entirely described by the gases' particle densities p, n minimizing the total energy (p, n). it is shown that for given P, N > 0 the energy functional admits a unique minimizer in {(p, n) ε L2(Ω) x L 2(Ω) : p, n ≥ 0, Ωp = P, Ωn = N} and that p, n ε C(Ω) ∩ L(Ω).

The analysis is applied to the hydrodynamic semiconductor device equations. These equations in general possess more than one thermal equilibrium solution, but only the unique solution of the corresponding variational problem minimizes the total energy. It is equivalent to prescribe boundary data for electrostatic potential and particle densities satisfying the usual compatibility relations and to prescribe Ve and P, N for the variational problem.  相似文献   


16.
We study the number of solutions N(B,F) of the diophantine equation n_1n_2 = n_3 n_4,where 1 ≤ n_1 ≤ B,1 ≤ n_3 ≤ B,n_2,n_4 ∈ F and F[1,B] is a factor closed set.We study more particularly the case when F={m = p_1~(ε1)···p_k~(εk),ε_j∈{0,1},1 ≤ j ≤ k},p_1,...,p_k being distinct prime numbers.  相似文献   

17.
Let I be a compact interval of real axis R, and(I, H) be the metric space of all nonempty closed subintervals of I with the Hausdorff metric H and f : I → I be a continuous multi-valued map. Assume that Pn =(x_0, x_1,..., xn) is a return tra jectory of f and that p ∈ [min Pn, max Pn] with p ∈ f(p). In this paper, we show that if there exist k(≥ 1) centripetal point pairs of f(relative to p)in {(x_i; x_i+1) : 0 ≤ i ≤ n-1} and n = sk + r(0 ≤ r ≤ k-1), then f has an R-periodic orbit, where R = s + 1 if s is even, and R = s if s is odd and r = 0, and R = s + 2 if s is odd and r 0. Besides,we also study stability of periodic orbits of continuous multi-valued maps from I to I.  相似文献   

18.
The parametric resource allocation problem asks to minimize the sum of separable single-variable convex functions containing a parameter λ, Σi = 1ni(xi + λgi(xi)), under simple constraints Σi = 1n xi = M, lixiui and xi: nonnegative integers for i = 1, 2, …, n, where M is a given positive integer, and li and ui are given lower and upper bounds on xi. This paper presents an efficient algorithm for computing the sequence of all optimal solutions when λ is continuously changed from 0 to ∞. The required time is O(GMlog2 n + n log n + n log(M/n)), where G = Σi = 1n ui − Σi = 1n li and an evaluation of ƒi(·) or gi(·) is assumed to be done in constant time.  相似文献   

19.
Let A be a matrix in r×r such that Re(z) > −1/2 for all the eigenvalues of A and let {πn(A,1/2) (x)} be the normalized sequence of Laguerre matrix polynomials associated with A. In this paper, it is proved that πn(A,1/2) (x) = O(n(A)/2lnr−1(n)) and πn+1(A,1/2) (x) − πn(A,1/2) (x) = O(n((A)−1)/2lnr−1(n)) uniformly on bounded intervals, where (A) = max{Re(z); z eigenvalue of A}.  相似文献   

20.
We consider the following model Hr(n, p) of random r-uniform hypergraphs. The vertex set consists of two disjoint subsets V of size | V | = n and U of size | U | = (r − 1)n. Each r-subset of V × (r−1U) is chosen to be an edge of H ε Hr(n, p) with probability p = p(n), all choices being independent. It is shown that for every 0 < < 1 if P = (C ln n)/nr−1 with C = C() sufficiently large, then almost surely every subset V1 V of size | V1 | = (1 − )n is matchable, that is, there exists a matching M in H such that every vertex of V1 is contained in some edge of M.  相似文献   

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

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