Linear differential and recurrence equations viewed as data-structures

Size: px
Start display at page:

Download "Linear differential and recurrence equations viewed as data-structures"

Transcription

1 Linear differential and recurrence equations viewed as data-structures Bruno Salvy Inria & ENS de Lyon Leçons de Mathématiques et d'informatique d'aujourd'hui Bordeaux, Mai 2015

2 Computer Algebra Effective mathematics (what can we compute?) Their complexity (how fast?) Several million users. 30 years of algorithmic progress. Thesis in this presentation: linear differential and recurrence equations are a good data-structure. 2

3 Topics Fast computation with high precision; automatic proofs of identities; «computation» of expansions, of (multiple) integrals, of (multiple) sums. 3

4 The objects of study Def. A power series is called differentially finite (D-finite) when it is the solution of a linear differential equation with polynomial coefficients. Exs: sin, cos, exp, log, arcsin, arccos, arctan, arcsinh,hypergeometric series, Bessel functions, Def. A sequence is polynomially recursive (P-recursive) when it is the solution of a linear recurrence with polynomial coefficients. 1X Prop. f = f n z n D-finite P-recursive. n=0 f n 4

5 Example Coefficient of X in P(X)=(1+X) (1+X+X 2 ) 10000? Linear differential equation of order 1 linear recurrence of order 2 unroll (cleverly). > P := (1+x)^(2*N)*(1+x+x^2)^N: > deq := gfun:-holexprtodiffeq(p,y(x)): > rec := gfun:-diffeqtorec(%,y(x),u(k)): > p := gfun:-rectoproc(subs(n=10000,rec),u(k)): > p(20000); 23982[ digits...]33952 Total time: 0.5 sec 5

6 I. Fast computation at large precision From large integers to precise numerical values

7 Fast multiplication Fast Fourier Transform (Gauss, Cooley-Tuckey, Schönhage-Strassen). Two integers of n digits can be multiplied with O(n log(n) loglog(n)) bit operations. Direct consequence (by Newton iteration): inverses, square-roots, : same cost. 7

8 Binary Splitting for linear recurrences (70 s and 80 s) n! by divide-and-conquer: Cost: O(n log 3 n loglog n) using FFT linear recurrences of order 1 reduce to arbitrary order: same idea, same cost (matrix factorial): ex: e n := en e n 1 nx k=0 n! :=n bn/2c {z } size O(n log n) 1 k! = 1 n satisfies a 2nd order rec, computed via n n {z 0 } A(n) (bn/2c + 1) 1 {z } size O(n log n) p!(n) := (p(n) p(bn/2c)) (p(bn/2c + 1) p(1)) en 1 e n 2 = 1 1 n! A!(n). 0 8

9 Numerical evaluation of solutions of LDEs Principle: f(x) = NX n=0 a n x n {z } fast evaluation f solution of a LDE with coeffs in Q(x) (our data-structure!) 1. linear recurrence in N for the first sum (easy); 2. tight bounds on the tail (technical); + 3. no numerical roundoff errors. 1X n=n+1 a n x n {z } good bounds The technique used for fast evaluation of constants like 1 = 12 C 3/2 1X n=0 ( 1) n (6n)!(A + nb) (3n)!n! 3 C 3n with A= , B= , C=

10 Analytic continuation Compute f(x), f 0 (x),...,f (d 1) (x) as new initial conditions and handle error propagation: Ex: erf(π) with 15 digits: arctan(1+i) 0! 200 terms ! 18 terms ! 6terms Again: computation on integers. No roundoff errors. 10

11 II. Proofs of Identities

12 Confinement k+1 vectors in dimension k an identity LDE the function and all its derivatives are confined in a finite dimensional vector space the sum and product of solutions of LDEs satisfy LDEs same property for P-recursive sequences 12

13 Proof technique > series(sin(x)^2+cos(x)^2-1,x,4); f satisfies a LDE f,f,f, live in a finite-dim. vector space O(x 4 ) Why is this a proof? 1. sin and cos satisfy a 2nd order LDE: y +y=0; 2. their squares and their sum satisfy a 3rd order LDE; 3. the constant -1 satisfies y =0; 4. thus sin 2 +cos 2-1 satisfies a LDE of order at most 4; 5. Cauchy s theorem concludes. Proofs of non-linear identities by linear algebra! 13

14 Example: Mehler s identity for Hermite polynomials 1X n=0 H n (x)h n (y) un n! = exp 4u(xy u(x 2 +y 2 )) 1 4u 2 p 1 4u 2 1. Definition of Hermite polynomials: recurrence of order 2; 2. Product by linear algebra: H n+k (x)h n+k (y)/(n+k)!, k N generated over H n (x)h n (y) n! Q (x,n) by, H n+1(x)h n (y) n!, H n(x)h n+1 (y) n! recurrence of order at most 4; 3. Translate into differential equation., H n+1(x)h n+1 (y) n! 14

15 Dynamic Dictionary of Mathematical Functions User need Recent algorithmic progress Maths on the web 15

16 Demonstration 16

17 Guess & prove continued fractions 1. Differential equation produces first terms (easy): arctan x = Taylor x x x x Guess a formula (easy): a n = n2 4n Prove that the CF with these a n satisfies the differential equation. Continued fraction No human intervention needed. 17

18 Automatic Proof of the guessed CF arctan x =? Aim: RHS satisfies (x 2 +1)y -1=0; 1 + Convergents P n /Q n where P n and Q n satisfy the LRE u n =u n-1 +a n u n-2 (and Q n (0) 0); 1 + x n 2 4n 2 1 x2 1 + Define H n :=(Q n ) 2 ((x 2 +1)(P n /Q n ) -1); H n is a polynomial in P n,q n and their derivatives; therefore, it satisfies a LRE that can be computed; from it, H n =O(x n ) visible from there, (P n /Q n ) -1/(1+x 2 )=O(x n ) too; conclude P n /Q n arctan by integrating. 18

19 III. Ore Polynomials

20 From equations to operators D x d/dx x mult by x product composition D x x=xd x +1 S n (n n+1) n mult by n product composition S n n=(n+1)s n Taylor morphism: D x (n+1)s n ; x S n -1 produces linear recurrence from LDE 20

21 Framework: Ore polynomials (fg) 0 = f 0 g+fg 0, S n (f n g n )=f n+1 S n (g n ), n(f n g n )=f n+1 n (g n )+ n (f n )g n, and many more (e.g., q-analogues) are captured by A (A integral domain) with = (a)@ + (a) σ a ring morphism, δ a σ-derivation (δ(ab)=σ(a)δ(b)+δ(a)b). Main property: A,B in A, then deg AB=deg A+deg B. Consequence 1: (non-commutative) Euclidean division Consequence 2: (non-commutative) Euclidean algorithm 21

