Topologically guaranteed univariate solutions of underconstrained polynomial systems via no–loop and single–component tests ∗

Michael Bartonˇ

Department of Computer Science, Technion 32000, Haifa, Israel

[email protected]

Gershon Elber Department of Computer Science, Technion 32000, Haifa, Israel

Department of Computer Science, Technion 32000, Haifa, Israel

[email protected] [email protected]

ABSTRACT We present an algorithm which robustly computes the intersection curve(s) of an under-constrained piecewise polynomial system consisting of n equations with n + 1 unknowns. The solution of such a system is typically a curve in Rn+1 . This work extends the single solution test of [6] for a set of algebraic constraints from zero dimensional solutions to univariate solutions, in Rn+1 . Our method exploits two tests: a no loop test (NLT) and a single component test (SCT) that together isolate and separate domains D where the solution curve consists of just one single component. For such domains, a numerical curve tracing is applied. If one of those tests fails, D is subdivided. Finally, the single components are merged together and, consequently, the topological configuration of the resulting curve is guaranteed. Several possible application of the solver, like 3D trisector curves or kinematic simulations in 3D are discussed.

Keywords Underconstrained polynomial systems, trisector curves, univariate solution spaces, kinematic synthesis

1.



Iddo Hanniel

INTRODUCTION AND PREVIOUS WORK

Solving (piecewise) polynomial systems of equations is a crucial problem in many fields such as computer-aided design, manufacturing, robotics and kinematics. A robust and efficient solution is in strong demand. The symbolically oriented approaches such as Gr¨ obner bases and similar elimination-based techniques [3] map the original system to a simpler one, preserving the solution set. Contrary to this, polynomial continuation methods start at roots of a suitable simple system and transform it continuously to the desired one [16]. These methods are very general and give global information about the solution set, regardless of the domain ∗Corresponding author. †Iddo Hanniel’s current affiliation: SolidWorks Corporation, 300 Baker Avenue, Concord, MA 01742 USA Permission to make digital or hard copies of all or part of this work for personal or classroom use is granted without fee provided that copies are not made or distributed for profit or commercial advantage and that copies bear this notice and the full citation on the first page. To copy otherwise, to republish, to post on servers or to redistribute to lists, requires prior specific permission and/or a fee. Copyright 200X ACM X-XXXXX-XX-X/XX/XX ...$5.00.

1

of interest. Typically, they operate in Cn and when only real solutions are sought, these methods can hence be inefficient. The other approach is represented by a family of subdivision based solvers, which typically treat the equations of the system as (parts of) hypersurfaces in Rn , and search for its (real) intersection points inside some particular domain, usually a box in Rn . The interval projected polyhedra algorithm [15] employs Bernstein-B´ezier representations of polynomials and projects its control points into 2D subspaces where corresponding convex hulls are computed and intersected. In order to reduce the number of computationally demanding subdivision steps or improve the robustness of the subdivision process, local preconditioning may be applied [9]. This technique is considered only for well-constrained, or also squared, (n×n) systems of equal-degrees constraints. Various other methods for solving squared systems exist and many related references can be found in [8]. For such systems, whose solution is, in general, a zerovariate set, termination criterion is presented in [6]. This geometrically oriented scheme detects isolated roots and allows the application of techniques such as the multivariate Newton-Raphson method, which converges quickly to the isolated root. The complexity of subdivision based solvers is exponential in the dimension of the problem, when tensor product representations are used. In [4], expression trees are employed, reducing the expected complexity to polynomial. Clearly, if the polynomial system of n equations is underconstrained having n + 1 degrees of freedom, the solution set is, in general, a curve in Rn+1 . In such a case, techniques that handle tracing of solution curve(s) are needed. For the last several decades, many tracing/marching methods were proposed, mostly inspired by the surface-surface intersection (SSI) problem, see [1, 5, 14, 7, 11] and the literature cited herein. Literature that relates to general n × (n + 1) systems is very sparse. One specific example (n = 2, 3, 4) of a subdivision method that traces algebraic implicit curves in 2D and 3D was introduced [10]. The domain is subdivided until the topology of the curve is determined. Points on the boundary of the box are then joined to get a graph isotopic to the sought curve. Recently, a general solver for over/well/underconstrained systems of equations, relying on the representation of polynomials in the barycentric Bernstein basis and exploiting the projecting control polyhedra algorithm, has been presented

