on Newton polytopes, tropisms, and Puiseux series to solve polynomial systems

Size: px
Start display at page:

Download "on Newton polytopes, tropisms, and Puiseux series to solve polynomial systems"

Transcription

1 on Newton polytopes, tropisms, and Puiseux series to solve polynomial systems Jan Verschelde joint work with Danko Adrovic University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science jan SIAM Conference on Discrete Mathematics Interactions between Computer Algebra and Discrete Mathematics June 2012, Dalhousie University, Halifax, NS, Canada Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

2 Outline 1 Introduction our problem: solving sparse polynomial systems Newton polytopes, Puiseux series, initial forms, and tropisms 2 Solving Binomial Systems a very sparse class of polynomial systems unimodular coordinate transformations solutions to the cyclic 4-roots system 3 Polyhedral Methods for Algebraic Sets computing pretropisms with the Cayley embedding Puiseux series for algebraic sets 4 Application to the Cyclic n-roots Problem a series solution for cyclic 8-roots curves an exact representation for cyclic 9-roots surfaces Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

3 problem statement A polynomial in n variables x = (x 0, x 1,..., x n 1 ) consists of a vector of nonzero complex coefficients with corresponding exponents in A: f(x) = a A c a x a, c a C\{0}, x a = x a 0 0 x a 1 1 x a n 1 n 1. Solve f(x) = 0, f = (f 0, f 1,..., f N 1 ) with supports (A 0, A 1,...,A N 1 ). Systems are sparse: few monomials have a nonzero coefficient. For a Z n, we consider Laurent polynomials, f C[x ±1 ] only solutions with coordinates in C = C\{0} matter. Many applications give rise to symmetric polynomial systems. The solution set is invariant under permutations of the variables. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

4 the cyclic n-roots system x 0 + x 1 + +x n 1 = 0 x 0 x 1 + x 1 x 2 + +x n 2 x n 1 + x n 1 x 0 = 0 n 1 j+i 1 f(x) = i = 3, 4,...,n 1 : x k mod n = 0 Lemma (Backelin) j=0 x 0 x 1 x 2 x n 1 1 = 0. If m 2 divides n, then the cyclic n-roots system has a solution set of dimension m 1. J. Backelin: Square multiples n give infinitely many cyclic n-roots. Reports, Matematiska Institutionen, Stockholms Universitet, k=j Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

