Sage for Dynamical Systems

Size: px
Start display at page:

Download "Sage for Dynamical Systems"

Transcription

1 for Dynamical Systems Benjamin Hutz Department of Mathematics and Computer Science Saint Louis University December 5, 2015 RTG Workshop: Arithmetic Dynamics This work is supported by NSF grant DMS Benjamin Hutz for Dynamical Systems 1 / 48

2 What is? Math is a free open-source mathematics software system licensed under the GPL. It builds on top of many existing open-source packages: NumPy, SciPy, matplotlib, Sympy, Maxima, GAP, FLINT, R and many more. Access their combined power through a common, Python-based language or directly via interfaces or wrappers. Mission Creating a viable free open source alternative to Magma, Maple, Mathematica and Matlab. Benjamin Hutz for Dynamical Systems 2 / 48

3 How can you use Online Locally Download from Prebuilt binaries Install from source code Benjamin Hutz for Dynamical Systems 3 / 48

4 Dynamical Systems and -dynamics project 1 Started at ICERM in days 55 in NSF grant DMS , (PI: Hutz) 4 Future -days?2017/2018? Resources Project Page: dynamics/arithmeticandcomplex Google group: sage-dynamics Benjamin Hutz for Dynamical Systems 4 / 48

5 Basic Functionality 1 Projective space, affine space, and subschemes (varieties) 2 Points and functions 3 Iteration 4 Heights and canonical heights 5 Periodic points, dynatomic polynomials 6 Critical points Benjamin Hutz for Dynamical Systems 5 / 48

6 Basic Examples: Iteration 1 sage: A.<x> = AffineSpace(QQ,1) 2 sage: f = DynamicalSystem_affine([xˆ2-1], domain=a) 3 sage: P=A(2) 4 sage: f(p), f(f(p)), f(f(f(p))), f.nth_iterate(p,4) 5 ((3), (8), (63), (3968)) 6 sage: f.orbit(p,[0,3]) 7 [(2), (3), (8), (63)] 8 sage: f.nth_iterate_map(2) 9 Scheme endomorphism of Affine Space of dimension 1 over Rational Field 10 Defn: Defined on coordinates by sending (x) to 11 (xˆ4-2*xˆ2) Benjamin Hutz for Dynamical Systems 6 / 48

7 Basic Examples: Varieties 1 sage: A.<x,y> = AffineSpace(QQ,2) 2 sage: X = A.subscheme([x-1, yˆ2-4]); 3 sage: X.dimension() sage: X.rational_points() 6 [(1, -2), (1, 2)] 7 sage: X.defining_ideal() 8 Ideal (x - 1, yˆ2-4) of Multivariate Polynomial Ring in x, y over Rational Field 9 sage: X.coordinate_ring() 10 Quotient of Multivariate Polynomial Ring in x, y over Rational Field by the ideal (x - 1, yˆ2-4) Benjamin Hutz for Dynamical Systems 7 / 48

8 Height definitions Given a point P = (P 0 : : P N ) The (absolute) global height is defined as h(p) = 1 [K : Q] log(max( P i )) The local height (Green s function) at a place v is defined as λ v (P) = log(max( P i v )) The canonical height with respect to a morphism f is defined as h(f n (P)) ĥ(p) = lim n deg(f ) n. Benjamin Hutz for Dynamical Systems 8 / 48

9 Basic Examples: Heights 1 sage: P.<x,y> = ProjectiveSpace(QQ,1) 2 sage: f = DynamicalSystem([4*xˆ2-3*yˆ2,4*yˆ2], domain=p) 3 sage: Q = P(3,5) 4 sage: f.green_function(q,2, prec=100, N=20) sage: Q.global_height() sage: Q.canonical_height(f,error_bound=0.001) Benjamin Hutz for Dynamical Systems 9 / 48

10 Basic Examples: Local Heights 1 sage: K.<w> = QuadraticField(3) 2 sage: P.<x,y> = ProjectiveSpace(K,1) 3 sage: f = DynamicalSystem([17*xˆ2+1/7*yˆ2,17*w*x*y], domain=p) 4 sage: f.green_function(p([2,1]), K.ideal(7), N=7) sage: f.green_function(p([w,1]), K.ideal(17), error_bound=0.001) Benjamin Hutz for Dynamical Systems 10 / 48

11 Definitions: Dynatomic Polynomial Let f K [z] be a single variable polynomial. Definition The n-th dynatomic polynomial for f is defined as Φ n(f ) = d n(f d (z) z) µ(n/d). Definition We can also define a generalized dynatomic polynomial for preperiodic points as Φ m,n(f ) = Φ n(f m ) Φ n(f m 1 ). More general definitions can be made using intersection theory. Benjamin Hutz for Dynamical Systems 11 / 48

12 Basic Examples: Dynatomic Polynomial 1 sage: R.<c> = FunctionField(QQ) 2 sage: P.<x,y> = ProjectiveSpace(R,1) 3 sage: f = DynamicalSystem([xˆ2+c*yˆ2,yˆ2], domain=p ) 4 sage: f.dynatomic_polynomial(3) 5 xˆ6 + xˆ5*y + (3*c + 1)*xˆ4*yˆ2 + (2*c + 1)*xˆ3*yˆ3 + (3*cˆ2 + 3*c + 1)*xˆ2*yˆ4 + (cˆ2 + 2*c + 1)* x*yˆ5 + (cˆ3 + 2*cˆ2 + c + 1)*yˆ6 6 sage: f.dynatomic_polynomial(3).subs({x:0,y:1}) 7 cˆ3 + 2*cˆ2 + c sage: f.nth_iterate(p(0),3) 9 (cˆ4 + 2*cˆ3 + cˆ2 + c : 1) Benjamin Hutz for Dynamical Systems 12 / 48

13 Basic Examples: Number Fields 1 sage: A.<z> = AffineSpace(QQ,1) 2 sage: f = DynamicalSystem([zˆ2+1], domain=a) 3 sage: R = A.coordinate_ring() 4 sage: K.<w> = NumberField(f.dynatomic_polynomial(2).polynomial(R.gen(0))) 5 sage: A.<z> = AffineSpace(K,1) 6 sage: f = DynamicalSystem_affine([zˆ2+1]) 7 sage: f.orbit(a(w),3) 8 [(w), (-w - 1), (w), (-w - 1)] Benjamin Hutz for Dynamical Systems 13 / 48

14 Basic Examples: All Periodic Points 1 sage: P.<x,y> = ProjectiveSpace(QQbar,1) 2 sage: H = End(P) 3 sage: f = H([xˆ2+yˆ2,yˆ2]) 4 sage: f.periodic_points(2) 5 [( ? ?*I : 1), 6 ( ? ?*I : 1)] Benjamin Hutz for Dynamical Systems 14 / 48

15 Basic Examples: Critical Points 1 sage: P.<x,y> = ProjectiveSpace(QQ,1) 2 sage: f = DynamicalSystem([xˆ2+yˆ2,yˆ2]) 3 sage: f.critical_points() 4 [(0 : 1), (1 : 0)] 5 sage: f.critical_height(error_bound=0.001) Benjamin Hutz for Dynamical Systems 15 / 48

16 Basic Examples: Finite Fields 1 sage: P.<x,y> = ProjectiveSpace(GF(13),1) 2 sage: f = DynamicalSystem([xˆ2+yˆ2,yˆ2]) 3 sage: f.cyclegraph() 4 Looped digraph on 14 vertices 5 sage: f.orbit_structure(p([2,1])) 6 [0, 4] Benjamin Hutz for Dynamical Systems 16 / 48

17 Rational preperiodic points Post-critically finite maps Automorphism Groups 1 Rational preperiodic points 1 Determine all of the rational preperiodic points for a morphism f : P N P N. 2 Determine if a given point is preperiodic for f. 2 Post-critically finite maps 1 Determine if a morphism f : P 1 P 1 is post-critically finite 2 Construct a pcf map with specified portrait 3 Automorphism groups 1 Construct a family of maps each of whose automorphism group contains the given finite group. 4 1 Products of projective spaces and Wehler K3 surfaces 2 Iteration of subvarieties Benjamin Hutz for Dynamical Systems 17 / 48

18 Rational preperiodic points Post-critically finite maps Automorphism Groups Definitions Theorem (Northcott) The set of rational preperiodic points for a morphism f : P N P N is a set of bounded height. Conjecture (Morton-Silverman) Given a morphism f : P N P N of degree d, defined over a number field of degree D, then there exists a constant C(d, D, N) such that # PrePer(f ) C(d, D, N). Benjamin Hutz for Dynamical Systems 18 / 48