[12]. In the case of the univariate solution set, the sequence of n-dimensional root-containing bounding simplices is sampled along the solution curve. If high accuracy is required, a vast number of simplices as well as subdivisions is to be expected. Also, the topology of the curve is not isolated. In this paper, we focus on the underconstrained problem of n (piecewise) polynomial equations in (n + 1) unknowns and present a generalization of the termination criterion of [6] for this class of systems. Our “divide and conquer” solver is based on two elementary tests:

step, usually a step in the direction of the tangent vector of the curve and 2) a correction step which puts the approximation point closer to the intersection curve. Apparently, the application of the curve tracing is not limited to tracing curves in Euclidean 3-space (E3 ) but may be equally applied for tracing a solution curve of an underconstrained polynomial system of size n in Rn+1 : Definition 2.1. Consider the mapping F : Rn+1 → Rn , such that each component fi , i = 1, . . . , n of F(x) = [f1 (x), f2 (x), . . . , fn (x)] is a polynomial function in variables x = (x1 , x2 , . . . , xn+1 ). Then, every solution x of the system,

1. A No Loop Test (NLT) which extends the idea of [13] for higher dimension and guarantees that the intersection curve has no loops, in the given domain.

F(x) = 0,

is called a root of F and the set of all roots is known as the zero set of the mapping F.

2. A Single Component Test (SCT) which assures the sought curve consists of just one component inside the given domain.

Definition 2.2. Vector w ~ ∈ Rn+1 is the wedge product of n linearly independent vectors ~vi ∈ Rn+1 , i = 1, . . . , n

If both tests are satisfied, a monotone single component is guaranteed and numerical tracing can be applied. In this curve tracing stage, we additionally assume that the hypersurfaces, represented as the zero sets of piecewise polynomial equations, possess C 2 continuity. If this assumption is violated, one can a-priori split the initial system into C 2 continuous sub-systems and, at the end of the process, merge the solution back together. The rest of the paper is organized as follows. Section 2 briefly discusses curve tracing in Rn+1 . Section 3 presents the no loop test (NLT) and the single component test (SCT) and Section 4 shows some examples where the presented solver may be applied. Finally, Section 5 identifies some possible future improvements of the presented method and concludes.

2.

w ~ = ~v1 ∧ ~v2 ∧ · · · ∧ ~vn ,

Let us assume system (1) has a univariate zero set in some domain D ⊆ Rn+1 and a = (a1 , a2 , . . . , an+1 ) ∈ D is a root. Based on the multivariate Newton–Raphson method [17], a univariate solution tracer may be described as follows. 1. prediction step: Compute the tangent direction of the solution curve, ~t = ∇f1 (a) ∧ ∇f2 (a) ∧ · · · ∧ ∇fn (a),

where ~t is the wedge product, see Def. 2.2, in R of ∇fi (a), the gradients of fi at point a. Let b = a + λ~t, where λ is the stepsize parameter, see Fig. 1. For now and unless otherwise stated, we assume the intersection problem is well defined, i.e. all fi are independent.

e

2. correction step: • Evaluate fi , i = 1, . . . , n at point b, and compute the gradients ∇fi (b) as well as the wedge product w ~ = ∇f1 (b) ∧ ∇f2 (b) ∧ · · · ∧ ∇fn (b).

c g

• Construct a 1st -order Taylor approximation, Tbi , the tangent plane of fi at point b, for all i.

f b

b t

• Create a hyperplane P through b with w ~ as its normal vector.

a

a

(a)

(3) n+1

d

c

(2)

if and only if hw, ~ ~vi i = 0, ∀i = 1, . . . , n.

CURVE TRACING d

(1)

(b)

• Solve the linear system Tb1 (x)

