The Fast Sweeping Method. Hongkai Zhao. Department of Mathematics University of California, Irvine

Size: px
Start display at page:

Download "The Fast Sweeping Method. Hongkai Zhao. Department of Mathematics University of California, Irvine"

Transcription

1 The Fast Sweeping Method Hongkai Zhao Department of Mathematics University of California, Irvine

2 Highlights of fast sweeping mehtod Simple (A Gauss-Seidel type of iterative method). Optimal complexity. A truly nonlinear method. A local solver for convex Hamiltonian on arbitrary mesh. 2

3 Outline Fast sweeping method (FSM): FSM for Eikonal equation on rectangular grid (convergence and error estimates). FSM on triangular mesh. (with J.Qian and Y. Zhang) FSM for general convex Hamilton-Jacobi equations (with J. Qian and Zhang). High order FSM (with Zhang and Qian). Parallel implementations. Understanding FSM in the framework of iterative methods.

4 The Eikonal equation: u(x) = c(x), u(x) =, x S u(x) is the first arrival time for a front starting at S with a propagation speed v n = c(x). T T T= v n =f 2 4

5 Numerical methods Two crucial ingredients: Appropriate discretization (local solver). Design numerical Hamiltonian that keeps the causality, deals with non-smoothness, and has high order accuracy if possible. Solve the system of discretized equations. Time marching methods: explicit but need many iterations due to finite speed of propagation and the CFL condition. Direct methods for the nonlinear boundary value problem: efficient but need to solve a large system of non-linear equations. 5

6 Other related work Danielson s algorithm (98). Schneider, etal, post sweeping (992). Boué and Dupuis, fast sweeping method for stochastic control (999). Jameson and Caughey use alternating sweeping to solve linearized steady compressible Euler equation (2). Tsitsiklis (995), Sethian (996) fast marching method. Sethian and Vladimirsky (2) ordered upwind scheme. 6

7 The fast sweeping algorithm on rectgangular grids Solve u(x) = c(x), with u(x) =, x S. Upwind difference at grid x i,j (nonlinear equation): [(u i,j u xmin ) + ] 2 +[(u i,j u ymin ) + ] 2 =h 2 c 2 i,j, i, j =,2,... () u xmin =min(u i,j, u i+,j ), u ymin =min(u i,j, u i,j+ ). Initial guess: u i,j = u(x i,j ) =, x i,j S, u i,j =, x i,j / S. G-S iterations with four alternating ordering: () i = : I, j = : J (2) i = I :, j = : J (3) i = I :, j = J : (4) i = : I, j = J : Let u be the solution to () using current values of u i±,j, u i,j±, u new i,j = min(u old i,j, u), 7

8 Gauss-Seidel method for a linear elliptic problem Solve u(x) = c(x), u(x) =, x S Discretization at grid x i,j (linear equation), i, j =,2,... u i+,j 2u i,j + u i,j + u i,j+ 2u i,j + u i,j = h 2 c i,j Give an initial guess of u with u(x) =, x S. Gauss-Seidel iteration: for i = : I, j = : J u n+ i,j = un i+,j + un+ i,j + un i,j+ + un+ i,j h2 c i,j 4 The iteration will converge. The number of iteration depends on the condition number of the matrix 8

9 The numerical Hamiltonian The numerical Hamiltonian: H h (p, p +, q, q + ) where = max{(p ) +,(p + ) } 2 + max{(q ) +,(q + ) } 2, p =D x u i,j=u i,j u i,j, p + =D x + u i,j=u i+,j u i,j, q =D y u i,j=u i,j u i,j, q + =D y + u i,j=u i,j+ u i,j, 9

10 Solve the numerical Hamiltonian in n dimensions Order a i s in the increasing order, assume a a 2... a n, there is a unique solution x to [(x a ) + ] 2 + [(x a 2 ) + ] [(x a n ) + ] 2 = c 2 i,j h2 which satisfies, (x a ) 2 + (x a 2 ) (x a p ) 2 = c 2 i,j h2 a p < x a p+ for some p, p n. Procedure:. Let x = a + hc i,j, if x a 2 then x = x; otherwise 2. Solve (x a ) 2 + (x a 2 ) 2 = c 2 i,j h2. Let x be the solution, if x a 3 then x = x, otherwise 3. Solve (x a ) 2 + (x a 2 ) 2 + (x a 3 ) 2 = c 2 i,j h2,..., untill we reach p.

11 Motivation for the fast sweeping method (c(x) = ) In D, there are two directions of characteristics, left or right. Two sweeps will find the exact solution. (a) the exact distance function to a point (b) the computed solution after first left to right sweeping (c) the computed solution after second right to left sweeping

12 The fast sweeping algorithm for distance function in 2D Facts: The characteristics have all directions. However all directions can be classified into four groups, up-right, up-left, downleft and down-right. Each sweep ordering covers one group of the characteristics simultaneously. i=i:, j=:j i=:i, j=:j i=i:, j=:j i=:i, j=:j i=:i, j=j: i=i:, j=j: j j i=:i, j=,j i=i:, j=:j i=i:, j=j: i=:i, j=j: i=i:, j=j: i=:i, j=j: i (a) one data point (b) a circle i

13 Questions Convergence: how many sweeps are needed for the Gauss- Seidel iterations? Error estimate for the numerical solution? Fast sweeping method on unstructured mesh. High order schemes. More general Hamilton-Jacobi equations and hyperbolic conservation law. 3

14 The monotonicity and Lipschitz continuity of the scheme Lemma: Let x be the solution to, we have [(x a ) + ] 2 + [(x a 2 ) + ] [(x a n ) + ] 2 = r 2 > x a x a 2... x a n, and x + x x =, a a 2 a n x r Theorem:(maximum change principle) The maximum change of u h at a grid point is no more than the maximum change of u h at its neighboring points in the G-S iterations. 4

15 Basic properties of the fast sweeping algorithm lemma: The fast sweeping algorithm is monotone in initial data. lemma2: The numerical solution of the fast sweeping algorithm is monotonically decreasing with iterations. lemma3: Let u (k) and v (k) be two numerical solutions at k- th sweep of the fast sweeping algorithm. Denote to be the maximum norm. We have () u (k) v (k) u (k ) v (k ). (2) max i,j {u (k) i,j u(k+) i,j (3) u (k) i,j u(k) i±,j u (k ) i,j u (k) i,j u(k) i,j± u (k ) i,j } max i,j {u (k ) i,j u (k ) i±,j, u (k) i±,j. u (k ) i,j }. Remark: (2) provides a stopping criterion. When u (k) u (k ) is O(h), the information has reached all points 5

16 Convergence of the fast sweeping algorithm Theorem: The solution of the fast sweeping algorithm converges monotonically to the solution of the discretized system. Proof: () u k i,j uk i,j u k i,j converges i, j. (2) [(u (k) i,j u(k) xmin )+ ] 2 + [(u (k) i,j u(k) ymin )+ ] 2 c 2 i,j h2 C max i,j {u (k ) i,j u (k) i,j }. Remark: If a grid point achieves the minimum value it can get at a certain iteration, it is the correct value and the value will not change in later iterations. 6

17 Main results for distance function Let S denote the data set, u h (x, S) denote the numerical solution, and d(x, S) denote the exact distance function. Theorem2: For a single data point S = {x }, u h (x, x ) converges after 2 n sweeps in n dimensions and d(x, x ) u h (x, x ) d(x, x ) + O(h log h ) (sharp!) 7

