Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Size: px
Start display at page:

Download "Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs"

Transcription

1 Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u x + u = f(x, y) (x, y) Ω = [0, ] [0, ] (.) y u Ω = g Basic concept: replacing the derivatives by finite differences. Let π = {x i, y j } M+,N+ i,j=0 define a mesh on Ω. For simplicity, we consider a uniform mesh with the meshsize h x = x i x i and h y = y j y j, and u ij be a mesh function on π. The finite difference approximation is defined by u xx u(x i, y j ) u(x i, y j ) + u(x i+, y j ) h x u yy u(x i, y j ) u(x i, y j ) + u(x i, y j+ ) h y Then the finite difference solution u ij is determined by the following system L h u ij := u i,j u i,j + u i+,j h x + u i,j u i,j + u i,j+ h y i =,,..., M; j =,,..., N u ij = g(x i, y j ) i = 0, i = M +, j = 0, j = N + = f(x i, y j ) (.) In matrix form, where for h x = h y = h A = h Au = f B I I B I I B B = and u = (u, u,..., u N, u..., u N,..., u M,...u MN ) T. In tensor product form, (A I N + I M A )u = f 40

2 where A = h x Here the tensor product is defined by M M A = h y N N B C = (b ij C) Some properties: () (A A )(B B ) = (A B ) (A B ) () (A A ) = A A () if Ax = λ A x, By = λ B y (A B)(x y) = λ A λ B (x y).. Linear Solvers. A major problem for elliptic PDEs is the efficient algorithms for solving the linear systems since the dimension of matrices for elliptic PDEs is much large than for two-point boundary value problems. Direct algorithm: Gaussian elimination. Complexity: (NM) / for two-demensional elliptic PDEs. Memory: O(NM ). Iterative algorithms: Jacobi, Gauss-Seidel, SOR, CG, Krylov subspace,... Alternatiing direction implicit (ADI) algorithm [(A + ωi) I] u n+/ = [I (A ωi)] u n + f [I (A + ωi)] u n+ = [(A ωi) I] u n+/ + f Convergence: (i) ADI is convergence for any ω > 0; (ii) If ω n = λ n, ADI is a finite method (direct) where λ n is the eigenvalue of A. Complexity: at each iteration, ADI algorithm needs to solve N M one-dimensional problems, i.e., tridiagonal linear systems. The complexity at each step is (N ) for N = M. Remarks: ADI algorithm is simple, efficient and restricted on separable problems. Convergence analysis: First we consider the following basic iteration The iterative scheme is convergent if u n+ = T u n + b ρ(t ) <. 4

3 (u: u = T u + b, proof is easy). ADI algorithm is a special case with T = [I (A + ωi)] [(A ωi) I] [(A + ωi) I] [I (A ωi)] It is easy to get T = [ (A ωi)(a + ωi) ] [ (A + ωi) (A ωi) ] and the eigenvalues of T are Fast Poisson s solver. We have proved that λ(t ) = (λ(a ) ω)(λ(a ) ω) (λ(a ) + ω)(λ(a ) + ω) < A F s = Λ F s where and F s F s = M + (sin ijπ M + ) λ i = 4(M + ) sin iπ (M + ) = I. Then the finite difference system can be rewitten by and moreoever, where Fast Poisson solver: (i) Calculate f = (F s I)f; (ii) Solve the system (F s I)(Λ I + I A )(F s I)u = f (Λ I + I A )ū = (F s I)f ū = (F s I)u (Λ I + I A )ū = f (iii) calculate u = (F s I)ū. Complexity: O(N logn) for N = M... General second-order Elliptic PDEs. General domain General boundary conditions Problems in three-dimensional spaces More general elliptic PDEs Linear elasticity equations where (u, v) define the displacement. a u xx + a u xy + a u yy + b u x + b u y + cu = f (λ + µ)u xx + µu yy + (λ + µ)v xy = f (λ + µ)v yy + µv xx + (λ + µ)u xy = f 4

4 FEM for two-dimensional elliptic PDEs. Basic idea We consider a simple model problem, Poisson equation u = f(x, y), u Ω = 0 where Ω denotes the boundary of Ω and (x, y) Ω (.) u u x + u y. Similarly to one-dimensional problem, we need a variational model which will be obtained by using Green formula instead of integration by part in the last section. Let u = u(x, y) and w = w(x, y) be smooth functions in Ω. Green formula is given by i.e., where v w dω = vw n ds + w v dω Ω Ω Ω ( ) w v Ω x + w dxdy = v w ( v y Ω n Ω ds + w x x + v y w = wn n x x + wn y y n x = cos < n, x >, n y = cos < n, y >, v = ( v x v y ) w = ( w x w y ). ) w dxdy y By using the Green formula for the model problem (.) and letting v H0(Ω), we have v w dω = u v dω = fv dω. Ω Ω Ω Let a(u, v) = Ω u v dω (f, v) = Ω fv dω F (v) = a(v, v) (f, v). We can obtain the equivalent (V) model and (M) model and Find u H 0 (Ω) such that for all v H 0 (Ω), a(u, v) = (f, v) (V ) min v H 0 (Ω) F (v) Similarly, the above models are to find a solution in a infinite dimensional space. In FEM, we need to approximate the infinite dimensional space by finite dimensional spaces V h. Let 4 (M)