Figure 1: Curve tracing of the solution curve of the system (1) for n = 1: a) Prediction step: step in the direction of the tangent vector ~t pointing into the domain D, b) correction step: point c is the solution of the linear system (4).

Tbn (x) P (x)

= 0, .. . = 0, = 0,

(4)

and use the solution as the corrected point. While numerically tracing a (intersection) curve is not the aim of this work, we briefly review this step for completeness. Assuming we have a starting and ending point on the intersection curve in Rn+1 , curve tracing is a numerically– oriented technique which tracks (and samples points that approximate) a given segment of the sought curve. Normally, such a method consists of two steps: 1) a prediction

The correction step is repeated until the improved point c (solution of system (4)) satisfies all input constraints (1) to within numerical tolerance. The sequence of interleaved steps 1 and 2 is terminated when the correction point reaches the vicinity of the ending point. The numerical tracer described above (or similar ones) poses some major potential drawbacks (can jump from one 2

branch of the curve to another, looping, etc.) unless some strict conditions are satisfied. Two tests, that guarantee that such a curve tracing can be safely used, are presented in Section 3.

3.

and the first coordinate ϕ1 (t) is increasing monotonously. Consequently ϕ(t) 6= ϕ(s) for any parameters t 6= s ∈ [0, 1].  In order to construct the complementary (or tangent) circular bounding hypercone, CiC , of hypersurface fi (x) = 0, we follow the computation of [6], Eq. (3). For the sake of brevity, the reader is referred to [6] to get more detailed explanation on circular tangent cones.

THE NO LOOP AND THE SINGLE COMPONENT TESTS

In this section, we formulate two subdivision termination criteria: a no loop test (NLT) and a single component test (SCT) which deal with solving underconstrained polynomial system (1). The first criterion guarantees the solution is a univariate and detects if the solution curve has a closed loop. The second test verifies that there exists just one connected component over a given domain. If both requirements are met, this domain contains a single connected component and further, this component starts and ends on the boundary (i.e. not a closed loop).

3.1

Theorem 3.5. Let F(x) = 0 be the polynomial system (1) defined in Definition 2.1. Denote by K the intersection of all tangent hypercones CiC , i = 1, 2, . . . , n, of fi , and Gaussian hypersphere Sn \ K=( CiC ) ∩ Sn . (9) i=1,2,...,n

If there exists a hyperplane α, passing through the center of the Gaussian hypersphere Sn , such that α ∩ K = ∅, then the dimension of the set of all real roots of (1) is at most one and these intersection curves have no closed loops.

The No Loop Test

