HOPS Tutorial: Lecture 1 Boundary Value Problems

Size: px
Start display at page:

Download "HOPS Tutorial: Lecture 1 Boundary Value Problems"

Transcription

1 HOPS Tutorial: Lecture 1 Boundary Value Problems David P. Nicholls Department of Mathematics, Statistics, and Computer Science University of Illinois at Chicago HOPS Tutorial: Lecture 1 David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 1 / 45

2 Collaborators Collaborators: Fernando Reitich (Minnesota) Ben Akers (AFIT) Alison Malcolm (MIT) Jie Shen (Purdue) Nilima Nigam (Simon Fraser) Walter Craig (McMaster; Fields) Students: Mark Taber, Carlo Fazioli, Zheng Fang, Venu Tammali Thanks to: NSF (DMS ) David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 2 / 45

3 References Milder, JASA 89(2): (1991). Milder, Radio Sci. 31(6): (1996). Bruno & Reitich, JOSA 10(6): (1993). Bruno & Reitich, JOSA 10(11): (1993). Bruno & Reitich, JOSA 10(12): (1993). Craig & Sulem, JCP 108(1): (1993). DPN & Reitich, PRSE A 131(6): (2001). DPN & Reitich, JCP 170(1): (2001). DPN & Reitich, Numer. Math. 94(1): (2003). David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 3 / 45

4 Introduction Numerical Solution of PDE Partial Differential Equations (PDEs) have long been recognized as the most powerful and successful mathematical modeling tool for engineering and science, and the study of surface water waves is no exception. With the advent of the modern computer, the possibility of numerical simulation of PDEs at last became a practical reality. The last years has seen an explosion in the development and implementation of algorithms which are: Robust, highly accurate, and fast. Among the myriad choices are 1 Finite Difference Methods 2 Finite Element Methods (Continuous and Discontinuous) 3 High Order Spectral (Element) Methods 4 Boundary Integral/Element Methods 5 Many more... David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 4 / 45

5 Introduction Numerical Simulation of Interfacial PDEs The class of High Order Perturbation of Surfaces (HOPS) methods we describe here are particularly well suited for PDEs posed on piecewise homogeneous domains. Such layered media problems abound in the sciences: Free surface fluid mechanics (e.g., the water wave problem), Acoustic waves in piecewise constant density media, Electromagnetic waves interacting with grating structures, Elastic waves in sediment layers. For such problems these HOPS methods can be: highly accurate (error decaying exponentially as the number of degrees of freedom increases), rapid (an order of magnitude fewer unknowns as compared with volumetric formulations), robust (delivering accurate results for rather rough/large interface shapes). These HOPS schemes are not competitive for problems with inhomogeneous domains and/or extreme geometries. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 5 / 45

6 Laplace s Equation Water Wave Problem: Gravity Waves on Deep Water To fix on a problem we consider a water wave problem: Model the evolution of the free surface of a deep, two dimensional, ideal fluid under the influence of gravity. The widely accepted model (Lamb; 1879,...,1932) is In these ϕ = 0, y < η(x, t) y ϕ 0, y t η + x η( x ϕ) = y ϕ, y = η(x, t) t ϕ + (1/2) ϕ ϕ + gη = 0, ϕ(x, y, t) is the velocity potential, u = ϕ, η(x, t) is the air water interface, g is the gravitational constant. y = η(x, t). David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 6 / 45

7 Laplace s Equation The Dirichlet Neumann Operator (DNO) At the center of this problem is the solution of the Elliptic Boundary Value Problem (BVP) v = 0 y v 0 v = ξ y < g(x) y y = g(x). In particular, with the Dirichlet Neumann Operator (DNO) G(g)[ξ] = [ y v ( x g) x v] y=g(x), the water wave problem becomes (Zakharov 1968; Craig & Sulem 1993) t η = G(η)ξ, t ξ = gη A(η)B(η, ξ) [ ( A = ( x η) 2)] 1, B = ( x ξ) 2 (G(η)ξ) 2 2( x η)( x ξ)(g(η)ξ). David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 7 / 45

8 Laplace s Equation Lateral Boundary Conditions: Periodicity For many problems of practical interest it suffices to consider the classical periodic boundary conditions, e.g., v(x + L, y) = v(x, y), g(x + L) = g(x), L = 2π. In this case we can express functions in terms of their Fourier Series g(x) = ĝ p e ipx, ĝ p = 1 2π g(s)e ips ds. 2π 0 p= Thus, we focus on the BVP: v = 0 y v 0 v = ξ v(x + 2π, y) = v(x, y). y < g(x) y y = g(x) David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 8 / 45

9 Field Expansions The Method of Field Expansions (FE) Our first HOPS approach for DNOs solves the BVP directly. Its orgins: The work of Rayleigh (1907) and Rice (1951). The first high order implementation is due to Bruno & Reitich (1993; 3 papers) and was originally denoted the Method of Variation of Boundaries. To prevent confusion with subsequent methods it was later renamed the Method of Field Expansions (FE). The key to the method: The realization that interior to the domain (i.e., y < g ) the solution of Laplace s equation is v(x, y) = a p e p y e ipx. p= This HOPS approach uses the fact that, for a boundary perturbation g(x) = εf (x), the field, v = v(x, y; ε), depends analytically upon ε. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 9 / 45

10 Field Expansions The FE Method Assume that the interface is shaped by g(x) = εf (x) where f O (1) and, initially, ε 1. We will be able to show a posteriori that v depends analytically upon ε so that v = v(x, y; ε) = v n (x, y)ε n. n=0 Inserting this expansion into the governing equations and equating at orders O (ε n ) yields v n = 0 y < 0 y v n 0 y v n = Q n y = 0 v n (x + 2π, y) = v n (x, y). David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 10 / 45

11 Field Expansions The FE Method: Solutions The crucial term is the boundary inhomogeneity Q n (x) = δ n,0 ξ(x) n 1 m=0 This form comes from the expansion v(x, εf ; ε) = v n (x, εf )ε n = n=0 F n m (x) n m y v m (x, 0), F m (x) := f m (x) m! n=0 ε n n m=0 F n m (x) n m y v m (x, 0). The solution of Laplace s equation subject to the bottom and lateral boundary conditions is v n (x, y) = p= a n,p e p y e ipx. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 11 / 45

12 FE Recursions Field Expansions Inserting this form into the surface boundary condition delivers p= a n,p e ipx = p= where, since exp( p εf ) = m εm F m p m, Q n (x) = δ n,0 p= ˆξ p e ipx n 1 m=0 F n m (x) More precisely we have the FE Recursions a n,p = δ n,0 ˆξ p n 1 m=0 q= ˆQ n,p e ipx, p= p n m a m,p e ipx, ˆF n m,p q q n m a m,q. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 12 / 45