22 GCRD & LCLM greatest common right divisor & least common left multiple GCRD(A,B): maximal operator whose solutions are common to A and B. LCLM(A,B): minimal operator having the solutions of A and B for solutions. Example: closure by sum. Computation: Euclidean algorithm or linear algebra. 22

23 Reduction of order Input: a (large) linear recurrence equation + ini. cond Output: a factor annihilating this solution Step 1: use the recurrence and its initial conditions to compute a large number of terms; Step 2: guess a linear recurrence equation annihilating this sequence (linear algebra); Step 3: take the gcrd of this operator and the initial one; Step 3: prove that this factor annihilates the solution by checking sufficiently many initial conditions. 23

24 Example from a continued fraction expansion P k = a k x 2 P k 2 + P k 1, a k = ( 2k (2k+1)(2k+3), 2(k+2) (2k+1)(2k+3), k even, k odd. Aim: a recurrence for all k. Step 1: use both recurrences to find a relation between P k,p k+2,p k+4 for even k and one for odd k; Step 2: compute their LCLM (order 8); Step 3: use the initial conditions to reduce (order 4). 24

25 Chebyshev expansions arctan Taylor Chebyshev z 1 3 z z5 + 2( p T1 (x) 2 + 1) (2 p 2 + 3) T 3 (x) 3(2 p 2 + 3) + T 5 (x) 2 5(2 p 2 + 3)

26 Ore fractions Generalize commutative case: R=Q -1 P with P & Q operators. B -1 A=D -1 C when ba=dc with bb=dd=lclm(b,d). Algorithms for sum and product: B -1 A+D -1 C=LCLM(B,D) -1 (ba+dc), with bb=dd=lclm(b,d) B -1 AD -1 C=(aB) -1 dc, with aa=dd=lclm(a,d). 26

27 Application: Chebyshev expansions Extend Taylor morphism to Chebyshev expansions Taylor x n+1 =x x n x X:=S -1 (x n ) =nx n-1 d/dx D:=(n+1)S Chebyshev 2xT n (x)=t n+1 (x)+t n-1 (x) x X:=(S+S -1 )/2 2(1-x 2 )T n (x)=-nt n+1 (x)+nt n-1 (x) d/dx D:=(1-X 2 ) -1 n(s-s -1 )/2. Prop. If y is a solution of L(x,d/dx), then its Chebyshev coefficients annihilate the numerator of L(X,D). 27

28 IV. Systems of equations

29 Example: Contiguity of Hypergeometric Series F(a, b; c; z) = 1X n=0 (a) n (b) n (c) n n! {z } u a,n z n, (x) n := x(x + 1) (x + n 1). u a,n+1 (a + n)(b + n) = u a,n (c + n)(n + 1)! z(1 z)f00 +(c (a + b + 1)z)F 0 abf = 0, u a+1,n = n u a,n a + 1! S af := F(a + 1, b; c; z) = z a F0 + F. S a Gauss 1812: contiguity relation. dim=2 ) S 2 af, S a F, F linearly dependent (coordinates in Q(a,b,c,z)) (a + 1)(z 1)S 2 af +((b a 1)z + 2 c + 2a)S a F +(c a 1)F = 0. z 29

30 Ore Algebras O:=K(x 1,,x r ) 1,, r :=K(x 1,,x r ) 1 r, with commuting i s and for i j, δ i ( j )=0 and σ i ( j )= j. Def. LM (leading monomial) on next slide. Main property: A,B in O, then LM(AB)=LM(A)LM(B). Consequence: (non-commutative) Gröbner bases Gröbner bases as a data-structure to encode special functions 30

31 Gröbner Bases 1. Monomial ordering: order on N k, compatible with +, 0 minimal. 2. Leading monomial of a polynomial: the largest one. 3. Gröbner basis of a (left) ideal I: corners of stairs. 4. Quotient mod I: basis below the stairs (Vect{ α f}). 5. Reduction of P: Rewrite P mod I on this basis. 6. Dimension: «size» of the quotient. 7. D-finiteness: dimension 0. An access to (finite-dimensional) vector spaces. 31

32 Closure Properties + Proposition. dim ann(f + g) apple max(dim ann f, dim ann g), dim ann(fg) apple dim ann f + dim ann g, dim ann(@f) apple dim ann f. Algorithms by linear algebra simple definitions data-structures for more complicated functions 32

33 V. Sums and Integrals

34 Examples X j,k nx 2 2 n n + k nx kx 3 n n + k k = k k k k j k=0 k=0 j=0 j + k r n s + n j k n + r s r ( 1) j+k =( 1) l k + l j k m j n + l m n l Z i xj 1 (ax)i 1 (ax)y 0 (x)k 0 (x) dx = ln(1 a4 ) 2 a 2 I (1 + 2xy + 4y 2 )exp 4x 2 y 2 1+4y 2 dy = H n(x) y n+1 (1 + 4y 2 ) 3 2 bn/2c! nx k=0 q k2 (q; q) k (q; q) n k = nx k= n ( 1) k q (5k2 k)/2 (q; q) n k (q; q) n+k Aims: 1. Prove them automatically 2. Find the rhs given the lhs Note: at least one free variable 34

35 I(x) = Example: u(n, k) = S(n + 1) = X k Creative telescoping Z Input: equations (differential for f or recurrence for u). n def. by k n + 1 f(x, t) dt =? or U(n) = X k k n + 1 = n + 1 n n, k n + 1 k k k + 1 = X n + 1 n + 1 n + k k + 1 k + 1 k {z } telesc. Output: equations for the sum or the integral. {z } telesc. IF one knows A(n,S n ) and B(n,k,S n,s k ) such that u(n, k) =? = n k n k + 1 k n n +2 k k Pascal = 2S(n). (A(n,S n )+Δ k B(n,k,S n,s k )) u(n,k)=0, certificate then the sum telescopes, leading to A(n,S n ) U(n)=0. 35

36 Creative Telescoping Z I(x) = f(x, t) dt =? IF one knows A(x, x ) and B(x,t, x, t ) such that (A(x, x ) + t B(x,t, x, t )) f(x,t)=0, then the integral «telescopes», leading to A(x, x ) I(x)=0. Then I come along and try differentiating under the integral sign, and often it worked. So I got a great reputation for doing integrals. Richard P. Feynman 1985 Method: integration (summation) by parts and differentiation (difference) under the integral (sum) sign 36

37 Telescoping Ideal T t (f) := Ann f t Q(x,t)h@ x,@ t i {z } int. by parts \ Q(x)h@ x i. {z } di. under R hypergeometric summation: dim=1 + param. Gosper. [Zeilberger] holonomy: restrict int. by parts to Q(x)h@ x,@ t i and Gröbner bases. [Wilf-Zeilberger, also Sister Celine] finite dim, Ore algebras & GB [Chyzak] infinite dim & GB rational f and restrict to Q(x)[t, 1/den f]h@ x,@ t i in very good complexity