Definition 3.1. Consider a polynomial function f : Rn+1 ∂f ) and its , . . . , ∂x∂f → R along with its gradient ∇f = ( ∂x 1 n+1

Proof. Let us denote by I the set of all real roots of system (1) and assume I is a k-dimensional variety. Let τy be the (k-dimensional) tangent space of I at some point y, y ∈ I and τyG its tangential image on the Gaussian sphere. The set K, by its definition, is a set holding all feasible unit tangent vectors of the solution variety I. Hence,

∇f normalized gradient ∇N f = k∇f , where k.k2 denotes the k2 Euclidean norm. Further, let us define the Gaussian unit hypersphere Sn as

x21 + x22 + · · · + x2n+1 = 1,

x1 , x2 , . . . , xn+1 ∈ R.

Then, the zero set of f is known as a hypersurface in R and ∇N f ⊆ Sn is the Gaussian image of f .

(5) n+1

τyG ⊆ K

τyG ∩ α = ∅

(6)

Lemma 3.4. Let ϕ(t), t ∈ [0, 1] be a regular C 1 continuous curve in Rn+1 and let ϕG be its tangential image. If there exists a hyperplane α, passing through the center of the Gaussian hypersphere Sn α : a1 x1 + a2 x2 + · · · + an+1 xn+1 = 0,

for all y ∈ I.

(11)

Now, let Lα be the linear space related to the hyperplane α (dim(Lα ) = n). Then, linear subspaces τy and Lα , of Rn+1 , are disjoint and hence dim(τy ) ≤ 1 for all y ∈ I. If not, dim(τy ) ≥ 2, there exist a non-trivial intersection (τy ∩ Lα 6= ∅) of both subspaces as well as its non-trivial image on the Gaussian hypersphere (τyG ∩ α 6= ∅) which violates the assumption (11) and proves the first part of the theorem. Since the dimension of variety I is at most one, the Gaussian image of its tangent space [ G τIG = τy (12)

Definition 3.3. We say that the solution of the polynomial system (1) contains a closed loop if there exist a regular curve ϕ : [0, 1] → Rn+1 such that for all t ∈ [0, 1],

(10)

and by the assumption

Definition 3.2. The differentiable mapping ϕ : [0, 1] → R is a regular curve if kϕ0 (t)k2 6= 0 for all t ∈ [0, 1]. The tangential image ϕG of ϕ is a one-parameter subset of the unit Gaussian hypersphere (5) that contains the images of 0 (t) all unit tangent vectors kϕϕ0 (t)k . 2 n+1

F(ϕ(t)) = 0, ϕ(0) = ϕ(1).

for all y ∈ I

y∈I

is composed of the finite number of continuous curves and isolated points. All these segments are bounded by K, so applying Lemma 3.4 on each solution component completes the proof. 

(7)

such that α ∩ ϕG = ∅, then ϕ is not a closed loop. Proof. Since ϕ(t) is a C 1 continuous curve, ϕG is also continuous. Further, the Gaussian hypersphere is split by α into two hemispheres. We assume that the normal vector ~a = (a1 , a2 , . . . , an+1 ) of α is of unit size and its Gaussian image ~aG lies in the same hemisphere as ϕG (if not, we apply −~a). Without loss of generality we assume ~a is the first coordinate vector of the Cartesian coordinate system in Rn+1 and consequently ~a = (1, 0, . . . , 0). Since ~aG and ϕG lies in the same hemisphere, it holds h~a, ϕ0 (t)i > 0 for all t ∈ [0, 1], where h·i denotes the Euclidean scalar product. Hence,

Based on the result of the previous theorem, we formulate a no loop test (NLT) which guarantees that no closed loops appears in the (univariate) solution of the system (1). See Algorithm 1 and Fig. 2. Some steps of Algorithm 1 are now explained in some detail: • In line 4, we construct a pair of hyperplanes that bound tangent hypercone CiC in Sn , following [6]. These hyperplanes are symmetric with respect to the origin, see Fig. 2c), their normal vector ~vi coincides with the axis vector of CiC and they intersect Sn in the same circles as CiC .

ϕ01 (t) = (1, 0, . . . , 0) · (ϕ01 (t), . . . , ϕ0n+1 (t)) = h~a, ϕ0 (t)i > 0, (8) 3

Algorithm 1 (see Fig. 2) { No loop test (NLT) in Rn+1 }

b

a

1: INPUT: Coefficients of the system (1), domain D; 2: for i = 1 to n do 3: CiC ← generate the complementary tangent bounding hypercone of the hypersurface fi (x) = 0 on domain D; 4: Hi+ , Hi− ← pair of hyperplanes that bounds CiC in Sn ; 5: end for 6: ~a ← ~v1 ∧~v2 ∧ · · · ∧~vn , the wedge product in Rn+1 , where ~vi are the axis–vectors of the tangent hypercones CiC , i = 1, . . . , n; 7: α ← hyperplane with normal vector ~a passing through the center of the Gaussian sphere Sn ; +/− +/− +/− 8: Pi ← α ∩ H1 ∩ H2 ∩ · · · ∩ Hn , intersection points n+1 n in R , i = 1, . . . , 2 , of α with the bounding hyperstrip P; 9: OUTPUT: TRUE if Pi ⊂ Sn , ∀ i = 1, . . . , 2n , FALSE otherwise;

(a)

(b)

c

a

a b

c b

(c)

(d)

a

• The mutual intersections of n pairs of bounding hyperplanes define a prismatic subset in Rn+1 , a bounding hyperstrip P, which is unbounded in the direction perpendicular to all axis vectors ~vi , i = 1, . . . , n; this direction ~a is computed in line 6, see also Fig. 2d).