13 The DNO via FE Field Expansions The FE recursions deliver the solution everywhere well inside the problem domain. However, is the expansion v(x, y) = a p e p y e ipx p= valid at the boundary? Near the boundary? Assuming that there is some validity at the boundary, recall that we wish to compute the Neumann data Expanding in ε ν n (x)ε n = n=0 ν(x) = [ y v ( x g) x v] y=g(x). [ y v n (x, εf ) ε( x f ) x v n (x, εf )] ε n. n=0 David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 13 / 45

14 Field Expansions FE Recursions for the DNO Equating at order O (ε n ) gives ν n (x) = n m=0 F n m n+1 m y Once again, more precisely, ˆν n,p = n m=0 q= n 1 n 1 v m (x, 0) ( x f )F n 1 m x y n 1 m v m (x, 0). m=0 ˆF n m,p q q n+1 m a m,q m=0 q= where F m(x) := ( x f )F m (x). ˆF n 1 m,p q (iq) q n 1 m a m,q, David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 14 / 45

15 Field Expansions MATLAB Code for FE Recursions: Field function [anp] = field_fe_laplace(xi,f,p,nx,n) anp = zeros(nx,n+1); fn = zeros(nx,n+1); fn(:,0+1) = ones(nx,1); for n=1:n fn(:,n+1) = f.*fn(:,n-1+1)/n; end anp(:,0+1) = fft( xi ); for n=1:n anp(:,n+1) = 0*xi; for m=0:n-1 anp(:,n+1) = anp(:,n+1) - fft(fn(:,n-m+1).*... ifft(abs(p).^(n-m).*anp(:,m+1))); end end David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 15 / 45

16 Field Expansions MATLAB Code for FE Recursions: DNO function [Gn] = dno_fe_laplace(anp,f,p,nx,n) Gn = zeros(nx,n+1); fn = zeros(nx,n+1); fn(:,0+1) = ones(nx,1); for n=1:n fn(:,n+1) = f.*fn(:,n-1+1)/n; end f_x = ifft( (1i*p).*fft(f) ); for n=0:n Gn(:,n+1) = ifft( abs(p).*anp(:,n+1) ); for m=0:n-1 Gn(:,n+1) = Gn(:,n+1) + fn(:,n-m+1).*... ifft( abs(p).^(n+1-m).*anp(:,m+1) )... - f_x.*fn(:,n-1-m+1).*ifft( (1i*p).*... abs(p).^(n-1-m).*anp(:,m+1) ); end end David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 16 / 45

17 Operator Expansions The Method of Operator Expansions (OE) The second HOPS approach we investigate considers the DNO alone without explicit reference to the underlying field equations. For this reason the method has been termed the Method of Operator Expansions (OE). The first high order implementation for electromagnetics (the Helmholtz equation) is due to Milder (1991; two papers) and Milder & Sharp (1992; two papers). The first high order implementation for water waves (the Laplace equation) is due to Craig & Sulem (1993). Once again, we use, in a fundamental way, the representation v(x, y) = a p e p y e ipx. p= This HOPS method uses the fact that, for a boundary perturbation g(x) = εf (x), the DNO, G = G(εf ), depends analytically upon ε. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 17 / 45

18 Operator Expansions The OE Method Again, assume that the interface is shaped by g(x) = εf (x) where f O (1) and, initially, ε 1. We now focus on the definition of the DNO, G, G(g)[ξ] = ν, and seek the action of G on a basis function, exp(ipx). To achieve this we use a solution of Laplace s equation (and relevant boundary conditions): v p (x, y) := e p y e ipx. Inserting the solution v p (x, y) into the defintion of the DNO gives G(g)[v p (x, g(x))] = [ y v p ( x g) x v p ] y=g(x). David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 18 / 45

19 Operator Expansions OE Recursions: Order Zero Assume that everything is analytic in ε and expand ( ) [ ] ε n G n (f ) ε m F m p m e ipx = n=0 m=0 ε n F n p n+1 e ipx n=0 ε( x f ) ε n F n (ip) p n e ipx. At O ( ε 0) this reads G 0 [ e ipx ] = p e ipx, so that we can conclude that G 0 [ξ] = G 0 [ p= ˆξ p e ipx ] = p= ˆξ p G 0 [ e ipx] = n=0 p= p ˆξ p e ipx =: D ξ. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 19 / 45

20 Operator Expansions OE Recursions: Higher Order Corrections At order O (ε n ), n > 0, we find n m=0 [ G m (f ) F n m p n m e ipx] = F n p n+1 e ipx ( x f )F n 1 (ip) p n 1 e ipx, which we can write as [ G n (f ) e ipx] = F n p n+1 e ipx ( x f )F n 1 (ip) p n 1 e ipx n 1 m=0 [ G m (f ) F n m p n m e ipx]. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 20 / 45

