SOLUTION OF Partial Differential Equations. (PDEs)

Size: px
Start display at page:

Download "SOLUTION OF Partial Differential Equations. (PDEs)"

Transcription

1 SOLUTION OF Partial Differential Equations (PDEs) Mathematics is the Language of Science PDEs are the expression of processes that occur across time & space: (x,t), (x,y), (x,y,z), or (x,y,z,t)

2 Partial Differential Equations (PDE's) A PDE is an equation which includes derivatives of an unknown function with respect to or more independent variables

3 Partial Differential Equations (PDE's) PDE's describe the behavior of many engineering phenomena: Wave propagation Fluid flow (air or liquid) Air around wings, helicopter blade, atmosphere Water in pipes or porous media Material transport and diffusion in air or water Weather: large system of coupled PDE's for momentum, pressure, moisture, heat, Vibration Mechanics of solids: stress-strain in material, machine part, structure Heat flow and distribution Electric fields and potentials Diffusion of chemicals in air or water Electromagnetism and quantum mechanics 3

4 Partial Differential Equations (PDE's) Weather Prediction heat transport & cooling advection & dispersion of moisture radiation & solar heating evaporation air (movement, friction, momentum, coriolis forces) heat transfer at the surface To predict weather one need "only" solve a very large systems of coupled PDE equations for momentum, pressure, moisture, heat, etc. 4

5 Modelización Numérica del Tiempo 360x80x3 x nvar Conservación de energía, masa, momento, vapor de agua, ecuación de estado de gases. resolución /Δt Duplicar la resolución espacial supone incrementar el tiempo de cómputo en un factor 6 v = (u, v, w), T, p, ρ = /α y q Condición inicial H+0 H+4 D+0 D+ D+ sábado 5// D+3 D+4 D+5 5

6 Partial Differential Equations (PDE's) Learning Objectives ) Be able to distinguish between the 3 classes of nd order, linear PDE's. Know the physical problems each class represents and the physical/mathematical characteristics of each. ) Be able to describe the differences between finite-difference and finite-element methods for solving PDEs. 3) Be able to solve Elliptical (Laplace/Poisson) PDEs using finite differences. 4) Be able to solve Parabolic (Heat/Diffusion) PDEs using finite differences. 6

7 Partial Differential Equations (PDE's) Engrd 4 Focus: Linear nd-order PDE's of the general form u u u A + B + C + D= 0 x y x y u(x,y), A(x,y), B(x,y), C(x,y), and D(x,y,u,,) The PDE is nonlinear if A, B or C include u, u/ x or u/ y, or if D is nonlinear in u and/or its first derivatives. Classification B 4AC < 0 > Elliptic (e.g. Laplace Eq.) B 4AC = 0 > Parabolic (e.g. Heat Eq.) B 4AC > 0 > Hyperbolic (e.g. Wave Eq.) Each category describes different phenomena. Mathematical properties correspond to those phenomena. 7

8 Partial Differential Equations (PDE's) Elliptic Equations (B 4AC < 0) [steady-state in time] typically characterize steady-state systems (no time derivative) temperature torsion pressure membrane displacement electrical potential closed domain with boundary conditions expressed in terms of u u u u(x,y), (in terms of and ) η x y Typical examples include 0 u u u + = u u x y D(x,y,u,, ) x y A =, B = 0, C = ==> B 4AC = 4 < 0 Laplace Eq. Poisson Eq. 8

9 Elliptic PDEs Boundary Conditions for Elliptic PDE's: Dirichlet: u provided along all of edge Neumann: u η provided along all of the edge (derivative in normal direction) Mixed: u provided for some of the edge and u η for the remainder of the edge Elliptic PDE's are analogous to Boundary Value ODE's 9

10 Elliptic PDEs u(x,y =) or u/ y given on boundary y u(x=0,y) or u/ x given on boundary Estimate u(x) from Laplace Equations u(x=,y) or u/ x given on boundary u(x,y =0) or u/ y given on boundary x 0

11 Parabolic PDEs Parabolic Equations (B 4AC = 0) [first derivative in time ] variation in both space (x,y) and time, t typically provided are: initial values: u(x,y,t = 0) boundary conditions: u(x = x o,y = y o, t) for all t u(x = x f,y = y f, t) for all t all changes are propagated forward in time, i.e., nothing goes backward in time; changes are propagated across space at decreasing amplitude.

12 Parabolic PDEs Parabolic Equations (B 4AC = 0) [first derivative in time ] Typical example: Heat Conduction or Diffusion (the Advection-Diffusion Equation) u u u D: = k + D(x,u, ) t x x A = k, B = 0, C = 0 > B 4AC = 0 u u u u u D: = k + D(x,y,u,, ) t + x y x y = k u + D

13 Parabolic PDEs t u(x=0,t) given on boundary for all t Estimate u(x,t) from the Heat Equation u(x=,t) given on boundary for all t u(x,t =0) given on boundary as initial conditions for u/ t x 3

14 Parabolic PDEs c(x,t) = concentration at time, t, and distance, x. x=0 Δx x=l An elongated reactor with a single entry and exit point and a uniform cross-section of area A. A mass balance is developed for a finite segment Δx along the tank's longitudinal axis in order to derive a differential equation for concentration (V = A Δx). 4

15 Parabolic PDEs x=0 Δx x=l Δc c(x) c(x) V = Qc(x) Q c(x) + Δx DA Δt x x Flow in Flow out Dispersion in c(x) c(x) + DA + Δx kvc(x) x x x Decay Dispersion out reaction As Δt and Δx ==> 0 Δc c c Q c ==> = D Δt t x A x kc 5

16 Hyperbolic PDEs Hyperbolic Equations (B 4AC > 0) [nd derivative in time ] variation in both space (x, y) and time, t requires: initial values: u(x,y,t=0), u/ t (x,y,t = 0) "initial velocity" boundary conditions: u(x = x o,y = y o, t) for all t u(x = x f,y = y f, t) for all t all changes are propagated forward in time, i.e., nothing goes backward in time. 6

17 Hyperbolic PDEs Hyperbolic Equations (B 4AC > 0) [nd derivative in time] Typical example: Wave Equation u u u u D : + D(x, y, u,, ) = 0 x c t x t A =, B = 0, C = -/c ==> B 4AC = 4/c > 0 Models vibrating string water waves voltage change in a wire 7

18 Hyperbolic PDEs t u(x=0,t) given on boundary for all t Estimate u(x,t) from the Wave Equation u(x=,t) given on boundary for all t x u(x,t =0) and u(x,t=0)/ t given on boundary as initial conditions for u/ t Now PDE is second order in time 8

19 Numerical Methods for Solving PDEs Numerical methods for solving different types of PDE's reflect the different character of the problems. Laplace - solve all at once for steady state conditions Parabolic (heat) and Hyperbolic (wave) equations. Integrate initial conditions forward through time. Methods Finite Difference (FD) Approaches (C&C Chs. 9 & 30) Based on approximating solution at a finite # of points, usually arranged in a regular grid. Finite Element (FE) Method (C&C Ch. 3) Based on approximating solution on an assemblage of simply shaped (triangular, quadrilateral) finite pieces or "elements" which together make up (perhaps complexly shaped) domain. In this course, we concentrate on FD applied to elliptic and parabolic equations. 9

20 Finite Difference for Solving Elliptic PDE's Solving Elliptic PDE's: Solve all at once Liebmann Method: Based on Boundary Conditions (BCs) and finite difference approximation to formulate system of equations Use Gauss-Seidel to solve the system 0 u + = u u x D(x,y,u,, ) x y u y Laplace Eq. Poisson Eq. 0

21 Finite Difference Methods for Solving Elliptic PDE's. Discretize domain into grid of evenly spaced points. For nodes where u is unknown: u ui,j ui,j+ ui+,j = + Δ x ( Δx) O( x ) w/ Δ x = Δ y = h, substitute into main equation u ui,j ui,j + ui,j + = + Δ y ( Δy) u u u i,j + u i+,j + u i,j + u i,j+ 4u i,j + = + x y h O( y ) 3. Using Boundary Conditions, write, n*m equations for u(x i=:m,y j=:n ) or n*m unknowns. 4. Solve this banded system with an efficient scheme. Using Gauss-Seidel iteratively yields the Liebmann Method. O(h )

22 Elliptical PDEs The Laplace Equation x u u + = y 0 The Laplace molecule j+ j j- i- i i+ If Δx= Δythen T + T + T + T 4T = 0 i+,j i,j i,j+ i,j i,j

23 Elliptical PDEs The Laplace molecule: T + T + T + T 4T = 0 i+,j i,j i,j+ i,j i,j T = 0 o C T = 00 o C,,,3,,,3 3, 3, 3,3 T = 0 o C T = 00 o C T T T3 T T T3 T3 T3 T T T T T T T T 33 The temperature distribution can be estimated by discretizing the Laplace equation at 9 points and solving the system of linear equations. T T = Excel 3

24 Solution of Elliptic PDE's: Additional Factors Primary (solve for first): u(x,y) = T(x,y) = temperature distribution Secondary (solve for second): heat flux: T T qx = k and qy = k x y obtain by employing: T Ti+,j Ti,j T Ti,j+ Ti,j x Δx y Δy then obtain resultant flux and direction: qn = qx + q qy y θ = tan qx qx > 0 qy θ = tan +π qx qx < 0 (with θ in radians) 4

25 Elliptical PDEs: additional factors T = 0 o C T = 00 o C T = 0 o C T = 00 o C T T qx = k k x T T qy = k k y k' = 0.49 cal/s cm C At point, (middle left): q x ~ (50-0)/( 0cm) = -.5 cal/(cm s) q y ~ (50-4.3)/( 0cm) = cal/(cm s) n x y T i+,j i,j Δx T q = q + q = =.85cal /(cm s) i,j+ i,j Δy qy θ= tan = tan = = 5.5 qx.5 o o o 5

26 Solution of Elliptic PDE's: Additional Factors Neumann Boundary Conditions (derivatives at edges) employ phantom points outside of domain use FD to obtain information at phantom point, T,j + T -,j + T 0,j+ + T 0,j- 4T 0,j = 0 [*] If given T x to obtain then use T T T = x Δx, j i, j T T, j = T, j Δx x T Substituting [*]: T,j Δ x + T0,j+ + T0,j 4T0,j = 0 x Irregular boundaries use unevenly spaced molecules close to edge use finer mesh 6

27 Elliptical PDEs: Derivative Boundary Conditions The Laplace molecule: T + T + T + T 4T = 0 i+,j i,j i,j+ i,j i,j T = 75 o C T = 00 o C,,,3,,,3 3, 3, 3,3 Insulated ==> T/ y = 0 T = 50 o C Derivative (Neumann) BC at (4,): T = y T3, - T5, Δy T T5, = T3, Δy y T + T + T + T 4T = 0 Substitute into: 4, 4,0 3, 5, 4, To obtain: T T4, T4,0 + T3, Δy 4T4, = 0 y 0 7

28 Parabolic PDE's: Finite Difference Solution Solution of Parabolic PDE's by FD Method use B.C.'s and finite difference approximations to formulate the model integrate I.C.'s forward through time for parabolic systems we will investigate: explicit schemes & stability criteria implicit schemes - Simple Implicit - Crank-Nicolson (CN) - Alternating Direction (A.D.I), D-space 8

29 Parabolic PDE's: Heat Equation Prototype problem, Heat Equation (C&C 30.): T T D = k Find T(x,t) t x T T T D = k + Find T(x,y,t) t x y Given the initial temperature distribution as well as boundary temperatures with k' k = = Coefficient of thermal diffusivity Cρ k' = coefficient of thermal conductivity where: C = heat capacity ρ = density 9

30 Parabolic PDE's: Finite Difference Solution Solution of Parabolic PDE's by FD Method. Discretize the domain into a grid of evenly spaces points (nodes). Express the derivatives in terms of Finite Difference Approximations of O(h ) and O(Δt) [or order O(Δt )] x T y T T t Finite Differences 3. Choose h = Δx= Δy, and Δt and use the I.C.'s and B.C.'s to solve the problem by systematically moving ahead in time. 30

31 Parabolic PDE's: Finite Difference Solution Time derivative: Explicit Schemes (C&C 30.) Express all future (t + Δt) values, T(x, t + Δt), in terms of current (t) and previous (t - Δt) information, which is known. Implicit Schemes (C&C ) Express all future (t + Δt) values, T(x, t + Δt), in terms of other future (t + Δt), current (t), and sometimes previous (t - Δt) information. 3

32 Parabolic PDE's: Notation Notation: Use subscript(s) to indicate spatial points. Use superscript to indicate time level: T m+ i = T(x i, t m+ ) Express a future state, T m+ i, only in terms of the present state, T m i T T -D Heat Equation: = k t x m m m T Ti Ti + Ti+ = + O( Δx) Centered FDD x ( Δx) m+ i m i T T T = + O( Δt) Forward FDD t Δt Solving for T i m+ results in: T i m+ = T im + λ(t i-m T im + T i+m ) with λ = k Δt/(Δx) T i m+ = (-λ) T im + λ (T i- m + T i+m ) 3

33 Parabolic PDE's: Explicit method t = t = 5 t = 4 t = 3 t = t = t = Initial temperature 33

34 Parabolic PDE's: Example - explicit method Example: The -D Heat Equation T t k = 0.8 cal/s cm oc, 0-cm long rod, Δt = secs, Δx =.5 cm (# segs. = 4) = k t x T t I.C.'s: T(0 < x < 0, t = 0) = 0 B.C.'s: T(x = 0, all t) = 00 T(x = 0, all t) = C Heat Eqn. Example 50 C with λ = k Δt/ (Δx) = 0.6 X = 0 0 C X = 0 cm ( ) + m+ m m m m i = i +λ i i + i T T T T T 34

35 Parabolic PDE's: Example - explicit method Example: The -D Heat Equation ( ) + m+ m m m m i = i +λ i i + i T T T T T Starting at t = 0 secs. (m = 0), find results at t = secs. (m = ): T = T 0 + λ(t 0 0 +T 0 +T 0 ) = [00 (0)+0] = 6. T = T 0 + λ(t 0 +T 0 +T 0 3 ) = [0 (0)+0] = 0 T 3 = T λ(t 0 +T 0 3 +T 0 4 ) = [0 (0)+50] = 3. From t = secs. (m = ), find results at t = 4 secs. (m = ): T = T + λ(t 0 +T +T ) = [00 (6.)+0] = 38.7 T = T + λ(t +T +T 3 ) = 0+0.6[6. (0)+3.] = 0.3 T 3 = T 3 + λ(t +T 3 +T 4 ) = [0 (3.)+50] = 9.3 T T = k t x 35

36 Parabolic PDE's: Explicit method t = 6 t = 4 t = Left Bndry 00 C Right Bndry 50 C t = 0 0 C Initial temperature T = T 0 + λ(t 00 T 0 +T 0 ) = [00 (0)+0] = 6. T = T 0 + λ(t 0 T 0 +T 30 ) = [0 (0)+0] = 0 T 3 = T λ(t 0 T 3 0 +T 40 ) = [0 (0)+50] = 3. 36

37 Parabolic PDE's: Explicit method t = 6 t = 4 t = Left Bndry 00 C Right Bndry 50 C t = 0 0 C Initial temperature T = T + λ(t 0 T +T ) = [00 (6.)+0] = 38.7 T = T + λ(t T +T 3 ) = [6. (0)+3.] = 0.3 T 3 = T 3 + λ(t T 3 +T 4 ) = [0 (3.)+50] =

38 Parabolic PDE's: Stability We will cover stability in more detail later, but we will show that: The Explicit Method is Conditionally Stable : For the -D spatial problem, the following is the stability condition: k Δ t ( Δ λ= or Δt x) ( Δx) k λ / can still yield oscillation (D) λ /4 ensures no oscillation (D) λ = /6 tends to optimize truncation error We will also see that the Implicit Methods are unconditionally stable. Excel: Explicit 38

39 Parabolic PDE's: Explicit Schemes Summary: Solution of Parabolic PDE's by Explicit Schemes Advantages: very easy calculations, simply step ahead Disadvantage: low accuracy, O (Δt) accurate with respect to time subject to instability; must use "small" Δt's requires many steps!!! 39

40 Parabolic PDE's: Implicit Schemes Implicit Schemes for Parabolic PDEs Express T i m+ terms of T j m+, T im, and possibly also T j m (in which j = i and i+ ) Represents spatial and time domain. For each new time, write m (# of interior nodes) equations and simultaneously solve for m unknown values (banded system). 40

41 The -D Heat Equation: T t = k x T Simple Implicit Method. Substituting: T m+ Ti m+ Ti m+ Ti+ + = + O( Δx) Centered FDD x ( Δx) m+ m T Ti Ti = + O( Δt) Backward FDD t Δt Δt results in: λ T + (+ λ)t λ T = T with λ = k ( Δ x) m+ m+ m+ m i i i+ i. Requires I.C.'s for case where m = 0: i.e., T i0 is given for all i.. Requires B.C.'s to write st and last interior nodes (i=0 and n+) for all m. 4

42 Parabolic PDE's: Simple Implicit Method t = t = 5 t = 4 t = 3 t = t = t = Initial temperature 4

43 Parabolic PDE's: Simple Implicit Method m+ m Explicit Method i- i i+ ( ) + m+ m m m m i = i +λ i i + i T T T T T Simple Implicit Method m + m i- i i+ ( ) m m m m i = λ i λ i + λ i+ + T T T T Δt with λ= k for both ( Δx) 43

44 Parabolic PDE's: Simple Implicit Method t = 6 t = 4 t = Left Bndry 00 C Right Bndry 50 C t = 0 0 C Initial temperature At the Left boundary: (+λ)t m+ - λt m+ = T m + λ T 0 m+ Away from boundary: -λt i- m+ + (+λ)t i m+ - λt i+ m+ = T i m At the Right boundary: (+λ)t i m+ - λt i- m+ = T i m + λ T i+ m+ 44

45 Parabolic PDE's: Simple Implicit Method m = 3; t = 6 m = ; t = 4 m = ; t = m = 0; t = 0 Let λ = 0.4 Left Bndry 00 C T 0 C Initial temperature Right Bndry 50 C At the Left boundary: (+λ)t - λt = T 0 + λt 0 T.8 T 0.4 T = *00 = 40 Away from boundary: -λt i- + (+λ)t i λt i+ = T i 0 T 3 T T T 0 = T T4 T 7.6 T 6.4 = T T4-0.4 T +.8 T 0.4 T 3 = 0 = T +.8 T T 4 = 0 = 0 At the Right boundary: (+λ)t 3 λt = T λt 4.8 T i m+ 0.4 T i- m+ = *50) = 0 45

46 Parabolic PDE's: Simple Implicit Method m = 3; t = 6 m = ; t = 4 m = ; t = m = 0; t = 0 Let λ = 0.4 Left Bndry 00 C T 0 C Initial temperature Right Bndry 50 C At the Left boundary: (+λ)t - λt = T + λt 0 T.8 T 0.4 T = *00 = 78.5 Away from boundary: -λt i- + (+λ)t i λt i+ = T i T 3 T T T 6.4 = T T4 T 38.5 T 4. = T T4-0.4*T +.8*T 0.4*T 3 = 6.4 = *T +.8*T 3 0.4*T 4 = 4.03 = 4.03 At the Right boundary: (+λ)t 3 λt 4 = T 3 + λt 4.8*T 3 0.4*T 4 = *50 = 3.0 Excel: Implicit 46

47 Parabolic PDE's: Crank-Nicolson Method Implicit Schemes for Parabolic PDEs Crank-Nicolson (CN) Method (Implicit Method) Provides nd-order accuracy in both space and time. Average the nd-derivative in space for t m+ and t m. m m m m+ m+ m+ T Ti Ti + Ti+ Ti Ti + T i+ = O( x) + + Δ x ( Δx) ( Δx) T t m+ i m i T T = + O( Δt ) Δt (central difference in time now) m+ m+ m+ m m m i i i+ i i i+ λ T + ( +λ)t λ T =λ T + ( λ)t λt Requires I.C.'s for case where m = 0: T i0 = given value, f(x) Requires B.C.'s in order to write expression for T 0 m+ & T i+ m+ 47

48 Parabolic PDE's: Crank-Nicolson Method x i- x i x i+ t m+ t m+/ t m Left Bndry 00 C Right Bndry 50 C 0 C Initial temperature m+ m+ m+ i i i+ m m m i i i+ λ T + ( +λ) T λ T =λ T + ( λ)t λt Crank-Nicolson 48

49 Parabolic PDE's: Implicit Schemes Summary: Solution of Parabolic PDE's by Implicit Schemes Advantages: Unconditionally stable. Δt choice governed by overall accuracy. [Error for CN is O(Δt ) ] May be able to take larger Δt fewer steps Disadvantages: More difficult calculations, especially for D and 3D spatially For D spatially, effort same as explicit because system is tridiagonal. 49

50 Stability Analysis of Numerical Solution to Heat Eq. Consider the classical solution of the Heat Equation: T T = k t x To find the form of the solutions, try: at T(x,t) = e sin( ωx) Substituting this into the Heat Equation yields: - a T(x,t) = - k ω T(x,t) OR a = k ω kω t T(x,t) = e sin( ωx) Each sin component of the initial temperature distribution decays as exp{- k ω t) 50

51 Stability Analysis Consider FD schemes as advancing one step with a "transition equation": {T m+ } = [A] {T m } with [A] a function of λ = k Δt/ (Δx) { } with T = T,T,,T,,T m m m m m T L i L n with zero boundary conditions First step can be written: {T } = [A] {T 0 } w/ {T 0 } = initial conditions Second step as: {T } = [A] {T } = [A] {T 0 } and m th step as: {T m } = [A] {T m- } = [A] m {T 0 } (Here "m" is an exponent on [A]) 5

52 Stability Analysis {T m } = [A] m {T 0 } For the influence of the initial conditions and any rounding errors in the IC (or rounding or truncation errors introduced in the transition process) to decay with time, it must be the case that A <.0 If A >.0, some eigenvectors of the matrix [A] can grow without bound generating ridiculous results. In such cases the method is said to be unstable. Taking r = A = A = maximum eigenvalue of [A] for symmetric A (the "spectral norm"), the maximum eigenvalue describes the stability of the method. 5

53 Stability Analysis Illustration of Instability of Explicit Method (for a simple case) Consider D spatial case: T i m+ = λt i-m + (- λ)t im + λt i+ m Worst case solution: T im = r m (-) i (high frequency x-oscillations in index i) Substitution of this solution into the difference equation yields: r m+ (-) i = λ r m (-) i- + (-λ) r m (-) i + λ r m (-) i+ r = λ (-) - + (-λ) + λ (-) + or r = 4 λ If initial conditions are to decay and nothing explodes, we need: < r < or 0 < λ < /. For no oscillations we want: 0 < r < or 0 < λ < /4. 53

54 Stability of the Simple Implicit Method Consider D spatial: Worst case solution: m+ m+ m+ m i i i + i λ T + (+ λ)t λ T = T i m m ( ) i T = r Substitution of this solution into difference equation yields: m+ i m+ i m+ i + m i ( ) ( ) ( ) ( ) ( ) λr + λ r λr = r r [ λ ( ) + ( + λ) λ ( )+] = or r = /[ + 4 λ] i.e., 0 < r < for all λ > 0 54

55 Stability of the Crank-Nicolson Implicit Method Consider: m + m + m + m m m i i i + i i i + λ T + ( + λ)t λ T = λ T + ( λ )T + λt Worst case solution: i m m ( ) i T = r Substitution of this solution into difference equation yields: m+ i m+ i m+ i + ( ) ( ) ( ) ( ) λr + + λ r λr = m i m i m i + ( ) ( ) ( ) ( ) λr + λ r +λr r [ λ ( ) + ( + λ) λ ( )+] = λ ( ) + ( λ) + λ ( )+ or r = [ λ ] / [ + λ] i.e., r < for all λ > 0 55

56 Stability Summary, Parabolic Heat Equation Roots for Stability Analysis of Parabolic Heat Eq r(explicit) r(implicit) r(c-n) analytical r λ 56

57 Parabolic PDE's: Stability Implicit Methods are Unconditionally Stable : Magnitude of all eigenvalues of [A] is < for all values of λ. Δx and Δt can be selected solely to control the overall accuracy. Explicit Method is Conditionally Stable : Explicit, -D Spatial: k Δ t ( Δ λ= or Δt x) ( Δx) k λ / can still yield oscillation (D) λ /4 ensures no oscillation (D) λ = /6 tends to optimize truncation error Explicit, -D Spatial: k Δ λ= t or Δt h h 4 4k (h = Δx = Δy) 57

58 Parabolic PDE's in Two Spatial dimension T T T D = k + Find T(x,y,t) t x y Explicit solutions : Stability criterion Δt ( Δ x) + ( Δy) 8k kδt h if h = Δ x = Δ y ==> λ = or Δt h 4 4k Implicit solutions : No longer tridiagonal 58

59 Parabolic PDE's: ADI method Alternating-Direction Implicit (ADI) Method Provides a method for using tridiagonal matrices for solving parabolic equations in spatial dimensions. Each time increment is implemented in two steps: first direction second direction 59

60 Parabolic PDE's: ADI method Provides a method for using tridiagonal matrices for solving parabolic equations in spatial dimensions. Each time increment is implemented in two steps: y i- y i y i+ Explicit Implicit x i- x i x i+ first half-step y i- y i y i+ x i- x i x i+ second half-step ADI example t γ+ t γ+/ t γ 60

SIXTY STUDY QUESTIONS TO THE COURSE NUMERISK BEHANDLING AV DIFFERENTIALEKVATIONER I

SIXTY STUDY QUESTIONS TO THE COURSE NUMERISK BEHANDLING AV DIFFERENTIALEKVATIONER I Lennart Edsberg, Nada, KTH Autumn 2008 SIXTY STUDY QUESTIONS TO THE COURSE NUMERISK BEHANDLING AV DIFFERENTIALEKVATIONER I Parameter values and functions occurring in the questions belowwill be exchanged

More information

Second Order Linear Partial Differential Equations. Part I

Second Order Linear Partial Differential Equations. Part I Second Order Linear Partial Differential Equations Part I Second linear partial differential equations; Separation of Variables; - point boundary value problems; Eigenvalues and Eigenfunctions Introduction

More information

1 Finite difference example: 1D implicit heat equation

1 Finite difference example: 1D implicit heat equation 1 Finite difference example: 1D implicit heat equation 1.1 Boundary conditions Neumann and Dirichlet We solve the transient heat equation ρc p t = ( k ) (1) on the domain L/2 x L/2 subject to the following

More information

Numerical Methods for Differential Equations

Numerical Methods for Differential Equations Numerical Methods for Differential Equations Course objectives and preliminaries Gustaf Söderlind and Carmen Arévalo Numerical Analysis, Lund University Textbooks: A First Course in the Numerical Analysis

More information

Chapter 9 Partial Differential Equations

Chapter 9 Partial Differential Equations 363 One must learn by doing the thing; though you think you know it, you have no certainty until you try. Sophocles (495-406)BCE Chapter 9 Partial Differential Equations A linear second order partial differential

More information

Two-Dimensional Conduction: Shape Factors and Dimensionless Conduction Heat Rates

Two-Dimensional Conduction: Shape Factors and Dimensionless Conduction Heat Rates Two-Dimensional Conduction: Shape Factors and Dimensionless Conduction Heat Rates Chapter 4 Sections 4.1 and 4.3 make use of commercial FEA program to look at this. D Conduction- General Considerations

More information

Fourth-Order Compact Schemes of a Heat Conduction Problem with Neumann Boundary Conditions

Fourth-Order Compact Schemes of a Heat Conduction Problem with Neumann Boundary Conditions Fourth-Order Compact Schemes of a Heat Conduction Problem with Neumann Boundary Conditions Jennifer Zhao, 1 Weizhong Dai, Tianchan Niu 1 Department of Mathematics and Statistics, University of Michigan-Dearborn,

More information

Introduction to the Finite Element Method

Introduction to the Finite Element Method Introduction to the Finite Element Method 09.06.2009 Outline Motivation Partial Differential Equations (PDEs) Finite Difference Method (FDM) Finite Element Method (FEM) References Motivation Figure: cross

More information

The Heat Equation. Lectures INF2320 p. 1/88

The Heat Equation. Lectures INF2320 p. 1/88 The Heat Equation Lectures INF232 p. 1/88 Lectures INF232 p. 2/88 The Heat Equation We study the heat equation: u t = u xx for x (,1), t >, (1) u(,t) = u(1,t) = for t >, (2) u(x,) = f(x) for x (,1), (3)

More information

Numerical Analysis Lecture Notes

Numerical Analysis Lecture Notes Numerical Analysis Lecture Notes Peter J. Olver. Finite Difference Methods for Partial Differential Equations As you are well aware, most differential equations are much too complicated to be solved by

More information

An Introduction to Partial Differential Equations

An Introduction to Partial Differential Equations An Introduction to Partial Differential Equations Andrew J. Bernoff LECTURE 2 Cooling of a Hot Bar: The Diffusion Equation 2.1. Outline of Lecture An Introduction to Heat Flow Derivation of the Diffusion

More information

POISSON AND LAPLACE EQUATIONS. Charles R. O Neill. School of Mechanical and Aerospace Engineering. Oklahoma State University. Stillwater, OK 74078

POISSON AND LAPLACE EQUATIONS. Charles R. O Neill. School of Mechanical and Aerospace Engineering. Oklahoma State University. Stillwater, OK 74078 21 ELLIPTICAL PARTIAL DIFFERENTIAL EQUATIONS: POISSON AND LAPLACE EQUATIONS Charles R. O Neill School of Mechanical and Aerospace Engineering Oklahoma State University Stillwater, OK 74078 2nd Computer

More information

Part II: Finite Difference/Volume Discretisation for CFD

Part II: Finite Difference/Volume Discretisation for CFD Part II: Finite Difference/Volume Discretisation for CFD Finite Volume Metod of te Advection-Diffusion Equation A Finite Difference/Volume Metod for te Incompressible Navier-Stokes Equations Marker-and-Cell

More information

Feature Commercial codes In-house codes

Feature Commercial codes In-house codes A simple finite element solver for thermo-mechanical problems Keywords: Scilab, Open source software, thermo-elasticity Introduction In this paper we would like to show how it is possible to develop a

More information

Application of Fourier Transform to PDE (I) Fourier Sine Transform (application to PDEs defined on a semi-infinite domain)

Application of Fourier Transform to PDE (I) Fourier Sine Transform (application to PDEs defined on a semi-infinite domain) Application of Fourier Transform to PDE (I) Fourier Sine Transform (application to PDEs defined on a semi-infinite domain) The Fourier Sine Transform pair are F. T. : U = 2/ u x sin x dx, denoted as U

More information

Heat Transfer and Energy

Heat Transfer and Energy What is Heat? Heat Transfer and Energy Heat is Energy in Transit. Recall the First law from Thermodynamics. U = Q - W What did we mean by all the terms? What is U? What is Q? What is W? What is Heat Transfer?

More information

Iterative Solvers for Linear Systems

Iterative Solvers for Linear Systems 9th SimLab Course on Parallel Numerical Simulation, 4.10 8.10.2010 Iterative Solvers for Linear Systems Bernhard Gatzhammer Chair of Scientific Computing in Computer Science Technische Universität München

More information

MATH 425, PRACTICE FINAL EXAM SOLUTIONS.

MATH 425, PRACTICE FINAL EXAM SOLUTIONS. MATH 45, PRACTICE FINAL EXAM SOLUTIONS. Exercise. a Is the operator L defined on smooth functions of x, y by L u := u xx + cosu linear? b Does the answer change if we replace the operator L by the operator

More information

The two dimensional heat equation

The two dimensional heat equation The two dimensional heat equation Ryan C. Trinity University Partial Differential Equations March 6, 2012 Physical motivation Consider a thin rectangular plate made of some thermally conductive material.

More information

5.4 The Heat Equation and Convection-Diffusion

5.4 The Heat Equation and Convection-Diffusion 5.4. THE HEAT EQUATION AND CONVECTION-DIFFUSION c 6 Gilbert Strang 5.4 The Heat Equation and Convection-Diffusion The wave equation conserves energy. The heat equation u t = u xx dissipates energy. The

More information

Parabolic Equations. Chapter 5. Contents. 5.1.2 Well-Posed Initial-Boundary Value Problem. 5.1.3 Time Irreversibility of the Heat Equation

Parabolic Equations. Chapter 5. Contents. 5.1.2 Well-Posed Initial-Boundary Value Problem. 5.1.3 Time Irreversibility of the Heat Equation 7 5.1 Definitions Properties Chapter 5 Parabolic Equations Note that we require the solution u(, t bounded in R n for all t. In particular we assume that the boundedness of the smooth function u at infinity

More information

Oscillations. Vern Lindberg. June 10, 2010

Oscillations. Vern Lindberg. June 10, 2010 Oscillations Vern Lindberg June 10, 2010 You have discussed oscillations in Vibs and Waves: we will therefore touch lightly on Chapter 3, mainly trying to refresh your memory and extend the concepts. 1

More information

Module 1 : Conduction. Lecture 5 : 1D conduction example problems. 2D conduction

Module 1 : Conduction. Lecture 5 : 1D conduction example problems. 2D conduction Module 1 : Conduction Lecture 5 : 1D conduction example problems. 2D conduction Objectives In this class: An example of optimization for insulation thickness is solved. The 1D conduction is considered

More information

Numerical PDE methods for exotic options

Numerical PDE methods for exotic options Lecture 8 Numerical PDE methods for exotic options Lecture Notes by Andrzej Palczewski Computational Finance p. 1 Barrier options For barrier option part of the option contract is triggered if the asset

More information

Numerical Methods for Differential Equations

Numerical Methods for Differential Equations Numerical Methods for Differential Equations Chapter 1: Initial value problems in ODEs Gustaf Söderlind and Carmen Arévalo Numerical Analysis, Lund University Textbooks: A First Course in the Numerical

More information

ME6130 An introduction to CFD 1-1

ME6130 An introduction to CFD 1-1 ME6130 An introduction to CFD 1-1 What is CFD? Computational fluid dynamics (CFD) is the science of predicting fluid flow, heat and mass transfer, chemical reactions, and related phenomena by solving numerically

More information

Lecture 3 Fluid Dynamics and Balance Equa6ons for Reac6ng Flows

Lecture 3 Fluid Dynamics and Balance Equa6ons for Reac6ng Flows Lecture 3 Fluid Dynamics and Balance Equa6ons for Reac6ng Flows 3.- 1 Basics: equations of continuum mechanics - balance equations for mass and momentum - balance equations for the energy and the chemical

More information

440 Geophysics: Heat flow with finite differences

440 Geophysics: Heat flow with finite differences 440 Geophysics: Heat flow with finite differences Thorsten Becker, University of Southern California, 03/2005 Some physical problems, such as heat flow, can be tricky or impossible to solve analytically

More information

Diffusion: Diffusive initial value problems and how to solve them

Diffusion: Diffusive initial value problems and how to solve them 84 Chapter 6 Diffusion: Diffusive initial value problems and how to solve them Selected Reading Numerical Recipes, 2nd edition: Chapter 19 This section will consider the physics and solution of the simplest

More information

MEL 807 Computational Heat Transfer (2-0-4) Dr. Prabal Talukdar Assistant Professor Department of Mechanical Engineering IIT Delhi

MEL 807 Computational Heat Transfer (2-0-4) Dr. Prabal Talukdar Assistant Professor Department of Mechanical Engineering IIT Delhi MEL 807 Computational Heat Transfer (2-0-4) Dr. Prabal Talukdar Assistant Professor Department of Mechanical Engineering IIT Delhi Time and Venue Course Coordinator: Dr. Prabal Talukdar Room No: III, 357

More information

Energy Transport. Focus on heat transfer. Heat Transfer Mechanisms: Conduction Radiation Convection (mass movement of fluids)

Energy Transport. Focus on heat transfer. Heat Transfer Mechanisms: Conduction Radiation Convection (mass movement of fluids) Energy Transport Focus on heat transfer Heat Transfer Mechanisms: Conduction Radiation Convection (mass movement of fluids) Conduction Conduction heat transfer occurs only when there is physical contact

More information

Numerical methods for American options

Numerical methods for American options Lecture 9 Numerical methods for American options Lecture Notes by Andrzej Palczewski Computational Finance p. 1 American options The holder of an American option has the right to exercise it at any moment

More information

Numerical Methods for Engineers

Numerical Methods for Engineers Steven C. Chapra Berger Chair in Computing and Engineering Tufts University RaymondP. Canale Professor Emeritus of Civil Engineering University of Michigan Numerical Methods for Engineers With Software

More information

Stability of Evaporating Polymer Films. For: Dr. Roger Bonnecaze Surface Phenomena (ChE 385M)

Stability of Evaporating Polymer Films. For: Dr. Roger Bonnecaze Surface Phenomena (ChE 385M) Stability of Evaporating Polymer Films For: Dr. Roger Bonnecaze Surface Phenomena (ChE 385M) Submitted by: Ted Moore 4 May 2000 Motivation This problem was selected because the writer observed a dependence

More information

FINITE ELEMENT : MATRIX FORMULATION. Georges Cailletaud Ecole des Mines de Paris, Centre des Matériaux UMR CNRS 7633

FINITE ELEMENT : MATRIX FORMULATION. Georges Cailletaud Ecole des Mines de Paris, Centre des Matériaux UMR CNRS 7633 FINITE ELEMENT : MATRIX FORMULATION Georges Cailletaud Ecole des Mines de Paris, Centre des Matériaux UMR CNRS 76 FINITE ELEMENT : MATRIX FORMULATION Discrete vs continuous Element type Polynomial approximation

More information

N 1. (q k+1 q k ) 2 + α 3. k=0

N 1. (q k+1 q k ) 2 + α 3. k=0 Teoretisk Fysik Hand-in problem B, SI1142, Spring 2010 In 1955 Fermi, Pasta and Ulam 1 numerically studied a simple model for a one dimensional chain of non-linear oscillators to see how the energy distribution

More information

Introduction to CFD Analysis

Introduction to CFD Analysis Introduction to CFD Analysis 2-1 What is CFD? Computational Fluid Dynamics (CFD) is the science of predicting fluid flow, heat and mass transfer, chemical reactions, and related phenomena by solving numerically

More information

Notes for AA214, Chapter 7. T. H. Pulliam Stanford University

Notes for AA214, Chapter 7. T. H. Pulliam Stanford University Notes for AA214, Chapter 7 T. H. Pulliam Stanford University 1 Stability of Linear Systems Stability will be defined in terms of ODE s and O E s ODE: Couples System O E : Matrix form from applying Eq.

More information

3-D WAVEGUIDE MODELING AND SIMULATION USING SBFEM

3-D WAVEGUIDE MODELING AND SIMULATION USING SBFEM 3-D WAVEGUIDE MODELING AND SIMULATION USING SBFEM Fabian Krome, Hauke Gravenkamp BAM Federal Institute for Materials Research and Testing, Unter den Eichen 87, 12205 Berlin, Germany email: Fabian.Krome@BAM.de

More information

TWO-DIMENSIONAL FINITE ELEMENT ANALYSIS OF FORCED CONVECTION FLOW AND HEAT TRANSFER IN A LAMINAR CHANNEL FLOW

TWO-DIMENSIONAL FINITE ELEMENT ANALYSIS OF FORCED CONVECTION FLOW AND HEAT TRANSFER IN A LAMINAR CHANNEL FLOW TWO-DIMENSIONAL FINITE ELEMENT ANALYSIS OF FORCED CONVECTION FLOW AND HEAT TRANSFER IN A LAMINAR CHANNEL FLOW Rajesh Khatri 1, 1 M.Tech Scholar, Department of Mechanical Engineering, S.A.T.I., vidisha

More information

Does Black-Scholes framework for Option Pricing use Constant Volatilities and Interest Rates? New Solution for a New Problem

Does Black-Scholes framework for Option Pricing use Constant Volatilities and Interest Rates? New Solution for a New Problem Does Black-Scholes framework for Option Pricing use Constant Volatilities and Interest Rates? New Solution for a New Problem Gagan Deep Singh Assistant Vice President Genpact Smart Decision Services Financial

More information

Dispersion diagrams of a water-loaded cylindrical shell obtained from the structural and acoustic responses of the sensor array along the shell

Dispersion diagrams of a water-loaded cylindrical shell obtained from the structural and acoustic responses of the sensor array along the shell Dispersion diagrams of a water-loaded cylindrical shell obtained from the structural and acoustic responses of the sensor array along the shell B.K. Jung ; J. Ryue ; C.S. Hong 3 ; W.B. Jeong ; K.K. Shin

More information

3. Diffusion of an Instantaneous Point Source

3. Diffusion of an Instantaneous Point Source 3. Diffusion of an Instantaneous Point Source The equation of conservation of mass is also known as the transport equation, because it describes the transport of scalar species in a fluid systems. In this

More information

NUMERICAL ANALYSIS PROGRAMS

NUMERICAL ANALYSIS PROGRAMS NUMERICAL ANALYSIS PROGRAMS I. About the Program Disk This disk included with Numerical Analysis, Seventh Edition by Burden and Faires contains a C, FORTRAN, Maple, Mathematica, MATLAB, and Pascal program

More information

Integration of a fin experiment into the undergraduate heat transfer laboratory

Integration of a fin experiment into the undergraduate heat transfer laboratory Integration of a fin experiment into the undergraduate heat transfer laboratory H. I. Abu-Mulaweh Mechanical Engineering Department, Purdue University at Fort Wayne, Fort Wayne, IN 46805, USA E-mail: mulaweh@engr.ipfw.edu

More information

College of the Holy Cross, Spring 2009 Math 373, Partial Differential Equations Midterm 1 Practice Questions

College of the Holy Cross, Spring 2009 Math 373, Partial Differential Equations Midterm 1 Practice Questions College of the Holy Cross, Spring 29 Math 373, Partial Differential Equations Midterm 1 Practice Questions 1. (a) Find a solution of u x + u y + u = xy. Hint: Try a polynomial of degree 2. Solution. Use

More information

1 The basic equations of fluid dynamics

1 The basic equations of fluid dynamics 1 The basic equations of fluid dynamics The main task in fluid dynamics is to find the velocity field describing the flow in a given domain. To do this, one uses the basic equations of fluid flow, which

More information

Finite Difference Approach to Option Pricing

Finite Difference Approach to Option Pricing Finite Difference Approach to Option Pricing February 998 CS5 Lab Note. Ordinary differential equation An ordinary differential equation, or ODE, is an equation of the form du = fut ( (), t) (.) dt where

More information

O.F.Wind Wind Site Assessment Simulation in complex terrain based on OpenFOAM. Darmstadt, 27.06.2012

O.F.Wind Wind Site Assessment Simulation in complex terrain based on OpenFOAM. Darmstadt, 27.06.2012 O.F.Wind Wind Site Assessment Simulation in complex terrain based on OpenFOAM Darmstadt, 27.06.2012 Michael Ehlen IB Fischer CFD+engineering GmbH Lipowskystr. 12 81373 München Tel. 089/74118743 Fax 089/74118749

More information

Heat Transfer Prof. Dr. Aloke Kumar Ghosal Department of Chemical Engineering Indian Institute of Technology, Guwahati

Heat Transfer Prof. Dr. Aloke Kumar Ghosal Department of Chemical Engineering Indian Institute of Technology, Guwahati Heat Transfer Prof. Dr. Aloke Kumar Ghosal Department of Chemical Engineering Indian Institute of Technology, Guwahati Module No. # 02 One Dimensional Steady State Heat Transfer Lecture No. # 05 Extended

More information

Heat equation examples

Heat equation examples Heat equation examples The Heat equation is discussed in depth in http://tutorial.math.lamar.edu/classes/de/intropde.aspx, starting on page 6. You may recall Newton s Law of Cooling from Calculus. Just

More information

Chapter 6: Solving Large Systems of Linear Equations

Chapter 6: Solving Large Systems of Linear Equations ! Revised December 8, 2015 12:51 PM! 1 Chapter 6: Solving Large Systems of Linear Equations Copyright 2015, David A. Randall 6.1! Introduction Systems of linear equations frequently arise in atmospheric

More information

3. Reaction Diffusion Equations Consider the following ODE model for population growth

3. Reaction Diffusion Equations Consider the following ODE model for population growth 3. Reaction Diffusion Equations Consider the following ODE model for population growth u t a u t u t, u 0 u 0 where u t denotes the population size at time t, and a u plays the role of the population dependent

More information

Introduction to the Finite Element Method (FEM)

Introduction to the Finite Element Method (FEM) Introduction to the Finite Element Method (FEM) ecture First and Second Order One Dimensional Shape Functions Dr. J. Dean Discretisation Consider the temperature distribution along the one-dimensional

More information

State of Stress at Point

State of Stress at Point State of Stress at Point Einstein Notation The basic idea of Einstein notation is that a covector and a vector can form a scalar: This is typically written as an explicit sum: According to this convention,

More information

LASER MELTED STEEL FREE SURFACE FORMATION

LASER MELTED STEEL FREE SURFACE FORMATION METALLURGY AND FOUNDRY ENGINEERING Vol. 33, 2007, No. 1 Aleksander Siwek * LASER MELTED STEEL FREE SURFACE FORMATION 1. INTRODUCTION Many phisical phenomena happen on the surface of worked object in the

More information

Introduction to Partial Differential Equations By Gilberto E. Urroz, September 2004

Introduction to Partial Differential Equations By Gilberto E. Urroz, September 2004 Introduction to Partial Differential Equations By Gilberto E. Urroz, September 2004 This chapter introduces basic concepts and definitions for partial differential equations (PDEs) and solutions to a variety

More information

Heating & Cooling in Molecular Clouds

Heating & Cooling in Molecular Clouds Lecture 8: Cloud Stability Heating & Cooling in Molecular Clouds Balance of heating and cooling processes helps to set the temperature in the gas. This then sets the minimum internal pressure in a core

More information

MODULE VII LARGE BODY WAVE DIFFRACTION

MODULE VII LARGE BODY WAVE DIFFRACTION MODULE VII LARGE BODY WAVE DIFFRACTION 1.0 INTRODUCTION In the wave-structure interaction problems, it is classical to divide into two major classification: slender body interaction and large body interaction.

More information

The 1-D Wave Equation

The 1-D Wave Equation The -D Wave Equation 8.303 Linear Partial Differential Equations Matthew J. Hancock Fall 006 -D Wave Equation : Physical derivation Reference: Guenther & Lee., Myint-U & Debnath.-.4 [Oct. 3, 006] We consider

More information

Section 5.0 : Horn Physics. By Martin J. King, 6/29/08 Copyright 2008 by Martin J. King. All Rights Reserved.

Section 5.0 : Horn Physics. By Martin J. King, 6/29/08 Copyright 2008 by Martin J. King. All Rights Reserved. Section 5. : Horn Physics Section 5. : Horn Physics By Martin J. King, 6/29/8 Copyright 28 by Martin J. King. All Rights Reserved. Before discussing the design of a horn loaded loudspeaker system, it is

More information

FINITE DIFFERENCE METHODS

FINITE DIFFERENCE METHODS FINITE DIFFERENCE METHODS LONG CHEN Te best known metods, finite difference, consists of replacing eac derivative by a difference quotient in te classic formulation. It is simple to code and economic to

More information

Figure 1 - Unsteady-State Heat Conduction in a One-dimensional Slab

Figure 1 - Unsteady-State Heat Conduction in a One-dimensional Slab The Numerical Method of Lines for Partial Differential Equations by Michael B. Cutlip, University of Connecticut and Mordechai Shacham, Ben-Gurion University of the Negev The method of lines is a general

More information

Coupling Forced Convection in Air Gaps with Heat and Moisture Transfer inside Constructions

Coupling Forced Convection in Air Gaps with Heat and Moisture Transfer inside Constructions Coupling Forced Convection in Air Gaps with Heat and Moisture Transfer inside Constructions M. Bianchi Janetti 1, F. Ochs 1 and R. Pfluger 1 1 University of Innsbruck, Unit for Energy Efficient Buildings,

More information

Chapter 12 IVP Practice Problems

Chapter 12 IVP Practice Problems PRACTICE PROBLEMS 43 Chapter IVP Practice Problems Use Excel and VBA to solve the following problems. Document your solutions using the Expert Problem Solving steps outlined in Table... Find an approximate

More information

Frequency-domain and stochastic model for an articulated wave power device

Frequency-domain and stochastic model for an articulated wave power device Frequency-domain stochastic model for an articulated wave power device J. Cândido P.A.P. Justino Department of Renewable Energies, Instituto Nacional de Engenharia, Tecnologia e Inovação Estrada do Paço

More information

CBE 6333, R. Levicky 1 Differential Balance Equations

CBE 6333, R. Levicky 1 Differential Balance Equations CBE 6333, R. Levicky 1 Differential Balance Equations We have previously derived integral balances for mass, momentum, and energy for a control volume. The control volume was assumed to be some large object,

More information

Teoretisk Fysik KTH. Advanced QM (SI2380), test questions 1

Teoretisk Fysik KTH. Advanced QM (SI2380), test questions 1 Teoretisk Fysik KTH Advanced QM (SI238), test questions NOTE THAT I TYPED THIS IN A HURRY AND TYPOS ARE POSSIBLE: PLEASE LET ME KNOW BY EMAIL IF YOU FIND ANY (I will try to correct typos asap - if you

More information

Dimensionless form of equations

Dimensionless form of equations Dimensionless form of equations Motivation: sometimes equations are normalized in order to facilitate the scale-up of obtained results to real flow conditions avoid round-off due to manipulations with

More information

Flow Sensors. - mass flow rate - volume flow rate - velocity. - stream line parabolic velocity profile - turbulent vortices. Methods of measurement

Flow Sensors. - mass flow rate - volume flow rate - velocity. - stream line parabolic velocity profile - turbulent vortices. Methods of measurement Flow Sensors Flow - mass flow rate - volume flow rate - velocity Types of flow - stream line parabolic velocity profile - turbulent vortices Methods of measurement - direct: positive displacement (batch

More information

Physics 9e/Cutnell. correlated to the. College Board AP Physics 1 Course Objectives

Physics 9e/Cutnell. correlated to the. College Board AP Physics 1 Course Objectives Physics 9e/Cutnell correlated to the College Board AP Physics 1 Course Objectives Big Idea 1: Objects and systems have properties such as mass and charge. Systems may have internal structure. Enduring

More information

The simulation of machine tools can be divided into two stages. In the first stage the mechanical behavior of a machine tool is simulated with FEM

The simulation of machine tools can be divided into two stages. In the first stage the mechanical behavior of a machine tool is simulated with FEM 1 The simulation of machine tools can be divided into two stages. In the first stage the mechanical behavior of a machine tool is simulated with FEM tools. The approach to this simulation is different

More information

FLUID DYNAMICS. Intrinsic properties of fluids. Fluids behavior under various conditions

FLUID DYNAMICS. Intrinsic properties of fluids. Fluids behavior under various conditions FLUID DYNAMICS Intrinsic properties of fluids Fluids behavior under various conditions Methods by which we can manipulate and utilize the fluids to produce desired results TYPES OF FLUID FLOW Laminar or

More information

1 Two-dimensional heat equation with FD

1 Two-dimensional heat equation with FD i+1,j -1 +1 H z i-1,j z x x L Figure 1: Finite difference discretization of the 2D heat problem. 1 Two-dimensional heat equation with FD We now revisit the transient heat equation, this time with sources/sinks,

More information

Midterm Solutions. mvr = ω f (I wheel + I bullet ) = ω f 2 MR2 + mr 2 ) ω f = v R. 1 + M 2m

Midterm Solutions. mvr = ω f (I wheel + I bullet ) = ω f 2 MR2 + mr 2 ) ω f = v R. 1 + M 2m Midterm Solutions I) A bullet of mass m moving at horizontal velocity v strikes and sticks to the rim of a wheel a solid disc) of mass M, radius R, anchored at its center but free to rotate i) Which of

More information

FLAP P11.2 The quantum harmonic oscillator

FLAP P11.2 The quantum harmonic oscillator F L E X I B L E L E A R N I N G A P P R O A C H T O P H Y S I C S Module P. Opening items. Module introduction. Fast track questions.3 Ready to study? The harmonic oscillator. Classical description of

More information

Inner Product Spaces

Inner Product Spaces Math 571 Inner Product Spaces 1. Preliminaries An inner product space is a vector space V along with a function, called an inner product which associates each pair of vectors u, v with a scalar u, v, and

More information

Høgskolen i Narvik Sivilingeniørutdanningen STE6237 ELEMENTMETODER. Oppgaver

Høgskolen i Narvik Sivilingeniørutdanningen STE6237 ELEMENTMETODER. Oppgaver Høgskolen i Narvik Sivilingeniørutdanningen STE637 ELEMENTMETODER Oppgaver Klasse: 4.ID, 4.IT Ekstern Professor: Gregory A. Chechkin e-mail: chechkin@mech.math.msu.su Narvik 6 PART I Task. Consider two-point

More information

3.2 Sources, Sinks, Saddles, and Spirals

3.2 Sources, Sinks, Saddles, and Spirals 3.2. Sources, Sinks, Saddles, and Spirals 6 3.2 Sources, Sinks, Saddles, and Spirals The pictures in this section show solutions to Ay 00 C By 0 C Cy D 0. These are linear equations with constant coefficients

More information

1D Numerical Methods With Finite Volumes

1D Numerical Methods With Finite Volumes 1D Numerical Methods With Finite Volumes Guillaume Riflet MARETEC IST 1 The advection-diffusion equation The original concept, applied to a property within a control volume V, from which is derived the

More information

Nonlinear Algebraic Equations Example

Nonlinear Algebraic Equations Example Nonlinear Algebraic Equations Example Continuous Stirred Tank Reactor (CSTR). Look for steady state concentrations & temperature. s r (in) p,i (in) i In: N spieces with concentrations c, heat capacities

More information

Multigrid preconditioning for nonlinear (degenerate) parabolic equations with application to monument degradation

Multigrid preconditioning for nonlinear (degenerate) parabolic equations with application to monument degradation Multigrid preconditioning for nonlinear (degenerate) parabolic equations with application to monument degradation M. Donatelli 1 M. Semplice S. Serra-Capizzano 1 1 Department of Science and High Technology

More information

Class Meeting # 1: Introduction to PDEs

Class Meeting # 1: Introduction to PDEs MATH 18.152 COURSE NOTES - CLASS MEETING # 1 18.152 Introduction to PDEs, Fall 2011 Professor: Jared Speck Class Meeting # 1: Introduction to PDEs 1. What is a PDE? We will be studying functions u = u(x

More information

Linköping University Electronic Press

Linköping University Electronic Press Linköping University Electronic Press Report Well-posed boundary conditions for the shallow water equations Sarmad Ghader and Jan Nordström Series: LiTH-MAT-R, 0348-960, No. 4 Available at: Linköping University

More information

Introduction to CFD Analysis

Introduction to CFD Analysis Introduction to CFD Analysis Introductory FLUENT Training 2006 ANSYS, Inc. All rights reserved. 2006 ANSYS, Inc. All rights reserved. 2-2 What is CFD? Computational fluid dynamics (CFD) is the science

More information

F en = mω 0 2 x. We should regard this as a model of the response of an atom, rather than a classical model of the atom itself.

F en = mω 0 2 x. We should regard this as a model of the response of an atom, rather than a classical model of the atom itself. The Electron Oscillator/Lorentz Atom Consider a simple model of a classical atom, in which the electron is harmonically bound to the nucleus n x e F en = mω 0 2 x origin resonance frequency Note: We should

More information

Scientic Computing 2013 Computer Classes: Worksheet 11: 1D FEM and boundary conditions

Scientic Computing 2013 Computer Classes: Worksheet 11: 1D FEM and boundary conditions Scientic Computing 213 Computer Classes: Worksheet 11: 1D FEM and boundary conditions Oleg Batrashev November 14, 213 This material partially reiterates the material given on the lecture (see the slides)

More information

Solved with COMSOL Multiphysics 4.3

Solved with COMSOL Multiphysics 4.3 Vibrating String Introduction In the following example you compute the natural frequencies of a pre-tensioned string using the 2D Truss interface. This is an example of stress stiffening ; in fact the

More information

SOLVING LINEAR SYSTEMS

SOLVING LINEAR SYSTEMS SOLVING LINEAR SYSTEMS Linear systems Ax = b occur widely in applied mathematics They occur as direct formulations of real world problems; but more often, they occur as a part of the numerical analysis

More information

Second Order Systems

Second Order Systems Second Order Systems Second Order Equations Standard Form G () s = τ s K + ζτs + 1 K = Gain τ = Natural Period of Oscillation ζ = Damping Factor (zeta) Note: this has to be 1.0!!! Corresponding Differential

More information

Lecture 4 Classification of Flows. Applied Computational Fluid Dynamics

Lecture 4 Classification of Flows. Applied Computational Fluid Dynamics Lecture 4 Classification of Flows Applied Computational Fluid Dynamics Instructor: André Bakker http://www.bakker.org André Bakker (00-006) Fluent Inc. (00) 1 Classification: fluid flow vs. granular flow

More information

On computer algebra-aided stability analysis of dierence schemes generated by means of Gr obner bases

On computer algebra-aided stability analysis of dierence schemes generated by means of Gr obner bases On computer algebra-aided stability analysis of dierence schemes generated by means of Gr obner bases Vladimir Gerdt 1 Yuri Blinkov 2 1 Laboratory of Information Technologies Joint Institute for Nuclear

More information

Lecture 6 - Boundary Conditions. Applied Computational Fluid Dynamics

Lecture 6 - Boundary Conditions. Applied Computational Fluid Dynamics Lecture 6 - Boundary Conditions Applied Computational Fluid Dynamics Instructor: André Bakker http://www.bakker.org André Bakker (2002-2006) Fluent Inc. (2002) 1 Outline Overview. Inlet and outlet boundaries.

More information

ALL GROUND-WATER HYDROLOGY WORK IS MODELING. A Model is a representation of a system.

ALL GROUND-WATER HYDROLOGY WORK IS MODELING. A Model is a representation of a system. ALL GROUND-WATER HYDROLOGY WORK IS MODELING A Model is a representation of a system. Modeling begins when one formulates a concept of a hydrologic system, continues with application of, for example, Darcy's

More information

Scalars, Vectors and Tensors

Scalars, Vectors and Tensors Scalars, Vectors and Tensors A scalar is a physical quantity that it represented by a dimensional number at a particular point in space and time. Examples are hydrostatic pressure and temperature. A vector

More information

8 Hyperbolic Systems of First-Order Equations

8 Hyperbolic Systems of First-Order Equations 8 Hyperbolic Systems of First-Order Equations Ref: Evans, Sec 73 8 Definitions and Examples Let U : R n (, ) R m Let A i (x, t) beanm m matrix for i,,n Let F : R n (, ) R m Consider the system U t + A

More information

Indiana's Academic Standards 2010 ICP Indiana's Academic Standards 2016 ICP. map) that describe the relationship acceleration, velocity and distance.

Indiana's Academic Standards 2010 ICP Indiana's Academic Standards 2016 ICP. map) that describe the relationship acceleration, velocity and distance. .1.1 Measure the motion of objects to understand.1.1 Develop graphical, the relationships among distance, velocity and mathematical, and pictorial acceleration. Develop deeper understanding through representations

More information