c a b

b

• In line 8, the intersection of the prismatic strip and a plane α is computed. There can be many planes that satisfy the condition in Theorem 3.5. However, we choose α to be perpendicular to ~a, the direction of the strip P, in order to minimize the maximum of distances between Pi and the center of the Gaussian sphere.

(e)

Figure 2: Algorithm 1, the no loop test (NLT): a) n hypersurfaces in Rn+1 , n = 2. b) the tangent bounding cone C1C of the horizontal surface and c) its bounding hyperplanes H1+ , H1− in S2 . d) Prismatic subset P in R3 defined by the intersection of two pairs of bounding hyperplanes and plane α perpendicular to the direction of the prism. e) K ⊆ S2 is the bounding set of the (normalized) tangent space of the solution variety and c = S2 ∩ α; if c ∩ K is empty, the intersection curve has no closed loops. f ) Instead of verifying this condition, the distances between the intersection points Pi = P ∩ α and the center of Gaussian hypersphere O are measured. If kPi Ok2 < 1 for all i, the return value of NLT test is TRUE.

In the surface-surface intersection literature, a similar idea of loop detection has been presented in [13], testing the mutual orientations of bounding cones of the two intersecting surfaces. However, we are aware of no generalization of that condition for a “no loop test” in the intersection of n hypersurfaces in Rn+1 .

3.2

(f)

Single Component Test

In order to robustly solve underconstrained polynomial system (1) over some domain D ⊆ Rn+1 , we present a second test which examines the number of points lying together on the solution curve and on the boundary of D. Due to this criterion (and the NLT), we can completely classify the number of curve segments inside D. Once the number of intersections of D with the solution curve is located, the curve is traced (two intersections), the domain is discarded (no intersections) or subdivided (more than two intersections). Moreover, the position of these points on the boundary gives us hints where to subdivide. Consider the case where the numerical solver computes all real boundary roots of polynomial systems n × n and the NLT returns a positive answer. Then, the single component test (SCT) is applied as in Algorithm 2. See also Fig. 3. The SCT guarantees that just one segment can reside inside the box of interest. Nevertheless, curve tracing may potentially become unstable even if such a strong condition is satisfied. Consider a curve forming a “semi-loop” shape, as in Fig. 4 (a). An undesired jump can occur when numerically tracing this curve if two locations of the same segment

are close to each other. Nevertheless, in the algorithm proposed here, SCT is called only if NLT returns a positive answer. Such a “semi-loop” is prevented by the NLT. After passing both the NLT and the SCT, only monotone curves are traced. See Fig. 4 (b). By monotone we mean that there exist a direction (vector ~a ∈ Rn+1 ) in which the inner product of the tangent of the intersection curve and ~a have the same sign throughout. This vector ~a is the normal vector of plane α from Theorem 3.5, constructed in line 6 of the NLT algorithm. Remark 3.6. In the general case, the SCT returns an even number of boundary points. Odd number of points may occur only in limit cases, having higher orders of contact, when some (segments of the) curve touches a boundary face of the domain. In such a case, the solver subdivides to this 4

a

c

e

a

c

a

b b

(a)

(b)

(a)

(b) c

a

a

e b b

d

(c) (c)

(d) Figure 4: Monotone solution curve is guaranteed via the NLT and SCT: A general single component solution curve ϕ (with its gray top projection) inside some domain in the solution space a), for which the NLT fails. b) A case with a successful NLT, where the solution curve ϕ is monotone with respect to some direction ~a, hϕ0 , ~ai > 0. c) Tangential image ϕG on the Gaussian hypersphere does not intersect the main circle defined by hyperplane α, for which ~a is the normal vector.

Figure 3: The single component test (SCT): n = 2 polynomial constraints in three variables: a) two hypersurfaces f1 (x) = 0 and f2 (x) = 0 over volumetric domain D, b) restrictions of both constraints on the boundary of D, c) problem is reduced to solve 2(n + 1) = 6 boundary 2 × 2 systems, d) two intersection points guarantee a single component inside domain D. Algorithm 2 (see Fig. 3) { Single component test (SCT) in Rn+1 }