21 OE Recursions, cont. Operator Expansions The Fourier multiplier D m is defined by D m e ipx = p m e ipx, so that [ G n (f ) e ipx] = F n D n+1 e ipx ( x f )F n 1 x D n 1 e ipx n 1 m=0 [ G m (f ) F n m D n m e ipx]. Since (ip) 2 = p 2 we deduce that D 2 = 2 x and we arrive at [ G n (f ) e ipx] ) = ( F n x 2 ( x f )F n 1 x D n 1 e ipx n 1 m=0 [ G m (f ) F n m D n m e ipx]. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 21 / 45

22 Operator Expansions Slow OE Recursions Next, since x [F n x G] = F n 2 x G + ( x f )F n 1 x G, we have [ G n (f ) e ipx] = x F n x D n 1 e ipx n 1 m=0 [ G m (f ) F n m D n m e ipx]. As we have the action of G n we write down the Slow OE Recursions G n (f ) [ξ] = x F n x D n 1 ξ n 1 m=0 G m (f ) [ F n m D n m ξ ]. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 22 / 45

23 Operator Expansions Accelerating the OE Recursions: Adjointness So what is wrong with this set of recursions? To compute G n one must evaluate G n 1, which requires the application of G n 2, etc. Since the argument of G m changes as m changes, these cannot be precomputed and stored. Therefore, a naive implementation will require time proportional to O (n!). One can improve this by storing G m as an operator (a matrix in finite dimensional space). To compute G n requires time proportional to O ( nn 2 x ). Happily we can do even better by using the self adjointness properties of the DNO. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 23 / 45

24 Operator Expansions Self Adjointness of the DNO: Fast Recursions It can be shown that the DNO, G, and all of its Taylor series terms G n are self adjoint: G = G and G n = G n. Question: How can we use this to advantage? Answer: Recall that (AB) = B A, x = x, and F n = F n ; now take the adjoint of G n. Thus we realize the Fast OE Recursions G n (f ) [ξ] = D n 1 x F n x ξ n 1 m=0 D n m F n m G m (f ) [ξ]. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 24 / 45

25 Operator Expansions MATLAB Code for OE Recursions function [Gn] = dno_oe_laplace(xi,f,p,nx,n) Gn = zeros(nx,n+1); fn = zeros(nx,n+1); fn(:,0+1) = ones(nx,1); for n=1:n fn(:,n+1) = f.*fn(:,n-1+1)/n; end xi_hat = fft(xi); xi_x = ifft( (1i*p).*xi_hat ); Gn(:,0+1) = ifft( abs(p).*xi_hat ); for n=1:n Gn(:,n+1) = -ifft( abs(p).^(n-1).*(1i*p).*... fft(fn(:,n+1).*xi_x) ); for m=0:n-1 Gn(:,n+1) = Gn(:,n+1) - ifft( abs(p).^(n-m).*... fft(fn(:,n-m+1).*gn(:,m+1)) ); end end David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 25 / 45

26 Numerical Tests Numerical Tests Now that we have two HOPS schemes for approximating DNOs, we should test them... and play! To test, it would be ideal to have an exact solution... in fact we do! Recall the solution we used for the OE formula v p (x, y) := e p y e ipx. If we choose a wavenumber, say r, and a profile f (x), for a given ε > 0, it is easy to see that the Dirichlet data generates Neumann data ξ r (x; ε) := v r (x, εf (x)) = e r εf (x) e irx. ν r (x; ε) := [ y v r ε( x f ) x v r ] (x, εf (x)) = [ r ε( x f )(ir)] e r εf (x) e irx. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 26 / 45

27 Convergence of FE Numerical Tests 10 2 Relative Error versus N FE(Taylor) Relative Error Interface shape: f (x) = exp(cos(x)) Physical parameters: L = 2π, ε = Numerical parameters: N x = 64, N = N David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 27 / 45

28 Convergence of OE Numerical Tests 10 2 Relative Error versus N OE(Taylor) Relative Error Interface shape: f (x) = exp(cos(x)) Physical parameters: L = 2π, ε = Numerical parameters: N x = 64, N = N David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 28 / 45

29 Numerical Tests Comparison of FE and OE Relative Error Relative Error versus N FE(Taylor) OE(Taylor) Interface shape: f (x) = exp(cos(x)) Physical parameters: L = 2π, ε = Numerical parameters: N x = 64, N = N David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 29 / 45

30 Three Dimensions Three Dimensions A generalization of crucial importance is to the more realistic situation of a genuinely three dimensional fluid. In this case the air fluid interface, y = g(x) = g(x 1, x 2 ) is two dimensional rather than one dimensional. Such a generalization for Boundary Integral/Element Methods requires a new formulation as the fundamental solution changes, Φ 2 (r) = C 2 ln(r), Φ 3 (r) = C 3 r 1. One of the most appealing features of our HOPS methods is the trivial nature of the changes required moving from two to three dimensions. This can be seen by inspecting the solution of Laplace s equation: v(x, y) = a p e p y e ip x, p = (p 1, p 2 ) Z 2. p =0 David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 30 / 45

31 Three Dimensions Field Expansions in Three Dimensions Once again assuming g(x 1, x 2 ) = εf (x 1, x 2 ), f O (1), ε 1, we expand v = v(x, y; ε) = v n (x, y)ε n. n=0 We find the same inhomogeneous Laplace problem at every perturbation order n which has solution v n (x, y) = a n,p e p y e ip x. p =0 Following the development from before we find a n,p = δ n,0 ˆξp n 1 m=0 q =0 ˆF n m,p q q n m a m,q. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 31 / 45

32 Three Dimensions FE Recursions for the DNO: Three Dimensions As before, if we seek the Neumann data and expand ν(x) = [ y v ( x g) x v] y=g(x), ν(x; ε) = ν n (x)ε n, n=0 then FE delivers approximations to ν n from the a n,p. More precisely, for F m(x) := ( x f )F m (x), ˆν n,p = n m=0 q =0 n 1 ˆF n m,p q q n+1 m a m,q m=0 q =0 ˆF n 1 m,p q (iq) q n 1 m a m,q, David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 32 / 45

33 Three Dimensions The OE Method: Three Dimensions Again, assume that the interface is shaped by g(x 1, x 2 ) = εf (x 1, x 2 ), f O (1), ε 1. Once again we seek the action of G on a basis function, exp(ip x). To achieve this we use a solution of Laplace s equation (and relevant boundary conditions): We make the expansion and seek forms for the G n. v p (x, y) := e p y e ip x. G(εf ) = G n (f )ε, n=0 David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 33 / 45

34 Three Dimensions Operator Expansions: Three Dimensions Using the methods outlined ealier, we can show that and, for n > 0, G 0 [ξ] = D ξ = p ˆξ p e ip x, p =0 ] n 1 G n (f ) [ξ] = div x [F n x D n 1 ξ m=0 G m (f ) [ F n m D n m ξ ]. Again, these can be accelerated by adjointness considerations to G n (f ) [ξ] = D n 1 div x [F n x ξ] n 1 m=0 D n m F n m G m (f ) [ξ]. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 34 / 45

35 Finite Depth Finite Depth As we will now show, the generalization to finite depth is immediate. The problem statement is the same, save we replace y v 0 with y v(x, h) = 0. Once again, the key is the solution of Laplace s equation v p (x, y) := cosh( p (y + h)) e ipx. cosh( p h) Since v p and y v p evaluated at y = 0 will clearly become important, we introduce the symbol { 1 n even T n,p = T n,p (h) := tanh(h p ) n odd. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 35 / 45

36 FE: Finite Depth Finite Depth We can show that the FE Recursions become and that ˆν n,p = a p,n = δ n,0 ˆξ p n 1 n m=0 q= m=0 q= n 1 m=0 q= ˆF n m,p q q n m T n m,q (h)a m,q. ˆF n m,p q q n+1 m T n+1 m (h)a m,q ˆF n 1 m,p q (iq) q n 1 m T n 1 m (h)a m,q, David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 36 / 45

37 OE: Finite Depth Finite Depth For the OE recursions we can show that, at order zero, G 0 [ξ] = D tanh(h D )ξ, while at higher orders (after appealing to self adjointness) G n (f ) [ξ] = D n 1 T n 1,D x F n x ξ n 1 m=0 D n m T n m,d F n m G m (f ) [ξ]. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 37 / 45

38 Padé Summation Padé Summation A classical problem of numerical analysis: The approximation of an analytic function given a truncation of its Taylor series. Simply evaluating the truncation will be spectrally accurate in the number of terms for points inside the disk of analyticity. However, one may be interested in points of analyticity outside this disk. Thus, a numerical analytic continuation is of great interest. Padé approximation (Baker & Graves Morris, 1996) is one of the most popular choices. See also 8.3 of Bender & Orszag, David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 38 / 45

39 Taylor Summation Padé Summation Consider the analytic function c(ε) = c n ε n n=0 which we approximate by its truncated Taylor series c N (ε) := N c n ε n. n=0 If ε 0 is in the disk of convergence then c(ε 0 ) c N (ε 0 ) < K ρ N. However, if ε 0 is a point of analyticity outside the disk of convergence of the Taylor series, c N will produce meaningless results. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 39 / 45

40 Padé Summation Rational Approximation Padé approximation: Approximate c N by the rational function where L + M = N and [L/M](ε) := al (ε) b M (ε) = [L/M](ε) = c N (ε) + O L l=0 a lε l M m=0 b mε m ( ε L+M+1). We choose the equiorder Padé approximant [N/2, N/2](ε). For the purposes of the following discussion we assume that either N is even or, in the case N odd, that the highest order term c N is ignored so that L = M = N/2 is an integer. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 40 / 45

41 The Padé Algorithm Padé Summation To derive equations for the {a l } and {b m } we note that a M (ε) b M (ε) = c2m (ε) + O (ε 2M+1) is equivalent to b M (ε)c 2M (ε) = a M (ε) + O ( ε 2M+1), or ( M ) ( 2M ) ( M ) ( b m ε m c n ε n = a m ε m + O ε 2M+1). m=0 n=0 m=0 Multiplying the polynomials on the left hand side and equating at equal orders in ε m for 0 m 2M reveals two sets of equations m c m j b j = a m, j=0 [0 m M]; M c m j b j = 0, j=0 [M+1 m 2M]. Given that the c m are known, if the b m can be computed then the first equation can be used to find the a m. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 41 / 45

42 Padé Summation Padé Approximation, cont. Without loss of generality we make the classical specification b 0 = 1 so that the second equation becomes M c m j b j = c m, M + 1 m 2M, j=1 or H b = r where c M... c 1 b 1 c M+1... c 2 H =....., b 2 b =., r = c 2M 1... c M b M c M+1 c M+2. c 2M. David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 42 / 45

43 Padé Summation Taylor: Divergence of FE 10 1 Relative Error versus N FE(Taylor) Relative Error Interface shape: f (x) = exp(cos(x)) Physical parameters: L = 2π, ε = 0.2. Numerical parameters: N x = 256, N = N David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 43 / 45

44 Padé Summation Taylor: Divergence of OE 10 4 Relative Error versus N OE(Taylor) Relative Error Interface shape: f (x) = exp(cos(x)) Physical parameters: L = 2π, ε = 0.2. Numerical parameters: N x = 256, N = N David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 44 / 45

45 Padé Summation Padé: Convergence of FE and OE Relative Error Relative Error versus N FE(Taylor) FE(Pade) OE(Taylor) OE(Pade) Interface shape: f (x) = exp(cos(x)) Physical parameters: L = 2π, ε = 0.2. Numerical parameters: N x = 256, N = N David P. Nicholls (UIC) HOPS Tutorial: Lecture 1 HOPS Tutorial: Lecture 1 45 / 45

Physica D. Spectral stability of traveling water waves: Eigenvalue collision, singularities, and direct numerical simulation

Physica D. Spectral stability of traveling water waves: Eigenvalue collision, singularities, and direct numerical simulation Physica D 240 (2011) 376 381 Contents lists available at ScienceDirect Physica D journal homepage: www.elsevier.com/locate/physd Spectral stability of traveling water waves: Eigenvalue collision, singularities,

More information

Boundary Perturbation Methods for Water Waves

Boundary Perturbation Methods for Water Waves GAMM-Mitt. 30, No. 1, 44 74 (2007) Boundary Perturbation Methods for Water Waves David P. Nicholls Department of Mathematics, Statistics, and Computer Science, 851 South Morgan Street University of Illinois

More information

Joint Analyticity and Analytic Continuation of Dirichlet Neumann Operators on Doubly Perturbed Domains

Joint Analyticity and Analytic Continuation of Dirichlet Neumann Operators on Doubly Perturbed Domains J. math. fluid mech. 10 (008) 38 71 14-698/08/0038-34 c 007 Birkhäuser Verlag, Basel DOI 10.1007/s0001-006-031-9 Journal of Mathematical Fluid Mechanics Joint Analyticity and Analytic Continuation of Dirichlet

More information

Lecture 4: Birkhoff normal forms

Lecture 4: Birkhoff normal forms Lecture 4: Birkhoff normal forms Walter Craig Department of Mathematics & Statistics Waves in Flows - Lecture 4 Prague Summer School 2018 Czech Academy of Science August 31 2018 Outline Two ODEs Water

More information

A RIGOROUS NUMERICAL ANALYSIS OF THE TRANSFORMED FIELD EXPANSION METHOD

A RIGOROUS NUMERICAL ANALYSIS OF THE TRANSFORMED FIELD EXPANSION METHOD SIAM J. NUMER. ANAL. Vol. 47, No. 4, pp. 2708 2734 c 2009 Society for Industrial and Applied Mathematics A RIGOROUS NUMERICAL ANALYSIS OF THE TRANSFORMED FIELD EXPANSION METHOD DAVID P. NICHOLLS AND JIE

More information

Physica D 241 (2012) Contents lists available at SciVerse ScienceDirect. Physica D. journal homepage:

Physica D 241 (2012) Contents lists available at SciVerse ScienceDirect. Physica D. journal homepage: Physica D 241 (212) 146 1416 Contents lists available at SciVerse ScienceDirect Physica D journal homepage: www.elsevier.com/locate/physd On stability of generalized short-crested water waves Travis McBride,

More information

Fast Multipole Methods: Fundamentals & Applications. Ramani Duraiswami Nail A. Gumerov

Fast Multipole Methods: Fundamentals & Applications. Ramani Duraiswami Nail A. Gumerov Fast Multipole Methods: Fundamentals & Applications Ramani Duraiswami Nail A. Gumerov Week 1. Introduction. What are multipole methods and what is this course about. Problems from physics, mathematics,

More information

Lecture 1: Water waves and Hamiltonian partial differential equations

Lecture 1: Water waves and Hamiltonian partial differential equations Lecture : Water waves and Hamiltonian partial differential equations Walter Craig Department of Mathematics & Statistics Waves in Flows Prague Summer School 208 Czech Academy of Science August 30 208 Outline...

More information

A Domain Decomposition Method for Layered Media Scattering with High Order Perturbation of Surfaces Implementation

A Domain Decomposition Method for Layered Media Scattering with High Order Perturbation of Surfaces Implementation A Domain Decomposition Method for Layered Media Scattering with High Order Perturbation of Surfaces Implementation David P. Nicholls Department of Mathematics, Statistics, and Computer Science University

More information

On Stability of Generalized Short-Crested Water Waves

On Stability of Generalized Short-Crested Water Waves On Stability of Generalized Short-Crested Water Waves BY TRAVIS R. MCBRIDE B.A., DePaul University, 1990 M.S., University of Illinois at Chicago, 1993 THESIS Submitted in partial fulfillment of the requirements

More information

In this chapter we study elliptical PDEs. That is, PDEs of the form. 2 u = lots,

In this chapter we study elliptical PDEs. That is, PDEs of the form. 2 u = lots, Chapter 8 Elliptic PDEs In this chapter we study elliptical PDEs. That is, PDEs of the form 2 u = lots, where lots means lower-order terms (u x, u y,..., u, f). Here are some ways to think about the physical

More information

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

More information

A Direct Method for reconstructing inclusions from Electrostatic Data

A Direct Method for reconstructing inclusions from Electrostatic Data A Direct Method for reconstructing inclusions from Electrostatic Data Isaac Harris Texas A&M University, Department of Mathematics College Station, Texas 77843-3368 iharris@math.tamu.edu Joint work with:

More information

Summation Techniques, Padé Approximants, and Continued Fractions

Summation Techniques, Padé Approximants, and Continued Fractions Chapter 5 Summation Techniques, Padé Approximants, and Continued Fractions 5. Accelerated Convergence Conditionally convergent series, such as 2 + 3 4 + 5 6... = ( ) n+ = ln2, (5.) n converge very slowly.

More information

Two special equations: Bessel s and Legendre s equations. p Fourier-Bessel and Fourier-Legendre series. p

Two special equations: Bessel s and Legendre s equations. p Fourier-Bessel and Fourier-Legendre series. p LECTURE 1 Table of Contents Two special equations: Bessel s and Legendre s equations. p. 259-268. Fourier-Bessel and Fourier-Legendre series. p. 453-460. Boundary value problems in other coordinate system.

More information

2 Introduction to perturbation methods

2 Introduction to perturbation methods 2 Introduction to perturbation methods 2.1 What are perturbation methods? Perturbation methods are methods which rely on there being a dimensionless parameter in the problem that is relatively small: ε

More information

Applied Numerical Mathematics. High-order numerical schemes based on difference potentials for 2D elliptic problems with material interfaces

Applied Numerical Mathematics. High-order numerical schemes based on difference potentials for 2D elliptic problems with material interfaces Applied Numerical Mathematics 111 (2017) 64 91 Contents lists available at ScienceDirect Applied Numerical Mathematics www.elsevier.com/locate/apnum High-order numerical schemes based on difference potentials

More information

Lecture Introduction

Lecture Introduction Lecture 1 1.1 Introduction The theory of Partial Differential Equations (PDEs) is central to mathematics, both pure and applied. The main difference between the theory of PDEs and the theory of Ordinary

More information

The Pole Condition: A Padé Approximation of the Dirichlet to Neumann Operator

The Pole Condition: A Padé Approximation of the Dirichlet to Neumann Operator The Pole Condition: A Padé Approximation of the Dirichlet to Neumann Operator Martin J. Gander and Achim Schädle Mathematics Section, University of Geneva, CH-, Geneva, Switzerland, Martin.gander@unige.ch

More information

MATH 6B Spring 2017 Vector Calculus II Study Guide Final Exam Chapters 8, 9, and Sections 11.1, 11.2, 11.7, 12.2, 12.3.

MATH 6B Spring 2017 Vector Calculus II Study Guide Final Exam Chapters 8, 9, and Sections 11.1, 11.2, 11.7, 12.2, 12.3. MATH 6B pring 2017 Vector Calculus II tudy Guide Final Exam Chapters 8, 9, and ections 11.1, 11.2, 11.7, 12.2, 12.3. Before starting with the summary of the main concepts covered in the quarter, here there

More information

Fundamental Solutions and Green s functions. Simulation Methods in Acoustics

Fundamental Solutions and Green s functions. Simulation Methods in Acoustics Fundamental Solutions and Green s functions Simulation Methods in Acoustics Definitions Fundamental solution The solution F (x, x 0 ) of the linear PDE L {F (x, x 0 )} = δ(x x 0 ) x R d Is called the fundamental

More information

Lecture 2: Computing functions of dense matrices

Lecture 2: Computing functions of dense matrices Lecture 2: Computing functions of dense matrices Paola Boito and Federico Poloni Università di Pisa Pisa - Hokkaido - Roma2 Summer School Pisa, August 27 - September 8, 2018 Introduction In this lecture

More information

Vectors in Function Spaces

Vectors in Function Spaces Jim Lambers MAT 66 Spring Semester 15-16 Lecture 18 Notes These notes correspond to Section 6.3 in the text. Vectors in Function Spaces We begin with some necessary terminology. A vector space V, also

More information

Solving Boundary Value Problems (with Gaussians)

Solving Boundary Value Problems (with Gaussians) What is a boundary value problem? Solving Boundary Value Problems (with Gaussians) Definition A differential equation with constraints on the boundary Michael McCourt Division Argonne National Laboratory

More information

9 Fluid Instabilities

9 Fluid Instabilities 9. Stability of a shear flow In many situations, gaseous flows can be subject to fluid instabilities in which small perturbations can rapidly flow, thereby tapping a source of free energy. An important

More information

On rational approximation of algebraic functions. Julius Borcea. Rikard Bøgvad & Boris Shapiro

On rational approximation of algebraic functions. Julius Borcea. Rikard Bøgvad & Boris Shapiro On rational approximation of algebraic functions http://arxiv.org/abs/math.ca/0409353 Julius Borcea joint work with Rikard Bøgvad & Boris Shapiro 1. Padé approximation: short overview 2. A scheme of rational

More information

Chapter Generating Functions

Chapter Generating Functions Chapter 8.1.1-8.1.2. Generating Functions Prof. Tesler Math 184A Fall 2017 Prof. Tesler Ch. 8. Generating Functions Math 184A / Fall 2017 1 / 63 Ordinary Generating Functions (OGF) Let a n (n = 0, 1,...)

More information

u xx + u yy = 0. (5.1)

u xx + u yy = 0. (5.1) Chapter 5 Laplace Equation The following equation is called Laplace equation in two independent variables x, y: The non-homogeneous problem u xx + u yy =. (5.1) u xx + u yy = F, (5.) where F is a function

More information

The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and engineering.

The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and engineering. Lecture 16 Applications of Conformal Mapping MATH-GA 451.001 Complex Variables The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and

More information

Simple Iteration, cont d

Simple Iteration, cont d Jim Lambers MAT 772 Fall Semester 2010-11 Lecture 2 Notes These notes correspond to Section 1.2 in the text. Simple Iteration, cont d In general, nonlinear equations cannot be solved in a finite sequence

More information

Quantitative Homogenization of Elliptic Operators with Periodic Coefficients

Quantitative Homogenization of Elliptic Operators with Periodic Coefficients Quantitative Homogenization of Elliptic Operators with Periodic Coefficients Zhongwei Shen Abstract. These lecture notes introduce the quantitative homogenization theory for elliptic partial differential

More information

On Ill-Posedness of Truncated Series Models for Water Waves

On Ill-Posedness of Truncated Series Models for Water Waves On Ill-Posedness of Truncated Series Models for Water Waves David M. Ambrose Department of Mathematics Drexel University Philadelphia, PA 19104 Jerry L. Bona Department of Mathematics, Statistics and Computer

More information

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES)

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) RAYTCHO LAZAROV 1 Notations and Basic Functional Spaces Scalar function in R d, d 1 will be denoted by u,