18 General data set For S = {x m } M m=, define uh (x, S) = min[u h (x, x ),..., u h (x, x M )] Since d(x, S) = min[d(x, x ), d(x, x 2 ),..., d(x, x M )], d(x, S) u h (x, S) d(x, S) + O( hlog h ). lemma: For a set of points S = {x m } M m=, uh (x, S) u h (x, S). Theorem3: For arbitrary S in n dimensions, after 2 n iterations. u(x i,j, S) u h (x i,j, S) u h (x i,j ) d(x i,j, S) + O( hlog h ), where u(x i,j, S) is the solution to the discretized system. 8

19 General Eikonal equation u(x) = c(x) Denote H(p, x) = p c(x), where p = u. The characteristic equations are: ẋ = p H = u c(x) ṗ = xh = c(x) u = u ẋ = c(x) Each characteristic curve can be segmented into a finite number of pieces and can be covered by the G-S sweeps successively. Ω 5 2 Γ x 4 3

20 Total direction variation along a characteristic ẋ = u c(x) =, ẍ = u c(x) u c c c ẋ = (I P n) c(x) c(x). Pn is the projection on n = u. ẍ is the curvature. u Denote K = maxx Ω c(x). The number of turns is bounded c(x) by 2π Γ ẍ ds 2π Γ c(x) c(x) ds K 2π Γ ds K 2π length(γ) 2

21 Maximum number of turns Let the characteristics Γ joins x S and a x Ω. c m ds c(s)ds = u(x) x c(s)ds c M x x Γ Γ x Hence length(γ) = ds Dc M Γ c m where D is the radius of the domain and c M (c m ) is the maximum (minimum) of c(x). The maximum number of turns is bounded by DK 2π c M cm. x x Γ S

22 Discrete version of interpretation (2D) The monotone upwind scheme on a rectangular grid admits a unique solution. All grid points can be divided into a finite number of simply connected regions. In each region the value at a grid point depends on two of its neighbors in four ways: () left and down neighbors; (2) left and above neighbors; (3) right and down neighbors; (4) right and above neighbors. Using GS iteration each connected region can be covered by one of the orderings simultaneously when the ordering is in the upwind direction of the dependence pattern. Moreover, a correct causality enforcement guarantee a correct value will not be changed by later iterations, e.g., no interference among different orderings. An appropriate upwind scheme + GS with systematic alternating orderings + causality enforcement are crucial. 22

23 Ordering strategy on unstructured mesh The Key point: Systematic ordering such that each characteristics can be covered in a finite number of sweep orderings. The solution: Order all vertices accroding to the distance to a few reference points and sweep back and forth according to these orderings. characteristic reference point C reference point reference point A reference point B characteristic 23

24 Local solver for each vertex At a vertex C, compute T(C) using its neighbors through each triangle and each edge then take the minimum one. T 2 T T 3 C T n T n T new (C) = min{t old (C), T new (C), T new 2 (C),...} 24

25 Local solver in one triangle C γ A α F β B T C = min s [,] { st B + ( s)t A + d(s) v g (C; s) F = sa + ( s)b, d(s) = AF, v g (C; s) is the group velocity in the direction of AF. Remark: For isotropic case, v g (C; s) = v g (C). if the triangle support a consistent and causality satisfying solution then T C > max{t A, T B }. }.

26 Local solver in one triangle for Eikonal case Given T(A), T(B) compute T(C). T(C) T(C) c* [ T(B) T(A)] = h T(C)= c*h+t(b) T(C)=min{T(A)+c*AC, T(B)+c*BC} T(A) T new (C) = min T(B) T(A) T(B) { T old (C), T(A) + AC } BC, T(B) +, T(A, B) v v Simple because the characteristic (ray) direction is the same as the travel time gradient (phase velocity). ẋ = p H = T c(x) 26

27 Local solver for general convex Hamiltonian Difficulty: the relation between ray direction and phase velocity. Our Solution: separate the consistency condition from causality check. Step : Find consistent T C from T A and T B. T(C) P using linear approximation, where P = ( xc x A b, x C x B a, T C T A b T C T B a y C y A b y C y B a Plug T(C) into the PDE and solve for T C, (2) H(C, T(C)) =, or Ĥ(C, T C, T A, T B ) =. ) (3) 27

28 Local solver (continued) No solution for T C T A, T B do not support a consistent T C in this triangle. There are one or more than one solutions for T C causality check. Step 2: Check Causality Condition: the characteristic starting from C against the direction p H(C, T(C)) intersects the line segment AB. If no T C satisfies the causality condition T A, T B do not support a T C that satisfies both the consistency and causality in this triangle. If multiple T C satisfy both the consistency and causality in this triangle choose the smallest one using the first-arrival time principle. 28

29 Geometric interpretation Step Step 2 P 2 C γ O P A α F β B Remark: If the Hamiltonian is convex there are at most two solutions for T C 29

30 Two special cases for rectangular grids. C C (a) Five point stencils. (b) Nine point stencils. Case (b) will yield more accurate solution due to better angle resolution. 3

31 Monotonicity and contraction property of the scheme Lemma The numerical Hamiltonian Ĥ ( C, T C T A b, T C T B a Ĥ is consistent: (if T h = p R 2 ). The numerical Hamiltonian if the causality condition holds. ) = H(C,p) (4) Ĥ is monotone T C T A, T C T B, T C T A + T C T B = Remark: For isotropic case, if γ < π 2 and T C = st B + ( s)t A + d(s) v g (C), < s < then < T C T A, T C T B <, T C T A + T C T B = If the true solution T C depends on T A and T B and the ordering is correct, each vertex update has a rate of contraction bounded away from.

32 Convergence Theorem There exists a unique solution for the discretized nonlinear system and the fast sweeping iteration converges. For convex Hamiltonian, if lim λ p H(x, λp) = dt dt = p dx dt = p ph The fast sweeping method works. The local solver is as difficult as solving the nonlinear Hamiltonian H(x,p) =. 32

33 Obtuse angle Obtuse angle may cause problems by using information in the wrong direction. Acute angle will not. Treatment of obtuse angle: virtual splitting and connection can be used to take care of this. C A B C A B D 33

34 Parallel implementations of the fast sweeping method Parallel sweeping: do different sweeping orderings in parallel. Synchronization: for each point take the minimal value from each sweeping (causality of the solution). Domain decomposition: do fast sweeping in each subdomain either in additive or multiplicative version. No overlap is needed between subdomains. Communications between subdomains: Take the minimal value at the boundary between two subdomains, which allows only correct information passing among subdomains (causality of the solution). Ω Γ 2 2 Ω Γ 3 Γ 24 o Ω Γ Ω

35 Can an iterative method converge in finite iterations? Elliptic problem: no! Every point is coupled with all other points the discretized system can not be a triangular system. Convergence mechanism: the iteration is a contraction map. Wish: a contraction rate that is bounded away from. Hyperbolic problem: yes! Information propagates along characteristics if an appropriate upwind scheme and ordering is used, the discretized system can be (or almost) put into a triangular system. Convergence mechanism: capture propagation of information. Wish: ordering or the nodes follows the characteristics. Linear problem: ordering can be determined á priori. Nonlinear problem: ordering depends on the solution. GS iteration with sweeping and upwind difference is a must to cover all characteristics blindly and efficiently.

36 Interpretation in the framework of iterative methods In theory, convergence in a finite number of iterations the nonlinear system can be put in a triangular (banded) system according to the causality. FSM achieves this by enforcing causality in the scheme and using Gauss-Seidel iterations with alternating sweeping. Time marching method is Jacobi type iteration which uses information from previous iteration (step). Information propagates with finite speed between iterations (steps). Gauss-Seidel iteration uses newest information. If causality is enforced correctly information can be propagated much more efficiently. Alternating sweeping does not affect elliptic problems but may help hyperbolic problems. Potential difficulties for more general hyperbolic problems: () causality, (2) upwind schemes and local solver.