5 φ j (x, y), j =,,, N, be the basis functions of V h. A function u h V h can be expressed by N u h (x, y) = α j φ j (x, y). Letting v = φ i, i =,,..., N, respectively, in the (V h )-model, we have and The linear system is given by where j= a(u h, φ j ) = (f, φ i ) N α j φ i φ j dω = fφ i dω, i =,,..., N. j= Ω Ω a ij = Ω Aα = b φ i φ j dω, b i = Ω fφ i dω. The importance is the choice of finite dimensional space. Piecewise polynomial space is one of most popular choices. In this case, one has to construct a mesh, i.e., divided the domain Ω into small pieces (element). Mesh generation in multi-dimensional space is one of important parts in study of FEM. Figure 4: Finite element mesh in two-dimensional space.. Basis functions Here we consider piecewise polynomial basis functions. Let Ω be a bounded domain which consists of the elements {K i } M i= and nodal points {(x j, y j } N j=. We first consider the piecewise linear space where V h = {v : continuous on Ω, piecewise linear, v = 0 on Ω}. The corresponding basis functions φ j (x) V h, j =,,..., N, satisfy * φ j (x) is piecewise linear; * φ j (x i ) = δ ij where x = (x, y). 44

6 Figure 5: The basis function of linear element in two-dimensional space. We see that the support of φ j (the set of points x for which φ j 0) consists of the triangles with the common node x j (shaded area). Now we need to formulate the piecewise linear function. Example. Find a linear function L(x, y) on Ω = {(x, y) 0 x a, 0 y b, x/a+y/b } satisfies * linear; * L(a, 0) = 0, L(0, b) = 0; * L(0, 0) =. L y x Figure 6: The function L(x, y). Since L(x, y) is a linear function, it can be expressed by L(x, y) = b 0 + b x + b y. Then the solution of problem is unique. The equation of line passed through the points (a, 0) and (0, b) is x a + y b =. Let l(x, y) = x a + y b. 45

7 Then the solution is L(x, y) = l(x, y) l(0, 0) = x a y b which satisfies the all above conditions. For a given triangle Ω with the three vertices x, x and x. We need to find three linear functions L j (x), j =,,, satisfying L j (x i ) = δ ij. Let l ij (x) denote the equation of line passed through the vertices x i and x j. Then L (x) = l (x) l (x ) L (x) = l (x) l (x ) L (x) = l (x) l (x ). Now we can formulate the linear basis functions, each of them corresponds to each interior node. φ j (x) is nonzero only in the elements around the vertex x j. The formula in such each element can be obtained as above. Example (Quadratic element). Find a function Q j (x, y) on a triangle Ω with its vertices x i, i =,,, satisfies * quadratic; * Q j (x i ) = δ ij, i, j =,,. It is obvious that the solution is not unique. We need to add some more conditions. Here we consider a triangular element below. X X 5 * * X 4 X * X 6 X Figure 7: The basis function of quadratic element. We require the second condition to be satisfied for j =,,, 4, 5, 6. Let l ij (x) be the equation of line passed through x i and x j. Then the solution is Q (x) = l 56(x) l (x) l 56 (x ) l (x ) Q (x) = l 45(x) l (x) l 45 (x ) l (x ) Q 5 (x) = l (x) l (x) l (x 5 ) l (x 5 ) Q (x) = l 46(x) l (x) l 46 (x ) l (x ) Q 4 (x) = l (x) l (x) l (x 4 ) l (x 4 ) Q 6 (x) = l (x) l (x) l (x 6 ) l (x 6 ). It is noted that Q j (x, y) defined above is quadratic for each component. Example (Quadrilateral element. Four-point quadrilateral element) 46

8 The linear basis functions L j (x) can be obtained analogously. L (x) = l (x) l 4 (x) l (x ) l 4 (x ) L (x) = l (x) l 4 (x) l (x ) l 4 (x ) which is not exact linear function in general. Some other high-order elements are as follows. L (x) = l 4(x) l 4 (x) l 4 (x ) l 4 (x ) L 4 (x) = l (x) l (x) l (x 4 ) l (x 4 ) X X 4 o o o o X o o X o o Figure 8: Some other elements. Stiffness matrix For the simple model problem (.), we have a ij = φ i φ j dω. Here we only consider the linear element. Ω X X4 K Xi K X K 4 K K 5 X5 X Figure 9: The elements around the node X i Let K i denote the five elements around the node x j. Then φ j (x) = l (x) l (x j ). The equation of line passed through x and x is x x x x y y y y = 0 47

9 i.e., We see that and l (x, y) := (x y x y ) x(y y ) + y(x x ) = 0. l (x j, y j ) = l (x, y) = x j x x y j y y x x x y y y where A(K ) = is the area of the element K. Since = A(K ) = ( ) φ j x = y y φ j y = x x, we have a ij = l K l φ i φ j dω = l K l ( φi x Obviously, if no segment between x i and x j, a ij = 0. Example. We consider the following Poisson s equation ) ( φ j φi + x y u = (x, y) Ω = [0, ] [0, ] u Ω = 0 By using linear triangular element and h = /. ) φ j dω. y Figure 0: An example. Node i =, a = K +K +K 4 +K 7 +K 8 +K 9 φ φ dxdy = K + K + K 4 + K 7 + K 8 + K 9. 48

10 We have calculate the integrals one by one. Since on K, φ = (x + y h)/h, Also we have and Then For a, we have We can obtain and therefore, Similarly, and Then the stiffness matrix is ( ) φ φ dxdy = dxdy =. K K h ( ) φ φ dxdy = dxdy = / K K h 4 7 K = K = K 8 = / a = 4. K 9 =. a = φ φ dxdy. K 4 +K 9 φ φ dxdy = φ φ dxdy = / K 4 K 9 a =. a = a 4 = 0 ( no edge between x and x 4 ) a = a = a 44 = 4 a = 0 a 4 = a 4 =. A = h The calculation of the load vector b is more complicated. b = K +K +K 4 +K 7 +K 8 +K 9 φ dxdy b = K 4 +K 5 +K 6 +K 9 +K 0+K φ dxdy b = K 8 +K 9 +K 0 +K +K 4 +K 5 φ dxdy b 4 = K 0 +K +K +K 5 +K 6 +K 7 φ 4 dxdy. The finite element linear system is Aα = b. 49

11 If we consider the case with N N mesh. Then the stiffness matrix is block tridiagonal B I I B I A = I B where B = If we have used different partition, or different index, we will obtain different stiffness matrices. It will be very complicated for general geometry, equations and boundary conditions.. Element stiffness matrix. The above approach is very complicated to implement in computer. As we discussed in the section one, we consider an alternative approach, element stiffness matrix. We assume that we have had a triangular mesh on the domain Ω, which consists of the elements K k, k =,,..., M and φ j, j =,,..., N, be the linear basis functions. For the element K k, we denote its element stiffness matrix by where for the simple model (.), a (k) ij = ā(φ i, φ j ) = A k = (a (k) ij ). K k φ i φ j dxdy. Xk K k Xk Xk Figure : A typical element. Let ( x i, ȳ i ), i =,,, be the coordinates of three vertices of K k. Then ( a (k) φki φ kj ij = K k x x + φ ) k i φ kj dxdy i, j =,, y y 50

12 and φ k = k x x x y ȳ ȳ φ k = k x x x y ȳ ȳ φ k = k x x x y ȳ ȳ. In general, where x 4 = x and x 5 = x. Hence, φ ki x = k We have the following formulas: and φ ki = k ȳ i+ ȳ i+ x x i+ x i+ y ȳ i+ ȳ i+ φ ki y = k x i+ x i+ a (k) ij = 4 k [(ȳ i+ ȳ i+ )(ȳ j+ ȳ j+ ) + ( x i+ x i+ )( x j+ x j+ )] (.) b (k) i = f(x, y)φ i dxdy. K k Since f(x, y) could be an arbitrary function, we need to use Gauss-Quadrature technique to calculate the above integrals b (k) i = p w l f(x l, yl )φ i (x l, yl ) l= where (x l, y l ) and w l define the Gaussian points and the corresponding weight. Remarks. For some complicated elliptic PDEs, a(u, v) could be complicated and we cannot obtain the above general formula. We have to use Gauss-Quadrature to calculate both a (k) ij and b (k) i. In most computer program, the stiffness matrix is obtained by using the following approach. Let A = (a ij ) and A k = a (k) ij be the (global) stiffness matrix and element stiffness matrix, respectively. Then for each element K k, we need the following loop. a jp,j q = a jp,j q + a (k) pq p, q =,, (.) and b jp = b jp + b (k) p p, q =,,. The relationship between (j p, j q ) and (p, q) will be discussed later. Finally we use the boundary conditions to reduce the size of the matrix. Example. We consider the same problem as in the last example. Here k = /8. 5

13 Figure : An example. 5 (i) Element stiffness matrices. By using the above formulas, a () [( ) ( ) ( ) ( )] = 4 + = a () [( ) ( ) ( ) ] = = / a () = 4 [( a () = [( 4 a () [( = 4 a () = 4 [ 0 + ( ) ( ) ( ) ( )] 0 + = / ) ( ) ] + 0 = / ) ( )] = 0 )] = /. Then we have and similarly Moreover, we have A = A = / / / / 0 / 0 / / / 0 / / 0 / /. A = A = A 5 = A 5 = A 7 A = A 4 = = A 6 = A 8. 5

14 (ii) Global stiffness matrix. Now we assemble them into a global stiffness matrix. Key point for the assembling is the local index and global index. In our formulas, p, q represent the local indexes and j p, j q are the global indexes. The relationship is as follows. 5 4 Figure : The connection. A : local global 5 A : local global 6 5 Following the rule, we can put the element matrix into the global matrix. For example, a () should be added in a 5 a 5 = a 5 + a () and a () should be added in a 6 a 6 = a 6 + a (). We obtain (assemble the first 8 elements) A = / / / + / + / 0 / / / + / + / / / / + / / / + / + / / / + / + / + / + / / / + / + / / + / / The right hand side can be assembled similarly. (iii) Condensation. By using the boundary conditions α = α = α = α 4 = α 5 = α 8 = α 9 = α = α = α 4 = α 5 = α 6 = 0, we obtain the final linear system 4 0 α α α α = b () + b () + b (4) + b (7) + b (8) + b (9) b (4) + b (5) + b (6) + b (9) + b (0) + b () b (8) + b (9) + b (0) + b () + b (4) + b (5) b (0) + b () + b () + b (5) + b (6) + b (7) 5.

15 The finite element solution can be obtained by solving the above system..4 Implementation Computer program structure. (i) Data input * functions (such as f(x, y)) and parameters in the PDE; * boundary conditions; * Geometry Ω. (ii) Mesh generation * generate the coordinates of all nodal points; * generate the connection among the local indexes (of points) and global indexes (of points). (iii) Stiffness matrix and load vector * generate element stiffness matrices; * generate element load vector; * Gaussian quadrature; * assembling. (iv) Linear solver (iterative methods or direct methods) (v) Post-process. Gauss quadrature We consider the integral 0 f(x) dx or f(x) dx In general, f(x, y) dx dy Usually we use the same approximation in FEM to approximate the function f(x, y). For example, if we use linear FEM method, then f(x, y) dx dy f L (x, y) dx dy where f L (x, y) is a linear interpolation polynomial on the element. Linear solver 54

16 Chapter Three Numerical Solution for Parabolic PDEs FD for parabolic PDEs. Here we consider numerical solutions of a simple model problem where u 0 (x) is given. Let {t n, x j } define a partition, where u t = u xx, x (0, ), t > 0 (.) u(0, x) = u 0 (x), x (0, ) u(t, 0) = u(t, ) = 0, t > 0 0 = t 0 < t < t... < t n < t n+ 0 = x 0 < x < x... < x N < x N+ =. For simplicity, we assume the mesh is uniform, i.e., h = x j+ x j τ = t n+ t n. Let u n j be a mesh function defined on the mesh {t n, x j }. Similarly, we use the following approximations u xx (t n, x j ) u(t n, x j ) u(t n, x j ) + u(t n, x j+ ) h u t (t n, x j ) u(t n+, x j ) u(t n, x j ) τ for the parabolic equation. The FD solution satisfies the following system u n j τ u 0 j = u 0 (x j ) u n+ j In matrix form, we have u n 0 = u n N+ = 0. (.) = un j un j + un j+ h j =,,..., N; n = 0,,... (.) U n+ = (I τ h A )U n (.4) U 0 = U 0 where A = U n = u n u n. u n N U 0 = u 0 (x ) u 0 (x ). u 0 (x N ) 55

17 which is called the explicit (forward) Euler FD scheme. Similarly, if we use the approximation u t (t n, x j ) u(t n, x j ) u(t n, x j ) τ Then we obtain the implicit (backward) Euler FD scheme and in matrix form, u n j un j τ u 0 j = u 0(x j ) u n 0 = u n N+ = 0 = un j un j + un j+ h j =,,..., N; n =,,... (.5) (I + τ h A )U n = U n n =,,... (.6) U 0 = U 0 In terms of Taylor s expansion, we can prove that the trunction error for both explicit and implicit Euler scheme is O(τ + h ). In order to get a scheme with second-order accuracy in t direction, we consider the approximation u t (t n + τ/, x j ) u(t n+, x j ) u(t n, x j ) τ u xx (t n + τ/, x j ) u(t n+, x j ) u(t n+, x j ) + u(t n+, x j+ ) (.7) h + u(t n, x j ) u(t n, x j ) + u(t n, x j+ ). h The corresponding scheme can be writtren by (I + τ h A )U n+ = (I τ h A )U n n = 0,,,... (.8) U 0 = U 0 This is so-called the Crank-Nicolson FD scheme. The trunction error is O(τ + h ).. FE for parabolic PDEs To formulate a finite element method, we need a variational model for the parabolic PDE. Let v H 0 and (u t, v) = (u xx, v) (u(0, x), v) = (u 0, v) 56

18 Using integration by part, (u t, v) + a(u, v) = 0 (u(0, x), v) = (u 0, v) (.) where a(u, v) = (u x, v x ). The corresponding variational model is: Find u H0 such that for all v H 0, the above equation holds. Theoretically, we can prove the equivalence of the parabolic PDE and the variational model. The variational model for FEM is to find u V N such that for all v V N, the equation (.) holds. Now we consider the linear FEM. Let {φ j } N j=0 be the basis functions of linear FEM. Then Let v = φ i (x), i =,,..., N, u(t, x) = α j (t)φ j (x), u t (t, x) = α j(t)φ j (x). ( α j(t)φ j, φ i ) + a( α j (t)φ j, φ i ) = 0 ( α j (0)φ j, φ i ) = (u 0, φ i ) equivalently α j (t)(φ j, φ i ) + α j (t)a(φ j, φ i ) = 0 In matrix form, where or αj (0)(φ j, φ i ) = (u 0, φ i ). Cα + Aα = 0 Cα(0) = b a ij = a(φ j, φ i ), c ij = (φ j, φ i ) b i = (u 0, φ i ) A = h A, C = tridiag(/6, /, /6), (.) α = (α (t), α (t),, α N (t)) T α = (α (t), α (t),, α N (t))t. (.) is a system of ODEs. In fact, in terms of FEM approximation in x direction, we reduce the parabolic PDE to a system of ODEs. One can use classical ODE solvers for solving the resulting ODE system. Thus such a scheme is called the semi-discrete method. There are many different fully-discrete schemes. Here we only consider some FD schemes for t direction. If we use the approximation in (.), the variational model is to find u V N such that for all v V N, ( u n+ (x) u n (x) τ, v ) + a(u n (x), v) = 0 (u 0 (x), v) = (u 0, v) (.) The variational model for FEM is to find u V n such that for all v V N, the equation (.) holds. 57

19 Similarly, we consider the linear FEM. Let {φ j } N j=0 be the basis functions of linear FEM. Then u n (x) = αj n φ j(x),. Let v = φ i (x), i =,,..., N, (α n+ j α n j )(φ j, φ i ) + τ α n j a(φ j, φ i ) = 0 α 0 j (φ j, φ i ) = (u 0, φ i ) In matrix form where Cα n+ = (C τa)α n Cα 0 = b α n = (α n (t), αn (t),, αn N (t))t. (.4) This is so-called the explicit Euler with linear FEM. Similarly, there are the implicit Euler with linear FEM and the Crank-Nicolson with linear FEM. Stablility Stability of parabolic PDEs We consider model problem (.). A perturbed model problem is given by where u 0 (x) is given. Let e(t, x) = u(t, x) v(t, x). We have v t = v xx, x (0, ), t > 0 (.) v(0, x) = u 0 (x) + δ(x), x (0, ) v(t, 0) = v(t, ) = 0, t > 0 e t = e xx, x (0, ), t > 0 (.) e(0, x) = δ(x), x (0, ) e(t, 0) = e(t, ) = 0, t > 0 The model problem (.) is said to be stable with respect to the norm, if there exist positive constants K such that e K δ. Stability of discrete methods First we consider a general scheme u n+ = Mu n + f (.) u 0 = b(given) 58

20 where M is an N N matrix. A perturbed system is defined by Let ɛ n = v n u n. Then and therefore, It follows that By theorem in Linear Algebra, if v n+ = Mv n + f v 0 = b + δ ɛ n+ = Mɛ n ɛ 0 = δ ɛ n+ = Mɛ n = M ɛ n =... = M n+ ɛ 0 = M n+ δ. ɛ n+ M n+ δ. ρ(m) := max λ j (M) <, (.4) j M n+ 0 as n and ɛ n+ 0. In this case, we say that the discrete method is (absolutely) stable. For the explicit (forward) Euler FD scheme Then M = (I τ h A ). λ j (I τ h A ) = τ 4 jπ h sin ( (N + ) ). The explicit Euler FD scheme is absolutely stable. τ 4 jπ h sin ( (N + ) ) < and approximately τ h <. For the implicit (backward) Euler FD scheme M = (I + τ h A ). We have λ j (M) = λ j ( (I + τ h A ) ) = + τ 4 sin jπ ( ) < h (N+) j =,,, N The implicit (backward) Euler FD scheme is unconditionally stable. 59

21 For the Crank-Nicolson FD scheme, M = (I + τ h A ) (I τ h A ). It is easy to verify that this method is also unconditionally stable. For FEM, we have Then A = h A, C = h(i 6 A ) For linear FEM with explicit Euler scheme, M = C (C τa) = I0C A = I τ h (I 6 A ) A. λ j (M) = τ h 4 sin jπ (N+) jπ (N+) The scheme is absolutely stable if τ h < 6. We can study the stability of linear FEM methods with implicity and Crank-Nicolson schemes similarly. 60

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

More information

10 The Finite Element Method for a Parabolic Problem

10 The Finite Element Method for a Parabolic Problem 1 The Finite Element Method for a Parabolic Problem In this chapter we consider the approximation of solutions of the model heat equation in two space dimensions by means of Galerkin s method, using piecewise

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

More information

Computation Fluid Dynamics

Computation Fluid Dynamics Computation Fluid Dynamics CFD I Jitesh Gajjar Maths Dept Manchester University Computation Fluid Dynamics p.1/189 Garbage In, Garbage Out We will begin with a discussion of errors. Useful to understand

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University The Implicit Schemes for the Model Problem The Crank-Nicolson scheme and θ-scheme

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University A Model Problem in a 2D Box Region Let us consider a model problem of parabolic

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Numerical Methods for Partial Differential Equations Finite Difference Methods

More information

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK KINGS COLLEGE OF ENGINEERING MA5-NUMERICAL METHODS DEPARTMENT OF MATHEMATICS ACADEMIC YEAR 00-0 / EVEN SEMESTER QUESTION BANK SUBJECT NAME: NUMERICAL METHODS YEAR/SEM: II / IV UNIT - I SOLUTION OF EQUATIONS

More information

The method of lines (MOL) for the diffusion equation

The method of lines (MOL) for the diffusion equation Chapter 1 The method of lines (MOL) for the diffusion equation The method of lines refers to an approximation of one or more partial differential equations with ordinary differential equations in just

More information

A very short introduction to the Finite Element Method

A very short introduction to the Finite Element Method A very short introduction to the Finite Element Method Till Mathis Wagner Technical University of Munich JASS 2004, St Petersburg May 4, 2004 1 Introduction This is a short introduction to the finite element

More information

Finite difference methods for the diffusion equation

Finite difference methods for the diffusion equation Finite difference methods for the diffusion equation D150, Tillämpade numeriska metoder II Olof Runborg May 0, 003 These notes summarize a part of the material in Chapter 13 of Iserles. They are based

More information

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 28 PART II Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 29 BOUNDARY VALUE PROBLEMS (I) Solving a TWO

More information

Finite Elements. Colin Cotter. January 15, Colin Cotter FEM

Finite Elements. Colin Cotter. January 15, Colin Cotter FEM Finite Elements January 15, 2018 Why Can solve PDEs on complicated domains. Have flexibility to increase order of accuracy and match the numerics to the physics. has an elegant mathematical formulation

More information

Boundary Value Problems and Iterative Methods for Linear Systems

Boundary Value Problems and Iterative Methods for Linear Systems Boundary Value Problems and Iterative Methods for Linear Systems 1. Equilibrium Problems 1.1. Abstract setting We want to find a displacement u V. Here V is a complete vector space with a norm v V. In

More information

Time-dependent variational forms

Time-dependent variational forms Time-dependent variational forms Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Oct 30, 2015 PRELIMINARY VERSION

More information

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value Numerical Analysis of Differential Equations 188 5 Numerical Solution of Elliptic Boundary Value Problems 5 Numerical Solution of Elliptic Boundary Value Problems TU Bergakademie Freiberg, SS 2012 Numerical

More information

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of,

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of, 269 C, Vese Practice problems [1] Write the differential equation u + u = f(x, y), (x, y) Ω u = 1 (x, y) Ω 1 n + u = x (x, y) Ω 2, Ω = {(x, y) x 2 + y 2 < 1}, Ω 1 = {(x, y) x 2 + y 2 = 1, x 0}, Ω 2 = {(x,

More information

Iterative Methods for Linear Systems

Iterative Methods for Linear Systems Iterative Methods for Linear Systems 1. Introduction: Direct solvers versus iterative solvers In many applications we have to solve a linear system Ax = b with A R n n and b R n given. If n is large the

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 11 Partial Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002.

More information

The Plane Stress Problem

The Plane Stress Problem The Plane Stress Problem Martin Kronbichler Applied Scientific Computing (Tillämpad beräkningsvetenskap) February 2, 2010 Martin Kronbichler (TDB) The Plane Stress Problem February 2, 2010 1 / 24 Outline

More information

Simple Examples on Rectangular Domains

Simple Examples on Rectangular Domains 84 Chapter 5 Simple Examples on Rectangular Domains In this chapter we consider simple elliptic boundary value problems in rectangular domains in R 2 or R 3 ; our prototype example is the Poisson equation

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

1 Discretizing BVP with Finite Element Methods.

1 Discretizing BVP with Finite Element Methods. 1 Discretizing BVP with Finite Element Methods In this section, we will discuss a process for solving boundary value problems numerically, the Finite Element Method (FEM) We note that such method is a

More information

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA Introduction to Finite and Spectral Element Methods Using MATLAB Second Edition C. Pozrikidis University of Massachusetts Amherst, USA (g) CRC Press Taylor & Francis Group Boca Raton London New York CRC

More information

Code: 101MAT4 101MT4B. Today s topics Finite-difference method in 2D. Poisson equation Wave equation

Code: 101MAT4 101MT4B. Today s topics Finite-difference method in 2D. Poisson equation Wave equation Code: MAT MTB Today s topics Finite-difference method in D Poisson equation Wave equation Finite-difference method for elliptic PDEs in D Recall that u is the short version of u x + u y Dirichlet BVP:

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Variational Problems of the Dirichlet BVP of the Poisson Equation 1 For the homogeneous

More information

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically Finite difference and finite element methods Lecture 1 Scope of the course Analysis and implementation of numerical methods for pricing options. Models: Black-Scholes, stochastic volatility, exponential

More information

x x2 2 + x3 3 x4 3. Use the divided-difference method to find a polynomial of least degree that fits the values shown: (b)

x x2 2 + x3 3 x4 3. Use the divided-difference method to find a polynomial of least degree that fits the values shown: (b) Numerical Methods - PROBLEMS. The Taylor series, about the origin, for log( + x) is x x2 2 + x3 3 x4 4 + Find an upper bound on the magnitude of the truncation error on the interval x.5 when log( + x)

More information

Applied/Numerical Analysis Qualifying Exam

Applied/Numerical Analysis Qualifying Exam Applied/Numerical Analysis Qualifying Exam August 9, 212 Cover Sheet Applied Analysis Part Policy on misprints: The qualifying exam committee tries to proofread exams as carefully as possible. Nevertheless,

More information

Lecture 42 Determining Internal Node Values

Lecture 42 Determining Internal Node Values Lecture 42 Determining Internal Node Values As seen in the previous section, a finite element solution of a boundary value problem boils down to finding the best values of the constants {C j } n, which

More information

Numerical Solution Techniques in Mechanical and Aerospace Engineering

Numerical Solution Techniques in Mechanical and Aerospace Engineering Numerical Solution Techniques in Mechanical and Aerospace Engineering Chunlei Liang LECTURE 3 Solvers of linear algebraic equations 3.1. Outline of Lecture Finite-difference method for a 2D elliptic PDE

More information

Notes on Numerical Analysis

Notes on Numerical Analysis Notes on Numerical Analysis Alejandro Cantarero This set of notes covers topics that most commonly show up on the Numerical Analysis qualifying exam in the Mathematics department at UCLA. Each section

More information

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Introduction to Simulation - Lecture 2 Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Outline Reminder about

More information

Numerical Analysis of Differential Equations Numerical Solution of Parabolic Equations

Numerical Analysis of Differential Equations Numerical Solution of Parabolic Equations Numerical Analysis of Differential Equations 215 6 Numerical Solution of Parabolic Equations 6 Numerical Solution of Parabolic Equations TU Bergakademie Freiberg, SS 2012 Numerical Analysis of Differential

More information

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem:

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem: Mathematics Chalmers & GU TMA37/MMG800: Partial Differential Equations, 011 08 4; kl 8.30-13.30. Telephone: Ida Säfström: 0703-088304 Calculators, formula notes and other subject related material are not

More information

ME Computational Fluid Mechanics Lecture 5

ME Computational Fluid Mechanics Lecture 5 ME - 733 Computational Fluid Mechanics Lecture 5 Dr./ Ahmed Nagib Elmekawy Dec. 20, 2018 Elliptic PDEs: Finite Difference Formulation Using central difference formulation, the so called five-point formula

More information

Math 5630: Iterative Methods for Systems of Equations Hung Phan, UMass Lowell March 22, 2018

Math 5630: Iterative Methods for Systems of Equations Hung Phan, UMass Lowell March 22, 2018 1 Linear Systems Math 5630: Iterative Methods for Systems of Equations Hung Phan, UMass Lowell March, 018 Consider the system 4x y + z = 7 4x 8y + z = 1 x + y + 5z = 15. We then obtain x = 1 4 (7 + y z)

More information

Question 9: PDEs Given the function f(x, y), consider the problem: = f(x, y) 2 y2 for 0 < x < 1 and 0 < x < 1. x 2 u. u(x, 0) = u(x, 1) = 0 for 0 x 1

Question 9: PDEs Given the function f(x, y), consider the problem: = f(x, y) 2 y2 for 0 < x < 1 and 0 < x < 1. x 2 u. u(x, 0) = u(x, 1) = 0 for 0 x 1 Question 9: PDEs Given the function f(x, y), consider the problem: 2 u x 2 u = f(x, y) 2 y2 for 0 < x < 1 and 0 < x < 1 u(x, 0) = u(x, 1) = 0 for 0 x 1 u(0, y) = u(1, y) = 0 for 0 y 1. a. Discuss how you

More information

Department of Mathematics California State University, Los Angeles Master s Degree Comprehensive Examination in. NUMERICAL ANALYSIS Spring 2015

Department of Mathematics California State University, Los Angeles Master s Degree Comprehensive Examination in. NUMERICAL ANALYSIS Spring 2015 Department of Mathematics California State University, Los Angeles Master s Degree Comprehensive Examination in NUMERICAL ANALYSIS Spring 2015 Instructions: Do exactly two problems from Part A AND two

More information

Finite Element Method in Geotechnical Engineering

Finite Element Method in Geotechnical Engineering Finite Element Method in Geotechnical Engineering Short Course on + Dynamics Boulder, Colorado January 5-8, 2004 Stein Sture Professor of Civil Engineering University of Colorado at Boulder Contents Steps

More information

An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations.

An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations. An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations by Tong Chen A thesis submitted in conformity with the requirements

More information

INTRODUCTION TO FINITE ELEMENT METHODS

INTRODUCTION TO FINITE ELEMENT METHODS INTRODUCTION TO FINITE ELEMENT METHODS LONG CHEN Finite element methods are based on the variational formulation of partial differential equations which only need to compute the gradient of a function.

More information

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1 Scientific Computing WS 2017/2018 Lecture 18 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 18 Slide 1 Lecture 18 Slide 2 Weak formulation of homogeneous Dirichlet problem Search u H0 1 (Ω) (here,

More information

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal FEniCS Course Lecture 0: Introduction to FEM Contributors Anders Logg, Kent-Andre Mardal 1 / 46 What is FEM? The finite element method is a framework and a recipe for discretization of mathematical problems

More information

Chapter 3 Second Order Linear Equations

Chapter 3 Second Order Linear Equations Partial Differential Equations (Math 3303) A Ë@ Õæ Aë áöß @. X. @ 2015-2014 ú GA JË@ É Ë@ Chapter 3 Second Order Linear Equations Second-order partial differential equations for an known function u(x,

More information

ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices. Numerical Methods and Simulation / Umberto Ravaioli

ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices. Numerical Methods and Simulation / Umberto Ravaioli ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices 1 General concepts Numerical Methods and Simulation / Umberto Ravaioli Introduction to the Numerical Solution of Partial Differential

More information

Finite Difference Methods for Boundary Value Problems

Finite Difference Methods for Boundary Value Problems Finite Difference Methods for Boundary Value Problems October 2, 2013 () Finite Differences October 2, 2013 1 / 52 Goals Learn steps to approximate BVPs using the Finite Difference Method Start with two-point

More information

9. Iterative Methods for Large Linear Systems

9. Iterative Methods for Large Linear Systems EE507 - Computational Techniques for EE Jitkomut Songsiri 9. Iterative Methods for Large Linear Systems introduction splitting method Jacobi method Gauss-Seidel method successive overrelaxation (SOR) 9-1

More information

Introduction to numerical schemes

Introduction to numerical schemes 236861 Numerical Geometry of Images Tutorial 2 Introduction to numerical schemes Heat equation The simple parabolic PDE with the initial values u t = K 2 u 2 x u(0, x) = u 0 (x) and some boundary conditions

More information

DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS

DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS Sergey Korotov BCAM Basque Center for Applied Mathematics http://www.bcamath.org 1 The presentation is based on my collaboration with several

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 11 Partial Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002.

More information

Finite difference method for elliptic problems: I

Finite difference method for elliptic problems: I Finite difference method for elliptic problems: I Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in/~praveen

More information

Finite difference method for heat equation

Finite difference method for heat equation Finite difference method for heat equation Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in/~praveen

More information

SOLUTION OF EQUATION AND EIGENVALUE PROBLEMS PART A( 2 MARKS)

SOLUTION OF EQUATION AND EIGENVALUE PROBLEMS PART A( 2 MARKS) CHENDU COLLEGE OF ENGINEERING AND TECHNOLOGY (Approved by AICTE New Delhi, Affiliated to Anna University Chennai. Zamin Endathur Village, Madurntakam Taluk, Kancheepuram Dist.-603311.) MA6459 - NUMERICAL

More information

x n+1 = x n f(x n) f (x n ), n 0.

x n+1 = x n f(x n) f (x n ), n 0. 1. Nonlinear Equations Given scalar equation, f(x) = 0, (a) Describe I) Newtons Method, II) Secant Method for approximating the solution. (b) State sufficient conditions for Newton and Secant to converge.

More information

Iterative Methods for Ax=b

Iterative Methods for Ax=b 1 FUNDAMENTALS 1 Iterative Methods for Ax=b 1 Fundamentals consider the solution of the set of simultaneous equations Ax = b where A is a square matrix, n n and b is a right hand vector. We write the iterative

More information

Module 3: BASICS OF CFD. Part A: Finite Difference Methods

Module 3: BASICS OF CFD. Part A: Finite Difference Methods Module 3: BASICS OF CFD Part A: Finite Difference Methods THE CFD APPROACH Assembling the governing equations Identifying flow domain and boundary conditions Geometrical discretization of flow domain Discretization

More information

Multi-Factor Finite Differences

Multi-Factor Finite Differences February 17, 2017 Aims and outline Finite differences for more than one direction The θ-method, explicit, implicit, Crank-Nicolson Iterative solution of discretised equations Alternating directions implicit

More information

Tutorial 2. Introduction to numerical schemes

Tutorial 2. Introduction to numerical schemes 236861 Numerical Geometry of Images Tutorial 2 Introduction to numerical schemes c 2012 Classifying PDEs Looking at the PDE Au xx + 2Bu xy + Cu yy + Du x + Eu y + Fu +.. = 0, and its discriminant, B 2

More information

Preliminary Examination in Numerical Analysis

Preliminary Examination in Numerical Analysis Department of Applied Mathematics Preliminary Examination in Numerical Analysis August 7, 06, 0 am pm. Submit solutions to four (and no more) of the following six problems. Show all your work, and justify

More information

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

More information

Scientific Computing I

Scientific Computing I Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Neckel Winter 2013/2014 Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 1 Part I: Introduction to

More information

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1 Scientific Computing WS 2018/2019 Lecture 15 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 15 Slide 1 Lecture 15 Slide 2 Problems with strong formulation Writing the PDE with divergence and gradient

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

From Completing the Squares and Orthogonal Projection to Finite Element Methods

From Completing the Squares and Orthogonal Projection to Finite Element Methods From Completing the Squares and Orthogonal Projection to Finite Element Methods Mo MU Background In scientific computing, it is important to start with an appropriate model in order to design effective

More information

Time stepping methods

Time stepping methods Time stepping methods ATHENS course: Introduction into Finite Elements Delft Institute of Applied Mathematics, TU Delft Matthias Möller (m.moller@tudelft.nl) 19 November 2014 M. Möller (DIAM@TUDelft) Time

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Discretization of Boundary Conditions Discretization of Boundary Conditions On

More information

Finite Difference Method for PDE. Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36

Finite Difference Method for PDE. Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36 Finite Difference Method for PDE Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36 1 Classification of the Partial Differential Equations Consider a scalar second order partial

More information

Characteristic finite-difference solution Stability of C C (CDS in time/space, explicit): Example: Effective numerical wave numbers and dispersion

Characteristic finite-difference solution Stability of C C (CDS in time/space, explicit): Example: Effective numerical wave numbers and dispersion Spring 015 Lecture 14 REVIEW Lecture 13: Stability: Von Neumann Ex.: 1st order linear convection/wave eqn., F-B scheme Hyperbolic PDEs and Stability nd order wave equation and waves on a string Characteristic

More information

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems Index A-conjugate directions, 83 A-stability, 171 A( )-stability, 171 absolute error, 243 absolute stability, 149 for systems of equations, 154 absorbing boundary conditions, 228 Adams Bashforth methods,

More information

Finite Difference and Finite Element Methods

Finite Difference and Finite Element Methods Finite Difference and Finite Element Methods Georgy Gimel farb COMPSCI 369 Computational Science 1 / 39 1 Finite Differences Difference Equations 3 Finite Difference Methods: Euler FDMs 4 Finite Element

More information

Higher-Order Compact Finite Element Method

Higher-Order Compact Finite Element Method Higher-Order Compact Finite Element Method Major Qualifying Project Advisor: Professor Marcus Sarkis Amorn Chokchaisiripakdee Worcester Polytechnic Institute Abstract The Finite Element Method (FEM) is

More information

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel LECTURE NOTES on ELEMENTARY NUMERICAL METHODS Eusebius Doedel TABLE OF CONTENTS Vector and Matrix Norms 1 Banach Lemma 20 The Numerical Solution of Linear Systems 25 Gauss Elimination 25 Operation Count

More information

Numerical Methods - Numerical Linear Algebra

Numerical Methods - Numerical Linear Algebra Numerical Methods - Numerical Linear Algebra Y. K. Goh Universiti Tunku Abdul Rahman 2013 Y. K. Goh (UTAR) Numerical Methods - Numerical Linear Algebra I 2013 1 / 62 Outline 1 Motivation 2 Solving Linear

More information

Numerical Analysis Comprehensive Exam Questions

Numerical Analysis Comprehensive Exam Questions Numerical Analysis Comprehensive Exam Questions 1. Let f(x) = (x α) m g(x) where m is an integer and g(x) C (R), g(α). Write down the Newton s method for finding the root α of f(x), and study the order

More information

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9 Spring 2015 Lecture 9 REVIEW Lecture 8: Direct Methods for solving (linear) algebraic equations Gauss Elimination LU decomposition/factorization Error Analysis for Linear Systems and Condition Numbers

More information

Additive Manufacturing Module 8

Additive Manufacturing Module 8 Additive Manufacturing Module 8 Spring 2015 Wenchao Zhou zhouw@uark.edu (479) 575-7250 The Department of Mechanical Engineering University of Arkansas, Fayetteville 1 Evaluating design https://www.youtube.com/watch?v=p

More information

Name of the Student: Unit I (Solution of Equations and Eigenvalue Problems)

Name of the Student: Unit I (Solution of Equations and Eigenvalue Problems) Engineering Mathematics 8 SUBJECT NAME : Numerical Methods SUBJECT CODE : MA6459 MATERIAL NAME : University Questions REGULATION : R3 UPDATED ON : November 7 (Upto N/D 7 Q.P) (Scan the above Q.R code for

More information

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

Chapter 7 Iterative Techniques in Matrix Algebra

Chapter 7 Iterative Techniques in Matrix Algebra Chapter 7 Iterative Techniques in Matrix Algebra Per-Olof Persson persson@berkeley.edu Department of Mathematics University of California, Berkeley Math 128B Numerical Analysis Vector Norms Definition

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

Fast Numerical Methods for Stochastic Computations

Fast Numerical Methods for Stochastic Computations Fast AreviewbyDongbinXiu May 16 th,2013 Outline Motivation 1 Motivation 2 3 4 5 Example: Burgers Equation Let us consider the Burger s equation: u t + uu x = νu xx, x [ 1, 1] u( 1) =1 u(1) = 1 Example:

More information

A brief introduction to finite element methods

A brief introduction to finite element methods CHAPTER A brief introduction to finite element methods 1. Two-point boundary value problem and the variational formulation 1.1. The model problem. Consider the two-point boundary value problem: Given a

More information

Applied Math Qualifying Exam 11 October Instructions: Work 2 out of 3 problems in each of the 3 parts for a total of 6 problems.

Applied Math Qualifying Exam 11 October Instructions: Work 2 out of 3 problems in each of the 3 parts for a total of 6 problems. Printed Name: Signature: Applied Math Qualifying Exam 11 October 2014 Instructions: Work 2 out of 3 problems in each of the 3 parts for a total of 6 problems. 2 Part 1 (1) Let Ω be an open subset of R

More information

Contents. Prologue Introduction. Classical Approximation... 19

Contents. Prologue Introduction. Classical Approximation... 19 Contents Prologue........................................................................ 15 1 Introduction. Classical Approximation.................................. 19 1.1 Introduction................................................................

More information

Algebra C Numerical Linear Algebra Sample Exam Problems

Algebra C Numerical Linear Algebra Sample Exam Problems Algebra C Numerical Linear Algebra Sample Exam Problems Notation. Denote by V a finite-dimensional Hilbert space with inner product (, ) and corresponding norm. The abbreviation SPD is used for symmetric

More information

Cache Oblivious Stencil Computations

Cache Oblivious Stencil Computations Cache Oblivious Stencil Computations S. HUNOLD J. L. TRÄFF F. VERSACI Lectures on High Performance Computing 13 April 2015 F. Versaci (TU Wien) Cache Oblivious Stencil Computations 13 April 2015 1 / 19

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

n 1 f n 1 c 1 n+1 = c 1 n $ c 1 n 1. After taking logs, this becomes

n 1 f n 1 c 1 n+1 = c 1 n $ c 1 n 1. After taking logs, this becomes Root finding: 1 a The points {x n+1, }, {x n, f n }, {x n 1, f n 1 } should be co-linear Say they lie on the line x + y = This gives the relations x n+1 + = x n +f n = x n 1 +f n 1 = Eliminating α and

More information

PH.D. PRELIMINARY EXAMINATION MATHEMATICS

PH.D. PRELIMINARY EXAMINATION MATHEMATICS UNIVERSITY OF CALIFORNIA, BERKELEY Dept. of Civil and Environmental Engineering FALL SEMESTER 2014 Structural Engineering, Mechanics and Materials NAME PH.D. PRELIMINARY EXAMINATION MATHEMATICS Problem

More information

Finite Element Solver for Flux-Source Equations

Finite Element Solver for Flux-Source Equations Finite Element Solver for Flux-Source Equations Weston B. Lowrie A thesis submitted in partial fulfillment of the requirements for the degree of Master of Science in Aeronautics Astronautics University

More information

Qualifying Examination

Qualifying Examination Summer 24 Day. Monday, September 5, 24 You have three hours to complete this exam. Work all problems. Start each problem on a All problems are 2 points. Please email any electronic files in support of

More information

1. Nonlinear Equations. This lecture note excerpted parts from Michael Heath and Max Gunzburger. f(x) = 0

1. Nonlinear Equations. This lecture note excerpted parts from Michael Heath and Max Gunzburger. f(x) = 0 Numerical Analysis 1 1. Nonlinear Equations This lecture note excerpted parts from Michael Heath and Max Gunzburger. Given function f, we seek value x for which where f : D R n R n is nonlinear. f(x) =

More information

Implicitly Defined High-Order Operator Splittings for Parabolic and Hyperbolic Variable-Coefficient PDE Using Modified Moments

Implicitly Defined High-Order Operator Splittings for Parabolic and Hyperbolic Variable-Coefficient PDE Using Modified Moments Implicitly Defined High-Order Operator Splittings for Parabolic and Hyperbolic Variable-Coefficient PDE Using Modified Moments James V. Lambers September 24, 2008 Abstract This paper presents a reformulation

More information

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

More information

Juan Vicente Gutiérrez Santacreu Rafael Rodríguez Galván. Departamento de Matemática Aplicada I Universidad de Sevilla

Juan Vicente Gutiérrez Santacreu Rafael Rodríguez Galván. Departamento de Matemática Aplicada I Universidad de Sevilla Doc-Course: Partial Differential Equations: Analysis, Numerics and Control Research Unit 3: Numerical Methods for PDEs Part I: Finite Element Method: Elliptic and Parabolic Equations Juan Vicente Gutiérrez

More information

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018 Numerical Analysis Preliminary Exam 1 am to 1 pm, August 2, 218 Instructions. You have three hours to complete this exam. Submit solutions to four (and no more) of the following six problems. Please start

More information

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

Basic Principles of Weak Galerkin Finite Element Methods for PDEs Basic Principles of Weak Galerkin Finite Element Methods for PDEs Junping Wang Computational Mathematics Division of Mathematical Sciences National Science Foundation Arlington, VA 22230 Polytopal Element

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

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations Sparse Linear Systems Iterative Methods for Sparse Linear Systems Matrix Computations and Applications, Lecture C11 Fredrik Bengzon, Robert Söderlund We consider the problem of solving the linear system

More information