More information

Complex geometrical optics solutions for Lipschitz conductivities

Complex geometrical optics solutions for Lipschitz conductivities Rev. Mat. Iberoamericana 19 (2003), 57 72 Complex geometrical optics solutions for Lipschitz conductivities Lassi Päivärinta, Alexander Panchenko and Gunther Uhlmann Abstract We prove the existence of

More information

Module 7: The Laplace Equation

Module 7: The Laplace Equation Module 7: The Laplace Equation In this module, we shall study one of the most important partial differential equations in physics known as the Laplace equation 2 u = 0 in Ω R n, (1) where 2 u := n i=1

More information

INTRODUCTION TO PDEs

INTRODUCTION TO PDEs INTRODUCTION TO PDEs In this course we are interested in the numerical approximation of PDEs using finite difference methods (FDM). We will use some simple prototype boundary value problems (BVP) and initial

More information

Introduction and Review of Power Series

Introduction and Review of Power Series Introduction and Review of Power Series Definition: A power series in powers of x a is an infinite series of the form c n (x a) n = c 0 + c 1 (x a) + c 2 (x a) 2 +...+c n (x a) n +... If a = 0, this is

More information

Weierstrass Products and More on Analytic Continuation

Weierstrass Products and More on Analytic Continuation Weierstrass Products and More on Analytic Continuation Thursday, December 05, 2013 1:58 PM Hard deadline for Homework 4: Wednesday, December 11 at 5 PM. rapid grading on or after Friday, December 6 Final