Algorithm 3 { Solving underconstrained n × (n + 1) system via NLT and SCT }

1: INPUT: NLT TRUE, coefficients of system (1), domain D = [α1 , β1 ] × · · · × [αn+1 , βn+1 ]; 2: S ← ∅; 3: for i = 1 to (n + 1) do 4: substitute for xi the boundary values {αi , βi } of D in the ith direction into system (1); 5: Si ← pairs of solutions of systems F(x)|xi =αi = 0 and F(x)|xi =βi = 0; S 6: S = S Si ; 7: end for 8: OUTPUT: |S|

1: INPUT: an underconstrained polynomial system F(x) = 0, (see (1)), subdivision tolerance εsub , tracing stepsize λ, domain D ⊂ Rn+1 ; 2: test the signs of the B´ezier representations of each constraint and discard the no-root containing domain; 3: if maximal side of the domain > εsub then 4: if NLT(F)=TRUE then 5: switch(SCT(F)) 6: case 0: discard D; 7: case 2: trace the solution curve with the stepsize λ; 8: case ≥ 4: subdivide F and go to line 3; 9: else 10: subdivide F and go to line 3; 11: end if 12: merge traced segments at common boundary points; 13: else 14: return the center of the domain (subdivision tolerance was reached); 15: end if 16: OUTPUT: (a set of) polyline(s) in Rn+1 that interpolate the solution curve(s) of the system F(x) = 0.

location. In order to avoid subdivision at such singular locations, if an odd number is reported, numerical perturbation is applied on the subdivision parameters of the hyperplanes. In the case of singular intersections, the solver subdivides to that location and returns a set of domains whose diameter is less than the subdivision tolerance. Exploiting both tests, the SCT and the NLP, the complete underconstrained n × (n + 1) subdivision-based solver is summarized in Algorithm 3.

4.

APPLICATIONS OF THE ALGORITHM

In this section, we present two possible applications of the new algorithm. The first relates to a problem of finding a 5

by n × (n + 1) polynomial system, like medial axis computation, rounding of two surfaces or some other types of kinematic problems (e.g., a self-motion of Stewart platform), are also within the scope of our interest, and will be experimented with.

c

6. a

Figure 5: Examples of 3D trisectors. The locus of centers (red) of cotangent spheres for three input curves C1 , C2 and C3 .

7.

trisector of three free-form objects in R3 , the locus of centers of all spheres that possess (at least) first order contact with all three objects. Fig. 5 shows the trisector curve of three curves (system of 5 equations with 6 unknowns). The second application is the kinematic analysis of a 3D mechanisms, for which the constraints between its components may be expressed algebraically. An example of a motion of the rigid triangle is shown at Fig. 6, yielding a (3 × 4) system. See [2] for more about the kinematic simulator that exploits Algorithm 3. All examples were created using the GuIrit GUI user interface 1 of the Irit solid modeling system 2 . The solver was implemented as a library of Irit.

CONCLUSION AND FUTURE WORK

In this work, we have presented a technique for robustly solving underconstrained (piecewise) polynomial system of n equations in n + 1 unknowns. A subdivision based solver that exploits two termination criteria, namely the no loop test (NLT) and the single component test (SCT), returns domains that contain a single monotone univariate solution. Segments are detected and isolated. The segmentation can also be used to safeguard the numerical tracing stage. Traced segments are then merged together with the right neighbors (inverse process to subdivision) and thus correct topology of the intersection curve is guaranteed. Other geometric problems, whose solutions are described 1 2

REFERENCES