5 Newton polytopes and Puiseux series The sparse structure is modeled by its Newton polytope. Definition Consider the support A Z n of f(x) = c a x a, c a C\{0}. a A The Newton polytope of f is the convex hull of A. Definition Consider a curve C defined by f(x) = 0. A Puiseux series of the curve C has the form { x0 = t v 0 x k = z k t v k(1+o(t)), k = 1, 2,...,n 1, where (z 1,...,z n 1 ) (C ) n 1. The Newton-Puiseux algorithm is in Walker s Algebraic Curves, Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

6 initial forms and tropisms Denote the inner product of vectors u and v as u, v. Definition Let v Z n \{0} be a direction vector. Consider f(x) = a A c a x a. The initial form of f in the direction v is in v (f) = c a x a, where m = min{ a, v a A }. a A a, v = m Definition Let the system f(x) = 0 define a curve. A tropism consists of the leading powers (v 0, v 1,..., v n 1 ) of a Puiseux series of the curve. The leading coefficients of the Puiseux series satisfy in v (f)(x) = 0. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

7 some references D.N. Bernshteǐn. The number of roots of a system of equations. Functional Anal. Appl., 9(3): , B. Sturmfels. Gröbner Bases and Convex Polytopes, AMS, T. Bogart, A.N. Jensen, D. Speyer, B. Sturmfels, and R.R. Thomas. Computing tropical varieties. J. Symbolic Computation, 42(1):54 73, A.N. Jensen, H. Markwig, and T. Markwig. An algorithm for lifting points in a tropical variety. Collectanea Mathematica, 59(2): , S. Payne. Fibers of tropicalization. Mathematische Zeitschrift, 262(2): , D. Adrovic and J. Verschelde. Tropical algebraic geometry in Maple: A preprocessing algorithm for finding common factors to multivariate polynomials with approximate coefficients. J. Symbolic Computation, 46(7): , Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

8 relevant software Maple, of course... cddlib by Komei Fukuda and Alain Prodon implements the double description method to efficiently enumerate all extreme rays of a general polyhedral cone. Gfan by Anders Jensen to compute Gröbner fans and tropical varieties uses cddlib. The Singular library tropical.lib by Anders Jensen, Hannah Markwig and Thomas Markwig for computations in tropical geometry. Macaulay2 interfaces to Gfan. Sage interfaces to Gfan. PHCpack (published as Algorithm 795 ACM TOMS) provides our numerical blackbox solver. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

9 binomial systems Definition A binomial system has exactly two monomials with nonzero coefficient in every equation. The binomial equation c a x a c b x b = 0, a, b Z n, c a, c b C\{0}, has normal representation x a b = c b /c a. A binomial system of N equations in n variables is then defined by an exponent matrix A Z N n and a coefficient vector c (C ) N : x A = c. Solution sets of binomial systems are related to toric varieties. Solution sets of binomial systems can be represented exactly by the first term of their Puiseux series. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

10 an example Consider as an example for x A = c the system { x 2 0 x 1 x 4 2 x = 0 x 0 x 1 x 2 x 3 1 = 0 A = [ ] T c = [ 1 1 ]. As basis of the null space of A we can for example take u = ( 3, 2, 1, 0) and v = ( 2, 1, 0, 1). The vectors u and v are tropisms for a two dimensional algebraic set. Placing u and v in the first two rows of a matrix M, extended so det(m) = 1, we obtain a coordinate transformation, x = y M : M = x 0 = y 3 0 y 2 1 y 2 x 1 = y 2 0 y 1y 3 x 2 = y 0 x 3 = y 1. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

11 monomial transformations By construction, as Au = 0 and Av = 0: MA = = = B. The corresponding monomial transformation x = y M performed on x A = c yields y MA = y B = c, eliminating the first two variables: { y 2 2 y 3 1 = 0 y 2 y 3 1 = 0. Solving this reduced system gives values z 2 and z 3 for y 2 and y 3. Leaving y 0 and y 1 as parameters t 0 and t 1 we find as solution (x 0 = z 2 t 3 0 t 2 1, x 1 = z 3 t 2 0 t 1, x 2 = t 0, x 3 = t 1 ). Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

12 unimodular coordinate transformations Definition A unimodular coordinate transformation x = y M is determined by an invertible matrix M Z n n : det(m) = ±1. For a d dimensional solution set of a binomial system: 1 The null space of A gives d tropisms, stored in the rows of a d-by-n-matrix B. 2 Compute the Smith normal form S of B: UBV = S. 3 There are three cases: 1 U = I M = V 1 2 If U I and S has ones on its diagonal, then extend U 1 with an identity matrix to form M. 3 Compute the Hermite normal form H of B and let D be the diagonal elements of H, then M = [ D 1 B 0 I ]. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

13 cyclic 4-roots and binomial systems x 0 + x 1 + x 2 + x 3 = 0 x f(x) = 0 x 1 + x 1 x 2 + x 2 x 3 + x 3 x 0 = 0 x 0 x 1 x 2 + x 1 x 2 x 3 + x 2 x 3 x 0 + x 3 x 0 x 1 = 0 x 0 x 1 x 2 x 3 1 = 0 Looking for a special solution, we apply the binomial system solver to x 0 + x 2 = 0 x 1 + x 3 = 0 x 0 x 1 + x 1 x 2 = 0 x 2 x 3 + x 3 x 0 = 0 x 0 x 1 x 2 + x 2 x 3 x 0 = 0 x 1 x 2 x 3 + x 3 x 0 x 1 = 0 x 0 x 1 x 2 x 3 1 = 0 Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

14 the output of phc -b 4 5 t1 - t1 + x0 - t1^1; x2 - ( E-16*i)*t1^1; x1 - (-1)*t1^-1; x3 - ( E-16*i)*t1^-1; 4 5 t1 - t1 + x0 - t1^1; x2 - ( E-16*i)*t1^1; x1 - ( E-16*i)*t1^-1; x3 - ( E-16*i)*t1^-1; This output corresponds to the two solutions (x 0 = t, x 1 = t 1, x 2 = t, x 3 = t 1 ) and (x 0 = t, x 1 = t 1, x 2 = t, x 3 = t 1 ) of the original problem. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

15 the Cayley embedding an example { p = (x0 x 2 1 )(x 0 + 1) = x x 0 x 2 1 x 0 x 2 1 = 0 q = (x 0 x 2 1 )(x 1 + 1) = x 0 x 1 + x 0 x 3 1 x 2 1 = 0 The Cayley polytope is the convex hull of {(2, 0, 0),(1, 0, 0), (1, 2, 0),(0, 2, 0)} {(1, 1, 1),(1, 0, 1), (0, 3, 1),(0, 2, 1)}. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

16 facet normals and initial forms The Cayley polytope has facets spanned by one edge of the Newton polygon of p and one edge of the Newton polygon of q. Consider v = (2, 1, 0). { ( in(2,1) (p) = in (2,1) x x 0 x1 2x 0 x1 2 ) = x0 x1 2 in (2,1) (q) = in (2,1) ( x0 x 1 + x 0 x 3 1 x 2 1) = x0 x 2 1 Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

17 computing all pretropisms Definition A nonzero vector v is a pretropism for the system f(x) = 0 if #in v (f k ) 2 for all k = 0, 1,...,N 1. Application of the Cayley embedding to (A 0, A 1,..., A N 1 ): N 1 E = { (a, 0) a A 0 } { (a, e k ) a A k } Z n+n 1, k=1 where 0, e 1 = (1, 0,...,0), e 2 = (0, 1,...,0),..., e N 1 = (0, 0,..., 1) span the standard unit simplex in R N 1. The set of all facet normals to the convex hull of E contains all normals to facets spanned by at least two points of each support. We used cddlib to compute all pretropisms of the cyclic n-roots system, up to n = 12. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

18 cones of pretropisms Definition A cone of pretropism is a polyhedral cone spanned by pretropisms. If we are looking for an algebraic set of dimension d and if there are no cones of vectors perpendicular to edges of the Newton polytopes of f(x) = 0 of dimension d, then the system f(x) = 0 has no solution set of dimension d that intersects the first d coordinate planes properly; otherwise if a d-dimensional cone of vectors perpendicular to edges of the Newton polytopes exists, then that cone defines a part of the tropical prevariety. For the cyclic 9-roots system, we found a two dimensional cone of pretropisms. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

19 solving the cyclic 4-roots system x 0 + x 1 + x 2 + x 3 = 0 x f(x) = 0 x 1 + x 1 x 2 + x 2 x 3 + x 3 x 0 = 0 x 0 x 1 x 2 + x 1 x 2 x 3 + x 2 x 3 x 0 + x 3 x 0 x 1 = 0 x 0 x 1 x 2 x 3 1 = 0 One tropism v = (+1, 1,+1, 1) with in v (f)(z) = 0: x 1 + x 3 = 0 x in v (f)(x) = 0 x 1 + x 1 x 2 + x 2 x 3 + x 3 x 0 = 0 x 1 x 2 x 3 + x 3 x 0 x 1 = 0 x 0 x 1 x 2 x 3 1 = 0 x 0 = y +1 0 x 1 = y 1 0 y 2 x 2 = y +1 0 y 3 x 3 = y 1 0 y 4 The system in v (f)(y) = 0 has two solutions. We find two solution curves: ( t, t 1, t, t 1) and ( t, t 1, t, t 1). Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

20 Puiseux series for algebraic sets Proposition If f(x) = 0 is in Noether position and defines a d-dimensional solution set in C n, intersecting the first d coordinate planes in regular isolated points, then there are d linearly independent tropisms v 0, v 1,...v d 1 Q n so that the initial form system in v0 (in v1 ( in vd 1 (f) ))(x = y M ) = 0 has a solution c (C\{0}) n d. This solution and the tropisms are the leading coefficients and powers of a generalized Puiseux series expansion for the algebraic set: x 0 = t v 0,0 0 x 1 = t v 0,1 0 t v 1,1 1. x d 1 = t v 0,d 1 0 t v 1,d 1 1 t v d 1,d 1 d 1 x d = c 0 t v 0,d 0 t v 1,d 1 t v d 1,d d 1 + x d+1 = c 1 t v 0,d+1 0 t v 1,d+1 1 t v d 1,d+1 d 1 +. x n = c n d 1 t v 0,n 1 0 t v 1,n 1 1 t v d 1,n 1 d 1 + Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

21 our polyhedral approach For every d-dimensional cone C of pretropisms: 1 We select d linearly independent generators to form the d-by-n matrix A and the unimodular transformation x = y M. 2 If in v0 (in v1 ( in vd 1 (f) ))(x = y M ) = 0 has no solution in (C ) n d, then return to step 1 with the next cone C, else continue. 3 If the leading term of the Puiseux series satisfies the entire system, then we report an explicit solution of the system and return to step 1 to process the next cone C. Otherwise, we take the current leading term to the next step. 4 If there is a second term in the Puiseux series, then we have computed an initial development for an algebraic set and report this development in the output. Note: to ensure the solution of the initial form system is not isolated, it suffices to compute a series development for a curve. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

22 applied to the cyclic 8-roots system Our approach applied to the cyclic 8-roots system: 831 facet normals (computed with cddlib) 29 pretropism generators 5 lead to initial forms with solutions (1, 1, 0, 1, 0, 0, 1, 0) (1, 1, 1, 1, 1, 1, 1, 1) (1, 0, 1, 0, 0, 1, 0, 1) (1, 0, 1, 1, 0, 1, 0, 0) (1, 0, 0, 1, 0, 1, 1, 0) For the initial form solutions we used the blackbox solver of PHCpack. Symbolic manipulations for the computation of the second term of the Puiseux series were done with Sage. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

23 an initial form system The pretropism v = (1, 1, 0, 1, 0, 0, 1, 0) defines x 1 + x 6 = 0 x 1 x 2 + x 5 x 6 + x 6 x 7 = 0 x 4 x 5 x 6 + x 5 x 6 x 7 = 0 x 0 x 1 x 6 x 7 + x 4 x 5 x 6 x 7 = 0 in v (f)(x) = x 0 x 1 x 2 x 6 x 7 + x 0 x 1 x 5 x 6 x 7 = 0 x 0 x 1 x 2 x 5 x 6 x 7 + x 0 x 1 x 4 x 5 x 6 x 7 + x 1 x 2 x 3 x 4 x 5 x 6 = 0 x 0 x 1 x 2 x 4 x 5 x 6 x 7 + x 1 x 2 x 3 x 4 x 5 x 6 x 7 = 0 x 0 x 1 x 2 x 3 x 4 x 5 x 6 x 7 1 = 0 v defines the unimodular coordinate transformation: x 0 = y 0, x 1 = y 1 /y 0, x 2 = y 2, x 3 = y 0 y 3, x 4 = y 4, x 5 = y 5, x 6 = y 6 /y 0, x 7 = y 7. Using the new coordinates, we transform in v (f)(x). Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

24 the transformed initial form system in v (f)(y) = y 1 + y 6 = 0 y 1 y 2 + y 5 y 6 + y 6 y 7 = 0 y 4 y 5 y 6 + y 5 y 6 y 7 = 0 y 4 y 5 y 6 y 7 + y 1 y 6 y 7 = 0 y 1 y 2 y 6 y 7 + y 1 y 5 y 6 y 7 = 0 y 1 y 2 y 3 y 4 y 5 y 6 + y 1 y 2 y 5 y 6 y 7 + y 1 y 4 y 5 y 6 y 7 = 0 y 1 y 2 y 3 y 4 y 5 y 6 y 7 + y 1 y 2 y 4 y 5 y 6 y 7 = 0 y 1 y 2 y 3 y 4 y 5 y 6 y 7 1 = 0 Solving in v (f)(y), we obtain 8 solutions (all in the same orbit), e.g.: y 0 = t, y 1 = I, y 2 = 1 2 I 2, y 3 = 1, y 4 = 1+I, y 5 = I 2, y 6 = I, y 7 = 1 I, I = 1. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

25 developing a series for the solution Taking solution at infinity, we build a series of the form: y 0 = t y 1 = I + c 1 t y 2 = 1 2 I 2 + c 2t y 3 = 1+c 3 t y 4 = 1+I + c 4 t y 5 = I 2 + c 5t y 6 = I + c 6 t y 7 = ( 1 I)+c 7 t Plugging series form into transformed system, collecting all coefficients of t 1, solving yields c 1 = 1 I c 2 = 1 2 c 3 = 0 c 4 = 1 c 5 = 1 2 c 6 = 1+I c 7 = 1 The second term in the series, still in the transformed coordinates: y 0 = t y 1 = I +( 1 I)t y 2 = 1 2 I t y 3 = 1 y 4 = 1+I t y 5 = I t y 6 = I +(1+I)t y 7 = ( 1 I)+t Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

26 degree computations Definition (Branch Degree) Let v = (v 0, v 1,..., v n 1 ) be a tropism and let R be the set of initial roots of the initial form system in v (f)(y) = 0. n 1 Then the degree of the branch is #R max v i min n 1 v i i=0 i=0. Tropisms, their cyclic permutations, and degrees: (1, 1, 1, 1, 1, 1, 1, 1) 8 2 = 16 (1, 1, 0, 1, 0, 0, 1, 0) (1, 0, 0, 1, 0, 1, 1, 0) = 32 (1, 0, 1, 0, 0, 1, 0, 1) (1, 0, 1, 1, 0, 1, 0, 0) = 32 (1, 0, 1, 1, 0, 1, 0, 0) (1, 0, 1, 0, 0, 1, 0, 1) = 32 (1, 0, 0, 1, 0, 1, 1, 0) (1, 1, 0, 1, 0, 0, 1, 0) = 32 TOTAL = is the degree of the solution curve of the cyclic 8-root system. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

27 an initial form of cyclic 9-roots v 0 = (1, 1, 2, 1, 1, 2, 1, 1, 2) and v 1 = (0, 1, 1, 0, 1, 1, 0, 1, 1) define the initial form system x 2 + x 5 + x 8 = 0 x 0 x 8 + x 2 x 3 + x 5 x 6 = 0 x 0 x 1 x 2 + x 0 x 1 x 8 + x 0 x 7 x 8 + x 1 x 2 x 3 + x 2 x 3 x 4 + x 3 x 4 x 5 + x 4 x 5 x 6 + x 5 x 6 x 7 + x 6 x 7 x 8 = 0 x 0 x 1 x 2 x 8 + x 2 x 3 x 4 x 5 + x 5 x 6 x 7 x 8 = 0 x 0 x 1 x 2 x 3 x 8 + x 0 x 5 x 6 x 7 x 8 + x 2 x 3 x 4 x 5 x 6 = 0 x 0 x 1 x 2 x 3 x 4 x 5 + x 0 x 1 x 2 x 3 x 4 x 8 + x 0 x 1 x 2 x 3 x 7 x 8 + x 0 x 1 x 2 x 6 x 7 x 8 + x 0 x 1 x 5 x 6 x 7 x 8 + x 0 x 4 x 5 x 6 x 7 x 8 + x 1 x 2 x 3 x 4 x 5 x 6 + x 2 x 3 x 4 x 5 x 6 x 7 + x 3 x 4 x 5 x 6 x 7 x 8 = 0 x 0 x 1 x 2 x 3 x 4 x 5 x 8 + x 0 x 1 x 2 x 5 x 6 x 7 x 8 + x 2 x 3 x 4 x 5 x 6 x 7 x 8 = 0 x 0 x 1 x 2 x 3 x 4 x 5 x 6 x 8 + x 0 x 1 x 2 x 3 x 5 x 6 x 7 x 8 + x 0 x 2 x 3 x 4 x 5 x 6 x 7 x 8 = 0 x 0 x 1 x 2 x 3 x 4 x 5 x 6 x 7 x 8 1 = 0 Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

28 the unimodular transformation x = y M M = x 0 = y 0 x 1 = y 0 y 1 x 2 = y 2 0 y 1 1 y 2 x 3 = y 0 y 3 x 4 = y 0 y 1 y 4 x 5 = y 2 0 y 1 1 y 5 x 6 = y 0 y 6 x 7 = y 0 y 1 y 7 x 8 = y 2 0 y 1 1 y 8 We use the coordinate change to transform the initial form system and the original cyclic 9-roots system. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

29 the transformed initial form system y 2 + y 5 + y 8 = 0 y 2 y 3 + y 5 y 6 + y 8 = 0 y 2 y 3 y 4 + y 3 y 4 y 5 + y 4 y 5 y 6 + y 5 y 6 y 7 + y 6 y 7 y 8 + y 2 y 3 + y 7 y 8 + y 2 + y 8 = 0 y 2 y 3 y 4 y 5 + y 5 y 6 y 7 y 8 + y 2 y 8 = 0 y 2 y 3 y 4 y 5 y 6 + y 5 y 6 y 7 y 8 + y 2 y 3 y 8 = 0 y 2 y 3 y 4 y 5 y 6 y 7 + y 3 y 4 y 5 y 6 y 7 y 8 + y 2 y 3 y 4 y 5 y 6 + y 4 y 5 y 6 y 7 y 8 + y 2 y 3 y 4 y 5 + y 2 y 3 y 4 y 8 + y 2 y 3 y 7 y 8 + y 2 y 6 y 7 y 8 + y 5 y 6 y 7 y 8 = 0 y 3 y 4 y 6 y 7 + y 3 y 4 + y 6 y 7 = 0 y 4 y 7 + y 4 + y 7 = 0 y 2 y 3 y 4 y 5 y 6 y 7 y 8 1 = 0 A solution is y 2 = 1 2 3I 2, y 3 = I 2, y 4 = I 2, y 5 = 1, y 6 = 1 2 3I 2, y 7 = 1 2 3I 2, y 8 = I 2, where I = 1. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

30 an exact representation of a two dimensional set y 0 = t 1 x 0 = t 1 x 0 = y 0 x 1 = y 0 y 1 x 2 = y 2 0 y 1 1 y 2 x 3 = y 0 y 3 x 4 = y 0 y 1 y 4 x 5 = y 2 0 y 1 1 y 5 x 6 = y 0 y 6 x 7 = y 0 y 1 y 7 x 8 = y 2 0 y 1 1 y 8 y 1 = t 2 y 2 = 1 2 3I 2 y 3 = I 2 y 4 = I 2 y 5 = 1 y 6 = 1 2 3I 2 y 7 = 1 2 3I 2 y 8 = I 2 x 1 = t 1 t 2 x 2 = t 2 1 t 1 2 ( 1 2 3I 2 ) x 3 = t 1 ( I 2 ) x 4 = t 1 t 2 ( 1 3I ) x 5 = t 2 1 t 1 2 x 6 = t 1 ( 1 3I 2 2 ) x 7 = t 1 t 2 ( 1 2 3I 2 ) x 8 = t 2 1 t 1 2 ( I 2 ) Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

31 a tropical interpretation of Backelin s Lemma Denoting by u = e i2π/3 the primitive third root of unity, u 3 1 = 0: x 0 = t 0 x 1 = t 0 t 1 x 2 = t 2 0 t 1 1 u2 x 3 = t 0 u x 4 = t 0 t 1 u x 5 = t 2 0 t 1 1 x 6 = t 0 u 2 x 7 = t 0 t 1 u 2 x 8 = t 2 0 t 1 1 u. Introducing new variables y 0 = t 0, y 1 = t 0 t 1, and y 2 = t 2 0 t 1 1 u2 : x 0 = y 0 x 1 = y 1 x 2 = y 2 x 3 = y 0 u x 4 = y 1 u x 5 = y 2 u x 6 = y 0 u 2 x 7 = y 1 u 2 x 8 = y 2 u 2 which modulo y 3 0 y 3 1 y 3 2 u9 1 = 0 satisfies by plain substitution the cyclic 9-roots system, as in the proof of Backelin s Lemma, see J.C. Faugère. Finding all the solutions of Cyclic 9 using Gröbner basis techniques. In Computer Mathematics - Proceedings of the Fifth Asian Symposium (ASCM 2001), pages World Scientific, Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

32 degree computations For u 3 = 1, our representation of the solution set is x 0 = t 0 x 1 = t 0 t 1 x 2 = t 2 0 t 1 1 u2 x 3 = t 0 u x 4 = t 0 t 1 u x 5 = t 2 0 t 1 1 x 6 = t 0 u 2 x 7 = t 0 t 1 u 2 x 8 = t 2 0 t 1 1 u. We compute the degree of the surface using two random hyperplanes: { α1 t 0 +α 2 t 0 t 1 +α 3 t 2 0 t 1 1 = 0 α 4 t 0 +α 5 t 0 t 1 +α 6 t 2 0 t 1 1 = 0, α 1,α 2,...,α 6 C. Simplifying, the system becomes { t 2 0 t 1 1 β 1 = 0 t 1 β 2 = 0, β 1,β 2 C. There are 3 solutions, so we have a cubic surface of cyclic 9 roots. Applying symmetry, we find an orbit of 6 cubic surfaces. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

33 cyclic m 2 -roots Proposition For n = m 2, there is an (m 1)-dimensional set of cyclic n-roots, represented exactly as x km+0 = u k t 0 x km+1 = u k t 0 t 1 x km+2 = u k t 0 t 1 t 2 x km+m 2 x km+m 1. = u k t 0 t 1 t 2 t m 2 = u k t m+1 0 t m+2 1 t 2 m 3 t 1 m 2 for k = 0, 1, 2,...,m 1 and u k = e i2kπ/m. The degree of this solution set equals m. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

34 conclusion Promising results on the cyclic n-roots problem give a proof of concept for a new polyhedral method to compute algebraic sets. Papers available via jan: J. Verschelde. Polyhedral methods in numerical algebraic geometry. In Interactions of Classical and Numerical Algebraic Geometry, volume 496 of Contemporary Mathematics, pages AMS, D. Adrovic and J. Verschelde. Polyhedral methods for space curves exploiting symmetry. arxiv: v1. D. Adrovic and J. Verschelde. Computing Puiseux series for algebraic surfaces. Proceedings of ISSAC 2012, to appear. Version of PHCpack solves binomial systems with phc -b. Jan Verschelde (UIC) Newton polytopes, tropisms, Puiseux series SIAM DM / 34

Tropical Approach to the Cyclic n-roots Problem

Tropical Approach to the Cyclic n-roots Problem Tropical Approach to the Cyclic n-roots Problem Danko Adrovic and Jan Verschelde University of Illinois at Chicago www.math.uic.edu/~adrovic www.math.uic.edu/~jan 3 Joint Mathematics Meetings - AMS Session

More information

Polyhedral Methods for Positive Dimensional Solution Sets

Polyhedral Methods for Positive Dimensional Solution Sets Polyhedral Methods for Positive Dimensional Solution Sets Danko Adrovic and Jan Verschelde www.math.uic.edu/~adrovic www.math.uic.edu/~jan 17th International Conference on Applications of Computer Algebra

More information

Computing Puiseux Series for Algebraic Surfaces

Computing Puiseux Series for Algebraic Surfaces Computing Puiseux Series for Algebraic Surfaces Danko Adrovic and Jan Verschelde Department of Mathematics, Statistics, and Computer Science University of Illinois at Chicago 851 South Morgan (M/C 249)

More information

Computing Puiseux Series for Algebraic Surfaces

Computing Puiseux Series for Algebraic Surfaces Computing Puiseux Series for Algebraic Surfaces Danko Adrovic and Jan Verschelde Department of Mathematics, Statistics, and Computer Science University of Illinois at Chicago 851 South Morgan (M/C 249)

More information

Tropical Algebraic Geometry in Maple. Jan Verschelde in collaboration with Danko Adrovic

Tropical Algebraic Geometry in Maple. Jan Verschelde in collaboration with Danko Adrovic Tropical Algebraic Geometry in Maple Jan Verschelde in collaboration with Danko Adrovic University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science http://www.math.uic.edu/

More information

Certificates in Numerical Algebraic Geometry. Jan Verschelde

Certificates in Numerical Algebraic Geometry. Jan Verschelde Certificates in Numerical Algebraic Geometry Jan Verschelde University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science http://www.math.uic.edu/ jan jan@math.uic.edu FoCM

More information

A Polyhedral Method to compute all Affine Solution Sets of Sparse Polynomial Systems

A Polyhedral Method to compute all Affine Solution Sets of Sparse Polynomial Systems A Polyhedral Method to compute all Affine Solution Sets of Sparse Polynomial Systems Danko Adrovic and Jan Verschelde Department of Mathematics, Statistics, and Computer Science University of Illinois

More information

Toolboxes and Blackboxes for Solving Polynomial Systems. Jan Verschelde

Toolboxes and Blackboxes for Solving Polynomial Systems. Jan Verschelde Toolboxes and Blackboxes for Solving Polynomial Systems Jan Verschelde University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science http://www.math.uic.edu/ jan jan@math.uic.edu

More information

Tropical Algebraic Geometry 3

Tropical Algebraic Geometry 3 Tropical Algebraic Geometry 3 1 Monomial Maps solutions of binomial systems an illustrative example 2 The Balancing Condition balancing a polyhedral fan the structure theorem 3 The Fundamental Theorem

More information

A Blackbox Polynomial System Solver on Parallel Shared Memory Computers

A Blackbox Polynomial System Solver on Parallel Shared Memory Computers A Blackbox Polynomial System Solver on Parallel Shared Memory Computers Jan Verschelde University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science The 20th Workshop on

More information

Homotopy Methods for Solving Polynomial Systems tutorial at ISSAC 05, Beijing, China, 24 July 2005

Homotopy Methods for Solving Polynomial Systems tutorial at ISSAC 05, Beijing, China, 24 July 2005 Homotopy Methods for Solving Polynomial Systems tutorial at ISSAC 05, Beijing, China, 24 July 2005 Jan Verschelde draft of March 15, 2007 Abstract Homotopy continuation methods provide symbolic-numeric

More information

Tropical Algebraic Geometry

Tropical Algebraic Geometry Tropical Algebraic Geometry 1 Amoebas an asymptotic view on varieties tropicalization of a polynomial 2 The Max-Plus Algebra at Work making time tables for a railway network 3 Polyhedral Methods for Algebraic

More information

Tropical Varieties. Jan Verschelde

Tropical Varieties. Jan Verschelde Tropical Varieties Jan Verschelde University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science http://www.math.uic.edu/ jan jan@math.uic.edu Graduate Computational Algebraic

More information

The Method of Gauss-Newton to Compute Power Series Solutions of Polynomial Homotopies

The Method of Gauss-Newton to Compute Power Series Solutions of Polynomial Homotopies The Method of Gauss-Newton to Compute Power Series Solutions of Polynomial Homotopies Nathan Bliss Jan Verschelde University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science

More information

Numerical Computations in Algebraic Geometry. Jan Verschelde

Numerical Computations in Algebraic Geometry. Jan Verschelde Numerical Computations in Algebraic Geometry Jan Verschelde University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science http://www.math.uic.edu/ jan jan@math.uic.edu AMS

More information

Solving Schubert Problems with Littlewood-Richardson Homotopies

Solving Schubert Problems with Littlewood-Richardson Homotopies Solving Schubert Problems with Littlewood-Richardson Homotopies Jan Verschelde joint work with Frank Sottile and Ravi Vakil University of Illinois at Chicago Department of Mathematics, Statistics, and

More information

Tropical Islands. Jan Verschelde

Tropical Islands. Jan Verschelde Tropical Islands Jan Verschelde University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science http://www.math.uic.edu/ jan jan@math.uic.edu Graduate Computational Algebraic

More information

Algorithmic Aspects of Gröbner Fans and Tropical Varieties

Algorithmic Aspects of Gröbner Fans and Tropical Varieties Algorithmic Aspects of Gröbner Fans and Tropical Varieties Anders Nedergaard Jensen Ph.D. Dissertation July 2007 Department of Mathematical Sciences Faculty of Science, University of Aarhus 2 Abstract

More information

Computing Series Expansions of Algebraic Space Curves

Computing Series Expansions of Algebraic Space Curves Computing Series Expansions of Algebraic Space Curves by Nathan Bliss B.S. (Wheaton College) 2012 M.S. (University of Illinois at Chicago) 2014 Thesis submitted in partial fulfillment of the requirements

More information

Discriminants, resultants, and their tropicalization

Discriminants, resultants, and their tropicalization Discriminants, resultants, and their tropicalization Course by Bernd Sturmfels - Notes by Silvia Adduci 2006 Contents 1 Introduction 3 2 Newton polytopes and tropical varieties 3 2.1 Polytopes.................................

More information

Tropical Geometry Homework 3

Tropical Geometry Homework 3 Tropical Geometry Homework 3 Melody Chan University of California, Berkeley mtchan@math.berkeley.edu February 9, 2009 The paper arxiv:07083847 by M. Vigeland answers this question. In Theorem 7., the author

More information

Tropical Elliptic Curves and their j-invariant

Tropical Elliptic Curves and their j-invariant and their j-invariant (joint work with Eric Katz and Hannah Markwig) Elliptic Tropical Thomas Markwig Technische Universität Kaiserslautern 15th February, 2008 Elliptic Tropical The tropical j-invariant

More information

A Blackbox Polynomial System Solver on Parallel Shared Memory Computers

A Blackbox Polynomial System Solver on Parallel Shared Memory Computers A Blackbox Polynomial System Solver on Parallel Shared Memory Computers Jan Verschelde University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science 851 S. Morgan Street

More information

Solving Polynomial Systems in the Cloud with Polynomial Homotopy Continuation

Solving Polynomial Systems in the Cloud with Polynomial Homotopy Continuation Solving Polynomial Systems in the Cloud with Polynomial Homotopy Continuation Jan Verschelde joint with Nathan Bliss, Jeff Sommars, and Xiangcheng Yu University of Illinois at Chicago Department of Mathematics,

More information

Parallel Polynomial Evaluation

Parallel Polynomial Evaluation Parallel Polynomial Evaluation Jan Verschelde joint work with Genady Yoffe University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science http://www.math.uic.edu/ jan jan@math.uic.edu

More information

MCS 563 Spring 2014 Analytic Symbolic Computation Monday 14 April. Binomial Ideals

MCS 563 Spring 2014 Analytic Symbolic Computation Monday 14 April. Binomial Ideals Binomial Ideals Binomial ideals offer an interesting class of examples. Because they occur so frequently in various applications, the development methods for binomial ideals is justified. 1 Binomial Ideals

More information

Finiteness of spatial central configurations in the five-body problem

Finiteness of spatial central configurations in the five-body problem Celestial Mechanics and Dynamical Astronomy manuscript No. (will be inserted by the editor) Finiteness of spatial central configurations in the five-body problem Marshall Hampton Anders Jensen the date

More information

An introduction to tropical geometry

An introduction to tropical geometry An introduction to tropical geometry Jan Draisma RWTH Aachen, 8 April 2011 Part I: what you must know Tropical numbers R := R { } the tropical semi-ring a b := min{a, b} a b := a + b b = b 0 b = b b =

More information

THE BKK ROOT COUNT IN C n. c e x e,

THE BKK ROOT COUNT IN C n. c e x e, MATHEMATICS OF COMPUTATION Volume 65, Number 216 October 1996, Pages 1477 1484 THE BKK ROOT COUNT IN C n T Y LI AND XIAOSHEN WANG Abstract The root count developed by Bernshtein, Kushnirenko and Khovanskii

More information

Numerical Algebraic Geometry and Symbolic Computation

Numerical Algebraic Geometry and Symbolic Computation Numerical Algebraic Geometry and Symbolic Computation Jan Verschelde Department of Math, Stat & CS University of Illinois at Chicago Chicago, IL 60607-7045, USA jan@math.uic.edu www.math.uic.edu/~jan ISSAC

More information

arxiv:math/ v1 [math.ag] 27 Jul 2005

arxiv:math/ v1 [math.ag] 27 Jul 2005 COMPUTING TROPICAL VARIETIES arxiv:math/0507563v1 [math.ag] 27 Jul 2005 T. BOGART, A. JENSEN, D. SPEYER, B. STURMFELS, R. THOMAS Abstract. The tropical variety of a d-dimensional prime ideal in a polynomial

More information

AN INTRODUCTION TO TROPICAL GEOMETRY

AN INTRODUCTION TO TROPICAL GEOMETRY AN INTRODUCTION TO TROPICAL GEOMETRY JAN DRAISMA Date: July 2011. 1 2 JAN DRAISMA Tropical numbers. 1. Tropical numbers and valuations R := R { } tropical numbers, equipped with two operations: tropical

More information

From the Zonotope Construction to the Minkowski Addition of Convex Polytopes

From the Zonotope Construction to the Minkowski Addition of Convex Polytopes From the Zonotope Construction to the Minkowski Addition of Convex Polytopes Komei Fukuda School of Computer Science, McGill University, Montreal, Canada Abstract A zonotope is the Minkowski addition of

More information

MCS 563 Spring 2014 Analytic Symbolic Computation Friday 31 January. Quotient Rings

MCS 563 Spring 2014 Analytic Symbolic Computation Friday 31 January. Quotient Rings Quotient Rings In this note we consider again ideals, but here we do not start from polynomials, but from a finite set of points. The application in statistics and the pseudo code of the Buchberger-Möller

More information

AN INTRODUCTION TO AFFINE TORIC VARIETIES: EMBEDDINGS AND IDEALS

AN INTRODUCTION TO AFFINE TORIC VARIETIES: EMBEDDINGS AND IDEALS AN INTRODUCTION TO AFFINE TORIC VARIETIES: EMBEDDINGS AND IDEALS JESSICA SIDMAN. Affine toric varieties: from lattice points to monomial mappings In this chapter we introduce toric varieties embedded in

More information

Quality Up in Polynomial Homotopy Continuation

Quality Up in Polynomial Homotopy Continuation Quality Up in Polynomial Homotopy Continuation Jan Verschelde joint work with Genady Yoffe University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science http://www.math.uic.edu/

More information

Heterogenous Parallel Computing with Ada Tasking

Heterogenous Parallel Computing with Ada Tasking Heterogenous Parallel Computing with Ada Tasking Jan Verschelde University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science http://www.math.uic.edu/ jan jan@math.uic.edu

More information

Solving Algebraic Equations in Terms of A-Hypergeometric Series. Bernd Sturmfels. Department of Mathematics. University of California

Solving Algebraic Equations in Terms of A-Hypergeometric Series. Bernd Sturmfels. Department of Mathematics. University of California Solving Algebraic Equations in Terms of A-Hypergeometric Series Bernd Sturmfels Department of Mathematics University of California Berkeley, CA 9472, U.S.A. bernd@math.berkeley.edu Abstract The roots of

More information

Gröbner Complexes and Tropical Bases

Gröbner Complexes and Tropical Bases Gröbner Complexes and Tropical Bases Jan Verschelde University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science http://www.math.uic.edu/ jan jan@math.uic.edu Graduate

More information

Problems on Minkowski sums of convex lattice polytopes

Problems on Minkowski sums of convex lattice polytopes arxiv:08121418v1 [mathag] 8 Dec 2008 Problems on Minkowski sums of convex lattice polytopes Tadao Oda odatadao@mathtohokuacjp Abstract submitted at the Oberwolfach Conference Combinatorial Convexity and

More information

T (I) = { (1, 0, 0), (0, 1, 0), ( 1 1

T (I) = { (1, 0, 0), (0, 1, 0), ( 1 1 3. Computing Tropical Varieties Given any polynomial f C[x] = C[x 1,..., x n ] and a vector w R n, the initial form in w (f) is the sum of all terms in f of lowest w-weight. For instance, if l = x 1 +

More information

ON THE RANK OF A TROPICAL MATRIX

ON THE RANK OF A TROPICAL MATRIX ON THE RANK OF A TROPICAL MATRIX MIKE DEVELIN, FRANCISCO SANTOS, AND BERND STURMFELS Abstract. This is a foundational paper in tropical linear algebra, which is linear algebra over the min-plus semiring.

More information

Dyck path triangulations and extendability

Dyck path triangulations and extendability Dyck path triangulations and extendability [extended abstract] Cesar Ceballos 1,2 Arnau Padrol 3 Camilo Sarmiento 4 1 York University 2 Fields Institute 3 Freie Universität Berlin 4 Otto-von-Guericke-Universität

More information

Polytopes and Algebraic Geometry. Jesús A. De Loera University of California, Davis

Polytopes and Algebraic Geometry. Jesús A. De Loera University of California, Davis Polytopes and Algebraic Geometry Jesús A. De Loera University of California, Davis Outline of the talk 1. Four classic results relating polytopes and algebraic geometry: (A) Toric Geometry (B) Viro s Theorem

More information

Commuting birth-and-death processes

Commuting birth-and-death processes Commuting birth-and-death processes Caroline Uhler Department of Statistics UC Berkeley (joint work with Steven N. Evans and Bernd Sturmfels) MSRI Workshop on Algebraic Statistics December 18, 2008 Birth-and-death

More information

Introduction to Computational Algebraic Geometry. Jan Verschelde

Introduction to Computational Algebraic Geometry. Jan Verschelde Introduction to Computational Algebraic Geometry Jan Verschelde University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science http://www.math.uic.edu/ jan jan@math.uic.edu

More information

TRISTRAM BOGART AND REKHA R. THOMAS

TRISTRAM BOGART AND REKHA R. THOMAS SMALL CHVÁTAL RANK TRISTRAM BOGART AND REKHA R. THOMAS Abstract. We introduce a new measure of complexity of integer hulls of rational polyhedra called the small Chvátal rank (SCR). The SCR of an integer

More information

Tropical Algebra. Notes by Bernd Sturmfels for the lecture on May 22, 2018, in the IMPRS Ringvorlesung Introduction to Nonlinear Algebra

Tropical Algebra. Notes by Bernd Sturmfels for the lecture on May 22, 2018, in the IMPRS Ringvorlesung Introduction to Nonlinear Algebra Tropical Algebra Notes by Bernd Sturmfels for the lecture on May 22, 2018, in the IMPRS Ringvorlesung Introduction to Nonlinear Algebra The tropical semiring (R { },, ) consists of the real numbers R,

More information

5. Grassmannians and the Space of Trees In this lecture we shall be interested in a very particular ideal. The ambient polynomial ring C[p] has ( n

5. Grassmannians and the Space of Trees In this lecture we shall be interested in a very particular ideal. The ambient polynomial ring C[p] has ( n 5. Grassmannians and the Space of Trees In this lecture we shall be interested in a very particular ideal. The ambient polynomial ring C[p] has ( n d) variables, which are called Plücker coordinates: C[p]

More information

Numerical Irreducible Decomposition

Numerical Irreducible Decomposition Numerical Irreducible Decomposition Jan Verschelde Department of Math, Stat & CS University of Illinois at Chicago Chicago, IL 60607-7045, USA e-mail: jan@math.uic.edu web: www.math.uic.edu/ jan CIMPA

More information

Hilbert Polynomials. dimension and counting monomials. a Gröbner basis for I reduces to in > (I)

Hilbert Polynomials. dimension and counting monomials. a Gröbner basis for I reduces to in > (I) Hilbert Polynomials 1 Monomial Ideals dimension and counting monomials 2 The Dimension of a Variety a Gröbner basis for I reduces to in > (I) 3 The Complexity of Gröbner Bases a bound on the degrees of

More information

The generic Gröbner walk

The generic Gröbner walk The generic Gröbner walk K. Fukuda, A. N. Jensen, N. Lauritzen, R. Thomas arxiv:math/0501345v1 [math.ac] 21 Jan 2005 February 28, 2008 Abstract The Gröbner walk is an algorithm for conversion between Gröbner

More information

FINITENESS OF RELATIVE EQUILIBRIA OF THE FOUR-BODY PROBLEM

FINITENESS OF RELATIVE EQUILIBRIA OF THE FOUR-BODY PROBLEM FINITENESS OF RELATIVE EQUILIBRIA OF THE FOUR-BODY PROBLEM MARSHALL HAMPTON AND RICHARD MOECKEL Abstract. We show that the number of relative equilibria of the Newtonian four-body problem is finite, up

More information

Multitasking Polynomial Homotopy Continuation in PHCpack. Jan Verschelde

Multitasking Polynomial Homotopy Continuation in PHCpack. Jan Verschelde Multitasking Polynomial Homotopy Continuation in PHCpack Jan Verschelde University of Illinois at Chicago Department of Mathematics, Statistics, and Computer Science http://www.math.uic.edu/ jan jan@math.uic.edu

More information

GRE Subject test preparation Spring 2016 Topic: Abstract Algebra, Linear Algebra, Number Theory.

GRE Subject test preparation Spring 2016 Topic: Abstract Algebra, Linear Algebra, Number Theory. GRE Subject test preparation Spring 2016 Topic: Abstract Algebra, Linear Algebra, Number Theory. Linear Algebra Standard matrix manipulation to compute the kernel, intersection of subspaces, column spaces,

More information

GALE DUALITY FOR COMPLETE INTERSECTIONS

GALE DUALITY FOR COMPLETE INTERSECTIONS GALE DUALITY FOR COMPLETE INTERSECTIONS Abstract. We show that every complete intersection defined by Laurent polynomials in an algebraic torus is isomorphic to a complete intersection defined by master

More information

arxiv:math.co/ v1 16 Jul 2006

arxiv:math.co/ v1 16 Jul 2006 THE NEWTON POLYTOPE OF THE IMPLICIT EQUATION BERND STURMFELS, JENIA TEVELEV, AND JOSEPHINE YU arxiv:math.co/0607368 v1 16 Jul 2006 Dedicated to Askold Khovanskii on the occasion of his 60th birthday Abstract.

More information

GPU acceleration of Newton s method for large systems of polynomial equations in double double and quad double arithmetic

GPU acceleration of Newton s method for large systems of polynomial equations in double double and quad double arithmetic GPU acceleration of Newton s method for large systems of polynomial equations in double double and quad double arithmetic Jan Verschelde joint work with Xiangcheng Yu University of Illinois at Chicago

More information

Rational Univariate Representation

Rational Univariate Representation Rational Univariate Representation 1 Stickelberger s Theorem a rational univariate representation (RUR) 2 The Elbow Manipulator a spatial robot arm with three links 3 Application of the Newton Identities

More information

MATHEMATICAL ENGINEERING TECHNICAL REPORTS. Markov Bases for Two-way Subtable Sum Problems

MATHEMATICAL ENGINEERING TECHNICAL REPORTS. Markov Bases for Two-way Subtable Sum Problems MATHEMATICAL ENGINEERING TECHNICAL REPORTS Markov Bases for Two-way Subtable Sum Problems Hisayuki HARA, Akimichi TAKEMURA and Ruriko YOSHIDA METR 27 49 August 27 DEPARTMENT OF MATHEMATICAL INFORMATICS

More information

THE NEWTON POLYTOPE OF THE IMPLICIT EQUATION

THE NEWTON POLYTOPE OF THE IMPLICIT EQUATION MOSCOW MATHEMATICAL JOURNAL Volume 7, Number 2, April June 2007, Pages 327 346 THE NEWTON POLYTOPE OF THE IMPLICIT EQUATION BERND STURMFELS, JENIA TEVELEV, AND JOSEPHINE YU Dedicated to Askold Khovanskii

More information

Toric statistical models: parametric and binomial representations

Toric statistical models: parametric and binomial representations AISM (2007) 59:727 740 DOI 10.1007/s10463-006-0079-z Toric statistical models: parametric and binomial representations Fabio Rapallo Received: 21 February 2005 / Revised: 1 June 2006 / Published online:

More information

arxiv:math/ v2 [math.ag] 17 May 2005

arxiv:math/ v2 [math.ag] 17 May 2005 arxiv:math/0502344v2 [math.ag] 17 May 2005 SECANT VARIETIES OF TORIC VARIETIES DAVID COX AND JESSICA SIDMAN Abstract. If X is a smooth projective toric variety of dimension n we give explicit conditions

More information

The universal Gröbner basis of a binomial edge ideal

The universal Gröbner basis of a binomial edge ideal The universal Gröbner basis of a binomial edge ideal Mourtadha Badiane Isaac Burke Emil Sköldberg National University of Ireland, Galway Galway, Ireland {m.badiane1,i.burke1,emil.skoldberg}@nuigalway.ie

More information

Lecture I: Introduction to Tropical Geometry David Speyer

Lecture I: Introduction to Tropical Geometry David Speyer Lecture I: Introduction to Tropical Geometry David Speyer The field of Puiseux series C[[t]] is the ring of formal power series a 0 + a 1 t + and C((t)) is the field of formal Laurent series: a N t N +

More information

MCS 563 Spring 2014 Analytic Symbolic Computation Monday 27 January. Gröbner bases

MCS 563 Spring 2014 Analytic Symbolic Computation Monday 27 January. Gröbner bases Gröbner bases In this lecture we introduce Buchberger s algorithm to compute a Gröbner basis for an ideal, following [2]. We sketch an application in filter design. Showing the termination of Buchberger

More information

The moduli space of binary quintics

The moduli space of binary quintics The moduli space of binary quintics A.A.du Plessis and C.T.C.Wall November 10, 2005 1 Invariant theory From classical invariant theory (we refer to the version in [2]), we find that the ring of (SL 2 )invariants

More information

Solving the 100 Swiss Francs Problem

Solving the 100 Swiss Francs Problem Solving the 00 Swiss Francs Problem Mingfu Zhu, Guangran Jiang and Shuhong Gao Abstract. Sturmfels offered 00 Swiss Francs in 00 to a conjecture, which deals with a special case of the maximum likelihood

More information

Roots of a Polynomial System

Roots of a Polynomial System Roots of a Polynomial System (Com S 477/577 Notes) Yan-Bin Jia Sep 8, 017 Systems of polynomial equations show up in many applications areas such as robotics (kinematics, motion planning, collision detection,

More information

AN INTRODUCTION TO TORIC SURFACES

AN INTRODUCTION TO TORIC SURFACES AN INTRODUCTION TO TORIC SURFACES JESSICA SIDMAN 1. An introduction to affine varieties To motivate what is to come we revisit a familiar example from high school algebra from a point of view that allows

More information

TORIC WEAK FANO VARIETIES ASSOCIATED TO BUILDING SETS

TORIC WEAK FANO VARIETIES ASSOCIATED TO BUILDING SETS TORIC WEAK FANO VARIETIES ASSOCIATED TO BUILDING SETS YUSUKE SUYAMA Abstract. We give a necessary and sufficient condition for the nonsingular projective toric variety associated to a building set to be

More information

HILBERT BASIS OF THE LIPMAN SEMIGROUP

HILBERT BASIS OF THE LIPMAN SEMIGROUP Available at: http://publications.ictp.it IC/2010/061 United Nations Educational, Scientific and Cultural Organization and International Atomic Energy Agency THE ABDUS SALAM INTERNATIONAL CENTRE FOR THEORETICAL

More information

The F 4 Algorithm. Dylan Peifer. 9 May Cornell University

The F 4 Algorithm. Dylan Peifer. 9 May Cornell University The F 4 Algorithm Dylan Peifer Cornell University 9 May 2017 Gröbner Bases History Gröbner bases were introduced in 1965 in the PhD thesis of Bruno Buchberger under Wolfgang Gröbner. Buchberger s algorithm

More information

INTRODUCTION TO TROPICAL ALGEBRAIC GEOMETRY

INTRODUCTION TO TROPICAL ALGEBRAIC GEOMETRY INTRODUCTION TO TROPICAL ALGEBRAIC GEOMETRY DIANE MACLAGAN These notes are the lecture notes from my lectures on tropical geometry at the ELGA 2011 school on Algebraic Geometry and Applications in Buenos

More information

Geometry of Phylogenetic Inference

Geometry of Phylogenetic Inference Geometry of Phylogenetic Inference Matilde Marcolli CS101: Mathematical and Computational Linguistics Winter 2015 References N. Eriksson, K. Ranestad, B. Sturmfels, S. Sullivant, Phylogenetic algebraic

More information

Monomial transformations of the projective space

Monomial transformations of the projective space Monomial transformations of the projective space Olivier Debarre and Bodo Lass Abstract We prove that, over any field, the dimension of the indeterminacy locus of a rational map f : P n P n defined by

More information

Gröbner Bases. eliminating the leading term Buchberger s criterion and algorithm. construct wavelet filters

Gröbner Bases. eliminating the leading term Buchberger s criterion and algorithm. construct wavelet filters Gröbner Bases 1 S-polynomials eliminating the leading term Buchberger s criterion and algorithm 2 Wavelet Design construct wavelet filters 3 Proof of the Buchberger Criterion two lemmas proof of the Buchberger

More information

Linear algebra I Homework #1 due Thursday, Oct Show that the diagonals of a square are orthogonal to one another.

Linear algebra I Homework #1 due Thursday, Oct Show that the diagonals of a square are orthogonal to one another. Homework # due Thursday, Oct. 0. Show that the diagonals of a square are orthogonal to one another. Hint: Place the vertices of the square along the axes and then introduce coordinates. 2. Find the equation

More information

Toric ideals finitely generated up to symmetry

Toric ideals finitely generated up to symmetry Toric ideals finitely generated up to symmetry Anton Leykin Georgia Tech MOCCA, Levico Terme, September 2014 based on [arxiv:1306.0828] Noetherianity for infinite-dimensional toric varieties (with Jan

More information

Black Box Linear Algebra with the LinBox Library. William J. Turner North Carolina State University wjturner

Black Box Linear Algebra with the LinBox Library. William J. Turner North Carolina State University   wjturner Black Box Linear Algebra with the LinBox Library William J. Turner North Carolina State University www.math.ncsu.edu/ wjturner Overview 1. Black Box Linear Algebra 2. Project LinBox 3. LinBox Objects 4.

More information

Toric Varieties. Madeline Brandt. April 26, 2017

Toric Varieties. Madeline Brandt. April 26, 2017 Toric Varieties Madeline Brandt April 26, 2017 Last week we saw that we can define normal toric varieties from the data of a fan in a lattice. Today I will review this idea, and also explain how they can

More information

The Closedness Subspace Method for Computing the Multiplicity Structure of a Polynomial System

The Closedness Subspace Method for Computing the Multiplicity Structure of a Polynomial System . The Closedness Subspace Method for Computing the Multiplicity Structure of a Polynomial System ZHONGGANG ZENG Abstract. The multiplicity structure of a polynomial system at an isolated zero is identified

More information

A PROOF OF SAARI S CONJECTURE FOR THE THREE-BODY PROBLEM IN R d

A PROOF OF SAARI S CONJECTURE FOR THE THREE-BODY PROBLEM IN R d A PROOF OF SAARI S CONJECTURE FOR THE THREE-BODY PROBLEM IN R d RICHARD MOECKEL Abstract. The well-known central configurations of the three-body problem give rise to periodic solutions where the bodies

More information

Exact Arithmetic on a Computer

Exact Arithmetic on a Computer Exact Arithmetic on a Computer Symbolic Computation and Computer Algebra William J. Turner Department of Mathematics & Computer Science Wabash College Crawfordsville, IN 47933 Tuesday 21 September 2010

More information

Algebra II Vocabulary Alphabetical Listing. Absolute Maximum: The highest point over the entire domain of a function or relation.

Algebra II Vocabulary Alphabetical Listing. Absolute Maximum: The highest point over the entire domain of a function or relation. Algebra II Vocabulary Alphabetical Listing Absolute Maximum: The highest point over the entire domain of a function or relation. Absolute Minimum: The lowest point over the entire domain of a function

More information

Factoring Solution Sets of Polynomial Systems in Parallel

Factoring Solution Sets of Polynomial Systems in Parallel Factoring Solution Sets of Polynomial Systems in Parallel Jan Verschelde Department of Math, Stat & CS University of Illinois at Chicago Chicago, IL 60607-7045, USA Email: jan@math.uic.edu URL: http://www.math.uic.edu/~jan

More information

Groebner Bases, Toric Ideals and Integer Programming: An Application to Economics. Tan Tran Junior Major-Economics& Mathematics

Groebner Bases, Toric Ideals and Integer Programming: An Application to Economics. Tan Tran Junior Major-Economics& Mathematics Groebner Bases, Toric Ideals and Integer Programming: An Application to Economics Tan Tran Junior Major-Economics& Mathematics History Groebner bases were developed by Buchberger in 1965, who later named

More information

The generic Gröbner walk

The generic Gröbner walk The generic Gröbner walk K. Fukuda, A. N. Jensen, N. Lauritzen, R. Thomas May 23, 2006 arxiv:math.ac/0501345 v3 13 Oct 2005 Abstract The Gröbner walk is an algorithm for conversion between Gröbner bases

More information

Toric Varieties in Coding Theory. Math in the Mountains Tutorial

Toric Varieties in Coding Theory. Math in the Mountains Tutorial Toric Varieties in Error-Control Coding Theory Math in the Mountains Tutorial Department of Mathematics and Computer Science College of the Holy Cross July 29-31, 2013 A bit of history Beginning of coding

More information

Combinatorics and geometry of E 7

Combinatorics and geometry of E 7 Combinatorics and geometry of E 7 Steven Sam University of California, Berkeley September 19, 2012 1/24 Outline Macdonald representations Vinberg representations Root system Weyl group 7 points in P 2

More information

BOUNDS ON THE NUMBER OF REAL SOLUTIONS TO POLYNOMIAL EQUATIONS

BOUNDS ON THE NUMBER OF REAL SOLUTIONS TO POLYNOMIAL EQUATIONS 2 October 2007 arxiv:0706.375 BOUNDS ON THE NUMBER OF REAL SOLUTIONS TO POLYNOMIAL EQUATIONS DANIEL J. BATES, FRÉDÉRIC BIHAN, AND FRANK SOTTILE Abstract. We use Gale duality for complete intersections

More information

Computing toric degenerations of flag varieties

Computing toric degenerations of flag varieties Computing toric degenerations of flag varieties Sara Lamboglia University of Warwick with Lara Bossinger, Kalina Mincheva and Fatemeh Mohammadi (arxiv 1702.05505 ) Compute Gröbner toric degenerations of

More information

Black Box Linear Algebra with the LinBox Library. William J. Turner North Carolina State University wjturner

Black Box Linear Algebra with the LinBox Library. William J. Turner North Carolina State University   wjturner Black Box Linear Algebra with the LinBox Library William J. Turner North Carolina State University www.math.ncsu.edu/ wjturner Overview 1. Black Box Linear Algebra 2. Project LinBox 3. LinBox Objects 4.

More information

Normal Fans of Polyhedral Convex Sets

Normal Fans of Polyhedral Convex Sets Set-Valued Analysis manuscript No. (will be inserted by the editor) Normal Fans of Polyhedral Convex Sets Structures and Connections Shu Lu Stephen M. Robinson Received: date / Accepted: date Dedicated

More information

Monomial Bases and Polynomial System Solving. (Extended Abstract) question is the construction of an explicit monomial

Monomial Bases and Polynomial System Solving. (Extended Abstract) question is the construction of an explicit monomial Monomial Bases and Polynomial System Solving (Extended Abstract) Ioannis Z Emiris Ashutosh Rege Abstract This paper addresses the problem of ecient construction of monomial bases for the coordinate rings

More information

Explicit Deformation of Lattice Ideals via Chip Firing Games on Directed Graphs

Explicit Deformation of Lattice Ideals via Chip Firing Games on Directed Graphs Explicit Deformation of Lattice Ideals via Chip Firing Games on Directed Graphs arxiv:40.3268v [math.co] 4 Jan 204 Spencer Backman and Madhusudan Manjunath For a finite index sublattice L of the root lattice

More information

TORIC REDUCTION AND TROPICAL GEOMETRY A.

TORIC REDUCTION AND TROPICAL GEOMETRY A. Mathematisches Institut, Seminars, (Y. Tschinkel, ed.), p. 109 115 Universität Göttingen, 2004-05 TORIC REDUCTION AND TROPICAL GEOMETRY A. Szenes ME Institute of Mathematics, Geometry Department, Egry

More information

Toric Ideals, an Introduction

Toric Ideals, an Introduction The 20th National School on Algebra: DISCRETE INVARIANTS IN COMMUTATIVE ALGEBRA AND IN ALGEBRAIC GEOMETRY Mangalia, Romania, September 2-8, 2012 Hara Charalambous Department of Mathematics Aristotle University

More information

LIFTING TROPICAL INTERSECTIONS

LIFTING TROPICAL INTERSECTIONS LIFTING TROPICAL INTERSECTIONS BRIAN OSSERMAN AND SAM PAYNE Abstract. We show that points in the intersection of the tropicalizations of subvarieties of a torus lift to algebraic intersection points with

More information

A Field Extension as a Vector Space

A Field Extension as a Vector Space Chapter 8 A Field Extension as a Vector Space In this chapter, we take a closer look at a finite extension from the point of view that is a vector space over. It is clear, for instance, that any is a linear

More information