19 Rational preperiodic points Post-critically finite maps Automorphism Groups A precise description of n Theorem (Morton-Silverman 1994, Zieve) Let f : P 1 P 1 defined over Q with deg(f ) 2. Assume that f has good reduction at p with a rational periodic point P. Define Then n = minimal period of P. m = minimal period of P modulo p. r = the multiplicative order of (f m ) (P) mod p n = m or n = mrp e for some explicitly bounded integer e 0. Benjamin Hutz for Dynamical Systems 19 / 48

20 Rational preperiodic points Post-critically finite maps Automorphism Groups Algorithm for finding all rational preperiodic points [Hut15] 1 For each prime p in PrimeSet with good reduction find the list of possible global periods: 1 Find all of the periodic cycles modulo p 2 Compute m, mrp e for each cycle. 2 Intersect the lists of possible periods for all primes in PrimeSet. 3 For each n in PossiblePeriods 1 Find all rational solutions to f n (x) = x. 4 Let PrePeriodicPoints = PeriodicPoints. 5 Repeat until PrePeriodicPoints is constant 1 Add the first rational preimage of each point in PrePeriodicPoints to PrePeriodicPoints. Use Weil restriction of scalars for number fields (polynomials in dimension 1). Benjamin Hutz for Dynamical Systems 20 / 48

21 Rational preperiodic points Post-critically finite maps Automorphism Groups Examples 1 sage: P.<x,y> = ProjectiveSpace(QQ,1) 2 sage: f = DynamicalSystem([xˆ2-29/16*yˆ2,yˆ2]) 3 sage: f.rational_preperiodic_graph() 4 Looped digraph on 9 vertices 1 sage: R.<t> = PolynomialRing(QQ) 2 sage: K.<v> = NumberField(tˆ3 + 16*tˆ *t ) 3 sage: PS.<x,y> = ProjectiveSpace(K,1) 4 sage: f = DynamicalSystem([xˆ2-29/16*yˆ2,yˆ2]) # Hutz 5 sage: len(f.rational_preperiodic_points()) #6s 6 21 Benjamin Hutz for Dynamical Systems 21 / 48

22 Rational preperiodic points Post-critically finite maps Automorphism Groups Examples 1 sage: K.<w> = QuadraticField(33) 2 sage: PS.<x,y> = ProjectiveSpace(K,1) 3 sage: f = DynamicalSystem([xˆ2-71/48*yˆ2,yˆ2]) # Stoll 4 sage: len(f.rational_preperiodic_points()) #1s sage: P.<x,y,z> = ProjectiveSpace(QQ,2) 2 sage: f = DynamicalSystem([xˆ2-21/16*zˆ2,yˆ2-2*zˆ 2,zˆ2]) 3 sage: len(f.rational_preperiodic_points()) #1.5s 4 44 Benjamin Hutz for Dynamical Systems 22 / 48

23 Rational preperiodic points Post-critically finite maps Automorphism Groups Is a point preperiodic? Let f : P N P N be a morphism of degree d. Theorem A point P is preperiodic for f if and only if ĥ(p) = 0. Theorem There exists a constant C independent of a point P such that ĥ(p) h(p) C(f ). Theorem For all points P ĥ(f (P)) = dĥ(p). Benjamin Hutz for Dynamical Systems 23 / 48

24 Rational preperiodic points Post-critically finite maps Automorphism Groups Algorithm: is preperiodic() 1 If ĥ(p) > C, then not preperiodic. 2 Compute forward images 1 If we encounter a cycle, return preperiodic 2 If the height becomes > C, return not preperiodic. Benjamin Hutz for Dynamical Systems 24 / 48

25 Rational preperiodic points Post-critically finite maps Automorphism Groups Example 1 sage: P.<x,y,z> = ProjectiveSpace(QQ,2) 2 sage: f = DynamicalSystem([xˆ2-29/16*zˆ2,yˆ2-21/ 16*zˆ2,zˆ2]) 3 sage: Q = P(1,-3,4) 4 sage: Q.is_preperiodic(f,return_period=True) 5 (1,3) 1 sage: K.<w> = QuadraticField(-2) 2 sage: P.<x,y,z> = ProjectiveSpace(K,2) 3 sage: f = DynamicalSystem([xˆ2-29/16*zˆ2,yˆ2-21/ 16*zˆ2,zˆ2]) 4 sage: Q = P(w,-3,4) 5 sage: Q.is_preperiodic(f) 6 False Benjamin Hutz for Dynamical Systems 25 / 48

26 Rational preperiodic points Post-critically finite maps Automorphism Groups Definitions Definition We say that P is a critical point for f if the jacobian of f does not have maximal rank at P. Definition We say that f is post-critically finite if all of the critical points are preperiodic. Definition The critical height of f is defined as ĥ(c). c crit Benjamin Hutz for Dynamical Systems 26 / 48

27 Rational preperiodic points Post-critically finite maps Automorphism Groups Algorithm: is postcritically finite() 1 Compute the critical points of f over Q 2 Determine if each is preperiodic. Benjamin Hutz for Dynamical Systems 27 / 48

28 Rational preperiodic points Post-critically finite maps Automorphism Groups Example 1 sage: P.<x,y> = ProjectiveSpace(QQ,1) 2 sage: f = DynamicalSystem([xˆ2 + 12*yˆ2, 7*x*y]) 3 sage: f.critical_points(r=qqbar) 4 [( ? : 1), ( ? : 1 )] 5 sage: f.is_postcritically_finite() 6 False 7 sage: f.critical_height(error_bound=0.001) Benjamin Hutz for Dynamical Systems 28 / 48

29 Rational preperiodic points Post-critically finite maps Automorphism Groups Example: Lattès maps 1 sage: P.<x,y> = ProjectiveSpace(QQ,1) 2 sage: E = EllipticCurve([0,0,0,0,2]);E 3 Elliptic Curve defined by yˆ2 = xˆ3 + 2 over Rational Field 4 sage: f = P.Lattes_map(E,2) 5 sage: f.is_postcritically_finite() 6 True 7 sage: f.critical_point_portrait() 8 Looped digraph on 10 vertices 9 sage: f.critical_height(error_bound=0.001) e-17 Benjamin Hutz for Dynamical Systems 29 / 48

30 Rational preperiodic points Post-critically finite maps Automorphism Groups Misiurewicz Point 1 sage: R.<c> = PolynomialRing(QQ) 2 sage: A.<z> = AffineSpace(R,1) 3 sage: f = DynamicalSystem([zˆ2+c], domain=a) 4 sage: f.dynatomic_polynomial([2,2]).subs({z:0}) 5 cˆ2+1 1 sage: R.<x> = QQ[] 2 sage: K.<i> = NumberField(xˆ2+1) 3 sage: A.<z> = AffineSpace(K,1) 4 sage: f = DynamicalSystem([zˆ2+i], domain=a) 5 sage: f.orbit(a(0),4) 6 [(0), (i), (i - 1), (-i), (i - 1)] Benjamin Hutz for Dynamical Systems 30 / 48

31 Rational preperiodic points Post-critically finite maps Automorphism Groups Gleason Polynomial 1 sage: R.<c> = PolynomialRing(QQ) 2 sage: A.<z> = AffineSpace(R,1) 3 sage: f = DynamicalSystem([zˆ2+c], domain=a) 4 sage: K.<w> = NumberField(f.dynatomic_polynomial(3).subs({z:0})) 5 sage: A.<z> = AffineSpace(K,1) 6 sage: f = DynamicalSystem([zˆ2+w],domain=A) 7 sage: f.orbit(a(0),3) 8 [(0), (w), (wˆ2 + w), (0)] Benjamin Hutz for Dynamical Systems 31 / 48

32 Rational preperiodic points Post-critically finite maps Automorphism Groups 2-parameters [HT15]: generate ideal 1 sage: R.<a,v> = PolynomialRing(QQ,2, order='lex') 2 sage: P.<x,y> = ProjectiveSpace(R,1) 3 sage: f = DynamicalSystem([xˆ3-3*aˆ2*x*yˆ2 +(2*aˆ3 +v)*yˆ3,yˆ3]) 4 sage: dyn1 = f.dynatomic_polynomial(2) 5 sage: dyn2 = f.dynatomic_polynomial(1) 6 sage: I = R.ideal([dyn1.subs({x:a,y:1}), dyn2.subs( {x:-a,y:1})]) Benjamin Hutz for Dynamical Systems 32 / 48