[1] C. Bajaj, C. M. Hoffmannn, R. E. Lynch, and J. E. H. Hopcroft. Tracing surface intersections. Computer Aided Geometric Design, (5):285–307, 1988. [2] M. Bartoˇ n, N. Shragai and G. Elber. Kinematic simulation of planar and spatial mechanisms using a polynomial constraint solver. Computer-Aided Design and Applications, (6):115–123, 2009. [3] D. A. Cox, J. B. Little, and D. O’Shea. Using algebraic geometry. Springer, 2005. [4] G. Elber and T. Grandine. Efficient solution to systems of multivariate polynomials using expression trees. In Tenth SIAM Conference on Geometric Design and Computing, 2007. [5] T. A. Grandine and F. W. Klein. New approach to the surface intersection problem. Computer Aided Geometric Design, (14):111−134, 1997. [6] I. Hanniel and G. Elber. Subdivision termination criteria in subdivision multivariate solvers using dual hyperplanes representations. Computer Aided Design, (39):369–378, 2007. [7] J. Hass, R. T. Farouki, C. Y. Han, X. Song, and T. W. Sederberg. Guaranteed consistency of surface intersections and trimmed surfaces using a coupled topology resolution and domain decomposition scheme. Advances in Comput. Math., (27):1–26, 2007. [8] J. M. McNamee. Bibliographies on roots of polynomials. In J. Comp. Appl. Math (47): 391–394, (78):1–1, (110):305–306; (142):433–434, 1993–2002. [9] B. Mourrain and J.-P. Pavone. Subdivision methods for solving polynomial equations. Journal of Symbolic Computation (44),3:292-306, 2009. [10] Ch. Liang, B. Mourrain and J.-P. Pavone. Subdivision methods for the topology of 2d and 3d implicit curves. Geometric Modeling and Algebraic Geometry, ed. B. Juetller and R. Piene, p. 199-214, 2007. [11] H. Mukundan, K. H. Ko, T. Maekawa, T. Sakkalis, and N. M. Patrikalakis. Tracing surface intersections with validated ODE system solver. In N. P. G. Elber and P. Brunet, editors, ACM Symposium on Solid Modeling and applications, 2004. [12] M. Reuter, T. S. Mikkelsen, E. C. Sherbrooke, T. Maekawa, and N. M. Patrikalakis. Solving nonlinear polynomial systems in the barycentric Bernstein basis. Visual Computer, (24):187–200, 2008. [13] T. W. Sederberg and R. J. Meyers. Loop detection in surface patch intersection. Computer Aided Geometric Design, (5):161–171, 1988. [14] R. Sharma and O. P. Sha. A tracing method for parametric B´ ezier triangular surface plane intersection over triangular domain. J. Indian Inst. Sci., (85):161–182, 2005. [15] E. C. Sherbrooke and N. M. Patrikalakis. Computation of solution of nonlinear polynomial systems. Computer Aided Geometric Design, 5(10):379–405, 1993. [16] A. J. Sommese and C. W. Wampler. The numerical solution of systems of polynomials arising in engineering and science. World Scientific, 2005. [17] J. Stewart. Multivariate Calculus. 2002.

Figure 6: A Kinematic mechanism. The motion of a rigid triangle in 3D. Two vertices are constrained to move along the two curves, the third is allowed to move on the surface. Several positions of the triangle are shown.

5.

ACKNOWLEDGMENTS

This research was partly supported by the Israel Science Foundation (grant No. 346/07), and in part by the New York metropolitan research fund, Technion.

b

www.cs.technion.ac.il/∼gershon/GuIrit www.cs.technion.ac.il/∼irit 6

Topologically guaranteed univariate solutions of ...

algebraic constraints from zero dimensional solutions to uni- variate solutions, in ..... In Tenth. SIAM Conference on Geometric Design and Computing,. 2007.

688KB Sizes 1 Downloads 188 Views

Recommend Documents

On the Degree of Univariate Polynomials Over the ...
Email: [email protected]. †Faculty of Computer Science, ... by the Israel Science. Foundation (grant number 339/10). ‡Faculty of Computer Science, Technion-Israel Institute of Technology, Haifa, Israel. Email: [email protected]. ......

density of real and complex decomposable univariate ...
For two univariate polynomials g, h ∈ F[x] of degrees d, e, respectively, over a field F, their composition. (1.1) ... the density of these components. Any proper algebraic subvariety X of Rn has volume and density ... complex ϵ-tubes inside the B