38 Chyzak s Algorithm T t (f) := Ann f t Q(x,t)h@ t i {z } int. by parts \ Q(x)h@ x i. {z } di. under R Input: a Gröbner basis G for Ann f in A= Q(x, t)h@ t i Output: P in Q(x)h@ x i and Q in A, reduced wrt G and such that (P+ t Q)f=0. For r=1,2,3, 1. use indeterminate coefficients to define Q = X q i,j (x, t)@ i x@ j t, P = X (i,j) below stairs appler p (x)@ x. 2. reduce P+ t Q using G, leading to a 1st order system for q i,j (x,t) and p α (x); 3. stop if a rational solution is found. 38

39 Examples of applications Hypergeometric: binomial sums, hypergeometric series; 2nX k=0 ( 1) k 2n k Higher dimension: classical orthogonal polynomials, special functions like Bessel, Airy, Struve, Weber, Anger, hypergeometric and generalized hypergeometric, J 0 (z) = 2 3 =( Z 1 Infinite dimension: Bernoulli, Stirling or Eulerian numbers, incomplete Gamma function, Z ) n (3n)! n! 3 cos(zt) p dt 1 t 2 exp( xy) (n, x) dx = (n) y 1 1 (y + 1) n 39

40 VI. Faster Creative Telescoping

41 Certificates are big n n + s n + r 2n r s C n := X r,s n ( 1) n+r+s r s s r n {z } f n,r,s (n + 2) 3 C n+2 2(2n + 3)(3n 2 + 9n + 7)C n+1 (4n + 3)(4n + 4)(4n + 5)C n = 180 kb ' 2 pages I(z) = I (1 + t 3 ) 2 dt 1 dt 2 dt 3 t 1 t 2 t 3 (1 + t 3 (1 + t 1 ))(1 + t 3 (1 + t 2 )) + z(1 + t 1 )(1 + t 2 )(1 + t 3 ) 4 z 2 (4z + 1)(16z 1)I 000 (z)+3z(128z z 1)I 00 (z)+(444z z 1)I 0 (z)+2(30z + 1)I(z) =1 080 kb Next, in T t (f) := Ann f t Q(x,t)h@ t i {z } int. by parts \ Q(x)h@ x i. {z } di. under R ' 12 pages we restrict to rational f t Q(x)[t, 1/ den f]h@ t i 41

42 Bivariate integrals by Hermite reduction I(t) = I P(t, x) Q m (t, x) dx Q square-free Int. over a cycle where Q 0. If m=1, Euclidean division: P=aQ+r, deg x r<deg x Q apple P P Def. Reduced form: Q = r Z Q x a Q If m>1, Bézout identity and integration by parts P = uq + v@ x Q! P u Q m = m 1 v/(1 m) Q m 1 +@ x Q m 1 {z } A m 1 Algorithm: R 0 :=[P/Q m ] for i=1,2, do R i :=[ t R i-1 ] when there is a relation c 0 (t)r 0 + +c i (t)r i =0 return c 0 + +c i t i apple P := r Q Q m := [A m 1] 42

43 More variables: Griffiths-Dwork reduction I(t) = I P(t, x) Q m (t, x) dx 1. Control degrees by homogenizing (x 1,,x n ) (x 0,,x n ) 2. If m=1, [P/Q]:=P/Q 3. If m>1, reduce modulo Jacobian ideal J := h@ 0 Q,...,@ n Qi P= r + v 0 Q + + v n Q P Q m = r 1 v 0 Q 0 m 1 Q m apple P Q m := r Q m +[A m 1] 1 + n v n Q m m 1 Thm. [Griffiths] In the regular case ( Q(t)[x]/J Q square-free Int. over a cycle where Q 0 v 0 + n v n Q m 1 {z } A m 1 finite dim), if R=P/Q m H hom of degree -n-1,[r] =0, Rdx = 0. SAME ALGORITHM. 43

44 Size and complexity I(t) = I P(t, x) Q m (t, x) {z } 2Q(t,x) dx no regularity assumed N := deg x Q, d t := max(deg t Q, deg t P) deg x P not too big Thm. A linear differential equation for I(t) can be computed in O(e 3n N 8n d t ) operations in Q. It has order N n and degree O(e n N 3n d t ). tight Note: generically, the certificate has at least N n2 /2 monomials. This has consequences for multiple binomial sums. 44

45 Conclusion Linear differential equations and recurrences are a great data-structure; Numerous algorithms have been developed in computer algebra; Efficient code is available; More is to be found (certificate-free algorithms, diagonals, )

Linear Differential Equations as a Data-Structure