33 Rational preperiodic points Post-critically finite maps Automorphism Groups 2-parameters: get solutions 1 sage: G = I.groebner_basis() 2 sage: S.<z> = QQ[] 3 sage: phi = R.hom([0,z],S) 4 sage: p = phi(g[-1]).factor() 5 sage: K.<V> = NumberField(p[0][0]) 6 sage: S.<z> = K[] 7 sage: phi2 = R.hom([z,V],S) 8 sage: q = phi2(g[-2]).factor() 9 sage: L.<A> = K.extension(q[0][0]) Benjamin Hutz for Dynamical Systems 33 / 48

34 Rational preperiodic points Post-critically finite maps Automorphism Groups 2-parameters: check orbits 1 sage: P.<x,y>=ProjectiveSpace(L,1) 2 sage: f=dynamicalsystem([xˆ3-3*aˆ2*x*yˆ2 +(2*Aˆ3+V )*yˆ3,yˆ3]) 3 sage: f.orbit(p(a),2) 4 [(2/3*Vˆ5 + Vˆ3 + 5/6*V : 1), (V : 1), (2/3*Vˆ5 + V ˆ3 + 5/6*V : 1)] 5 sage: f.orbit(p(-a),2) 6 [(-2/3*Vˆ5 - Vˆ3-5/6*V : 1), 7 (-2/3*Vˆ5 - Vˆ3-5/6*V : 1), 8 (-2/3*Vˆ5 - Vˆ3-5/6*V : 1)] Benjamin Hutz for Dynamical Systems 34 / 48

35 Rational preperiodic points Post-critically finite maps Automorphism Groups Definitions Definition Let f : P N P N. Then an element α PGL N+1 acts on f via conjugation f α = α f α 1 Definition The automorphism group of f is the group Aut(f ) = {α PGL N+1 : f α = f }. Benjamin Hutz for Dynamical Systems 35 / 48

36 Rational preperiodic points Post-critically finite maps Automorphism Groups Determining Automorphism Groups [FMV14] 1 sage: R.<x,y> = ProjectiveSpace(QQ,1) 2 sage: f = DynamicalSystem([xˆ2-2*x*y-2*yˆ2,-2*xˆ2-2 *x*y+yˆ2]) 3 sage: f.automorphism_group(return_functions=true) 4 [x, 2/(2*x), -x - 1, -2*x/(2*x + 2), (-x - 1)/x, -1 /(x + 1)] 5 sage: f.conjugate(matrix([[-1,-1],[0,1]])) == f 6 True Benjamin Hutz for Dynamical Systems 36 / 48

37 Rational preperiodic points Post-critically finite maps Automorphism Groups Constructing Automorphisms [dfh17] Definition Given a finite matrix group G, we say that a polynomial p is an invariant of G if Theorem (Klein) p g = p for all g G. If F is an invariant for a finite group G, then has G Aut(f ). f = ( F y : F x ) : P 1 P 1 Benjamin Hutz for Dynamical Systems 37 / 48

38 Rational preperiodic points Post-critically finite maps Automorphism Groups Tetrahedral family: Invariants 1 sage: R.<x> = QQ[] 2 sage: K.<i> = CyclotomicField(4) 3 sage: m1 = matrix(k,2,[(-1+i)/2,(-1+i)/2, (1+i)/2,( -1-i)/2]) 4 sage: m2 = matrix(k,2, [0,i, -i,0]) 5 sage: tetra = MatrixGroup(m1,m2) 6 sage: [p8,p12a,p12b] = tetra.invariant_generators() 7 sage: S = p8.parent() 8 sage: x1,x2 = S.gens() 9 sage: F7 = [-p8.derivative(x2),p8.derivative(x1)] 10 sage: F11 = [-p12a.derivative(x2),p12a.derivative( x1)] 11 sage: F5 = [-p12b.derivative(x2),p12b.derivative(x1 )] Benjamin Hutz for Dynamical Systems 38 / 48

39 Rational preperiodic points Post-critically finite maps Automorphism Groups Tetrahedral family: Morphisms 1 sage: P.<x,y> = ProjectiveSpace(K,1) 2 sage: R = P.coordinate_ring() 3 sage: phi = S.hom([x,y],R) 4 sage: f7 = DynamicalSystem([phi(t) for t in F7]) 5 sage: f11 = DynamicalSystem([phi(t) for t in F11]) 6 sage: f5 = DynamicalSystem([phi(t) for t in F5]) 7 sage: f5.normalize_coordinates() 8 sage: [[f.conjugate(m)==f for m in [m1,m2]] for f in [f7,f11,f5]] 9 [[True, True], [True, True], [True, True]] Benjamin Hutz for Dynamical Systems 39 / 48

40 Rational preperiodic points Post-critically finite maps Automorphism Groups Tetrahedral family: Family 1 sage: B.<t> = PolynomialRing(K) 2 sage: PB = P.change_ring(B) 3 sage: u,v = PB.gens() 4 sage: RB = PB.coordinate_ring() 5 sage: phib = R.hom([u,v],RB) 6 sage: f = DynamicalSystem([phiB(f7[0]*phi(p12a)) + t*phib(f11[0]*phi(p8)), phib(f7[1]*phi(p12a)) + t*phib(f11[1]*phi(p8))]) 7 sage: [f.conjugate(m)==f for m in [m1,m2]] 8 [True, True] 9 sage: f.resultant().factor() 10 C*tˆ12*(t + 2/3)ˆ18 Benjamin Hutz for Dynamical Systems 40 / 48

41 Products of projective space Iteration of subvarieties Example: P 2 P 1 1 sage: T.<x,y,z,w,u> = ProductProjectiveSpaces([2,1],QQ) 2 sage: F = DynamicalSystem([xˆ2*u,yˆ2*w,zˆ2*u,wˆ2,uˆ 2], domain=t) 3 sage: F(T([2,1,3,0,1])) 4 (4/9 : 0 : 1, 0 : 1) Benjamin Hutz for Dynamical Systems 41 / 48

42 Products of projective space Iteration of subvarieties WehlerK3 [CS96, Sil91, dfh15] 1 sage: PP.<x0,x1,x2,y0,y1,y2> = ProductProjectiveSpaces([2,2],GF(7)) 2 sage: Q = x0ˆ2*y0ˆ2 + 3*x0*x1*y0ˆ2 + x1ˆ2*y0ˆ2 + 4* x0ˆ2*y0*y1 + 3*x0*x1*y0*y1-2*x2ˆ2*y0*y1 - x0ˆ2 *y1ˆ2 + 2*x1ˆ2*y1ˆ2 - x0*x2*y1ˆ2-4*x1*x2*y1ˆ2 + 5*x0*x2*y0*y2-4*x1*x2*y0*y2 + 7*x0ˆ2*y1*y2 + 4*x1ˆ2*y1*y2 + x0*x1*y2ˆ2 + 3*x2ˆ2*y2ˆ2 3 sage: L = x0*y0 + x1*y1 + x2*y2 4 sage: X = WehlerK3Surface([L,Q]) 5 sage: T = X([0,0,1,1,0,0]) 6 sage: X.orbit_phi(T,5) 7 [(0 : 0 : 1, 1 : 0 : 0), 8 (6 : 0 : 1, 0 : 1 : 0), 9 (4 : 4 : 1, 1 : 4 : 1), 10 (6 : 0 : 1, 1 : 4 : 1), 11 (0 : 0 : 1, 0 : 1 : 0), 12 (0 : 0 : 1, 1 : 0 : 0)] 13 sage: X.cardinality() Benjamin Hutz for Dynamical Systems 42 / 48

43 Products of projective space Iteration of subvarieties WehlerK3: Canonical Heights 1 sage: R.<x0,x1,x2,y0,y1,y2> = PolynomialRing(QQ,6) 2 sage: L = (-y0 - y1)*x0 + (-y0*x1 - y2*x2) 3 sage: Q = (-y2*y0 - y1ˆ2)*x0ˆ2 + ((-y0ˆ2 - y2*y0 + (-y2*y1 - y2ˆ2))*x1 +(-y0ˆ2 - y2*y1)*x2)*x0 + ( (-y0ˆ2 - y2*y0 - y2ˆ2)*x1ˆ2 + (-y2*y0 - y1ˆ2)* x2*x1 + (-y0ˆ2 + (-y1 - y2)*y0)*x2ˆ2) 4 sage: X = WehlerK3Surface([L,Q]) 5 sage: P = X([1,0,-1,1,-1,0]) #order 16 6 sage: X.canonical_height(P,5) Benjamin Hutz for Dynamical Systems 43 / 48

44 Products of projective space Iteration of subvarieties Computing the forward image Proposition Let f : P N P N be a morphism and X = V (g 1,..., g k ) be a subvariety. Let I K [x 0,..., x N, y 0,..., y N ] be the ideal I = (g 1 (x),..., g k (x), y 0 f 0 (x),..., y N f N (x)). Then the elimination ideal I N+1 = I K [y 0,..., y N ] is a homogeneous ideal and f (X) = V (I N+1 ). Benjamin Hutz for Dynamical Systems 44 / 48