Cooperative Coevolution and Univariate ... - Semantic Scholar
elements aij represent the reward when genotypes i (from the first .... card information that is normally available to a more traditional evolutionary algorithm. Such.

Guaranteed Node Overage
Every renewal period our customers purchase a certain number of nodes that their subscription covers. However, with changes in your organization such as new employees, PC refresh projects, or acquisitions – your node count increases and you incur o

On the Degree of Univariate Polynomials Over the ...
polynomial f : {0,...,n}→{0,...,O(2k)} of degree n/3 − O(k) ≤ deg(f) ≤ n − k. ... ∗Department of Computer Science and Applied Mathematics, The Weizmann ...

Cooperative Coevolution and Univariate ... - Research at Google
Analyses of cooperative (and other) coevolution will often make use of an infinite population ..... Given a joint reward system with a unique global optimum ai⋆.

topologically adaptive parallel breadth-first search on ...
input graphs and the performance of BFS on multicore sys- tems. We propose a model to estimate the scalability of. BFS with respect to a given graph. Using this model, we propose a topologically adaptive parallel BFS algorithm on multicore systems. T

Guaranteed Non-convex Optimization: Submodular ...
Submodular continuous functions naturally find applications in various real-world settings, including influence and revenue maximization with continuous assign- ments, sensor energy management, multi-resolution data summarization, facility location,

Profiting from Non-Guaranteed Advertising: The Value of ...
priority tiering system is used to manage the delivery of ads (of different varieties, formats, messaging, etc.) into ad space on any given page. Through their direct ...

Profiting from Non-Guaranteed Advertising: The Value of ...
Overview. For most large online publishers, the supply of available ad inventory far exceeds demand for it. A research study conducted by Forrester indicated ...

Guaranteed Non-convex Optimization: Submodular ...
Department of Computer Science, ETH Zurich. 1ybian, baharanm .... α 2 (0, 1] is the mulplicative error level, δ 2 [0, ¯δ] is the additive error level. 4 find stepsize k, e.g. .... In Approximation and Online Algorithms, pages 133–144. Springer,

Guaranteed Non-convex Optimization: Submodular ...
Submodular continuous functions are defined on product of compact sub- ..... free assignment, it can be some non-negative, non-decreasing submodular function; φ(xi(t)) ...... Association for Computational Linguistics, pages 912–920, 2010.

A Guaranteed Opportunity in Programmatic Advertising.indd
Feb 3, 2018 - market will be 63%. (See Exhibit 1.) One fast-rising driver of this growth is commonly known as “programmatic guaran- teed.” It effectively replaces the manual execution processes involved in the premi- um inventory ... software to

A Guaranteed Opportunity in Programmatic Advertising.indd
3 Feb 2018 - 10. A Guaranteed Opportunity in Programmatic Advertising tures that accommodate partial integration of nonstandard or custom creative for- mats. The benefits to agencies from such platforms include consolidated reporting and real-time tr

Vietoris-Rips Complexes also Provide Topologically ...
Let P be a finite set of points in Rn. We call any non-empty subset σ ⊂ P an abstract simplex. .... If X is compact then Hull(X, t) is a superset of Centers(X, t). If P is a finite ...... An appealing aspect of Rips complexes is that they can be d

Vietoris-Rips complexes also provide topologically ...
We associate with each compact set X of Rn two real-valued functions cX and hX defined on R+ ...... polynomial of degree 2 in ε and holds whenever ε is smaller than the .... and New Trends in Computer Science, volume 555, pages 359–370.

The Isomap and MDS algorithm are topologically ...
We give two illustrations in. Fig. S1. The curse of failure stems from the special structure of the distance matrix formed by peripherally symmetric graph. It is not ...

READING GUIDE - DAY 2 UNIVARIATE DATA ...
In R, change your working directory to 'stat'. You are now ready. Type. > data hist(data$str). > hist(data$read scr). > plot(data$str ... variable is the long-run average value of the variable over many repeated trials. Other measures of central loc

Watch Safety Not Guaranteed (2012) Full Movie Online Free ...
Watch Safety Not Guaranteed (2012) Full Movie Online Free .MP4________.pdf. Watch Safety Not Guaranteed (2012) Full Movie Online Free .MP4________.