37 Remarks on the complexity of FSM Let M be the total number of nodes, the complexity of FSM: on rectangular grids: O(M); on unstructured meshes. O(M log M). Remark : On unstructured meshes the log M factor comes from the initial sorting of all nodes. Once the sorting is done the complexity of the fast sweeping iterations is O(M). Remark 2: The constant in the complexity formula does not depend on the anisotropy of the Hamiltonian. 37

38 Anisotropic eikonal equations [ T(x)M(x) T(x)] 2 =, x R d, (5) where M(x) is a d d symmetric positive definite matrix. In two dimensions H = a(x) p 2 2c(x) p p 2 + b(x) p 2 2 =, (6) where a >, b > and c 2 ab <, e.g., ( a, c M = c, b The anisotropy of M (the metric) is characterized by η = ) λ max(m) λ min (M), where λ max (M) and λ min (M) are the larger and smaller eigenvalues of M, respectively. 38

39 Five-ring problem, Zoom in the mesh a=, b=, c= 26 nodes, 29 iterations Y.5 Y X X (a) (b) a=, b=, c=.7 26 nodes, 28 iterations a=, b=, c=.9 26 nodes, 28 iterations Y Y X X (c) (a): the mesh; (b): a=, b=, c=; η = +c c (d) = ; 29 sweepings; (c): a=, b=, c=.7; 28 sweepings; (d): a=, b=, c=.9; 28 sweepings.

40 Wrapping [.2,.2] [.2,.2] No wrapping Nodes Elements L error order iter L error order iter E E E E E E E E The order of convergence; a = 5.25, b = 5.75, c = , η = 2. Wrapping [.2,.2] [.2,.2] No wrapping Nodes Elements L error order iter L error order iter E E E E E E E-4. 4.E The order of convergence; a = 5.25, b = 5.75, c = , η = 2. Comparison between the five point stencils and the nine point stencils. a =, b =, c =.9. five point stencils nine point stencils Mesh L error order iter L error order iter 4 4.7E- 4.57E E E E E E E