45 Products of projective space Iteration of subvarieties Sanity Check: Iteration of points 1 sage: P.<x,y,z> = ProjectiveSpace(QQ,2) 2 sage: f = DynamicalSystem([xˆ2 -zˆ2,yˆ2-2*zˆ2,zˆ2]) 3 sage: X = P.subscheme([x, y-2*z]) 4 sage: [Z.defining_polynomials() for Z in f.orbit(x, 2)] 5 [(x, y - 2*z), (y - 2*z, x + z), (y - 2*z, x)] 6 sage: f.orbit(p([0,2,1]),2) 7 [(0 : 2 : 1), (-1 : 2 : 1), (0 : 2 : 1)] Benjamin Hutz for Dynamical Systems 45 / 48

46 Products of projective space Iteration of subvarieties Example: Periodic 1 sage: P.<x,y,z> = ProjectiveSpace(QQ,2) 2 sage: f = DynamicalSystem([xˆ2 + 6*x*z + 9*zˆ2, -x* z - 3/2*zˆ2, 4*x*y + 12*yˆ2-2*x*z - 3*zˆ2]) 3 sage: X = P.subscheme(x) 4 sage: [Z.defining_polynomials() for Z in f.orbit(x, 3)] 5 [(x,), (x + 6*y,), (x + 3*z,), (x,)] Benjamin Hutz for Dynamical Systems 46 / 48

47 Products of projective space Iteration of subvarieties Example: PCF 1 sage: P.<x,y,z> = ProjectiveSpace(QQ,2) 2 sage: f = DynamicalSystem([(x-2*y)ˆ2,(x-2*z)ˆ2,xˆ2] ) #fornaess 3 sage: X = P.subscheme(f.wronskian_ideal()) 4 sage: IC = X.irreducible_components() 5 sage: for X in IC: 6 sage: [Z.defining_polynomials() for Z in f. orbit(x,5)] 7 [(x,), (z,),(y - z,), (x - y,), (x - z,), (y - z,)] 8 [(x-2z,),(y,),(x - z,),(y - z,),(x - y,),(x - z,)] 9 [(x - 2y,),(x,),(z,),(y - z,), (x - y,), (x - z,)] Benjamin Hutz for Dynamical Systems 47 / 48

48 Products of projective space Iteration of subvarieties References [CS96] Gregory S. Call and Joseph H. Silverman, Computing the canonical height on K3 surfaces, Math. Comp. 65 (1996), [dfh15] Joao de Faria and Benjamim Hutz, Cycles on Wehler K3 surfaces, New Zealand Journal of Mathematics 45 (2015), [dfh17], Automorphism groups and invariant theory on PN, Journal of Algebra and its Applications forthcoming (2017). [FMV14] Xander Faber, Michelle Manes, and Bianca Viray, Computing conjugating sets and automorphism groups of rational functions, Journal of Algebra 423 (2014), [HT15] [Hut15] [Sil91] Benjamim Hutz and Adam Towsley, Thurston s theorem and misiurewicz points for polynomial maps, New York J. Math 21 (2015), Benjamin Hutz, Determination of all rational preperiodic points for morphisms of PN, Mathematics of Comptutaion 84 (2015), no. 291, Joseph H. Silverman, Rational points on K3 surfaces: a new cannonical height, Invent. Math. 105 (1991), Benjamin Hutz for Dynamical Systems 48 / 48

Automorphism Groups and Invariant Theory on PN

Automorphism Groups and Invariant Theory on PN Automorphism Groups and Invariant Theory on PN Benjamin Hutz Department of Mathematics and Computer Science Saint Louis University January 9, 2016 JMM: Special Session on Arithmetic Dynamics joint work

More information

Moduli Spaces for Dynamical Systems Joseph H. Silverman

Moduli Spaces for Dynamical Systems Joseph H. Silverman Moduli Spaces for Dynamical Systems Joseph H. Silverman Brown University CNTA Calgary Tuesday, June 21, 2016 0 Notation: We fix The Space of Rational Self-Maps of P n 1 Rational Maps on Projective Space

More information

On the Number of Rational Iterated Pre-Images of -1 under Quadratic Dynamical Systems

On the Number of Rational Iterated Pre-Images of -1 under Quadratic Dynamical Systems AMERICA JOURAL OF UDERGRADUATE RESEARCH VOL. 9, O. 1 (2010) On the umber of Rational Iterated Pre-Images of -1 under Quadratic Dynamical Systems Trevor Hyde Department of Mathematics Amherst College Amherst,

More information

(Non)-Uniform Bounds for Rational Preperiodic Points in Arithmetic Dynamics

(Non)-Uniform Bounds for Rational Preperiodic Points in Arithmetic Dynamics (Non)-Uniform Bounds for Rational Preperiodic Points in Arithmetic Dynamics Robert L. Benedetto Amherst College Special Session on The Interface Between Number Theory and Dynamical Systems AMS Spring Sectional

More information

Variations on a Theme: Fields of Definition, Fields of Moduli, Automorphisms, and Twists

Variations on a Theme: Fields of Definition, Fields of Moduli, Automorphisms, and Twists Variations on a Theme: Fields of Definition, Fields of Moduli, Automorphisms, and Twists Michelle Manes (mmanes@math.hawaii.edu) ICERM Workshop Moduli Spaces Associated to Dynamical Systems 17 April, 2012

More information

arxiv: v1 [math.nt] 4 Jun 2018

arxiv: v1 [math.nt] 4 Jun 2018 On the orbit of a post-critically finite polynomial of the form x d +c arxiv:1806.01208v1 [math.nt] 4 Jun 2018 Vefa Goksel Department of Mathematics University of Wisconsin Madison, WI 53706, USA E-mail:

More information

Geometry and Arithmetic of Dominant Rational Self-Maps of Projective Space Joseph H. Silverman

Geometry and Arithmetic of Dominant Rational Self-Maps of Projective Space Joseph H. Silverman Geometry and Arithmetic of Dominant Rational Self-Maps of Projective Space Joseph H. Silverman Brown University Conference on automorphisms and endomorphisms of algebraic varieties and compact complex

More information

ELLIOT WELLS. n d n h(φ n (P));

ELLIOT WELLS. n d n h(φ n (P)); COMPUTING THE CANONICAL HEIGHT OF A POINT IN PROJECTIVE SPACE arxiv:1602.04920v1 [math.nt] 16 Feb 2016 ELLIOT WELLS Abstract. We give an algorithm which requires no integer factorization for computing

More information

MANIN-MUMFORD AND LATTÉS MAPS

MANIN-MUMFORD AND LATTÉS MAPS MANIN-MUMFORD AND LATTÉS MAPS JORGE PINEIRO Abstract. The present paper is an introduction to the dynamical Manin-Mumford conjecture and an application of a theorem of Ghioca and Tucker to obtain counterexamples

More information

Dynamics of Quadratic Polynomials over Quadratic Fields. John Robert Doyle. (Under the direction of Robert Rumely) Abstract

Dynamics of Quadratic Polynomials over Quadratic Fields. John Robert Doyle. (Under the direction of Robert Rumely) Abstract Dynamics of Quadratic Polynomials over Quadratic Fields by John Robert Doyle (Under the direction of Robert Rumely) Abstract In 1998, Poonen gave a conjecturally complete classification of the possible

More information

I.G.C.S.E. Similarity. You can access the solutions from the end of each question

I.G.C.S.E. Similarity. You can access the solutions from the end of each question I.G.C.S.E. Similarity Inde: Please click on the question number you want Question 1 Question Question Question 4 Question 5 Question 6 Question 7 Question 8 You can access the solutions from the end of

More information

BIFURCATIONS, INTERSECTIONS, AND HEIGHTS

BIFURCATIONS, INTERSECTIONS, AND HEIGHTS BIFURCATIONS, INTERSECTIONS, AND HEIGHTS LAURA DE MARCO Abstract. In this article, we prove the equivalence of dynamical stability, preperiodicity, and canonical height 0, for algebraic families of rational

More information

Introduction Main Theorem