Linear Differential Equations as a Data-Structure Linear Differential Equations as a Data-Structure Bruno Salvy Inria & ENS de Lyon FoCM, July 14, 2017 Computer Algebra Effective mathematics: what can we compute exactly? And complexity: how fast? (also,

More information

Automatic Proofs of Identities: Beyond A=B

Automatic Proofs of Identities: Beyond A=B Bruno.Salvy@inria.fr FPSAC, Linz, July 20, 2009 Joint work with F. Chyzak and M. Kauers 1 / 28 I Introduction 2 / 28 Examples of Identities: Definite Sums, q-sums, Integrals n k=0 + 0 1 2πi n=0 ( ) H n

More information

The Dynamic Dictionary of Mathematical Functions

The Dynamic Dictionary of Mathematical Functions The Dynamic Dictionary of Mathematical Functions Bruno.Salvy@inria.fr AISC 2010. July 6, 2010 Joint work with: Alexandre Benoit, Alin Bostan, Frédéric Chyzak, Alexis Darrasse, Stefan Gerhold, Marc Mezzarobba

More information

Algorithmic Tools for the Asymptotics of Linear Recurrences

Algorithmic Tools for the Asymptotics of Linear Recurrences Algorithmic Tools for the Asymptotics of Linear Recurrences Bruno Salvy Inria & ENS de Lyon Computer Algebra in Combinatorics, Schrödinger Institute, Vienna, Nov. 2017 Motivation p 0 (n)a n+k + + p k (n)a

More information

This ODE arises in many physical systems that we shall investigate. + ( + 1)u = 0. (λ + s)x λ + s + ( + 1) a λ. (s + 1)(s + 2) a 0

This ODE arises in many physical systems that we shall investigate. + ( + 1)u = 0. (λ + s)x λ + s + ( + 1) a λ. (s + 1)(s + 2) a 0 Legendre equation This ODE arises in many physical systems that we shall investigate We choose We then have Substitution gives ( x 2 ) d 2 u du 2x 2 dx dx + ( + )u u x s a λ x λ a du dx λ a λ (λ + s)x

More information

Algorithmic Tools for the Asymptotics of Diagonals

Algorithmic Tools for the Asymptotics of Diagonals Algorithmic Tools for the Asymptotics of Diagonals Bruno Salvy Inria & ENS de Lyon Lattice walks at the Interface of Algebra, Analysis and Combinatorics September 19, 2017 Asymptotics & Univariate Generating

More information

Diagonals: Combinatorics, Asymptotics and Computer Algebra

Diagonals: Combinatorics, Asymptotics and Computer Algebra Diagonals: Combinatorics, Asymptotics and Computer Algebra Bruno Salvy Inria & ENS de Lyon Families of Generating Functions (a n ) 7! A(z) := X n 0 a n z n counts the number of objects of size n captures

More information

Algorithmic Tools for the Asymptotics of Linear Recurrences

Algorithmic Tools for the Asymptotics of Linear Recurrences Algorithmic Tools for the Asymptotics of Linear Recurrences Bruno Salvy Inria & ENS de Lyon aaacuxicbvhlbtraejw1r2beg+aghxhrsgitvjycahkhcc7cskqsibs2vunxez3jpjyznsli+rf4bq7wbfwknz6f8torzenli5wqutvtxvklhcmo+juirl2/cfpwxu3wzt179x8mnx9+cqa2hkbcsgmpm+zacg1tfcjhsllavcbhidt+3+khn8e6yfq+litifvtouqjo0fpz4epelmacmfmvbkzgpnfwes2hw9ekwhw9cujzslxz9ofeb0li7nxz8dxjda8vaossotelowrthlkuxeibjhih/m96gwwtijzhqcixbjtxevdtmnqoksap2qjmhmqmwkxn2cpds0eeymlhrh8a6yr9d6rhyrmlynynyli6da0j/6fnaixep43qvy2geb+oqcvfq7tt0vxy4cixhjbuhbdcecks4+gpgiywnjxyoxtt+yveftkurjby1kzq19wcksgxfx1/m/3sef2o/q5rucybdln2pk1pxjyvctd9lapqmhbugrxfjtf7cdp0g52v0ccyr+d1fuxftt5m4j2f5dvs1wz5qp6r5yqm22shfcc7zeo4+uk+ke/kr/a2yiiyoopbg8h5zcnyqql3bxdu3c8=

More information

Section Taylor and Maclaurin Series

Section Taylor and Maclaurin Series Section.0 Taylor and Maclaurin Series Ruipeng Shen Feb 5 Taylor and Maclaurin Series Main Goal: How to find a power series representation for a smooth function us assume that a smooth function has a power

More information

Bon anniversaire Marc!

Bon anniversaire Marc! Bon anniversaire Marc! The full counting function of Gessel walks is algebraic Alin Bostan (INRIA) joint work with Manuel Kauers (INRIA/RISC) Journées GECKO/TERA 2008 Context: restricted lattice walks

More information

Section III.6. Factorization in Polynomial Rings

Section III.6. Factorization in Polynomial Rings III.6. Factorization in Polynomial Rings 1 Section III.6. Factorization in Polynomial Rings Note. We push several of the results in Section III.3 (such as divisibility, irreducibility, and unique factorization)

More information

CS 4424 GCD, XGCD

CS 4424 GCD, XGCD CS 4424 GCD, XGCD eschost@uwo.ca GCD of polynomials First definition Let A and B be in k[x]. k[x] is the ring of polynomials with coefficients in k A Greatest Common Divisor of A and B is a polynomial

More information

PUTNAM PROBLEMS SEQUENCES, SERIES AND RECURRENCES. Notes

PUTNAM PROBLEMS SEQUENCES, SERIES AND RECURRENCES. Notes PUTNAM PROBLEMS SEQUENCES, SERIES AND RECURRENCES Notes. x n+ = ax n has the general solution x n = x a n. 2. x n+ = x n + b has the general solution x n = x + (n )b. 3. x n+ = ax n + b (with a ) can be

More information

Fast Polynomial Multiplication

Fast Polynomial Multiplication Fast Polynomial Multiplication Marc Moreno Maza CS 9652, October 4, 2017 Plan Primitive roots of unity The discrete Fourier transform Convolution of polynomials The fast Fourier transform Fast convolution

More information

Moreover this binary operation satisfies the following properties

Moreover this binary operation satisfies the following properties Contents 1 Algebraic structures 1 1.1 Group........................................... 1 1.1.1 Definitions and examples............................. 1 1.1.2 Subgroup.....................................

More information

5.4 Bessel s Equation. Bessel Functions

5.4 Bessel s Equation. Bessel Functions SEC 54 Bessel s Equation Bessel Functions J (x) 87 # with y dy>dt, etc, constant A, B, C, D, K, and t 5 HYPERGEOMETRIC ODE At B (t t )(t t ), t t, can be reduced to the hypergeometric equation with independent

More information

Closed Form Solutions

Closed Form Solutions Closed Form Solutions Mark van Hoeij 1 Florida State University ISSAC 2017 1 Supported by NSF 1618657 1 / 26 What is a closed form solution? Example: Solve this equation for y = y(x). y = 4 x 3 (1 x) 2

More information

Closed Form Solutions

Closed Form Solutions Closed Form Solutions Mark van Hoeij 1 Florida State University Slides of this talk: www.math.fsu.edu/ hoeij/issac2017.pdf 1 Supported by NSF 1618657 1 / 29 What is a closed form solution? Example: Solve

More information

Ch 7 Summary - POLYNOMIAL FUNCTIONS

Ch 7 Summary - POLYNOMIAL FUNCTIONS Ch 7 Summary - POLYNOMIAL FUNCTIONS 1. An open-top box is to be made by cutting congruent squares of side length x from the corners of a 8.5- by 11-inch sheet of cardboard and bending up the sides. a)

More information

Notes on generating functions in automata theory

Notes on generating functions in automata theory Notes on generating functions in automata theory Benjamin Steinberg December 5, 2009 Contents Introduction: Calculus can count 2 Formal power series 5 3 Rational power series 9 3. Rational power series

More information

SYMMETRY AND SPECIALIZABILITY IN THE CONTINUED FRACTION EXPANSIONS OF SOME INFINITE PRODUCTS

SYMMETRY AND SPECIALIZABILITY IN THE CONTINUED FRACTION EXPANSIONS OF SOME INFINITE PRODUCTS SYMMETRY AND SPECIALIZABILITY IN THE CONTINUED FRACTION EXPANSIONS OF SOME INFINITE PRODUCTS J MC LAUGHLIN Abstract Let fx Z[x] Set f 0x = x and for n 1 define f nx = ff n 1x We describe several infinite

More information

On homogeneous Zeilberger recurrences

On homogeneous Zeilberger recurrences Advances in Applied Mathematics 40 (2008) 1 7 www.elsevier.com/locate/yaama On homogeneous Zeilberger recurrences S.P. Polyakov Dorodnicyn Computing Centre, Russian Academy of Science, Vavilova 40, Moscow