More information

Solutions to Laplace s Equations- II

Solutions to Laplace s Equations- II Solutions to Laplace s Equations- II Lecture 15: Electromagnetic Theory Professor D. K. Ghosh, Physics Department, I.I.T., Bombay Laplace s Equation in Spherical Coordinates : In spherical coordinates

More information

Contents. I Basic Methods 13

Contents. I Basic Methods 13 Preface xiii 1 Introduction 1 I Basic Methods 13 2 Convergent and Divergent Series 15 2.1 Introduction... 15 2.1.1 Power series: First steps... 15 2.1.2 Further practical aspects... 17 2.2 Differential

More information

2.20 Fall 2018 Math Review

2.20 Fall 2018 Math Review 2.20 Fall 2018 Math Review September 10, 2018 These notes are to help you through the math used in this class. This is just a refresher, so if you never learned one of these topics you should look more

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Xu Chen Assistant Professor United Technologies Engineering Build, Rm. 382 Department of Mechanical Engineering University of Connecticut xchen@engr.uconn.edu Contents 1

More information

We denote the space of distributions on Ω by D ( Ω) 2.

We denote the space of distributions on Ω by D ( Ω) 2. Sep. 1 0, 008 Distributions Distributions are generalized functions. Some familiarity with the theory of distributions helps understanding of various function spaces which play important roles in the study