41 Reconstruction of functions (images) from gradient Reconstruct u from u and local minima or maxima (boundary conditions) by solving the Eikonal equation, e,g, compression of Digital Terrain Elevation Data (DTED). Example: Given an image (the intensity function) u i,j, step : Record locations and values of local minima. u i,j is a local minimum if u i,j min{u i±,j, u i,j± }. step 2: Extract the gradient. Define u x = { ui,j u xmin h if u i,j > u xmin else u y = { ui,j u ymin h if u i,j > u ymin else f = u 2 x + u 2 y

42 Remarks: The gradient extraction is the exact inverse procedure of solving the Eikonal equation. Gradient space has many nice properties for geometric features. Many processing operations can be done in the gradient space. The reconstruction is an integral operator and is true multidimensional. Higher order of gradients can be used. Extraction of gradient and local minimum (or saddle) points needs care.

43 Shape from shading The equation for the graph of surface u(x, y) is ν n = I(x, y), ν is the direction of incoming light, n = ( u x, u y,)/ u 2 x + u 2 y + is the unit surface normal, and I(x, y) is the reflected light intensity. Take ν = (,,) we get the H-J equation for u(x, y): u 2 x + u2 y + = I(x, y) light z n n n n n n x

44 Examples Ω = [,]x[,], u(x, y) = at Ω. I(x, y) = / + (2π cos(2πx)sin(2πy)) 2 + (2π sin(2πx)cos(2πy)) 2, (a) u( 4, 4 ) = u(3 4, 3 4 ) =, u( 4, 3 4 ) = u(3 4, 4 ) =, u( 2, 2 ) = (b) u( 4, 4 ) = u(3 4, 3 4 ) = u( 4, 3 4 ) = u(3 4, 4 ) =, u( 2, 2 ) = case (a) case (b)

45 First order method on rectangular grids case (a) h = e e L e L # of sweeps 9 case (b) h = e e L e L # of sweeps

46 First order method on triangular mesh Order of convergence dist. to 2 circles SFS(a) SFS(b) Nodes L error order L error order L error order E E E E E E E E E E E E-3.93 Treatment for abtuse angle before treatment after treatment Ele. Obt. ele. L error order ite L error order ite E E E E E E E E E E

47 Number of iterations for different ordering spherical ordering using l 2 distance (x x ref ) 2 + (y y ref ) 2 Nodes dist. to 2 circles SFS (a) SFS (b) five-rings planar ordering using l distance x x ref + y y ref Nodes two-circles SFS (a) SFS (b) five-rings

48 3D computation on unstructured mesh Phi -2-2 Z x 8 x 8 mesh 3rd-order Godunov fast-sweeping Y Y 2 2 X Phi Z 8 x 8 x 8 mesh 3rd-order Godunov fast-sweeping X Interior of left picture Nodes Elements L error order iteration E E E Tetrahedron mesh. Spherical sweeping front with 8 reference points

49 High order methods: using Godunov flux High order method: using the same Godunov flux with high order WENO approximation of D ±. where [( φnew i,j φ (xmin) i,j φ (ymin) i,j φ (xmin) i,j ) + ] 2 + [( φnew i,j h φ (ymin) i,j ) + ] 2 = fi,j 2 h = min(φ old i,j h (φ x) i,j, φold i,j + h (φ x) + i,j ), = min(φ old i,j h (φ y) i,j, φold i,j + h (φ y) + i,j ). φ i,j ± h (φ x ) ± i,j and φ i,j ± h (φ y ) ± i,j can be considered as approximations to φ i±,j and φ i,j± respectively. Here (φ x ) ± i,j and (φ y ) ± i,j are computed using WENO schemes. When the iterations converge, we have solved the system max{[(φ x ) i,j ]+,[ (φ x ) + i,j ]+ } 2 + max{[(φ y ) i,j ]+,[ (φ y ) + i,j ]+ } 2 = f i,j

50 High order methods: using Lax-Friedrichs Ĥ(u, u + ; v, v + )=H( u + u +, v + v + ) α xu+ u α yv+ v where α x = max A u B H (u, v), α y = max A u B H 2 (u, v). C v D C v D The st order L-F scheme by Kao, Osher and Qian: φ new i,j = α x h x + α y h y [ f H +α x φ i+,j +φ i,j 2h x ( φi+,j φ i,j 2h x ] φ + α i,j+ +φ i,j y 2h y, φ i,j+ φ i,j 2h y replace φ i±,j and φ i,j± by φ i,j ± h (φ x ) ± i,j and φ i,j ± h (φ y ) ± i,j respectively, where (φ x ) ± i,j and (φ y) ± i,j are computed using WENO: φ new i,j = α x h x + α y h y f H (φ x) i,j + (φ x) + i,j 2 (φ x ) + i,j +α (φ x) i,j (φ y ) + i,j x 2 + α (φ y) i,j y 2 ] ), (φ y) i,j + (φ y) + i,j 2 + φ old i,j.

51 Remarks Godunov: needs local flux solver; more upwind; fewer iterations; need a first order sweep for good initial guess. L-F: works for general Hamiltonian; less upwind; more iterations; less sensitive to initial guess. The number of iterations depends on grid size but is much fewer than time marching. Retain high order in certain regions. Shocks give no pollution. Rarefactions cause pollution. Rarefaction Shock Rarefaction R

52 Accuracy in different regions. Godunov Hamiltonian. smooth region whole region rarefaction mesh L error order L error order L error order iter 8 8.3E-5.7E-4 5.7E-4 38x E E E x E E E x E E E x4 exact solution numerical solution, mesh: 8x Y Y X 2-2 X 2-2

53 High order methods 3rd order Godunov method SFS case a (smooth) SFS case b (non-smooth) mesh L error order iteration # L error order iteration # E-4 6x4.4E-3 8x E x4.98E x E x4 2.95E x E x4 7.28E x4 3rd order Lax-Friedrichs method α x = α y =. SFS case a (smooth) SFS case b (non-smooth) Comparision between time-marching and fast sweeping with 3rd order WENO mesh L error order iteration # L error order iteration # E-4 22x4 2.94E-3 28x E x4 8.35E x E x4 2.2E x E x4 4.67E x4 3rd-order Time-marching 3rd-order fast sweeping mesh L error order iteration # L error order iteration # 8 8.4E E E E E E E E

54 Third order scheme, mesh: 8x8 First order scheme, mesh: 8x Y.5 Y X.5 X Third order scheme, mesh: 8x8 First order scheme, mesh: 8x Y.5 Y X.5 X

55 Travel-time for elastic wave The quasi-p and the quasi-sv slowness surfaces are: c φ 4 x + c 2 φ 2 xφ 2 y + c 3 φ 4 y + c 4 φ 2 x + c 5 φ 2 y + =, where c i are defined by elastic tensor a ij. The quasi-p wave eikonal equation (convex) is: 2 (c 4φ 2 x + c 5 φ 2 y) + 4 (c 4φ 2 x + c 5 φ 2 y) 2 (c φ 4 x + c 2 φ 2 xφ 2 y + c 3 φ 4 y) = The quasi-sv wave eikonal equation (non-convex) is: 2 (c 4φ 2 x + c 5φ 2 y ) 4 (c 4φ 2 x + c 5φ 2 y )2 (c φ 4 x + c 2φ 2 x φ2 y + c 3φ 4 y ) = 55

56 Slowness surfaces for quasi-p wave (left) and quasi-sv wave (right) φ y φ y φ x φ x Convexification of the Hamiltonian for the quasi-sv wave φ y φ φ x x

57 mesh L error order L error order iteration # E-4 3.7E-3 27x E E x E E x E E x E E x4 Quasi-P wave, Lax-Friedrichs method, α x = α y = 4. mesh L error order L error order iteration # smooth region.5 away from x = and y = E E-3 42x E E x E E x E E x E E x4 Whole region E-3.53E-2 42x E E x E E x E E x E E x4 Quasi-SV wave, Lax-Friedrichs method, α x = α y = 2.

58 Third-order LxF-FS scheme, 8 x 8 mesh Third-order LxF-FS scheme, 8 x 8 mesh Y Y X X travel time for quasi-p wave (left) and quasi-sv wave (right)

59 Fast sweeping method for steady state scalar hyperbolic conservation laws (joint with Chen, Shu, Zhang) Motivation: Information propagates along characteristics starting from inflow boundary until shocks form. Main difficulties: causality rule and upwind difference schemes are more complicated. 59

60 Numerical procedure For a particular ordering march from the boundary inward as far as possible, e.g., at a grid point update its value using an upwind scheme corresponding to this sweeping direction unless either upwind causality is violated: the grid value updated from the upwind scheme using the sweeping ordering is against the causality. or shock is detected: current values of the point and its neighbors satisfies both the conservation law and the entropy condition for a shock. x=a x=b 6

61 Discretization D case: f(u) x = h(u, x) The discretization is f j+ f 2 j 2 x using Roe flux: f j+ 2 = f(u j ), f(u j+ ), = h(u j, x j ) f(u j+ ) f(u j ) u j+ u ; j f(u j+ ) f(u j ) u j+ u <. j 2D case: f(u) x + g(u) y = h(u, x, y) is treated similarly. High resolution method such as the discontinuous Galerkin (DG) method can also be used in this formulation. 6

62 { ( Example : 2 u 2 ) x = a(x)u, x ; u() =, u() =.. where a(x) = 6x 3. Exact solution for this problem is u(x) = { 3x 2 3x +, x < x ; 3x 2 3x., x < x. x = is the shock location. N st order L error order DG P L error order 2.2E E E E E E two sweeps are needed.8.6 st order numerical solution, N=8 Exact solution.4.2 u(x) x

63 Example 2. yu x xu y =, The exact solution is u(x, y) = (x, y) [,] [,]. x 2 + y 2. N st order L error order DG P L error order 2 8.2E E E E E E E E four sweeps are needed y y x x left: st order upwind; right: DG P

64 Example 3. u y +( u2 2 ) x =, (x, y) [,] [,]. u(x, y) = Exact solution is u(x, y) =.5, x =, 2.5x +.5, y =,., x =. u L, (x, y) between lines g and g 3, u R, (x, y) between lines g 2 and g 3, (u R u L )(x p + y p(x x p ) y p ) + u y L, (x, y) between lines g and g 2, where u L =.5, u R =., x p = u L /(u L u R ), y p = /(u L u R ); the leftmost char. g is y = x/u L, the rightmost char. g 2 is y = (x )/u R, the shock g 3 is y = (2x )/(u L + u R ). Two sweeps are needed y x Contour plot of the solution. Solid line: exact; Dashed line: numerical

65 Example 4. u y +( u2 2 ) x =, (x, y) [,] [,]. u(x, y) = Exact solution is u(x, y) =.5, x.6 y.4,.4, x.6 y.4.5, x.6.5 < y.4 <.4, x.6 y.4.4. {.5, x.6, y =,.4, x >.6, y =. Fixed Roe and special treatment is needed for rarefaction. Two sweeps are needed y x Contour plot of the solution. Solid line: exact; Dashed line: numerical

66 Example 5. ( u2 2 2 ) x+( u2 2 2 ) y= πcos(π x+y )u, (x, y) [, ] [, ] Where x s =.4876, and the exact solution is u(x, y) = sin(π x+y 2 ),. sin(π x+y 2 ), Four sweeps are needed. if x+y 2 x s, if x+y 2 > x s y x Contour plot of the solution. Solid line: exact; Dashed line: numerical

67 Conclusion and current work Conclusion: FS method is a GS type of iterative scheme. Properly designed, it can work efficiently for hyperbolic problems. Current work: Hyperbolic conservation laws, in particular for systems. Convection dominated diffusion problem. Righthand (the velocity) is discontinuous across an interface. The solution satisfies a nonlinear jump condition (Snell s law) across the interface. [u] =, [u 2 n] = [c 2 ] How to enforce the jump conditions to get high order accuracy across the interface?

A STOPPING CRITERION FOR HIGHER-ORDER SWEEPING SCHEMES FOR STATIC HAMILTON-JACOBI EQUATIONS *

A STOPPING CRITERION FOR HIGHER-ORDER SWEEPING SCHEMES FOR STATIC HAMILTON-JACOBI EQUATIONS * Journal of Computational Mathematics Vol.8, No.4, 010, 55 568. http://www.global-sci.org/jcm doi:10.408/jcm.1003-m0016 A STOPPING CRITERION FOR HIGHER-ORDER SWEEPING SCHEMES FOR STATIC HAMILTON-JACOBI

More information

A Second Order Discontinuous Galerkin Fast Sweeping Method for Eikonal Equations

A Second Order Discontinuous Galerkin Fast Sweeping Method for Eikonal Equations A Second Order Discontinuous Galerkin Fast Sweeping Method for Eikonal Equations Fengyan Li, Chi-Wang Shu, Yong-Tao Zhang 3, and Hongkai Zhao 4 ABSTRACT In this paper, we construct a second order fast

More information

Accepted Manuscript. A Second Order Discontinuous Galerkin Fast Sweeping Method for Eikonal Equations

Accepted Manuscript. A Second Order Discontinuous Galerkin Fast Sweeping Method for Eikonal Equations Accepted Manuscript A Second Order Discontinuous Galerkin Fast Sweeping Method for Eikonal Equations Fengyan Li, Chi-Wang Shu, Yong-Tao Zhang, Hongkai Zhao PII: S-()- DOI:./j.jcp... Reference: YJCPH To

More information

A Third Order Fast Sweeping Method with Linear Computational Complexity for Eikonal Equations

A Third Order Fast Sweeping Method with Linear Computational Complexity for Eikonal Equations DOI.7/s95-4-9856-7 A Third Order Fast Sweeping Method with Linear Computational Complexity for Eikonal Equations Liang Wu Yong-Tao Zhang Received: 7 September 23 / Revised: 23 February 24 / Accepted: 5

More information

Fast Marching Methods for Front Propagation Lecture 1/3

Fast Marching Methods for Front Propagation Lecture 1/3 Outline for Front Propagation Lecture 1/3 M. Falcone Dipartimento di Matematica SAPIENZA, Università di Roma Autumn School Introduction to Numerical Methods for Moving Boundaries ENSTA, Paris, November,

More information

Convergence Analysis of Fast Sweeping Method for Static Convex Hamilton-Jacobi Equations

Convergence Analysis of Fast Sweeping Method for Static Convex Hamilton-Jacobi Equations Convergence Analysis of Fast Sweeping Method for Static Convex Hamilton-Jacobi Equations Songting Luo 1, Department of Mathematics, Iowa State University, Ames IA 50011. Hongkai Zhao 2 Department of Mathematics,

More information

Positivity-preserving high order schemes for convection dominated equations

Positivity-preserving high order schemes for convection dominated equations Positivity-preserving high order schemes for convection dominated equations Chi-Wang Shu Division of Applied Mathematics Brown University Joint work with Xiangxiong Zhang; Yinhua Xia; Yulong Xing; Cheng

More information

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 25: Introduction to Discontinuous Galerkin Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods

More information

A Survey of Computational High Frequency Wave Propagation II. Olof Runborg NADA, KTH

A Survey of Computational High Frequency Wave Propagation II. Olof Runborg NADA, KTH A Survey of Computational High Frequency Wave Propagation II Olof Runborg NADA, KTH High Frequency Wave Propagation CSCAMM, September 19-22, 2005 Numerical methods Direct methods Wave equation (time domain)

More information

Bound-preserving high order schemes in computational fluid dynamics Chi-Wang Shu

Bound-preserving high order schemes in computational fluid dynamics Chi-Wang Shu Bound-preserving high order schemes in computational fluid dynamics Chi-Wang Shu Division of Applied Mathematics Brown University Outline Introduction Maximum-principle-preserving for scalar conservation

More information

HIGH ORDER NUMERICAL METHODS FOR TIME DEPENDENT HAMILTON-JACOBI EQUATIONS

HIGH ORDER NUMERICAL METHODS FOR TIME DEPENDENT HAMILTON-JACOBI EQUATIONS June 6, 7 :7 WSPC/Lecture Notes Series: 9in x 6in chapter HIGH ORDER NUMERICAL METHODS FOR TIME DEPENDENT HAMILTON-JACOBI EQUATIONS Chi-Wang Shu Division of Applied Mathematics, Brown University Providence,

More information

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Dedicated to Todd F. Dupont on the occasion of his 65th birthday Yingjie Liu, Chi-Wang Shu and Zhiliang

More information

Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods

Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods Jianxian Qiu School of Mathematical Science Xiamen University jxqiu@xmu.edu.cn http://ccam.xmu.edu.cn/teacher/jxqiu

More information

Math 660-Lecture 23: Gudonov s method and some theories for FVM schemes

Math 660-Lecture 23: Gudonov s method and some theories for FVM schemes Math 660-Lecture 3: Gudonov s method and some theories for FVM schemes 1 The idea of FVM (You can refer to Chapter 4 in the book Finite volume methods for hyperbolic problems ) Consider the box [x 1/,

More information

Self-similar solutions for the diffraction of weak shocks

Self-similar solutions for the diffraction of weak shocks Self-similar solutions for the diffraction of weak shocks Allen M. Tesdall John K. Hunter Abstract. We numerically solve a problem for the unsteady transonic small disturbance equations that describes

More information

A parametrized maximum principle preserving flux limiter for finite difference RK-WENO schemes with applications in incompressible flows.

A parametrized maximum principle preserving flux limiter for finite difference RK-WENO schemes with applications in incompressible flows. A parametrized maximum principle preserving flux limiter for finite difference RK-WENO schemes with applications in incompressible flows Tao Xiong Jing-ei Qiu Zhengfu Xu 3 Abstract In Xu [] a class of

More information

Poisson Equation in 2D

Poisson Equation in 2D A Parallel Strategy Department of Mathematics and Statistics McMaster University March 31, 2010 Outline Introduction 1 Introduction Motivation Discretization Iterative Methods 2 Additive Schwarz Method

More information

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

More information

Numerical Methods of Applied Mathematics -- II Spring 2009

Numerical Methods of Applied Mathematics -- II Spring 2009 MIT OpenCourseWare http://ocw.mit.edu 18.336 Numerical Methods of Applied Mathematics -- II Spring 2009 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms.

More information

High order finite difference Hermite WENO schemes for the Hamilton-Jacobi equations on unstructured meshes

High order finite difference Hermite WENO schemes for the Hamilton-Jacobi equations on unstructured meshes High order finite difference Hermite WENO schemes for the Hamilton-Jacobi equations on unstructured meshes Feng Zheng, Chi-Wang Shu and Jianxian Qiu 3 Abstract In this paper, a new type of high order Hermite

More information

Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of. Conservation Laws 1. Abstract

Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of. Conservation Laws 1. Abstract Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of Conservation Laws Sirui Tan and Chi-Wang Shu 3 Abstract We develop a high order finite difference numerical boundary condition for solving

More information

The RAMSES code and related techniques I. Hydro solvers

The RAMSES code and related techniques I. Hydro solvers The RAMSES code and related techniques I. Hydro solvers Outline - The Euler equations - Systems of conservation laws - The Riemann problem - The Godunov Method - Riemann solvers - 2D Godunov schemes -

More information

A central discontinuous Galerkin method for Hamilton-Jacobi equations

A central discontinuous Galerkin method for Hamilton-Jacobi equations A central discontinuous Galerkin method for Hamilton-Jacobi equations Fengyan Li and Sergey Yakovlev Abstract In this paper, a central discontinuous Galerkin method is proposed to solve for the viscosity

More information

The one-dimensional equations for the fluid dynamics of a gas can be written in conservation form as follows:

The one-dimensional equations for the fluid dynamics of a gas can be written in conservation form as follows: Topic 7 Fluid Dynamics Lecture The Riemann Problem and Shock Tube Problem A simple one dimensional model of a gas was introduced by G.A. Sod, J. Computational Physics 7, 1 (1978), to test various algorithms

More information

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations Hao Li Math Dept, Purdue Univeristy Ocean University of China, December, 2017 Joint work with

More information

Dijkstra-like Ordered Upwind Methods for Solving Static Hamilton-Jacobi Equations

Dijkstra-like Ordered Upwind Methods for Solving Static Hamilton-Jacobi Equations Dijkstra-like Ordered Upwind Methods for Solving Static Hamilton-Jacobi Equations by Ken Alton Bachelor of Science, University of Calgary, 2000 Master of Science, University of British Columbia, 2005 a

More information

30 crete maximum principle, which all imply the bound-preserving property. But most

30 crete maximum principle, which all imply the bound-preserving property. But most 3 4 7 8 9 3 4 7 A HIGH ORDER ACCURATE BOUND-PRESERVING COMPACT FINITE DIFFERENCE SCHEME FOR SCALAR CONVECTION DIFFUSION EQUATIONS HAO LI, SHUSEN XIE, AND XIANGXIONG ZHANG Abstract We show that the classical

More information

Chapter 1. Introduction

Chapter 1. Introduction Chapter 1 Introduction Many astrophysical scenarios are modeled using the field equations of fluid dynamics. Fluids are generally challenging systems to describe analytically, as they form a nonlinear

More information

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Dedicated to Todd F. Dupont on the occasion of his 65th birthday Yingjie Liu, Chi-Wang Shu and Zhiliang

More information

A class of the fourth order finite volume Hermite weighted essentially non-oscillatory schemes

A class of the fourth order finite volume Hermite weighted essentially non-oscillatory schemes Science in China Series A: Mathematics Aug., 008, Vol. 51, No. 8, 1549 1560 www.scichina.com math.scichina.com www.springerlink.com A class of the fourth order finite volume Hermite weighted essentially

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

[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

Relevant self-assessment exercises: [LIST SELF-ASSESSMENT EXERCISES HERE]

Relevant self-assessment exercises: [LIST SELF-ASSESSMENT EXERCISES HERE] Chapter 6 Finite Volume Methods In the previous chapter we have discussed finite difference methods for the discretization of PDEs. In developing finite difference methods we started from the differential

More information

Recovery-Based A Posteriori Error Estimation

Recovery-Based A Posteriori Error Estimation Recovery-Based A Posteriori Error Estimation Zhiqiang Cai Purdue University Department of Mathematics, Purdue University Slide 1, March 2, 2011 Outline Introduction Diffusion Problems Higher Order Elements

More information

Finite volume method on unstructured grids

Finite volume method on unstructured grids Finite volume method on unstructured grids 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

DISCONTINUOUS GALERKIN METHOD FOR TIME DEPENDENT PROBLEMS: SURVEY AND RECENT DEVELOPMENTS

DISCONTINUOUS GALERKIN METHOD FOR TIME DEPENDENT PROBLEMS: SURVEY AND RECENT DEVELOPMENTS DISCONTINUOUS GALERKIN METHOD FOR TIME DEPENDENT PROBLEMS: SURVEY AND RECENT DEVELOPMENTS CHI-WANG SHU Abstract. In these lectures we give a general survey on discontinuous Galerkin methods for solving

More information

ALTERNATING EVOLUTION DISCONTINUOUS GALERKIN METHODS FOR HAMILTON-JACOBI EQUATIONS

ALTERNATING EVOLUTION DISCONTINUOUS GALERKIN METHODS FOR HAMILTON-JACOBI EQUATIONS ALTERNATING EVOLUTION DISCONTINUOUS GALERKIN METHODS FOR HAMILTON-JACOBI EQUATIONS HAILIANG LIU AND MICHAEL POLLACK Abstract. In this work, we propose a high resolution Alternating Evolution Discontinuous

More information

Fast Sweeping Algorithms for a Class of Hamilton-Jacobi Equations

Fast Sweeping Algorithms for a Class of Hamilton-Jacobi Equations Fast Sweeping Algorithms for a Class of Hamilton-Jacobi Equations Yen-Hsi Richard Tsai, Li-Tien Cheng, Stanley Osher, and Hong-Kai Zhao Abstract We derive a Godunov-type numerical flux for the class of

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

Foliations of hyperbolic space by constant mean curvature surfaces sharing ideal boundary

Foliations of hyperbolic space by constant mean curvature surfaces sharing ideal boundary Foliations of hyperbolic space by constant mean curvature surfaces sharing ideal boundary David Chopp and John A. Velling December 1, 2003 Abstract Let γ be a Jordan curve in S 2, considered as the ideal

More information

A minimum entropy principle of high order schemes for gas dynamics. equations 1. Abstract

A minimum entropy principle of high order schemes for gas dynamics. equations 1. Abstract A minimum entropy principle of high order schemes for gas dynamics equations iangxiong Zhang and Chi-Wang Shu 3 Abstract The entropy solutions of the compressible Euler equations satisfy a minimum principle

More information

A Narrow-Stencil Finite Difference Method for Hamilton-Jacobi-Bellman Equations

A Narrow-Stencil Finite Difference Method for Hamilton-Jacobi-Bellman Equations A Narrow-Stencil Finite Difference Method for Hamilton-Jacobi-Bellman Equations Xiaobing Feng Department of Mathematics The University of Tennessee, Knoxville, U.S.A. Linz, November 23, 2016 Collaborators

More information

Filtered scheme and error estimate for first order Hamilton-Jacobi equations

Filtered scheme and error estimate for first order Hamilton-Jacobi equations and error estimate for first order Hamilton-Jacobi equations Olivier Bokanowski 1 Maurizio Falcone 2 2 1 Laboratoire Jacques-Louis Lions, Université Paris-Diderot (Paris 7) 2 SAPIENZA - Università di Roma

More information

Finite Volume Method

Finite Volume Method Finite Volume Method An Introduction Praveen. C CTFD Division National Aerospace Laboratories Bangalore 560 037 email: praveen@cfdlab.net April 7, 2006 Praveen. C (CTFD, NAL) FVM CMMACS 1 / 65 Outline

More information

AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy

AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy Antony Jameson 1 1 Thomas V. Jones Professor of Engineering Department of Aeronautics and Astronautics Stanford University

More information

NUMERICAL SOLUTION OF HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS

NUMERICAL SOLUTION OF HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS NUMERICAL SOLUTION OF HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS JOHN A. TRANGENSTEIN Department of Mathematics, Duke University Durham, NC 27708-0320 Ш CAMBRIDGE ЩР UNIVERSITY PRESS Contents 1 Introduction

More information

ALGEBRAIC FLUX CORRECTION FOR FINITE ELEMENT DISCRETIZATIONS OF COUPLED SYSTEMS

ALGEBRAIC FLUX CORRECTION FOR FINITE ELEMENT DISCRETIZATIONS OF COUPLED SYSTEMS Int. Conf. on Computational Methods for Coupled Problems in Science and Engineering COUPLED PROBLEMS 2007 M. Papadrakakis, E. Oñate and B. Schrefler (Eds) c CIMNE, Barcelona, 2007 ALGEBRAIC FLUX CORRECTION

More information

Bindel, Fall 2016 Matrix Computations (CS 6210) Notes for

Bindel, Fall 2016 Matrix Computations (CS 6210) Notes for 1 Iteration basics Notes for 2016-11-07 An iterative solver for Ax = b is produces a sequence of approximations x (k) x. We always stop after finitely many steps, based on some convergence criterion, e.g.

More information

Finite difference Hermite WENO schemes for the Hamilton-Jacobi equations 1

Finite difference Hermite WENO schemes for the Hamilton-Jacobi equations 1 Finite difference Hermite WENO schemes for the Hamilton-Jacobi equations Feng Zheng, Chi-Wang Shu 3 and Jianian Qiu 4 Abstract In this paper, a new type of finite difference Hermite weighted essentially

More information

A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations

A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations Khosro Shahbazi 1, Paul F. Fischer 2 and C. Ross Ethier 1 1 University of Toronto and 2 Argonne National

More information

Comparison of cell-centered and node-centered formulations of a high-resolution well-balanced finite volume scheme: application to shallow water flows

Comparison of cell-centered and node-centered formulations of a high-resolution well-balanced finite volume scheme: application to shallow water flows Comparison of cell-centered and node-centered formulations of a high-resolution well-balanced finite volume scheme: application to shallow water flows Dr Argiris I. Delis Dr Ioannis K. Nikolos (TUC) Maria

More information

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws Kilian Cooley 1 Prof. James Baeder 2 1 Department of Mathematics, University of Maryland - College Park 2 Department of Aerospace

More information

An Introduction to the Discontinuous Galerkin Method

An Introduction to the Discontinuous Galerkin Method An Introduction to the Discontinuous Galerkin Method Krzysztof J. Fidkowski Aerospace Computational Design Lab Massachusetts Institute of Technology March 16, 2005 Computational Prototyping Group Seminar

More information

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A. A. I. Peer a,, A. Gopaul a, M. Z. Dauhoo a, M. Bhuruth a, a Department of Mathematics, University of Mauritius, Reduit,

More information

Partial differential equations

Partial differential equations Partial differential equations Many problems in science involve the evolution of quantities not only in time but also in space (this is the most common situation)! We will call partial differential equation

More information

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II Advection / Hyperbolic PDEs Notes In addition to the slides and code examples, my notes on PDEs with the finite-volume method are up online: https://github.com/open-astrophysics-bookshelf/numerical_exercises

More information

The Center for Astrophysical Thermonuclear Flashes. FLASH Hydrodynamics

The Center for Astrophysical Thermonuclear Flashes. FLASH Hydrodynamics The Center for Astrophysical Thermonuclear Flashes FLASH Hydrodynamics Jonathan Dursi (CITA), Alan Calder (FLASH) B. Fryxell, T. Linde, A. Mignone, G. Wiers Many others! Mar 23, 2005 An Advanced Simulation

More information

Fourier analysis for discontinuous Galerkin and related methods. Abstract

Fourier analysis for discontinuous Galerkin and related methods. Abstract Fourier analysis for discontinuous Galerkin and related methods Mengping Zhang and Chi-Wang Shu Abstract In this paper we review a series of recent work on using a Fourier analysis technique to study the

More information

Motivation: Sparse matrices and numerical PDE's

Motivation: Sparse matrices and numerical PDE's Lecture 20: Numerical Linear Algebra #4 Iterative methods and Eigenproblems Outline 1) Motivation: beyond LU for Ax=b A little PDE's and sparse matrices A) Temperature Equation B) Poisson Equation 2) Splitting

More information

Multi-D MHD and B = 0

Multi-D MHD and B = 0 CapSel DivB - 01 Multi-D MHD and B = 0 keppens@rijnh.nl multi-d MHD and MHD wave anisotropies dimensionality > 1 non-trivial B = 0 constraint even if satisfied exactly t = 0: can numerically generate B

More information

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology 7th World Congress on Computational Mechanics

More information

An adaptive mesh redistribution method for nonlinear Hamilton-Jacobi equations in two- and three-dimensions

An adaptive mesh redistribution method for nonlinear Hamilton-Jacobi equations in two- and three-dimensions An adaptive mesh redistribution method for nonlinear Hamilton-Jacobi equations in two- and three-dimensions H.-Z. Tang, Tao Tang and Pingwen Zhang School of Mathematical Sciences, Peking University, Beijing

More information

FDM for wave equations

FDM for wave equations FDM for wave equations Consider the second order wave equation Some properties Existence & Uniqueness Wave speed finite!!! Dependence region Analytical solution in 1D Finite difference discretization Finite

More information

Zonal modelling approach in aerodynamic simulation

Zonal modelling approach in aerodynamic simulation Zonal modelling approach in aerodynamic simulation and Carlos Castro Barcelona Supercomputing Center Technical University of Madrid Outline 1 2 State of the art Proposed strategy 3 Consistency Stability

More information

Finite Volume Schemes: an introduction

Finite Volume Schemes: an introduction Finite Volume Schemes: an introduction First lecture Annamaria Mazzia Dipartimento di Metodi e Modelli Matematici per le Scienze Applicate Università di Padova mazzia@dmsa.unipd.it Scuola di dottorato

More information

YINGJIE LIU, CHI-WANG SHU, EITAN TADMOR, AND MENGPING ZHANG

YINGJIE LIU, CHI-WANG SHU, EITAN TADMOR, AND MENGPING ZHANG CENTRAL DISCONTINUOUS GALERKIN METHODS ON OVERLAPPING CELLS WITH A NON-OSCILLATORY HIERARCHICAL RECONSTRUCTION YINGJIE LIU, CHI-WANG SHU, EITAN TADMOR, AND MENGPING ZHANG Abstract. The central scheme of

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

Computational High Frequency Wave Propagation

Computational High Frequency Wave Propagation Computational High Frequency Wave Propagation Olof Runborg CSC, KTH Isaac Newton Institute Cambridge, February 2007 Olof Runborg (KTH) High-Frequency Waves INI, 2007 1 / 52 Outline 1 Introduction, background

More information

Sung-Ik Sohn and Jun Yong Shin

Sung-Ik Sohn and Jun Yong Shin Commun. Korean Math. Soc. 17 (2002), No. 1, pp. 103 120 A SECOND ORDER UPWIND METHOD FOR LINEAR HYPERBOLIC SYSTEMS Sung-Ik Sohn and Jun Yong Shin Abstract. A second order upwind method for linear hyperbolic

More information

A NUMERICAL STUDY FOR THE PERFORMANCE OF THE RUNGE-KUTTA FINITE DIFFERENCE METHOD BASED ON DIFFERENT NUMERICAL HAMILTONIANS

A NUMERICAL STUDY FOR THE PERFORMANCE OF THE RUNGE-KUTTA FINITE DIFFERENCE METHOD BASED ON DIFFERENT NUMERICAL HAMILTONIANS A NUMERICAL STUDY FOR THE PERFORMANCE OF THE RUNGE-KUTTA FINITE DIFFERENCE METHOD BASED ON DIFFERENT NUMERICAL HAMILTONIANS HASEENA AHMED AND HAILIANG LIU Abstract. High resolution finite difference methods

More information

Riemann Solvers and Numerical Methods for Fluid Dynamics

Riemann Solvers and Numerical Methods for Fluid Dynamics Eleuterio R Toro Riemann Solvers and Numerical Methods for Fluid Dynamics A Practical Introduction With 223 Figures Springer Table of Contents Preface V 1. The Equations of Fluid Dynamics 1 1.1 The Euler

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. ) :545 563 DOI.7/s--443-7 Numerische Mathematik A minimum entropy principle of high order schemes for gas dynamics equations iangxiong Zhang Chi-Wang Shu Received: 7 July / Revised: 5 September

More information

Notes: Outline. Shock formation. Notes: Notes: Shocks in traffic flow

Notes: Outline. Shock formation. Notes: Notes: Shocks in traffic flow Outline Scalar nonlinear conservation laws Traffic flow Shocks and rarefaction waves Burgers equation Rankine-Hugoniot conditions Importance of conservation form Weak solutions Reading: Chapter, 2 R.J.

More information

Anti-diffusive finite difference WENO methods for shallow water with. transport of pollutant

Anti-diffusive finite difference WENO methods for shallow water with. transport of pollutant Anti-diffusive finite difference WENO methods for shallow water with transport of pollutant Zhengfu Xu 1 and Chi-Wang Shu 2 Dedicated to Professor Qun Lin on the occasion of his 70th birthday Abstract

More information

Chp 4: Non-linear Conservation Laws; the Scalar Case. By Prof. Dinshaw S. Balsara

Chp 4: Non-linear Conservation Laws; the Scalar Case. By Prof. Dinshaw S. Balsara Chp 4: Non-linear Conservation Laws; the Scalar Case By Prof. Dinshaw S. Balsara 1 4.1) Introduction We have seen that monotonicity preserving reconstruction and iemann solvers are essential building blocks

More information

A Multi-Dimensional Limiter for Hybrid Grid

A Multi-Dimensional Limiter for Hybrid Grid APCOM & ISCM 11-14 th December, 2013, Singapore A Multi-Dimensional Limiter for Hybrid Grid * H. W. Zheng ¹ 1 State Key Laboratory of High Temperature Gas Dynamics, Institute of Mechanics, Chinese Academy

More information

Discontinuous Galerkin methods Lecture 2

Discontinuous Galerkin methods Lecture 2 y y RMMC 2008 Discontinuous Galerkin methods Lecture 2 1 Jan S Hesthaven Brown University Jan.Hesthaven@Brown.edu y 1 0.75 0.5 0.25 0-0.25-0.5-0.75 y 0.75-0.0028-0.0072-0.0117 0.5-0.0162-0.0207-0.0252

More information

Dedicated to the 70th birthday of Professor Lin Qun

Dedicated to the 70th birthday of Professor Lin Qun Journal of Computational Mathematics, Vol.4, No.3, 6, 39 5. ANTI-DIFFUSIVE FINITE DIFFERENCE WENO METHODS FOR SHALLOW WATER WITH TRANSPORT OF POLLUTANT ) Zhengfu Xu (Department of Mathematics, Pennsylvania

More information

On the Comparison of the Finite Volume and Discontinuous Galerkin Methods

On the Comparison of the Finite Volume and Discontinuous Galerkin Methods Diploma Thesis Institute for Numerical Simulation, TUHH On the Comparison of the Finite Volume and Discontinuous Galerkin Methods Corrected version Katja Baumbach August 17, 2006 Supervisor: Prof. Dr.

More information

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations Semi-Lagrangian Formulations for Linear Advection and Applications to Kinetic Department of Mathematical and Computer Science Colorado School of Mines joint work w/ Chi-Wang Shu Supported by NSF and AFOSR.

More information

HOMOGENIZATION OF METRIC HAMILTON-JACOBI EQUATIONS

HOMOGENIZATION OF METRIC HAMILTON-JACOBI EQUATIONS HOMOGENIZATION OF METRIC HAMILTON-JACOBI EQUATIONS ADAM M. OBERMAN, RYO TAKEI, AND ALEXANDER VLADIMIRSKY Abstract. In this work we provide a novel approach to homogenization for a class of static Hamilton-Jacobi

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

A Very Brief Introduction to Conservation Laws

A Very Brief Introduction to Conservation Laws A Very Brief Introduction to Wen Shen Department of Mathematics, Penn State University Summer REU Tutorial, May 2013 Summer REU Tutorial, May 2013 1 / The derivation of conservation laws A conservation

More information

Local discontinuous Galerkin methods for elliptic problems

Local discontinuous Galerkin methods for elliptic problems COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2002; 18:69 75 [Version: 2000/03/22 v1.0] Local discontinuous Galerkin methods for elliptic problems P. Castillo 1 B. Cockburn

More information

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Romain Teyssier CEA Saclay Romain Teyssier 1 Outline - Euler equations, MHD, waves, hyperbolic

More information

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION ECCOMAS Congress 2016 VII European Congress on Computational Methods in Applied Sciences and Engineering M. Papadrakakis, V. Papadopoulos, G. Stefanou, V. Plevris (eds.) Crete Island, Greece, 5 10 June

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

Non-linear Scalar Equations

Non-linear Scalar Equations Non-linear Scalar Equations Professor Dr. E F Toro Laboratory of Applied Mathematics University of Trento, Italy eleuterio.toro@unitn.it http://www.ing.unitn.it/toro August 24, 2014 1 / 44 Overview Here

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

Entropy stable high order discontinuous Galerkin methods. for hyperbolic conservation laws

Entropy stable high order discontinuous Galerkin methods. for hyperbolic conservation laws Entropy stable high order discontinuous Galerkin methods for hyperbolic conservation laws Chi-Wang Shu Division of Applied Mathematics Brown University Joint work with Tianheng Chen, and with Yong Liu

More information

High-resolution finite volume methods for hyperbolic PDEs on manifolds

High-resolution finite volume methods for hyperbolic PDEs on manifolds High-resolution finite volume methods for hyperbolic PDEs on manifolds Randall J. LeVeque Department of Applied Mathematics University of Washington Supported in part by NSF, DOE Overview High-resolution

More information

A positivity-preserving high order discontinuous Galerkin scheme for convection-diffusion equations

A positivity-preserving high order discontinuous Galerkin scheme for convection-diffusion equations A positivity-preserving high order discontinuous Galerkin scheme for convection-diffusion equations Sashank Srinivasan a, Jonathan Poggie a, Xiangxiong Zhang b, a School of Aeronautics and Astronautics,

More information

A Central Discontinuous Galerkin Method for Hamilton-Jacobi Equations

A Central Discontinuous Galerkin Method for Hamilton-Jacobi Equations J Sci Comput (00) 45: 404 48 DOI 0.007/s095-009-9340-y A Central Discontinuous Galerkin Method for Hamilton-Jacobi Equations Fengyan Li Sergey Yakovlev Received: 6 August 009 / Revised: November 009 /

More information

ENO and WENO schemes. Further topics and time Integration

ENO and WENO schemes. Further topics and time Integration ENO and WENO schemes. Further topics and time Integration Tefa Kaisara CASA Seminar 29 November, 2006 Outline 1 Short review ENO/WENO 2 Further topics Subcell resolution Other building blocks 3 Time Integration

More information

Weighted ENO Schemes

Weighted ENO Schemes Xiaolei Chen Advisor: Prof. Xiaolin Li Department of Applied Mathematics and Statistics Stony Brook University, The State University of New York February 7, 014 1 3 Mapped WENO-Z Scheme 1D Scalar Hyperbolic

More information

Splitting Enables Overcoming the Curse of Dimensionality

Splitting Enables Overcoming the Curse of Dimensionality Splitting Enables Overcoming the Curse of Dimensionality Jerome Darbon Stanley Osher In this short note we briefly outline a new and remarkably fast algorithm for solving a a large class of high dimensional

More information

arxiv: v1 [math.na] 7 Dec 2018

arxiv: v1 [math.na] 7 Dec 2018 A High-Order Scheme for Image Segmentation via a modified Level-Set method Maurizio Falcone Giulio Paolucci Silvia Tozza arxiv:1812.03026v1 [math.na] 7 Dec 2018 December 10, 2018 Abstract In this paper

More information

A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations

A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations Motivation Numerical methods Numerical tests Conclusions A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations Xiaofeng Cai Department of Mathematics

More information

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

More information

Aspects of Multigrid

Aspects of Multigrid Aspects of Multigrid Kees Oosterlee 1,2 1 Delft University of Technology, Delft. 2 CWI, Center for Mathematics and Computer Science, Amsterdam, SIAM Chapter Workshop Day, May 30th 2018 C.W.Oosterlee (CWI)

More information