More information

SQUARE ROOTS OF 2x2 MATRICES 1. Sam Northshield SUNY-Plattsburgh

SQUARE ROOTS OF 2x2 MATRICES 1. Sam Northshield SUNY-Plattsburgh SQUARE ROOTS OF x MATRICES Sam Northshield SUNY-Plattsburgh INTRODUCTION A B What is the square root of a matrix such as? It is not, in general, A B C D C D This is easy to see since the upper left entry

More information

Chapter 11. Taylor Series. Josef Leydold Mathematical Methods WS 2018/19 11 Taylor Series 1 / 27

Chapter 11. Taylor Series. Josef Leydold Mathematical Methods WS 2018/19 11 Taylor Series 1 / 27 Chapter 11 Taylor Series Josef Leydold Mathematical Methods WS 2018/19 11 Taylor Series 1 / 27 First-Order Approximation We want to approximate function f by some simple function. Best possible approximation

More information

Computational Complexity - Pseudocode and Recursions

Computational Complexity - Pseudocode and Recursions Computational Complexity - Pseudocode and Recursions Nicholas Mainardi 1 Dipartimento di Elettronica e Informazione Politecnico di Milano nicholas.mainardi@polimi.it June 6, 2018 1 Partly Based on Alessandro

More information

CALCULUS JIA-MING (FRANK) LIOU

CALCULUS JIA-MING (FRANK) LIOU CALCULUS JIA-MING (FRANK) LIOU Abstract. Contents. Power Series.. Polynomials and Formal Power Series.2. Radius of Convergence 2.3. Derivative and Antiderivative of Power Series 4.4. Power Series Expansion

More information

Math 192r, Problem Set #3: Solutions

Math 192r, Problem Set #3: Solutions Math 192r Problem Set #3: Solutions 1. Let F n be the nth Fibonacci number as Wilf indexes them (with F 0 F 1 1 F 2 2 etc.). Give a simple homogeneous linear recurrence relation satisfied by the sequence

More information

Course 311: Michaelmas Term 2005 Part III: Topics in Commutative Algebra

Course 311: Michaelmas Term 2005 Part III: Topics in Commutative Algebra Course 311: Michaelmas Term 2005 Part III: Topics in Commutative Algebra D. R. Wilkins Contents 3 Topics in Commutative Algebra 2 3.1 Rings and Fields......................... 2 3.2 Ideals...............................

More information

SOLVED PROBLEMS ON TAYLOR AND MACLAURIN SERIES

SOLVED PROBLEMS ON TAYLOR AND MACLAURIN SERIES SOLVED PROBLEMS ON TAYLOR AND MACLAURIN SERIES TAYLOR AND MACLAURIN SERIES Taylor Series of a function f at x = a is ( f k )( a) ( x a) k k! It is a Power Series centered at a. Maclaurin Series of a function

More information

and the compositional inverse when it exists is A.

and the compositional inverse when it exists is A. Lecture B jacques@ucsd.edu Notation: R denotes a ring, N denotes the set of sequences of natural numbers with finite support, is a generic element of N, is the infinite zero sequence, n 0 R[[ X]] denotes

More information

Polynomial evaluation and interpolation on special sets of points

Polynomial evaluation and interpolation on special sets of points Polynomial evaluation and interpolation on special sets of points Alin Bostan and Éric Schost Laboratoire STIX, École polytechnique, 91128 Palaiseau, France Abstract We give complexity estimates for the

More information

Intro to Rings, Fields, Polynomials: Hardware Modeling by Modulo Arithmetic

Intro to Rings, Fields, Polynomials: Hardware Modeling by Modulo Arithmetic Intro to Rings, Fields, Polynomials: Hardware Modeling by Modulo Arithmetic Priyank Kalla Associate Professor Electrical and Computer Engineering, University of Utah kalla@ece.utah.edu http://www.ece.utah.edu/~kalla

More information

Lecture Notes on DISCRETE MATHEMATICS. Eusebius Doedel

Lecture Notes on DISCRETE MATHEMATICS. Eusebius Doedel Lecture Notes on DISCRETE MATHEMATICS Eusebius Doedel c Eusebius J. Doedel, 009 Contents Logic. Introduction............................................................................... Basic logical

More information

Week 9-10: Recurrence Relations and Generating Functions

Week 9-10: Recurrence Relations and Generating Functions Week 9-10: Recurrence Relations and Generating Functions April 3, 2017 1 Some number sequences An infinite sequence (or just a sequence for short is an ordered array a 0, a 1, a 2,..., a n,... of countably

More information

Power Series Solutions to the Legendre Equation

Power Series Solutions to the Legendre Equation Department of Mathematics IIT Guwahati The Legendre equation The equation (1 x 2 )y 2xy + α(α + 1)y = 0, (1) where α is any real constant, is called Legendre s equation. When α Z +, the equation has polynomial

More information

swapneel/207

swapneel/207 Partial differential equations Swapneel Mahajan www.math.iitb.ac.in/ swapneel/207 1 1 Power series For a real number x 0 and a sequence (a n ) of real numbers, consider the expression a n (x x 0 ) n =

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

(3) Let Y be a totally bounded subset of a metric space X. Then the closure Y of Y

(3) Let Y be a totally bounded subset of a metric space X. Then the closure Y of Y () Consider A = { q Q : q 2 2} as a subset of the metric space (Q, d), where d(x, y) = x y. Then A is A) closed but not open in Q B) open but not closed in Q C) neither open nor closed in Q D) both open

More information

1 Question related to polynomials

1 Question related to polynomials 07-08 MATH00J Lecture 6: Taylor Series Charles Li Warning: Skip the material involving the estimation of error term Reference: APEX Calculus This lecture introduced Taylor Polynomial and Taylor Series

More information

Chapter 4. Series Solutions. 4.1 Introduction to Power Series

Chapter 4. Series Solutions. 4.1 Introduction to Power Series Series Solutions Chapter 4 In most sciences one generation tears down what another has built and what one has established another undoes. In mathematics alone each generation adds a new story to the old

More information

Fast reversion of formal power series

Fast reversion of formal power series Fast reversion of formal power series Fredrik Johansson LFANT, INRIA Bordeaux RAIM, 2016-06-29, Banyuls-sur-mer 1 / 30 Reversion of power series F = exp(x) 1 = x + x 2 2! + x 3 3! + x 4 G = log(1 + x)

More information

Math Assignment 11

Math Assignment 11 Math 2280 - Assignment 11 Dylan Zwick Fall 2013 Section 8.1-2, 8, 13, 21, 25 Section 8.2-1, 7, 14, 17, 32 Section 8.3-1, 8, 15, 18, 24 1 Section 8.1 - Introduction and Review of Power Series 8.1.2 - Find

More information