More information

Course Outline. Date Lecture Topic Reading

Course Outline. Date Lecture Topic Reading Course Outline Date Lecture Topic Reading Graduate Mathematical Physics Tue 24 Aug Linear Algebra: Theory 744 756 Vectors, bases and components Linear maps and dual vectors Inner products and adjoint operators

More information

LEGENDRE POLYNOMIALS AND APPLICATIONS. We construct Legendre polynomials and apply them to solve Dirichlet problems in spherical coordinates.

LEGENDRE POLYNOMIALS AND APPLICATIONS. We construct Legendre polynomials and apply them to solve Dirichlet problems in spherical coordinates. LEGENDRE POLYNOMIALS AND APPLICATIONS We construct Legendre polynomials and apply them to solve Dirichlet problems in spherical coordinates.. Legendre equation: series solutions The Legendre equation is

More information

Appendix C: Recapitulation of Numerical schemes

Appendix C: Recapitulation of Numerical schemes Appendix C: Recapitulation of Numerical schemes August 31, 2009) SUMMARY: Certain numerical schemes of general use are regrouped here in order to facilitate implementations of simple models C1 The tridiagonal

More information

1 Separation of Variables

1 Separation of Variables Jim ambers ENERGY 281 Spring Quarter 27-8 ecture 2 Notes 1 Separation of Variables In the previous lecture, we learned how to derive a PDE that describes fluid flow. Now, we will learn a number of analytical

More information

California Common Core State Standards for Mathematics Standards Map Algebra I

California Common Core State Standards for Mathematics Standards Map Algebra I A Correlation of Pearson CME Project Algebra 1 Common Core 2013 to the California Common Core State s for Mathematics s Map Algebra I California Common Core State s for Mathematics s Map Algebra I Indicates

More information

Borel Summability in PDE initial value problems

Borel Summability in PDE initial value problems Borel Summability in PDE initial value problems Saleh Tanveer (Ohio State University) Collaborator Ovidiu Costin & Guo Luo Research supported in part by Institute for Math Sciences (IC), EPSRC & NSF. Main

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

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations Moshe Israeli Computer Science Department, Technion-Israel Institute of Technology, Technion city, Haifa 32000, ISRAEL Alexander

More information

APPROXIMATING THE INVERSE FRAME OPERATOR FROM LOCALIZED FRAMES

APPROXIMATING THE INVERSE FRAME OPERATOR FROM LOCALIZED FRAMES APPROXIMATING THE INVERSE FRAME OPERATOR FROM LOCALIZED FRAMES GUOHUI SONG AND ANNE GELB Abstract. This investigation seeks to establish the practicality of numerical frame approximations. Specifically,

More information

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS JASON ALBRIGHT, YEKATERINA EPSHTEYN, AND QING XIA Abstract. Highly-accurate numerical methods that can efficiently

More information

where is the Laplace operator and is a scalar function.

where is the Laplace operator and is a scalar function. Elliptic PDEs A brief discussion of two important elliptic PDEs. In mathematics, Laplace's equation is a second-order partial differential equation named after Pierre-Simon Laplace who first studied its

More information

1 Introduction to MATLAB

1 Introduction to MATLAB L3 - December 015 Solving PDEs numerically (Reports due Thursday Dec 3rd, carolinemuller13@gmail.com) In this project, we will see various methods for solving Partial Differential Equations (PDEs) using

More information

REMARKS ON THE VANISHING OBSTACLE LIMIT FOR A 3D VISCOUS INCOMPRESSIBLE FLUID

REMARKS ON THE VANISHING OBSTACLE LIMIT FOR A 3D VISCOUS INCOMPRESSIBLE FLUID REMARKS ON THE VANISHING OBSTACLE LIMIT FOR A 3D VISCOUS INCOMPRESSIBLE FLUID DRAGOŞ IFTIMIE AND JAMES P. KELLIHER Abstract. In [Math. Ann. 336 (2006), 449-489] the authors consider the two dimensional

More information