Introduction Main Theorem Abstract: We study the number of rational pre-images of a rational number a under the quadratic polynomial map (x) = x 2 + c. We state the existence of a uniform bound (uniform over the family of maps

More information

A CRITERION FOR POTENTIALLY GOOD REDUCTION IN NON-ARCHIMEDEAN DYNAMICS

A CRITERION FOR POTENTIALLY GOOD REDUCTION IN NON-ARCHIMEDEAN DYNAMICS A CRITERION FOR POTENTIALLY GOOD REDUCTION IN NON-ARCHIMEDEAN DYNAMICS ROBERT L. BENEDETTO Abstract. Let K be a non-archimedean field, and let φ K(z) be a polynomial or rational function of degree at least

More information

THE MODULI SPACE OF RATIONAL FUNCTIONS OF DEGREE d

THE MODULI SPACE OF RATIONAL FUNCTIONS OF DEGREE d THE MODULI SPACE OF RATIONAL FUNCTIONS OF DEGREE d MICHELLE MANES. Short Introduction to Varieties For simplicity, the whole talk is going to be over C. This sweeps some details under the rug, but it s

More information

Elliptic Curves and the abc Conjecture

Elliptic Curves and the abc Conjecture Elliptic Curves and the abc Conjecture Anton Hilado University of Vermont October 16, 2018 Anton Hilado (UVM) Elliptic Curves and the abc Conjecture October 16, 2018 1 / 37 Overview 1 The abc conjecture

More information

arxiv: v1 [math.ds] 27 Jan 2015

arxiv: v1 [math.ds] 27 Jan 2015 PREPERIODIC PORTRAITS FOR UNICRITICAL POLYNOMIALS JOHN R. DOYLE arxiv:1501.06821v1 [math.ds] 27 Jan 2015 Abstract. Let K be an algebraically closed field of characteristic zero, and for c K and an integer

More information

DIPOLES III. q const. The voltage produced by such a charge distribution is given by. r r'

DIPOLES III. q const. The voltage produced by such a charge distribution is given by. r r' DIPOLES III We now consider a particularly important charge configuration a dipole. This consists of two equal but opposite charges separated by a small distance. We define the dipole moment as p lim q

More information

Bjorn Poonen. MSRI Introductory Workshop on Rational and Integral Points on Higher-dimensional Varieties. January 17, 2006

Bjorn Poonen. MSRI Introductory Workshop on Rational and Integral Points on Higher-dimensional Varieties. January 17, 2006 University of California at Berkeley MSRI Introductory Workshop on Rational and Integral Points on Higher-dimensional (organized by Jean-Louis Colliot-Thélène, Roger Heath-Brown, János Kollár,, Alice Silverberg,

More information

Dynamics and Canonical Heights on K3 Surfaces with Noncommuting Involutions Joseph H. Silverman

Dynamics and Canonical Heights on K3 Surfaces with Noncommuting Involutions Joseph H. Silverman Dynamics and Canonical Heights on K3 Surfaces with Noncommuting Involutions Joseph H. Silverman Brown University Conference on the Arithmetic of K3 Surfaces Banff International Research Station Wednesday,

More information

SMALL DYNAMICAL HEIGHTS FOR QUADRATIC POLYNOMIALS AND RATIONAL FUNCTIONS

SMALL DYNAMICAL HEIGHTS FOR QUADRATIC POLYNOMIALS AND RATIONAL FUNCTIONS SMALL DYNAMICAL HEIGHTS FOR QUADRATIC POLYNOMIALS AND RATIONAL FUNCTIONS ROBERT L. BENEDETTO, RUQIAN CHEN, TREVOR HYDE, YORDANKA KOVACHEVA, AND COLIN WHITE Abstract. Let φ Q(z) be a polynomial or rational

More information

K-RATIONAL PREPERIODIC POINTS AND HYPERSURFACES ON PROJECTIVE SPACE.

K-RATIONAL PREPERIODIC POINTS AND HYPERSURFACES ON PROJECTIVE SPACE. K-RATIONAL PREPERIODIC POINTS AND HYPERSURFACES ON PROJECTIVE SPACE. By Sebastian Ignacio Troncoso Naranjo A DISSERTATION Submitted to Michigan State University in partial fulfillment of the requirements

More information

PERIODS OF RATIONAL MAPS MODULO PRIMES

PERIODS OF RATIONAL MAPS MODULO PRIMES PERIODS OF RATIONAL MAPS MODULO PRIMES ROBERT L. BENEDETTO, DRAGOS GHIOCA, BENJAMIM HUTZ, PÄR KURLBERG, THOMAS SCANLON, AND THOMAS J. TUCKER Abstract. Let K be a number field, let ϕ K(t) be a rational

More information

GEOMETRY OF 3-SELMER CLASSES THE ALGEBRAIC GEOMETRY LEARNING SEMINAR 7 MAY 2015

GEOMETRY OF 3-SELMER CLASSES THE ALGEBRAIC GEOMETRY LEARNING SEMINAR 7 MAY 2015 IN GEOMETRY OF 3-SELMER CLASSES THE ALGEBRAIC GEOMETRY LEARNING SEMINAR AT ESSEN 7 MAY 2015 ISHAI DAN-COHEN Abstract. We discuss the geometry of 3-Selmer classes of elliptic curves over a number field,

More information

PROBLEMS, MATH 214A. Affine and quasi-affine varieties

PROBLEMS, MATH 214A. Affine and quasi-affine varieties PROBLEMS, MATH 214A k is an algebraically closed field Basic notions Affine and quasi-affine varieties 1. Let X A 2 be defined by x 2 + y 2 = 1 and x = 1. Find the ideal I(X). 2. Prove that the subset

More information

Handout - Algebra Review

Handout - Algebra Review Algebraic Geometry Instructor: Mohamed Omar Handout - Algebra Review Sept 9 Math 176 Today will be a thorough review of the algebra prerequisites we will need throughout this course. Get through as much

More information

SHIMURA CURVES II. Contents. 2. The space X 4 3. The Shimura curve M(G, X) 7 References 11

SHIMURA CURVES II. Contents. 2. The space X 4 3. The Shimura curve M(G, X) 7 References 11 SHIMURA CURVES II STEFAN KUKULIES Abstract. These are the notes of a talk I gave at the number theory seminar at University of Duisburg-Essen in summer 2008. We discuss the adèlic description of quaternionic

More information

Arithmetic properties of periodic points of quadratic maps, II

Arithmetic properties of periodic points of quadratic maps, II ACTA ARITHMETICA LXXXVII.2 (1998) Arithmetic properties of periodic points of quadratic maps, II by Patrick Morton (Wellesley, Mass.) 1. Introduction. In this paper we prove that the quadratic map x f(x)

More information

Néron Models of Elliptic Curves.

Néron Models of Elliptic Curves. Néron Models of Elliptic Curves. Marco Streng 5th April 2007 These notes are meant as an introduction and a collection of references to Néron models of elliptic curves. We use Liu [Liu02] and Silverman

More information

FORMAL GROUPS OF CERTAIN Q-CURVES OVER QUADRATIC FIELDS

FORMAL GROUPS OF CERTAIN Q-CURVES OVER QUADRATIC FIELDS Sairaiji, F. Osaka J. Math. 39 (00), 3 43 FORMAL GROUPS OF CERTAIN Q-CURVES OVER QUADRATIC FIELDS FUMIO SAIRAIJI (Received March 4, 000) 1. Introduction Let be an elliptic curve over Q. We denote by ˆ

More information

Theorem 6.1 The addition defined above makes the points of E into an abelian group with O as the identity element. Proof. Let s assume that K is

Theorem 6.1 The addition defined above makes the points of E into an abelian group with O as the identity element. Proof. Let s assume that K is 6 Elliptic curves Elliptic curves are not ellipses. The name comes from the elliptic functions arising from the integrals used to calculate the arc length of ellipses. Elliptic curves can be parametrised

More information

3.3 The Uniform Boundedness Conjecture

3.3 The Uniform Boundedness Conjecture 3.3. The Uniform Boundedness Conjecture 95 3.3 The Uniform Boundedness Conjecture Northcott s Theorem 3.12 says that a morphism φ : P N P N has only finitely many K-rational preperiodic points. It is even

More information

A POSITIVE PROPORTION OF THUE EQUATIONS FAIL THE INTEGRAL HASSE PRINCIPLE

A POSITIVE PROPORTION OF THUE EQUATIONS FAIL THE INTEGRAL HASSE PRINCIPLE A POSITIVE PROPORTION OF THUE EQUATIONS FAIL THE INTEGRAL HASSE PRINCIPLE SHABNAM AKHTARI AND MANJUL BHARGAVA Abstract. For any nonzero h Z, we prove that a positive proportion of integral binary cubic

More information

Lecture 2: Elliptic curves

Lecture 2: Elliptic curves Lecture 2: Elliptic curves This lecture covers the basics of elliptic curves. I begin with a brief review of algebraic curves. I then define elliptic curves, and talk about their group structure and defining

More information

M ath. Res. Lett. 16 (2009), no. 1, c International Press 2009 UNIFORM BOUNDS ON PRE-IMAGES UNDER QUADRATIC DYNAMICAL SYSTEMS

M ath. Res. Lett. 16 (2009), no. 1, c International Press 2009 UNIFORM BOUNDS ON PRE-IMAGES UNDER QUADRATIC DYNAMICAL SYSTEMS M ath. Res. Lett. 16 (2009), no. 1, 87 101 c International Press 2009 UNIFORM BOUNDS ON PRE-IMAGES UNDER QUADRATIC DYNAMICAL SYSTEMS Xander Faber, Benjamin Hutz, Patrick Ingram, Rafe Jones, Michelle Manes,

More information

Introduction to Elliptic Curves

Introduction to Elliptic Curves IAS/Park City Mathematics Series Volume XX, XXXX Introduction to Elliptic Curves Alice Silverberg Introduction Why study elliptic curves? Solving equations is a classical problem with a long history. Starting

More information

1.6.1 What are Néron Models?

1.6.1 What are Néron Models? 18 1. Abelian Varieties: 10/20/03 notes by W. Stein 1.6.1 What are Néron Models? Suppose E is an elliptic curve over Q. If is the minimal discriminant of E, then E has good reduction at p for all p, in

More information

Galois theory of quadratic rational functions with a non-trivial automorphism 1

Galois theory of quadratic rational functions with a non-trivial automorphism 1 Galois theory of quadratic rational functions with a non-trivial automorphism 1 Michelle Manes University of Hawai i at Mānoa January 15, 2010 1 Joint work with Rafe Jones Strands of work Maps with automorphisms

More information

Lecture Notes on Arithmetic Dynamics Arizona Winter School March 13 17, 2010

Lecture Notes on Arithmetic Dynamics Arizona Winter School March 13 17, 2010 Lecture Notes on Arithmetic Dynamics Arizona Winter School March 13 17, 2010 JOSEPH H. SILVERMAN jhs@math.brown.edu Contents About These Notes/Note to Students 1 1. Introduction 2 2. Background Material:

More information

Rational Points on Curves

Rational Points on Curves Rational Points on Curves 1 Q algebraic closure of Q. k a number field. Ambient variety: Elliptic curve E an elliptic curve defined over Q. E N = E E. In general A an abelian variety defined over Q. For

More information

On the generation of the coefficient field of a newform by a single Hecke eigenvalue

On the generation of the coefficient field of a newform by a single Hecke eigenvalue On the generation of the coefficient field of a newform by a single Hecke eigenvalue Koopa Tak-Lun Koo and William Stein and Gabor Wiese November 2, 27 Abstract Let f be a non-cm newform of weight k 2

More information

Constructing genus 2 curves over finite fields

Constructing genus 2 curves over finite fields Constructing genus 2 curves over finite fields Kirsten Eisenträger The Pennsylvania State University Fq12, Saratoga Springs July 15, 2015 1 / 34 Curves and cryptography RSA: most widely used public key

More information

Integral points of a modular curve of level 11. by René Schoof and Nikos Tzanakis

Integral points of a modular curve of level 11. by René Schoof and Nikos Tzanakis June 23, 2011 Integral points of a modular curve of level 11 by René Schoof and Nikos Tzanakis Abstract. Using lower bounds for linear forms in elliptic logarithms we determine the integral points of the

More information

The Arithmetic of Dynamical Systems

The Arithmetic of Dynamical Systems The Arithmetic of Dynamical Systems Joseph H. Silverman December 28, 2006 2 Preface This book is designed to provide a path for the reader into an amalgamation of two venerable areas of mathematics, Dynamical

More information

On symmetric square values of quadratic polynomials

On symmetric square values of quadratic polynomials ACTA ARITHMETICA 149.2 (2011) On symmetric square values of quadratic polynomials by Enrique González-Jiménez (Madrid) and Xavier Xarles (Barcelona) 1. Introduction. In this note we are dealing with the

More information

TROPICAL SCHEME THEORY

TROPICAL SCHEME THEORY TROPICAL SCHEME THEORY 5. Commutative algebra over idempotent semirings II Quotients of semirings When we work with rings, a quotient object is specified by an ideal. When dealing with semirings (and lattices),

More information

D-MATH Algebra I HS18 Prof. Rahul Pandharipande. Solution 6. Unique Factorization Domains

D-MATH Algebra I HS18 Prof. Rahul Pandharipande. Solution 6. Unique Factorization Domains D-MATH Algebra I HS18 Prof. Rahul Pandharipande Solution 6 Unique Factorization Domains 1. Let R be a UFD. Let that a, b R be coprime elements (that is, gcd(a, b) R ) and c R. Suppose that a c and b c.

More information

A Number Theorist s Perspective on Dynamical Systems

A Number Theorist s Perspective on Dynamical Systems A Number Theorist s Perspective on Dynamical Systems Joseph H. Silverman Brown University Frontier Lectures Texas A&M, Monday, April 4 7, 2005 Rational Functions and Dynamical Systems

More information

Resolution of Singularities in Algebraic Varieties

Resolution of Singularities in Algebraic Varieties Resolution of Singularities in Algebraic Varieties Emma Whitten Summer 28 Introduction Recall that algebraic geometry is the study of objects which are or locally resemble solution sets of polynomial equations.

More information

HARTSHORNE EXERCISES

HARTSHORNE EXERCISES HARTSHORNE EXERCISES J. WARNER Hartshorne, Exercise I.5.6. Blowing Up Curve Singularities (a) Let Y be the cusp x 3 = y 2 + x 4 + y 4 or the node xy = x 6 + y 6. Show that the curve Ỹ obtained by blowing

More information

Vojta s Conjecture and Dynamics

Vojta s Conjecture and Dynamics RIMS Kôkyûroku Bessatsu B25 (2011), 75 86 Vojta s Conjecture and Dynamics By Yu Yasufuku Abstract Vojta s conjecture is a deep conjecture in Diophantine geometry, giving a quantitative description of how

More information

COMPLEX MULTIPLICATION: LECTURE 15

COMPLEX MULTIPLICATION: LECTURE 15 COMPLEX MULTIPLICATION: LECTURE 15 Proposition 01 Let φ : E 1 E 2 be a non-constant isogeny, then #φ 1 (0) = deg s φ where deg s is the separable degree of φ Proof Silverman III 410 Exercise: i) Consider

More information

THE TATE MODULE. Seminar: Elliptic curves and the Weil conjecture. Yassin Mousa. Z p

THE TATE MODULE. Seminar: Elliptic curves and the Weil conjecture. Yassin Mousa. Z p THE TATE MODULE Seminar: Elliptic curves and the Weil conjecture Yassin Mousa Abstract This paper refers to the 10th talk in the seminar Elliptic curves and the Weil conjecture supervised by Prof. Dr.

More information

Chapter 3. Rings. The basic commutative rings in mathematics are the integers Z, the. Examples

Chapter 3. Rings. The basic commutative rings in mathematics are the integers Z, the. Examples Chapter 3 Rings Rings are additive abelian groups with a second operation called multiplication. The connection between the two operations is provided by the distributive law. Assuming the results of Chapter

More information

FINITE GROUPS AND EQUATIONS OVER FINITE FIELDS A PROBLEM SET FOR ARIZONA WINTER SCHOOL 2016

FINITE GROUPS AND EQUATIONS OVER FINITE FIELDS A PROBLEM SET FOR ARIZONA WINTER SCHOOL 2016 FINITE GROUPS AND EQUATIONS OVER FINITE FIELDS A PROBLEM SET FOR ARIZONA WINTER SCHOOL 2016 PREPARED BY SHABNAM AKHTARI Introduction and Notations The problems in Part I are related to Andrew Sutherland

More information

Geometric motivic integration

Geometric motivic integration Université Lille 1 Modnet Workshop 2008 Introduction Motivation: p-adic integration Kontsevich invented motivic integration to strengthen the following result by Batyrev. Theorem (Batyrev) If two complex

More information

AN INTRODUCTION TO AFFINE SCHEMES

AN INTRODUCTION TO AFFINE SCHEMES AN INTRODUCTION TO AFFINE SCHEMES BROOKE ULLERY Abstract. This paper gives a basic introduction to modern algebraic geometry. The goal of this paper is to present the basic concepts of algebraic geometry,

More information

AMICABLE PAIRS AND ALIQUOT CYCLES FOR ELLIPTIC CURVES OVER NUMBER FIELDS

AMICABLE PAIRS AND ALIQUOT CYCLES FOR ELLIPTIC CURVES OVER NUMBER FIELDS ROCKY MOUNTAIN JOURNAL OF MATHEMATICS Volume 46, Number 6, 2016 AMICABLE PAIRS AND ALIQUOT CYCLES FOR ELLIPTIC CURVES OVER NUMBER FIELDS JIM BROWN, DAVID HERAS, KEVIN JAMES, RODNEY KEATON AND ANDREW QIAN

More information

x 9 or x > 10 Name: Class: Date: 1 How many natural numbers are between 1.5 and 4.5 on the number line?

x 9 or x > 10 Name: Class: Date: 1 How many natural numbers are between 1.5 and 4.5 on the number line? 1 How many natural numbers are between 1.5 and 4.5 on the number line? 2 How many composite numbers are between 7 and 13 on the number line? 3 How many prime numbers are between 7 and 20 on the number

More information

August 2015 Qualifying Examination Solutions

August 2015 Qualifying Examination Solutions August 2015 Qualifying Examination Solutions If you have any difficulty with the wording of the following problems please contact the supervisor immediately. All persons responsible for these problems,

More information

EXTRA CREDIT FOR MATH 39

EXTRA CREDIT FOR MATH 39 EXTRA CREDIT FOR MATH 39 This is the second, theoretical, part of an extra credit homework. This homework in not compulsory. If you do it, you can get up to 6 points (3 points for each part) of extra credit

More information

How to compute regulators using Arakelov intersection theory

How to compute regulators using Arakelov intersection theory How to compute regulators using Arakelov intersection theory Raymond van Bommel 25 October 2018 These are notes for a talk given in the SFB/TRR45 Kolloquium held in Mainz, Germany, in the autumn of 2018.

More information

FINITENESS OF COMMUTABLE MAPS OF BOUNDED DEGREE

FINITENESS OF COMMUTABLE MAPS OF BOUNDED DEGREE Bull. Korean Math. Soc. 52 (2015), No. 1, pp. 45 56 http://dx.doi.org/10.4134/bkms.2015.52.1.045 FINITENESS OF COMMUTABLE MAPS OF BOUNDED DEGREE Chong Gyu Lee and Hexi Ye Abstract. In this paper, we study

More information

Potential reachability in commutative nets

Potential reachability in commutative nets Potential reachability in commutative nets Christoph Schneider 1, Joachim Wehler 2 6. Workshop Algorithmen und Werkzeuge für Petrinetze, Frankfurt/Main 1999 Abstract. Potential reachability is a question

More information

Ideals of three dimensional Artin-Schelter regular algebras. Koen De Naeghel Thesis Supervisor: Michel Van den Bergh

Ideals of three dimensional Artin-Schelter regular algebras. Koen De Naeghel Thesis Supervisor: Michel Van den Bergh Ideals of three dimensional Artin-Schelter regular algebras Koen De Naeghel Thesis Supervisor: Michel Van den Bergh February 17, 2006 Polynomial ring Put k = C. Commutative polynomial ring S = k[x, y,

More information

Elliptic Curves Spring 2017 Lecture #5 02/22/2017

Elliptic Curves Spring 2017 Lecture #5 02/22/2017 18.783 Elliptic Curves Spring 017 Lecture #5 0//017 5 Isogenies In almost every branch of mathematics, when considering a category of mathematical objects with a particular structure, the maps between

More information

Various algorithms for the computation of Bernstein-Sato polynomial

Various algorithms for the computation of Bernstein-Sato polynomial Various algorithms for the computation of Bernstein-Sato polynomial Applications of Computer Algebra (ACA) 2008 Notations and Definitions Motivation Two Approaches Let K be a field and let D = K x, = K

More information

THE JACOBIAN AND FORMAL GROUP OF A CURVE OF GENUS 2 OVER AN ARBITRARY GROUND FIELD E. V. Flynn, Mathematical Institute, University of Oxford

THE JACOBIAN AND FORMAL GROUP OF A CURVE OF GENUS 2 OVER AN ARBITRARY GROUND FIELD E. V. Flynn, Mathematical Institute, University of Oxford THE JACOBIAN AND FORMAL GROUP OF A CURVE OF GENUS 2 OVER AN ARBITRARY GROUND FIELD E. V. Flynn, Mathematical Institute, University of Oxford 0. Introduction The ability to perform practical computations

More information

ADVANCED TOPICS IN ALGEBRAIC GEOMETRY

ADVANCED TOPICS IN ALGEBRAIC GEOMETRY ADVANCED TOPICS IN ALGEBRAIC GEOMETRY DAVID WHITE Outline of talk: My goal is to introduce a few more advanced topics in algebraic geometry but not to go into too much detail. This will be a survey of

More information

A DARK GREY P O N T, with a Switch Tail, and a small Star on the Forehead. Any

A DARK GREY P O N T, with a Switch Tail, and a small Star on the Forehead. Any Y Y Y X X «/ YY Y Y ««Y x ) & \ & & } # Y \#$& / Y Y X» \\ / X X X x & Y Y X «q «z \x» = q Y # % \ & [ & Z \ & { + % ) / / «q zy» / & / / / & x x X / % % ) Y x X Y $ Z % Y Y x x } / % «] «] # z» & Y X»

More information

On a Homoclinic Group that is not Isomorphic to the Character Group *

On a Homoclinic Group that is not Isomorphic to the Character Group * QUALITATIVE THEORY OF DYNAMICAL SYSTEMS, 1 6 () ARTICLE NO. HA-00000 On a Homoclinic Group that is not Isomorphic to the Character Group * Alex Clark University of North Texas Department of Mathematics

More information

ON THE NUMBER OF PLACES OF CONVERGENCE FOR NEWTON S METHOD OVER NUMBER FIELDS

ON THE NUMBER OF PLACES OF CONVERGENCE FOR NEWTON S METHOD OVER NUMBER FIELDS ON THE NUMBER OF PLACES OF CONVERGENCE FOR NEWTON S METHOD OVER NUMBER FIELDS XANDER FABER AND JOSÉ FELIPE VOLOCH Abstract. Let f be a polynomial of degree at least 2 with coefficients in a number field

More information

An unusual cubic representation problem

An unusual cubic representation problem Annales Mathematicae et Informaticae 43 (014) pp. 9 41 http://ami.ektf.hu An unusual cubic representation problem Andrew Bremner a, Allan Macleod b a School of Mathematics and Mathematical Statistics,

More information

Prologue: General Remarks on Computer Algebra Systems

Prologue: General Remarks on Computer Algebra Systems Prologue: General Remarks on Computer Algebra Systems Computer algebra algorithms allow us to compute in, and with, a multitude of mathematical structures. Accordingly, there is a large number of computer

More information

Arithmetic Analogues of Derivations

Arithmetic Analogues of Derivations JOURNAL OF ALGEBRA 198, 9099 1997 ARTICLE NO. JA977177 Arithmetic Analogues of Derivations Alexandru Buium Department of Math and Statistics, Uniersity of New Mexico, Albuquerque, New Mexico 87131 Communicated

More information

Math Midterm Solutions

Math Midterm Solutions Math 145 - Midterm Solutions Problem 1. (10 points.) Let n 2, and let S = {a 1,..., a n } be a finite set with n elements in A 1. (i) Show that the quasi-affine set A 1 \ S is isomorphic to an affine set.

More information

3. Lecture 3. Y Z[1/p]Hom (Sch/k) (Y, X).

3. Lecture 3. Y Z[1/p]Hom (Sch/k) (Y, X). 3. Lecture 3 3.1. Freely generate qfh-sheaves. We recall that if F is a homotopy invariant presheaf with transfers in the sense of the last lecture, then we have a well defined pairing F(X) H 0 (X/S) F(S)

More information

Power structure over the Grothendieck ring of varieties and generating series of Hilbert schemes of points

Power structure over the Grothendieck ring of varieties and generating series of Hilbert schemes of points arxiv:math/0407204v1 [math.ag] 12 Jul 2004 Power structure over the Grothendieck ring of varieties and generating series of Hilbert schemes of points S.M. Gusein-Zade I. Luengo A. Melle Hernández Abstract

More information

Algebraic Varieties. Notes by Mateusz Micha lek for the lecture on April 17, 2018, in the IMPRS Ringvorlesung Introduction to Nonlinear Algebra

Algebraic Varieties. Notes by Mateusz Micha lek for the lecture on April 17, 2018, in the IMPRS Ringvorlesung Introduction to Nonlinear Algebra Algebraic Varieties Notes by Mateusz Micha lek for the lecture on April 17, 2018, in the IMPRS Ringvorlesung Introduction to Nonlinear Algebra Algebraic varieties represent solutions of a system of polynomial

More information

Geometry and Computer Science Pescara, February 0810, 2017

Geometry and Computer Science Pescara, February 0810, 2017 Geometry and Computer Science Pescara, February 0810, 2017 SageMath experiments in Dierential and Complex Geometry Daniele Angella Dipartimento di Matematica e Informatica "Ulisse Dini" Università di Firenze

More information

REVIEW: THE ARITHMETIC OF DYNAMICAL SYSTEMS, BY JOSEPH H. SILVERMAN

REVIEW: THE ARITHMETIC OF DYNAMICAL SYSTEMS, BY JOSEPH H. SILVERMAN BULLETIN (New Series) OF THE AMERICAN MATHEMATICAL SOCIETY Volume 00, Number 0, Pages 000 000 S 0273-0979(XX)0000-0 REVIEW: THE ARITHMETIC OF DYNAMICAL SYSTEMS, BY JOSEPH H. SILVERMAN ROBERT L. BENEDETTO

More information

Gröbner Bases. Martin R. Albrecht. DTU Crypto Group

Gröbner Bases. Martin R. Albrecht. DTU Crypto Group Gröbner Bases Martin R. Albrecht DTU Crypto Group 22 October 2013 Contents Sage Polynomial Rings Ideals Gröbner Bases Buchberger s Algorithm Quotient Rings Solving Polynomial Systems with Gröbner Bases

More information

Pacific Journal of Mathematics

Pacific Journal of Mathematics Pacific Journal of Mathematics PICARD VESSIOT EXTENSIONS WITH SPECIFIED GALOIS GROUP TED CHINBURG, LOURDES JUAN AND ANDY R. MAGID Volume 243 No. 2 December 2009 PACIFIC JOURNAL OF MATHEMATICS Vol. 243,

More information

Linear maps. Matthew Macauley. Department of Mathematical Sciences Clemson University Math 8530, Spring 2017

Linear maps. Matthew Macauley. Department of Mathematical Sciences Clemson University  Math 8530, Spring 2017 Linear maps Matthew Macauley Department of Mathematical Sciences Clemson University http://www.math.clemson.edu/~macaule/ Math 8530, Spring 2017 M. Macauley (Clemson) Linear maps Math 8530, Spring 2017

More information

ON POONEN S CONJECTURE CONCERNING RATIONAL PREPERIODIC POINTS OF QUADRATIC MAPS

ON POONEN S CONJECTURE CONCERNING RATIONAL PREPERIODIC POINTS OF QUADRATIC MAPS ROCKY MOUNTAIN JOURNAL OF MATHEMATICS Volume 43, Number 1, 2013 ON POONEN S CONJECTURE CONCERNING RATIONAL PREPERIODIC POINTS OF QUADRATIC MAPS BENJAMIN HUTZ AND PATRICK INGRAM ABSTRACT. The purpose of

More information

CORRESPONDENCE BETWEEN ELLIPTIC CURVES IN EDWARDS-BERNSTEIN AND WEIERSTRASS FORMS

CORRESPONDENCE BETWEEN ELLIPTIC CURVES IN EDWARDS-BERNSTEIN AND WEIERSTRASS FORMS CORRESPONDENCE BETWEEN ELLIPTIC CURVES IN EDWARDS-BERNSTEIN AND WEIERSTRASS FORMS DEPARTMENT OF MATHEMATICS AND STATISTICS UNIVERSITY OF OTTAWA SUPERVISOR: PROFESSOR MONICA NEVINS STUDENT: DANG NGUYEN

More information

Invariant varieties for polynomial dynamical systems

Invariant varieties for polynomial dynamical systems Annals of Mathematics 00 (XXXX), 1 99 http://dx.doi.org/10.4007/annals.xxxx.00.0.0000 Invariant varieties for polynomial dynamical systems By Alice Medvedev and Thomas Scanlon Abstract We study algebraic

More information

Arithmetic Mirror Symmetry

Arithmetic Mirror Symmetry Arithmetic Mirror Symmetry Daqing Wan April 15, 2005 Institute of Mathematics, Chinese Academy of Sciences, Beijing, P.R. China Department of Mathematics, University of California, Irvine, CA 92697-3875

More information

GALOIS GROUPS ATTACHED TO POINTS OF FINITE ORDER ON ELLIPTIC CURVES OVER NUMBER FIELDS (D APRÈS SERRE)

GALOIS GROUPS ATTACHED TO POINTS OF FINITE ORDER ON ELLIPTIC CURVES OVER NUMBER FIELDS (D APRÈS SERRE) GALOIS GROUPS ATTACHED TO POINTS OF FINITE ORDER ON ELLIPTIC CURVES OVER NUMBER FIELDS (D APRÈS SERRE) JACQUES VÉLU 1. Introduction Let E be an elliptic curve defined over a number field K and equipped

More information

Introduction to Algebraic Geometry. Jilong Tong

Introduction to Algebraic Geometry. Jilong Tong Introduction to Algebraic Geometry Jilong Tong December 6, 2012 2 Contents 1 Algebraic sets and morphisms 11 1.1 Affine algebraic sets.................................. 11 1.1.1 Some definitions................................

More information

Q N id β. 2. Let I and J be ideals in a commutative ring A. Give a simple description of

Q N id β. 2. Let I and J be ideals in a commutative ring A. Give a simple description of Additional Problems 1. Let A be a commutative ring and let 0 M α N β P 0 be a short exact sequence of A-modules. Let Q be an A-module. i) Show that the naturally induced sequence is exact, but that 0 Hom(P,

More information

Math 429/581 (Advanced) Group Theory. Summary of Definitions, Examples, and Theorems by Stefan Gille

Math 429/581 (Advanced) Group Theory. Summary of Definitions, Examples, and Theorems by Stefan Gille Math 429/581 (Advanced) Group Theory Summary of Definitions, Examples, and Theorems by Stefan Gille 1 2 0. Group Operations 0.1. Definition. Let G be a group and X a set. A (left) operation of G on X is

More information

VARIETIES WITHOUT EXTRA AUTOMORPHISMS II: HYPERELLIPTIC CURVES

VARIETIES WITHOUT EXTRA AUTOMORPHISMS II: HYPERELLIPTIC CURVES VARIETIES WITHOUT EXTRA AUTOMORPHISMS II: HYPERELLIPTIC CURVES BJORN POONEN Abstract. For any field k and integer g 2, we construct a hyperelliptic curve X over k of genus g such that #(Aut X) = 2. We

More information

Group, Rings, and Fields Rahul Pandharipande. I. Sets Let S be a set. The Cartesian product S S is the set of ordered pairs of elements of S,

Group, Rings, and Fields Rahul Pandharipande. I. Sets Let S be a set. The Cartesian product S S is the set of ordered pairs of elements of S, Group, Rings, and Fields Rahul Pandharipande I. Sets Let S be a set. The Cartesian product S S is the set of ordered pairs of elements of S, A binary operation φ is a function, S S = {(x, y) x, y S}. φ

More information

Fundamental groups, polylogarithms, and Diophantine

Fundamental groups, polylogarithms, and Diophantine Fundamental groups, polylogarithms, and Diophantine geometry 1 X: smooth variety over Q. So X defined by equations with rational coefficients. Topology Arithmetic of X Geometry 3 Serious aspects of the

More information

LECTURE 10, MONDAY MARCH 15, 2004

LECTURE 10, MONDAY MARCH 15, 2004 LECTURE 10, MONDAY MARCH 15, 2004 FRANZ LEMMERMEYER 1. Minimal Polynomials Let α and β be algebraic numbers, and let f and g denote their minimal polynomials. Consider the resultant R(X) of the polynomials

More information

Symbolic-Algebraic Methods for Linear Partial Differential Operators (LPDOs) RISC Research Institute for Symbolic Computation

Symbolic-Algebraic Methods for Linear Partial Differential Operators (LPDOs) RISC Research Institute for Symbolic Computation Symbolic-Algebraic Methods for Linear Partial Differential Operators (LPDOs) Franz Winkler joint with Ekaterina Shemyakova RISC Research Institute for Symbolic Computation Johannes Kepler Universität.

More information

Computing a Lower Bound for the Canonical Height on Elliptic Curves over Q

Computing a Lower Bound for the Canonical Height on Elliptic Curves over Q Computing a Lower Bound for the Canonical Height on Elliptic Curves over Q John Cremona 1 and Samir Siksek 2 1 School of Mathematical Sciences, University of Nottingham, University Park, Nottingham NG7

More information

Math 121 Homework 5: Notes on Selected Problems

Math 121 Homework 5: Notes on Selected Problems Math 121 Homework 5: Notes on Selected Problems 12.1.2. Let M be a module over the integral domain R. (a) Assume that M has rank n and that x 1,..., x n is any maximal set of linearly independent elements

More information