1 Series Solutions Near Regular Singular Points

1 Series Solutions Near Regular Singular Points 1 Series Solutions Near Regular Singular Points All of the work here will be directed toward finding series solutions of a second order linear homogeneous ordinary differential equation: P xy + Qxy + Rxy

More information

DIFFERENTIATION RULES

DIFFERENTIATION RULES 3 DIFFERENTIATION RULES DIFFERENTIATION RULES We have: Seen how to interpret derivatives as slopes and rates of change Seen how to estimate derivatives of functions given by tables of values Learned how

More information

TAYLOR AND MACLAURIN SERIES

TAYLOR AND MACLAURIN SERIES TAYLOR AND MACLAURIN SERIES. Introduction Last time, we were able to represent a certain restricted class of functions as power series. This leads us to the question: can we represent more general functions

More information

Math 4263 Homework Set 1

Math 4263 Homework Set 1 Homework Set 1 1. Solve the following PDE/BVP 2. Solve the following PDE/BVP 2u t + 3u x = 0 u (x, 0) = sin (x) u x + e x u y = 0 u (0, y) = y 2 3. (a) Find the curves γ : t (x (t), y (t)) such that that

More information

Relevant sections from AMATH 351 Course Notes (Wainwright): Relevant sections from AMATH 351 Course Notes (Poulin and Ingalls):

Relevant sections from AMATH 351 Course Notes (Wainwright): Relevant sections from AMATH 351 Course Notes (Poulin and Ingalls): Lecture 5 Series solutions to DEs Relevant sections from AMATH 35 Course Notes (Wainwright):.4. Relevant sections from AMATH 35 Course Notes (Poulin and Ingalls): 2.-2.3 As mentioned earlier in this course,

More information

Congruences for Coefficients of Power Series Expansions of Rational Functions. Bachelor Thesis

Congruences for Coefficients of Power Series Expansions of Rational Functions. Bachelor Thesis Congruences for Coefficients of Power Series Expansions of Rational Functions Bachelor Thesis Author Marc Houben 4094573 Supervisor prof. dr. Frits Beukers Acknowledgements First and foremost I would like

More information

Mathematical Olympiad Training Polynomials

Mathematical Olympiad Training Polynomials Mathematical Olympiad Training Polynomials Definition A polynomial over a ring R(Z, Q, R, C) in x is an expression of the form p(x) = a n x n + a n 1 x n 1 + + a 1 x + a 0, a i R, for 0 i n. If a n 0,

More information

OR MSc Maths Revision Course

OR MSc Maths Revision Course OR MSc Maths Revision Course Tom Byrne School of Mathematics University of Edinburgh t.m.byrne@sms.ed.ac.uk 15 September 2017 General Information Today JCMB Lecture Theatre A, 09:30-12:30 Mathematics revision

More information

4. Noether normalisation

4. Noether normalisation 4. Noether normalisation We shall say that a ring R is an affine ring (or affine k-algebra) if R is isomorphic to a polynomial ring over a field k with finitely many indeterminates modulo an ideal, i.e.,

More information

Approximation theory

Approximation theory Approximation theory Xiaojing Ye, Math & Stat, Georgia State University Spring 2019 Numerical Analysis II Xiaojing Ye, Math & Stat, Georgia State University 1 1 1.3 6 8.8 2 3.5 7 10.1 Least 3squares 4.2

More information

Fast Computation of the Nth Term of an Algebraic Series over a Finite Prime Field

Fast Computation of the Nth Term of an Algebraic Series over a Finite Prime Field Fast Computation of the Nth Term of an Algebraic Series over a Finite Prime Field Alin Bostan 1 Gilles Christol 2 Philippe Dumas 1 1 Inria (France) 2 Institut de mathématiques de Jussieu (France) Specfun

More information

q-binomial coefficient congruences

q-binomial coefficient congruences CARMA Analysis and Number Theory Seminar University of Newcastle August 23, 2011 Tulane University, New Orleans 1 / 35 Our first -analogs The natural number n has the -analog: [n] = n 1 1 = 1 + +... n

More information

Power Series Solutions And Special Functions: Review of Power Series

Power Series Solutions And Special Functions: Review of Power Series Power Series Solutions And Special Functions: Review of Power Series Pradeep Boggarapu Department of Mathematics BITS PILANI K K Birla Goa Campus, Goa September, 205 Pradeep Boggarapu (Dept. of Maths)

More information

Linear Recurrence Relations for Sums of Products of Two Terms

Linear Recurrence Relations for Sums of Products of Two Terms Linear Recurrence Relations for Sums of Products of Two Terms Yan-Ping Mu College of Science, Tianjin University of Technology Tianjin 300384, P.R. China yanping.mu@gmail.com Submitted: Dec 27, 2010; Accepted:

More information

Power series and Taylor series

Power series and Taylor series Power series and Taylor series D. DeTurck University of Pennsylvania March 29, 2018 D. DeTurck Math 104 002 2018A: Series 1 / 42 Series First... a review of what we have done so far: 1 We examined series

More information

(vi) xry iff x y 2 (see the previous exercise); (iii) xry iff xy 0;

(vi) xry iff x y 2 (see the previous exercise); (iii) xry iff xy 0; Final: Practice problems Relations Properties Exercise: For the following relations on Z, investigate the four basic properties. (i) arb iff a = b ; (v) arb iff a = b+; (ii) arb iff a b; (vi) arb iff a

More information

The Perrin Conjugate and the Laguerre Orthogonal Polynomial

The Perrin Conjugate and the Laguerre Orthogonal Polynomial The Perrin Conjugate and the Laguerre Orthogonal Polynomial In a previous chapter I defined the conjugate of a cubic polynomial G(x) = x 3 - Bx Cx - D as G(x)c = x 3 + Bx Cx + D. By multiplying the polynomial

More information

Honors Algebra 4, MATH 371 Winter 2010 Assignment 3 Due Friday, February 5 at 08:35

Honors Algebra 4, MATH 371 Winter 2010 Assignment 3 Due Friday, February 5 at 08:35 Honors Algebra 4, MATH 371 Winter 2010 Assignment 3 Due Friday, February 5 at 08:35 1. Let R 0 be a commutative ring with 1 and let S R be the subset of nonzero elements which are not zero divisors. (a)

More information

Engg. Math. II (Unit-IV) Numerical Analysis

Engg. Math. II (Unit-IV) Numerical Analysis Dr. Satish Shukla of 33 Engg. Math. II (Unit-IV) Numerical Analysis Syllabus. Interpolation and Curve Fitting: Introduction to Interpolation; Calculus of Finite Differences; Finite Difference and Divided

More information

E.J. Barbeau. Polynomials. With 36 Illustrations. Springer