Inverse Scattering Theory: Transmission Eigenvalues and Non-destructive Testing

Inverse Scattering Theory: Transmission Eigenvalues and Non-destructive Testing Inverse Scattering Theory: Transmission Eigenvalues and Non-destructive Testing Isaac Harris Texas A & M University College Station, Texas 77843-3368 iharris@math.tamu.edu Joint work with: F. Cakoni, H.

More information

Partial Differential Equations

Partial Differential Equations M3M3 Partial Differential Equations Solutions to problem sheet 3/4 1* (i) Show that the second order linear differential operators L and M, defined in some domain Ω R n, and given by Mφ = Lφ = j=1 j=1

More information

Green s Functions and Distributions

Green s Functions and Distributions CHAPTER 9 Green s Functions and Distributions 9.1. Boundary Value Problems We would like to study, and solve if possible, boundary value problems such as the following: (1.1) u = f in U u = g on U, where

More information

MATH 1A, Complete Lecture Notes. Fedor Duzhin

MATH 1A, Complete Lecture Notes. Fedor Duzhin MATH 1A, Complete Lecture Notes Fedor Duzhin 2007 Contents I Limit 6 1 Sets and Functions 7 1.1 Sets................................. 7 1.2 Functions.............................. 8 1.3 How to define a

More information

Chapter 4: First-order differential equations. Similarity and Transport Phenomena in Fluid Dynamics Christophe Ancey

Chapter 4: First-order differential equations. Similarity and Transport Phenomena in Fluid Dynamics Christophe Ancey Chapter 4: First-order differential equations Similarity and Transport Phenomena in Fluid Dynamics Christophe Ancey Chapter 4: First-order differential equations Phase portrait Singular point Separatrix

More information

Linear Hyperbolic Systems

Linear Hyperbolic Systems Linear Hyperbolic Systems Professor Dr E F Toro Laboratory of Applied Mathematics University of Trento, Italy eleuterio.toro@unitn.it http://www.ing.unitn.it/toro October 8, 2014 1 / 56 We study some basic

More information

Problems of Corner Singularities

Problems of Corner Singularities Stuttgart 98 Problems of Corner Singularities Monique DAUGE Institut de Recherche MAthématique de Rennes Problems of Corner Singularities 1 Vertex and edge singularities For a polyhedral domain Ω and a

More information

My doctoral research concentrated on elliptic quasilinear partial differential equations of the form

My doctoral research concentrated on elliptic quasilinear partial differential equations of the form 1 Introduction I am interested in applied analysis and computation of non-linear partial differential equations, primarily in systems that are motivated by the physics of fluid dynamics. My Ph.D. thesis

More information

Diffusion on the half-line. The Dirichlet problem

Diffusion on the half-line. The Dirichlet problem Diffusion on the half-line The Dirichlet problem Consider the initial boundary value problem (IBVP) on the half line (, ): v t kv xx = v(x, ) = φ(x) v(, t) =. The solution will be obtained by the reflection

More information

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN INTROUCTION TO FINITE ELEMENT METHOS ON ELLIPTIC EQUATIONS LONG CHEN CONTENTS 1. Poisson Equation 1 2. Outline of Topics 3 2.1. Finite ifference Method 3 2.2. Finite Element Method 3 2.3. Finite Volume

More information

Laplace s Equation. Chapter Mean Value Formulas

Laplace s Equation. Chapter Mean Value Formulas Chapter 1 Laplace s Equation Let be an open set in R n. A function u C 2 () is called harmonic in if it satisfies Laplace s equation n (1.1) u := D ii u = 0 in. i=1 A function u C 2 () is called subharmonic

More information

Alexander Ostrowski

Alexander Ostrowski Ostrowski p. 1/3 Alexander Ostrowski 1893 1986 Walter Gautschi wxg@cs.purdue.edu Purdue University Ostrowski p. 2/3 Collected Mathematical Papers Volume 1 Determinants Linear Algebra Algebraic Equations

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

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

SUMMATION TECHNIQUES

SUMMATION TECHNIQUES SUMMATION TECHNIQUES MATH 53, SECTION 55 (VIPUL NAIK) Corresponding material in the book: Scattered around, but the most cutting-edge parts are in Sections 2.8 and 2.9. What students should definitely

More information

Limits at Infinity. Horizontal Asymptotes. Definition (Limits at Infinity) Horizontal Asymptotes

Limits at Infinity. Horizontal Asymptotes. Definition (Limits at Infinity) Horizontal Asymptotes Limits at Infinity If a function f has a domain that is unbounded, that is, one of the endpoints of its domain is ±, we can determine the long term behavior of the function using a it at infinity. Definition

More information

Computer simulation of multiscale problems

Computer simulation of multiscale problems Progress in the SSF project CutFEM, Geometry, and Optimal design Computer simulation of multiscale problems Axel Målqvist and Daniel Elfverson University of Gothenburg and Uppsala University Umeå 2015-05-20

More information

Huntington Beach City School District Grade 8 Mathematics Accelerated Standards Schedule

Huntington Beach City School District Grade 8 Mathematics Accelerated Standards Schedule Huntington Beach City School District Grade 8 Mathematics Accelerated Standards Schedule 2016-2017 Interim Assessment Schedule Orange Interim Assessment: November 1-18, 2016 Green Interim Assessment: January

More information

MATH3383. Quantum Mechanics. Appendix D: Hermite Equation; Orthogonal Polynomials

MATH3383. Quantum Mechanics. Appendix D: Hermite Equation; Orthogonal Polynomials MATH3383. Quantum Mechanics. Appendix D: Hermite Equation; Orthogonal Polynomials. Hermite Equation In the study of the eigenvalue problem of the Hamiltonian for the quantum harmonic oscillator we have

More information

Mathematics. Number and Quantity The Real Number System

Mathematics. Number and Quantity The Real Number System Number and Quantity The Real Number System Extend the properties of exponents to rational exponents. 1. Explain how the definition of the meaning of rational exponents follows from extending the properties

More information

Taylor Series and Asymptotic Expansions

Taylor Series and Asymptotic Expansions Taylor Series and Asymptotic Epansions The importance of power series as a convenient representation, as an approimation tool, as a tool for solving differential equations and so on, is pretty obvious.

More information

MATH 131P: PRACTICE FINAL SOLUTIONS DECEMBER 12, 2012

MATH 131P: PRACTICE FINAL SOLUTIONS DECEMBER 12, 2012 MATH 3P: PRACTICE FINAL SOLUTIONS DECEMBER, This is a closed ook, closed notes, no calculators/computers exam. There are 6 prolems. Write your solutions to Prolems -3 in lue ook #, and your solutions to

More information

Harmonic Analysis Homework 5

Harmonic Analysis Homework 5 Harmonic Analysis Homework 5 Bruno Poggi Department of Mathematics, University of Minnesota November 4, 6 Notation Throughout, B, r is the ball of radius r with center in the understood metric space usually

More information