E.J. Barbeau. Polynomials. With 36 Illustrations. Springer E.J. Barbeau Polynomials With 36 Illustrations Springer Contents Preface Acknowledgment of Problem Sources vii xiii 1 Fundamentals 1 /l.l The Anatomy of a Polynomial of a Single Variable 1 1.1.5 Multiplication

More information

Euclidean Domains. Kevin James

Euclidean Domains. Kevin James Suppose that R is an integral domain. Any function N : R N {0} with N(0) = 0 is a norm. If N(a) > 0, a R \ {0 R }, then N is called a positive norm. Suppose that R is an integral domain. Any function N

More information

CSC 344 Algorithms and Complexity. Proof by Mathematical Induction

CSC 344 Algorithms and Complexity. Proof by Mathematical Induction CSC 344 Algorithms and Complexity Lecture #1 Review of Mathematical Induction Proof by Mathematical Induction Many results in mathematics are claimed true for every positive integer. Any of these results

More information

Exercises for algebraic curves

Exercises for algebraic curves Exercises for algebraic curves Christophe Ritzenthaler February 18, 2019 1 Exercise Lecture 1 1.1 Exercise Show that V = {(x, y) C 2 s.t. y = sin x} is not an algebraic set. Solutions. Let us assume that

More information

1. Group Theory Permutations.

1. Group Theory Permutations. 1.1. Permutations. 1. Group Theory Problem 1.1. Let G be a subgroup of S n of index 2. Show that G = A n. Problem 1.2. Find two elements of S 7 that have the same order but are not conjugate. Let π S 7

More information

7.1. Calculus of inverse functions. Text Section 7.1 Exercise:

7.1. Calculus of inverse functions. Text Section 7.1 Exercise: Contents 7. Inverse functions 1 7.1. Calculus of inverse functions 2 7.2. Derivatives of exponential function 4 7.3. Logarithmic function 6 7.4. Derivatives of logarithmic functions 7 7.5. Exponential

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

Solutions: Problem Set 3 Math 201B, Winter 2007

Solutions: Problem Set 3 Math 201B, Winter 2007 Solutions: Problem Set 3 Math 201B, Winter 2007 Problem 1. Prove that an infinite-dimensional Hilbert space is a separable metric space if and only if it has a countable orthonormal basis. Solution. If

More information

Diagonals and Walks. Alin Bostan 1 Louis Dumont 1 Bruno Salvy 2. November 4, Introduction Diagonals Walks. 1 INRIA, SpecFun.

Diagonals and Walks. Alin Bostan 1 Louis Dumont 1 Bruno Salvy 2. November 4, Introduction Diagonals Walks. 1 INRIA, SpecFun. and Alin Bostan 1 Louis Dumont 1 Bruno Salvy 2 1 INRIA, SpecFun 2 INRIA, AriC November 4, 2014 1/16 Louis Dumont and 2/16 Louis Dumont and Motivations In combinatorics: Lattice walks w i,j : number of

More information

1 Ordinary points and singular points

1 Ordinary points and singular points Math 70 honors, Fall, 008 Notes 8 More on series solutions, and an introduction to \orthogonal polynomials" Homework at end Revised, /4. Some changes and additions starting on page 7. Ordinary points and

More information

Applications. More Counting Problems. Complexity of Algorithms

Applications. More Counting Problems. Complexity of Algorithms Recurrences Applications More Counting Problems Complexity of Algorithms Part I Recurrences and Binomial Coefficients Paths in a Triangle P(0, 0) P(1, 0) P(1,1) P(2, 0) P(2,1) P(2, 2) P(3, 0) P(3,1) P(3,

More information

ENGI 9420 Lecture Notes 1 - ODEs Page 1.01

ENGI 9420 Lecture Notes 1 - ODEs Page 1.01 ENGI 940 Lecture Notes - ODEs Page.0. Ordinary Differential Equations An equation involving a function of one independent variable and the derivative(s) of that function is an ordinary differential equation

More information

Public-key Cryptography: Theory and Practice

Public-key Cryptography: Theory and Practice Public-key Cryptography Theory and Practice Department of Computer Science and Engineering Indian Institute of Technology Kharagpur Chapter 2: Mathematical Concepts Divisibility Congruence Quadratic Residues

More information

Review For the Final: Problem 1 Find the general solutions of the following DEs. a) x 2 y xy y 2 = 0 solution: = 0 : homogeneous equation.

Review For the Final: Problem 1 Find the general solutions of the following DEs. a) x 2 y xy y 2 = 0 solution: = 0 : homogeneous equation. Review For the Final: Problem 1 Find the general solutions of the following DEs. a) x 2 y xy y 2 = 0 solution: y y x y2 = 0 : homogeneous equation. x2 v = y dy, y = vx, and x v + x dv dx = v + v2. dx =

More information

1 + lim. n n+1. f(x) = x + 1, x 1. and we check that f is increasing, instead. Using the quotient rule, we easily find that. 1 (x + 1) 1 x (x + 1) 2 =

1 + lim. n n+1. f(x) = x + 1, x 1. and we check that f is increasing, instead. Using the quotient rule, we easily find that. 1 (x + 1) 1 x (x + 1) 2 = Chapter 5 Sequences and series 5. Sequences Definition 5. (Sequence). A sequence is a function which is defined on the set N of natural numbers. Since such a function is uniquely determined by its values

More information

Analytic Number Theory Solutions

Analytic Number Theory Solutions Analytic Number Theory Solutions Sean Li Cornell University sxl6@cornell.edu Jan. 03 Introduction This document is a work-in-progress solution manual for Tom Apostol s Introduction to Analytic Number Theory.

More information

COURSE SUMMARY FOR MATH 504, FALL QUARTER : MODERN ALGEBRA

COURSE SUMMARY FOR MATH 504, FALL QUARTER : MODERN ALGEBRA COURSE SUMMARY FOR MATH 504, FALL QUARTER 2017-8: MODERN ALGEBRA JAROD ALPER Week 1, Sept 27, 29: Introduction to Groups Lecture 1: Introduction to groups. Defined a group and discussed basic properties

More information

MATHEMATICAL FORMULAS AND INTEGRALS

MATHEMATICAL FORMULAS AND INTEGRALS HANDBOOK OF MATHEMATICAL FORMULAS AND INTEGRALS Second Edition ALAN JEFFREY Department of Engineering Mathematics University of Newcastle upon Tyne Newcastle upon Tyne United Kingdom ACADEMIC PRESS A Harcourt

More information

1. If 1, ω, ω 2, -----, ω 9 are the 10 th roots of unity, then (1 + ω) (1 + ω 2 ) (1 + ω 9 ) is A) 1 B) 1 C) 10 D) 0

1. If 1, ω, ω 2, -----, ω 9 are the 10 th roots of unity, then (1 + ω) (1 + ω 2 ) (1 + ω 9 ) is A) 1 B) 1 C) 10 D) 0 4 INUTES. If, ω, ω, -----, ω 9 are the th roots of unity, then ( + ω) ( + ω ) ----- ( + ω 9 ) is B) D) 5. i If - i = a + ib, then a =, b = B) a =, b = a =, b = D) a =, b= 3. Find the integral values for

More information

Efficient Experimental Mathematics for Lattice Path Combinatorics

Efficient Experimental Mathematics for Lattice Path Combinatorics 1/45 Efficient Experimental Mathematics for Lattice Path Combinatorics Alin Bostan based on joint works with M. Bousquet-Mélou, F. Chyzak, M. van Hoeij, M. Kauers, S. Melczer, L. Pech, K. Raschel, B. Salvy

More information

Part 3.3 Differentiation Taylor Polynomials

Part 3.3 Differentiation Taylor Polynomials Part 3.3 Differentiation 3..3.1 Taylor Polynomials Definition 3.3.1 Taylor 1715 and Maclaurin 1742) If a is a fixed number, and f is a function whose first n derivatives exist at a then the Taylor polynomial

More information

q-series Michael Gri for the partition function, he developed the basic idea of the q-exponential. From

q-series Michael Gri for the partition function, he developed the basic idea of the q-exponential. From q-series Michael Gri th History and q-integers The idea of q-series has existed since at least Euler. In constructing the generating function for the partition function, he developed the basic idea of

More information

Math 3 Variable Manipulation Part 3 Polynomials A

Math 3 Variable Manipulation Part 3 Polynomials A Math 3 Variable Manipulation Part 3 Polynomials A 1 MATH 1 & 2 REVIEW: VOCABULARY Constant: A term that does not have a variable is called a constant. Example: the number 5 is a constant because it does

More information

Outline. MSRI-UP 2009 Coding Theory Seminar, Week 2. The definition. Link to polynomials

Outline. MSRI-UP 2009 Coding Theory Seminar, Week 2. The definition. Link to polynomials Outline MSRI-UP 2009 Coding Theory Seminar, Week 2 John B. Little Department of Mathematics and Computer Science College of the Holy Cross Cyclic Codes Polynomial Algebra More on cyclic codes Finite fields

More information

Modern Computer Algebra

Modern Computer Algebra Modern Computer Algebra JOACHIM VON ZUR GATHEN and JURGEN GERHARD Universitat Paderborn CAMBRIDGE UNIVERSITY PRESS Contents Introduction 1 1 Cyclohexane, cryptography, codes, and computer algebra 9 1.1

More information

arxiv:math/ v1 [math.ca] 19 Apr 1994

arxiv:math/ v1 [math.ca] 19 Apr 1994 arxiv:math/9404220v1 [math.ca] 19 Apr 1994 Algorithmic Work with Orthogonal Polynomials and Special Functions Wolfram Koepf Konrad-Zuse-Zentrum für Informationstechnik Berlin, Heilbronner Str. 10, D-10711

More information

Math221: HW# 7 solutions

Math221: HW# 7 solutions Math22: HW# 7 solutions Andy Royston November 7, 25.3.3 let x = e u. Then ln x = u, x2 = e 2u, and dx = e 2u du. Furthermore, when x =, u, and when x =, u =. Hence x 2 ln x) 3 dx = e 2u u 3 e u du) = e

More information

Is Analysis Necessary?

Is Analysis Necessary? Is Analysis Necessary? Ira M. Gessel Brandeis University Waltham, MA gessel@brandeis.edu Special Session on Algebraic and Analytic Combinatorics AMS Fall Eastern Meeting University of Connecticut, Storrs

More information

Math 112 Rahman. Week Taylor Series Suppose the function f has the following power series:

Math 112 Rahman. Week Taylor Series Suppose the function f has the following power series: Math Rahman Week 0.8-0.0 Taylor Series Suppose the function f has the following power series: fx) c 0 + c x a) + c x a) + c 3 x a) 3 + c n x a) n. ) Can we figure out what the coefficients are? Yes, yes

More information

Factorization in Polynomial Rings

Factorization in Polynomial Rings Factorization in Polynomial Rings Throughout these notes, F denotes a field. 1 Long division with remainder We begin with some basic definitions. Definition 1.1. Let f, g F [x]. We say that f divides g,

More information

EXAMPLES OF PROOFS BY INDUCTION

EXAMPLES OF PROOFS BY INDUCTION EXAMPLES OF PROOFS BY INDUCTION KEITH CONRAD 1. Introduction In this handout we illustrate proofs by induction from several areas of mathematics: linear algebra, polynomial algebra, and calculus. Becoming

More information

Irregular continued fractions

Irregular continued fractions 9 Irregular continued fractions We finish our expedition with a look at irregular continued fractions and pass by some classical gems en route. 9. General theory There exist many generalisations of classical

More information

Bessel s and legendre s equations

Bessel s and legendre s equations Chapter 12 Bessel s and legendre s equations 12.1 Introduction Many linear differential equations having variable coefficients cannot be solved by usual methods and we need to employ series solution method

More information

Chapter 7. Linear Algebra: Matrices, Vectors,

Chapter 7. Linear Algebra: Matrices, Vectors, Chapter 7. Linear Algebra: Matrices, Vectors, Determinants. Linear Systems Linear algebra includes the theory and application of linear systems of equations, linear transformations, and eigenvalue problems.

More information

Generating Functions of Partitions

Generating Functions of Partitions CHAPTER B Generating Functions of Partitions For a complex sequence {α n n 0,, 2, }, its generating function with a complex variable q is defined by A(q) : α n q n α n [q n ] A(q). When the sequence has

More information

Power series solutions for 2nd order linear ODE s (not necessarily with constant coefficients) a n z n. n=0

Power series solutions for 2nd order linear ODE s (not necessarily with constant coefficients) a n z n. n=0 Lecture 22 Power series solutions for 2nd order linear ODE s (not necessarily with constant coefficients) Recall a few facts about power series: a n z n This series in z is centered at z 0. Here z can

More information

12. Hilbert Polynomials and Bézout s Theorem

12. Hilbert Polynomials and Bézout s Theorem 12. Hilbert Polynomials and Bézout s Theorem 95 12. Hilbert Polynomials and Bézout s Theorem After our study of smooth cubic surfaces in the last chapter, let us now come back to the general theory of

More information

Solution of Algebric & Transcendental Equations

Solution of Algebric & Transcendental Equations Page15 Solution of Algebric & Transcendental Equations Contents: o Introduction o Evaluation of Polynomials by Horner s Method o Methods of solving non linear equations o Bracketing Methods o Bisection

More information

Scientific Computing

Scientific Computing 2301678 Scientific Computing Chapter 2 Interpolation and Approximation Paisan Nakmahachalasint Paisan.N@chula.ac.th Chapter 2 Interpolation and Approximation p. 1/66 Contents 1. Polynomial interpolation

More information