MA22S3 Summary Sheet: Ordinary Differential Equations

MA22S3 Summary Sheet: Ordinary Differential Equations MA22S3 Summary Sheet: Ordinary Differential Equations December 14, 2017 Kreyszig s textbook is a suitable guide for this part of the module. Contents 1 Terminology 1 2 First order separable 2 2.1 Separable

More information

PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED

PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED ALAN DEMLOW Abstract. Recent results of Schatz show that standard Galerkin finite element methods employing piecewise polynomial elements of degree

More information

Last Update: April 7, 201 0

Last Update: April 7, 201 0 M ath E S W inter Last Update: April 7, Introduction to Partial Differential Equations Disclaimer: his lecture note tries to provide an alternative approach to the material in Sections.. 5 in the textbook.

More information

arxiv: v2 [math.na] 2 Jul 2014

arxiv: v2 [math.na] 2 Jul 2014 arxiv:46.56v [math.na] Jul 4 COMPARISON OF FIVE METHODS OF COMPUTING THE DIRICHLET NEUMANN OPERATOR FOR THE WATER WAVE PROBLEM JON WILKENING AND VISHAL VASAN Abstract. We compare the effectiveness of solving

More information

Algebra I, Common Core Correlation Document

Algebra I, Common Core Correlation Document Resource Title: Publisher: 1 st Year Algebra (MTHH031060 and MTHH032060) University of Nebraska High School Algebra I, Common Core Correlation Document Indicates a modeling standard linking mathematics

More information

WEYL S LEMMA, ONE OF MANY. Daniel W. Stroock

WEYL S LEMMA, ONE OF MANY. Daniel W. Stroock WEYL S LEMMA, ONE OF MANY Daniel W Stroock Abstract This note is a brief, and somewhat biased, account of the evolution of what people working in PDE s call Weyl s Lemma about the regularity of solutions

More information

Extreme Value Analysis and Spatial Extremes

Extreme Value Analysis and Spatial Extremes Extreme Value Analysis and Department of Statistics Purdue University 11/07/2013 Outline Motivation 1 Motivation 2 Extreme Value Theorem and 3 Bayesian Hierarchical Models Copula Models Max-stable Models

More information

Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche

Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche Scuola di Dottorato THE WAVE EQUATION Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche Lucio Demeio - DIISM wave equation 1 / 44 1 The Vibrating String Equation 2 Second

More information

A LOWER BOUND ON BLOWUP RATES FOR THE 3D INCOMPRESSIBLE EULER EQUATION AND A SINGLE EXPONENTIAL BEALE-KATO-MAJDA ESTIMATE. 1.

A LOWER BOUND ON BLOWUP RATES FOR THE 3D INCOMPRESSIBLE EULER EQUATION AND A SINGLE EXPONENTIAL BEALE-KATO-MAJDA ESTIMATE. 1. A LOWER BOUND ON BLOWUP RATES FOR THE 3D INCOMPRESSIBLE EULER EQUATION AND A SINGLE EXPONENTIAL BEALE-KATO-MAJDA ESTIMATE THOMAS CHEN AND NATAŠA PAVLOVIĆ Abstract. We prove a Beale-Kato-Majda criterion

More information

Practical in Numerical Astronomy, SS 2012 LECTURE 9

Practical in Numerical Astronomy, SS 2012 LECTURE 9 Practical in Numerical Astronomy, SS 01 Elliptic partial differential equations. Poisson solvers. LECTURE 9 1. Gravity force and the equations of hydrodynamics. Poisson equation versus Poisson integral.

More information

Discreteness of Transmission Eigenvalues via Upper Triangular Compact Operators

Discreteness of Transmission Eigenvalues via Upper Triangular Compact Operators Discreteness of Transmission Eigenvalues via Upper Triangular Compact Operators John Sylvester Department of Mathematics University of Washington Seattle, Washington 98195 U.S.A. June 3, 2011 This research

More information

Problem Set Number 01, MIT (Winter-Spring 2018)

Problem Set Number 01, MIT (Winter-Spring 2018) Problem Set Number 01, 18.377 MIT (Winter-Spring 2018) Rodolfo R. Rosales (MIT, Math. Dept., room 2-337, Cambridge, MA 02139) February 28, 2018 Due Thursday, March 8, 2018. Turn it in (by 3PM) at the Math.

More information

Part IV: Numerical schemes for the phase-filed model

Part IV: Numerical schemes for the phase-filed model Part IV: Numerical schemes for the phase-filed model Jie Shen Department of Mathematics Purdue University IMS, Singapore July 29-3, 29 The complete set of governing equations Find u, p, (φ, ξ) such that

More information

PHYS 502 Lecture 8: Legendre Functions. Dr. Vasileios Lempesis

PHYS 502 Lecture 8: Legendre Functions. Dr. Vasileios Lempesis PHYS 502 Lecture 8: Legendre Functions Dr. Vasileios Lempesis Introduction Legendre functions or Legendre polynomials are the solutions of Legendre s differential equation that appear when we separate

More information

Class Meeting # 2: The Diffusion (aka Heat) Equation

Class Meeting # 2: The Diffusion (aka Heat) Equation MATH 8.52 COURSE NOTES - CLASS MEETING # 2 8.52 Introduction to PDEs, Fall 20 Professor: Jared Speck Class Meeting # 2: The Diffusion (aka Heat) Equation The heat equation for a function u(, x (.0.). Introduction

More information

Determination of thin elastic inclusions from boundary measurements.

Determination of thin elastic inclusions from boundary measurements. Determination of thin elastic inclusions from boundary measurements. Elena Beretta in collaboration with E. Francini, S. Vessella, E. Kim and J. Lee September 7, 2010 E. Beretta (Università di Roma La

More information

Algebra I Number and Quantity The Real Number System (N-RN)

Algebra I Number and Quantity The Real Number System (N-RN) Number and Quantity The Real Number System (N-RN) Use properties of rational and irrational numbers N-RN.3 Explain why the sum or product of two rational numbers is rational; that the sum of a rational

More information

Operator Expansions for Linear Waves: Parallel Implementation and. Multilayer Inversion

Operator Expansions for Linear Waves: Parallel Implementation and. Multilayer Inversion Operator Expansions for Linear Waves: Parallel Implementation and Multilayer Inversion by Zheng Fang B.A. (University of Science and Technology of China) 2010 M.S. (University of Illinois at Chicago) 2012

More information

Waves on 2 and 3 dimensional domains

Waves on 2 and 3 dimensional domains Chapter 14 Waves on 2 and 3 dimensional domains We now turn to the studying the initial boundary value problem for the wave equation in two and three dimensions. In this chapter we focus on the situation

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

Lecture 1: Introduction

Lecture 1: Introduction CBMS Conference on Fast Direct Solvers Dartmouth College June June 7, 4 Lecture : Introduction Gunnar Martinsson The University of Colorado at Boulder Research support by: Many thanks to everyone who made

More information