Jian-Guo Liu 1 and Chi-Wang Shu 2

Size: px
Start display at page:

Download "Jian-Guo Liu 1 and Chi-Wang Shu 2"

Transcription

1 Journal of Computational Pysics 60, (000) doi:0.006/jcp , available online at ttp:// on Jian-Guo Liu and Ci-Wang Su Institute for Pysical Science and Tecnology and Department of Matematics, University of Maryland, College Park, Maryland 074; and Division of Applied Matematics, Brown University, Providence, Rode Island Received June 4, 999; revised January 6, 000 In tis paper we introduce a ig-order discontinuous Galerkin metod for twodimensional incompressible flow in te vorticity stream-function formulation. Te momentum equation is treated explicitly, utilizing te efficiency of te discontinuous Galerkin metod. Te stream function is obtained by a standard Poisson solver using continuous finite elements. Tere is a natural matcing between tese two finite element spaces, since te normal component of te velocity field is continuous across element boundaries. Tis allows for a correct upwinding gluing in te discontinuous Galerkin framework, wile still maintaining total energy conservation wit no numerical dissipation and total enstropy stability. Te metod is efficient for inviscid or ig Reynolds number flows. Optimal error estimates are proved and verified by numerical experiments. c 000 Academic Press Key Words: incompressible flow; discontinuous Galerkin; ig-order accuracy.. INTRODUCTION AND THE SETUP OF THE SCHEME We are interested in solving te following D time-dependent incompressible Euler equations in vorticity stream-function formulation; u n t u 0 given on u (.) Researc supported by NSF Grant DMS Researc supported by ARO Grant DAAG , NSF Grants DMS , ECS , and INT , NASA Langley Grant NAG--070 and Contract NAS wile tis autor was in residence at ICASE, NASA Langley Researc Center, Hampton, VA , and AFOSR Grant F /00 $35.00 Copyrigt c 000 by Academic Press All rigts of reproduction in any form reserved.

2 578 LIU AND SHU were y x. Notice tat te boundary condition, plus te fact tat u n, recovers on te boundary (up to a constant) in a simple connected domain b (.) We are also interested in solving te Navier Stokes equations wit ig Reynolds numbers Re : u t u given on Re u (.3) Te boundary condition is now (.) plus te non-slip type boundary condition: n u b (.4) For simplicity, we only consider te no-flow, no-slip boundary conditions b 0 u b 0 and periodic boundary conditions. We first empasize tat, for Euler equations (.) and ig Reynolds number (Re ) Navier Stokes equations (.3), it is advantageous to treat bot te convective terms and te viscous terms explicitly. Te metods discussed in tis paper are stable under standard CFL conditions. Since te momentum equation (te first equation in (.) and (.3)) is treated explicitly in te discontinuous Galerkin framework, tere is no global mass matrix to invert, unlike conventional finite element metods. Tis makes te metod igly efficient for parallel implementation, see for example [3]. As any finite element metod, our approac as te flexibility for complicated geometry and boundary conditions. Te metod is adapted from te Runge Kutta discontinuous Galerkin metods discussed by Cockburn et al. in a series of papers [7 3, 0]. Te main difficulties in solving incompressible flows are te incompressibility condition and boundary conditions. Te incompressibility condition is global and is tus solved by te standard Poisson solver for te stream function using continuous finite elements. One advantage of our approac is tat tere is no matcing conditions needed for te two finite element spaces for te vorticity and for te stream function. Te incompressibility condition, represented by te stream function, is exactly satisfied pointwise and is naturally matced wit te convective terms in te momentum equation. Te normal velocity u n is automatically continuous along any element boundary, allowing for correct upwinding for te convective terms and still maintaining a total energy conservation and total enstropy stability. Tere is an easy proof for stability, bot in te total enstropy and in te total energy, wic does not depend on te regularity of te exact solutions. For smoot solutions error estimates can be obtained. We use te vorticity stream-function formulation of te Navier Stokes equations. Tis formulation wit te local vorticity boundary condition as been revitalized by te recent work of E and Liu [4, 5, 3]. Te main idea is to use convectively stable time-stepping procedure to overcome te cell Reynolds number constraint, explicit treatment of te viscous terms and te local vorticity boundary condition. Tis results in a decoupling of te

3 HIGH-ORDER DISCONTINUOUS GALERKIN METHOD 579 computation of stream function and vorticity at every time step. Tis metod is very efficient and accurate for moderate to ig Reynolds number flows, as demonstrated in [4, 5, 3]. Our metod, as it stands, can only compute D flows. In 3D, te normal velocity u n is no longer continuous along an element boundary, ence making te metod more complicated to design and to analyze. Similar approaces for te stream-function vorticity formulation, or for te primitive variable formulation, suitable for 3D calculations, are under investigation. We do not advocate our metod for modest or low Reynolds number flows. In suc regime viscous terms sould be treated implicitly for efficiency. Tis is a muc more callenging task in terms of space matcing caracterized by te Babu ska Brezzi Ladyzenskaja condition, projection type metods, and global vorticity boundary conditions; see, for example [4, 7 9, 5, 6, 8] etc. We remark tat te only problem of our metod for modest or low Reynolds number flows is te small time step dictated by te stability of te explicit time discretization. Of course, if te objective is to resolve te full viscous effect, ence a small time step is justified for accuracy, ten it is still adequate to use our metod. For convection-dominated flows, as we investigate in tis paper, we mention te work of Bell et al. [] for second-order Godunov-type upwinding metods; see also Levy and Tadmor [] and E and Su [6]. Tis is still an active field for researc. We now describe te setup of te sceme. We start wit a triangulation of te domain, consisting of polygons of maximum size (diameter), and te following two approximation spaces V k : K P k K K W k 0 V k C 0 (.5) were P k K is te set of all polynomials of degree at most k on te cell K. For te Euler equations (.), te numerical metod is defined as follows: find V k and W0 k, suc tat t K u K e K u n e 0 V k (.6) W0 k (.7) wit te velocity field obtained from te stream function by u (.8) Here is te usual integration over eiter te wole domain or a subdomain denoted by a subscript; similarly for te L norm. Notice tat te normal velocity u n is continuous across any element boundary e, but bot te solution and te test function are discontinuous tere. We take te values of te test function from witin te element K denoted by. Te solution at te edge is taken as a single-valued flux, wic can be eiter a central or an upwind-biased average. For example, te central flux is defined by (.9) were is te value of on te edge e from outside K, te complete upwind flux is

4 580 LIU AND SHU defined by if u n 0 if u n 0 (.0) and te Lax Friedrics upwind biased flux is defined by u n [u n ] (.) were is te maximum of u n eiter locally (local Lax Friedrics) or globally (global Lax Friedrics). We remark tat, for general boundary conditions (.), te space W0 k in (.5) sould be modified to take te boundary value into consideration. Moreover, additional pysical vorticity boundary condition for any inlet sould be given. Navier Stokes equations (.3) can be andled in a similar way, wit te additional viscous terms treated by te local discontinuous Galerkin tecnique in [3], and wit a local vorticity boundary condition in [4]. Te details are left to Section 3. Section is devoted to te discussion of stability and error estimates for te Euler equations. Accuracy ceck and numerical examples are given in Section 4. Concluding remarks are given in Section 5.. STABILITY AND ERROR ESTIMATES FOR THE EULER EQUATIONS For stability analysis, we take te test function in (.6), obtaining d dt K u K e K u n e 0 were we ave used te exact incompressibility condition satisfied by u for te second term. Performing an integration by parts for te second term, we obtain d dt K e K u n e 0 Now, using te fact tat [ ] [ ] were [ ] we obtain d dt K e K u n e e K u n[ ] e 0 Notice tat te second term is of opposite sign for adjacent elements saring a common edge e, ence it becomes zero after summing over all te elements K (using te no-flow

5 HIGH-ORDER DISCONTINUOUS GALERKIN METHOD 58 boundary condition on te pysical boundary or periodic boundary conditions). Te tird term is te numerical dissipation: wen is taken as te central flux (.9), te tird term is exactly zero; for te upwind flux (.0), te tird term becomes a positive quantity 4 e K u n [ ] e (.) wic is te total enstropy dissipation. Te effect of tis is to control te size of te jump across te element interface and essentially gluing te solution tere. Oter upwindbiased fluxes suc as te Lax Friedrics flux (.) would produce a positive term similar to tat of te total enstropy dissipation. For smoot flows tese jumps are of te order O k witin te truncation error of te sceme. We tus obtain te enstropy inequality d dt 0 (.) wic becomes an equality if te central flux (.9) is used. Te stability for te velocity field is now straigtforward: we take obtain in (.7) to C by te Poincare inequality, wic implies u C (.3) Indeed, we can obtain a total energy conservation troug te following arguments. Taking in (.6), we obtain t K u K e K u n e 0 Now te second term is zero since u 0. Te tird term vanises after summing over all elements since is continuous. Finally, noticing tat t we obtain te conservation of energy d dt d dt u d dt u 0 (.4) even for a upwind flux. Tus tere is no numerical dissipation for te energy. We remark tat te stability proof above for te total energy and total enstropy does not need any ypoteses on te regularity of te solution or te mes. We now turn to te error estimates. For tese we would need to assume tat te solution is regular ( H k for k ) and te mes is quasi-uniform. Conceptionally, since tis is a finite element metod, te exact solution of te PDE satisfies te sceme exactly. As

6 58 LIU AND SHU usual, we define te two projection operators: P is te standard L projection into te space V k ; and is te standard projection into W k 0 : Denote te error functions by 0 W k 0 and teir projections by P P We first obtain a control of in terms of, W k 0 from te sceme (.7) and te fact tat te exact solution also satisfies (.7). Now, taking, we obtain wic gives C Tis leads to a bound for te velocity field u u Since bot te numerical solution and te exact solution satisfy (.6), C (.5) t K u u K e K u n u n e 0 V k (.6) Take. Te second term becomes u u K u u K u K u P K (.7) Noticing tat u u is exactly divergence free, we may perform integration by parts to te first term on te rigt side of (.7) to obtain u u K u u K e K u u n e

7 HIGH-ORDER DISCONTINUOUS GALERKIN METHOD 583 Te second term on te rigt side of (.7) is a complete derivative and ence can be integrated to give a pure boundary term u K e K u n e Plugging all tese into (.6) wit, and collecting boundary terms, we obtain t K u u K u P K were te boundary terms e K I e 0 I e u u n e u u n ˆ n ˆ u n e e u nˆ P e e u n u n e Using te stability analysis in (.), we are left wit d dt K u u K u P K e K u nˆ P e (.8) Assuming for te moment u C (.9) we can first estimate te boundary term, using te fact tat te mes is quasi-uniform: K e K u nˆ P e K e K C [P ] e ˆ e C K e K [P ] e Using te above inequality togeter wit (.5) and (.8), we now obtain (wit te regularity assumption H k ) d dt C P H K e K [P ] e Here we understand te norms as a summation of te same norm on eac K Using te standard interpolation teory [6], we obtain d dt C C k wic yields C k

8 584 LIU AND SHU Togeter wit (.5), we ave Using an inverse inequality, we ave u u C k (.0) u u C k wit te assumption k, tis justifies te a priori assumption (.9). Te estimate (.0) is optimal in terms of te space W0 k, wic is important since te main cost for te sceme is in te Poisson solver in W0 k. Te vorticity estimate in (.0) is, owever, suboptimal wit respect to te space V k.ifw eu se W k 0 instead for te stream function and use te upwind flux (.0), ten a more detailed analysis will produce an order O k for te error in ; see [3, ] for details. However, we do not recommend tis coice in practice, as te increase of alf-order accuracy is obtained wit te price of one degree iger polynomials in te most expensive part of te algoritm, namely te Poisson solver. In our numerical experiments in Section 5, we observe tat close to k t order of accuracy is generally acieved wen kt degree polynomials are used in bot te discontinuous space for and te continuous space for, bot for uniform and for non-uniform meses. 3. THE SCHEME FOR THE NAVIER STOKES EQUATIONS For te Navier Stokes equations (.3), tere are two additional ingredients tat require our attention:. Te viscous terms cannot be directly implemented in te discontinuous space V k. Instead, te stress tensor is first obtained locally using te same discontinuous Galerkin framework.. Vorticity boundary values are not known pysically. We obtain vorticity boundary conditions locally from te stream function using te kinematic relation in (.3). We use te same finite element spaces V k and W 0 k defined in (.5) for te vorticity and stream function, respectively. Denote by V0 k k te subspace of V wit zero value at te boundary. Let W k be te finite element space extended from W 0 k wit general non-zero values at te boundary. Te numerical metod now becomes t K u K e K u n e K e K n e V k 0 (3.) Notice tat te test function is now in V0 k, (see [3]), and te stress tensor V k obtained from te vorticity by te same discontinuous Galerkin framework: is Re v K v K e K v n e v V k (3.)

9 HIGH-ORDER DISCONTINUOUS GALERKIN METHOD 585 We remark tat (3.) gives a local solution for te stress tensor, given te vorticity ; neiter a global inversion nor a global storage is needed. Te fluxes and can be cosen as central averages (3.3) or better still, as alternate one-sided fluxes, namely, at eac edge e wit an arbitrarily fixed orientation, one of and is taken as te left value and te oter taken as te rigt value. It can be verified tat, for k 0 and a rectangular triangulation, te central fluxes (3.3) produce a wide stencil central approximation to te second derivatives ( i, i and i are used for approximating xx ), wile te alternate one-sided fluxes produce a compact stencil central approximation ( i, i and i are used for approximating xx ). Also, numerical and teoretical evidence sow tat te alternate one-sided fluxes produce more accurate results [3]. In tis paper we use only te alternate one-sided fluxes for te viscous terms. For periodic boundary conditions, te sceme is now well defined. For te non-periodic case, we advocate using te approac in [3]. Altoug te basic idea in computing te vorticity boundary condition is similar to tat of te standard finite element metod in [3], tere is some difference due to te fact tat te approximation space for te vorticity in te discontinuous Galerkin metod is large tan tat in a continuous finite element metod. We outline te detailed steps ere for completeness. n Since (3.) is treated explicitly and te local discontinuous Galerkin metod is used, in te interior elements can be directly computed. However, for te boundary elements, we n need to compute in tree steps. First, for all test functions V0 k, we can compute te inner product n K directly from (3.) tanks to te explicit time stepping. Second, since W0 k k is a subspace of V0, from (3.), te inner products, n K for all W0 k as already been computed. Tis is sufficient for obtaining te stream function from n n n W k 0 (3.4) wit te velocity field obtained from te stream function by u n n (3.5) Finally, we are able to compute te vorticity n at boundary elements directly from n n for all te test functions V k tanks to te fact tat n as already been computed. For problems wit periodic boundary conditions, te formulation above admits te following stability results, d dt 0 (3.6)

10 586 LIU AND SHU wic in turn implies stability for te velocity field (.3). Te proof is similar to te Euler case; see [3] for te details. Wit te vorticity boundary condition mentioned above, we are unable to obtain a stability estimate. However, tis type of vorticity boundary treatment for conventional finite difference and finite elements is stable; see [5, 3]. Witout suc a stability estimate, tere is an issue about te uniqueness of te solution to te metod of lines discretization wit te boundary condition treatment mentioned above. However, te full discretized version works well in te numerical experiments; see Example of te next section. 4. ACCURACY CHECK AND NUMERICAL EXAMPLES We implement our metod on triangulations based on rectangles. Wen a P k Q k result is referred to it is obtained wit P k elements for te vorticity and Q k elements for te stream function, were Q k refers to te space of tensor products of D polynomials of degree up to k. We remark tat some of te teoretical results in previous sections do not apply for tese coices of mes and spaces. For example, Q k elements sould also be used for te vorticity for te exact energy conservation (.4) to old; owever, to save cost we use P k elements for te vorticity instead. Energy stability (.3) and enstropy stability (.) still old in tis case. We ave used bot te upwind flux (.0) and te (global) Lax Friedrics flux (.) for te calculations; owever, we will only sow te results obtained wit te Lax Friedrics flux to save space. Te time discretization is by te tird-order positive Runge Kutta metods in [7]. EXAMPLE. Tis example is used to ceck te accuracy of our scemes, bot for te Euler equations (.) and for te Navier Stokes equations (.3) wit Re 00, for bot te periodic and te Diriclet boundary conditions, and wit bot a uniform mes and a non-uniform mes. Te Diriclet boundary conditions use te data taken from te exact solution. Te non-uniform mes is obtained by alternating between 0 9 x and x for te mes sizes in te x direction; similarly for te mes sizes in te y direction. Te initial condition is taken as x y 0 sin x sin y (4.) wic was used in [5]. Te exact solution for tis case is known: x y t sin x sin y e t Re (4.) We use te domain [0 ] [0 ] for te periodic case and [0 ] [0 ] for te Diriclet case and compute te errors at t for te periodic case and at t for te Diriclet case. We list in Tables 5. (uniform mes) and 5. (non-uniform mes) te L and L errors, at t, measured at te center of te cells, for te periodic boundary conditions. Tables 5.3 (uniform mes) and 5.4 (non-uniform mes) contain te results wit te Diriclet boundary conditions at t. We remark tat, because of te difference in te sizes of te domains of te periodic and Diriclet cases, te errors wit te same number of cells are of different values, but te orders of accuracy are similar. We ave also computed te errors of te relevant derivatives at te centers of te cells, wic elp in giving us truly L errors trougout te domain. We will not sow tem to save space. To get an idea about te effect of te viscous terms on te time step restriction and CPU time, we point out tat for P 3 Q 3

11 HIGH-ORDER DISCONTINUOUS GALERKIN METHOD 587 TABLE 5. Accuracy Test, Uniform Meses, Periodic Boundary Conditions Euler Navier Stokes wit Re 00 Mes L error order L error order L error order L error order P Q E-03.80E E-03.8E-0 3.0E E E E E E E E E E E E P Q 6 6.6E-04.58E-03.06E E E E E E E E E E E E E E P 3 Q E-05.3E E-05.33E E E E E E E E E E E E E wit a 6 mes, te Navier Stokes code takes about twice as many time steps and about tree times as muc CPU time as te Euler code to reac te same pysical time. We ave also made several runs were te periodic and non-periodic cases ave te same pysical domain, mes, and pysical time. Te errors are very close, indicating tat te boundary effect on accuracy is small. TABLE 5. Accuracy Test, Non-uniform Meses, Periodic Boundary Conditions Euler Navier Stokes wit Re 00 Mes L error order L error order L error order L error order P Q E-03.85E E-03.80E E E E E E E E E E E E E-04.4 P Q E-04.77E E-04.8E E E E E E E E E E E E E P 3 Q E E-04.0E E E E E E E E E E E E E E

12 588 LIU AND SHU TABLE 5.3 Accuracy Test, Uniform Meses, Diriclet Boundary Conditions Euler Navier Stokes wit Re 00 Mes L error order L error order L error order L error order P Q 6 5.9E-04.3E E-04.3E E E E E E E E E E E E E-06. P Q E-05.57E-04.5E E E E E E E E E E E E E E-07.8 P 3 Q E-06.58E E-06.53E E E E E E E E E E E E E We can clearly see from tese tables tat close to k t order of accuracy is generally acieved wen kt degree polynomials are used in bot te discontinuous space for and for te Poisson solver, bot for te uniform and for te non-uniform meses. EXAMPLE. Te double sear layer problem taken from []. We solve te Euler equation (.) in te domain [0 ] [0 ] wit a periodic boundary condition and an initial TABLE 5.4 Accuracy Test, Non-uniform Meses, Diriclet Boundary Conditions Euler Navier Stokes wit Re 00 Mes L error order L error order L error order L error order P Q 6.E E E E E E E E E E E E E E E E-05.3 P Q E E-04.98E E E E E E E E E E E E E E P 3 Q E-06.49E E-06.8E E E E E E E E E E E E E

13 HIGH-ORDER DISCONTINUOUS GALERKIN METHOD 589 condition x y 0 cos x cos x sec y y sec 3 y y (4.3) were we take 5 and Te solution quickly develops into roll-ups wit smaller and smaller scales, so on any fixed grid te full resolution is lost eventually. We use fixed uniform meses of and 8 8 rectangles and perform te calculation up to t 8. We plot te time istory of te total energy (square of te L norm of velocity u) and te total enstropy (square of te L norm of vorticity ) in Fig. 5., as well as contours of te vorticity at t 6 in Fig. 5. and at t 8 in Fig. 5.3 to sow te resolution. We can see from Fig. 5. tat te numerical dissipation decreases rougly in te order of P Q -64, P Q -8, P Q -64, P 3 Q 3-64, P Q -8, and P 3 Q 3-8. We remark tat due to te dissipation from Runge Kutta time discretization and te coice of finite element spaces, te total energy in Fig. 5., left, decays rater tan stays at a constant as proved in (.4). Te decay rate of total energy or total enstropy in Fig. 5. is an indication of te actual resolution of te scemes for te given mes. Te iger-order metods ave better resolutions and in general te resolution is quite good judging from te contours. We remark tat wen te numerical viscosity becomes too small wit iger-order metods, since te scemes are linear, numerical oscillations are unavoidable wen resolution to sarp fronts is lost, leading to instability. Tis is common for all linear scemes. However, te discontinuous Galerkin metod we use ere is able to get stable solutions for muc sarper fronts wit te same mes tan central type finite difference or finite element metods. FIG. 5.. Te time istory of energy (square of te L norm of te velocity u) and total enstropy (square of te L norm of vorticity ). P Q wit 64 mes in solid line, P Q wit 8 mes in dased line, P Q wit 64 mes in das dot line, P Q wit 8 mes in dotted line, P 3 Q 3 wit 64 mes in long dased line, and P 3 Q 3 wit 8 mes in das dot dot line.

14 590 LIU AND SHU FIG. 5.. Contour of vorticity at t 6. Tirty equally spaced contour lines between 4 9 and 4 9. Left: results wit 64 mes; rigt: results wit 8 mes. Top: P Q ; middle: P Q, bottom: P 3 Q 3.

15 HIGH-ORDER DISCONTINUOUS GALERKIN METHOD 59 FIG Contour of vorticity at t 8. Tirty equally spaced contour lines between 4 9 and 4 9. Left: results wit 64 mes; rigt: results wit 8 mes. Top: P Q ; middle: P Q, bottom: P 3 Q 3.

16 59 LIU AND SHU FIG Contour of vorticity at t 8. Tirty equally spaced contour lines between 5 and 5. Left: results of te tin sear layer, 50, Re , P Q metod wit a 56 mes; rigt: results of te ultra tin sear layer, 00, Re 0 000, P Q metod wit a 5 mes. In [], sear layers are distinguised between tick and tin ones, wit te latter producing spurious vortices. Te result above corresponds to te tick sear layer in []. We sow in Fig. 5.4, left, a tin sear layer case as defined in [], corresponding to 50 wit a Reynolds number Re , simulated wit a uniform rectangular mes of cells wit P Q metod at t 8. Notice tat tis is at a muc iger Reynolds number tan tat used in [], were te Reynolds number is Re 000 and a second-order Godunov upwind projection metod wit points produces spurious non-pysical vortices. We also compute a ultratin sear layer wit 00 wit Reynolds number Re Te simulation result wit a uniform rectangular mes of 5 5 cells wit P Q metod at t 8 is sown in Fig. 5.4, rigt. More extensive numerical resolution study for tis example can be found in [4], were we explore torougly te resolution bot for te tick and for te tin sear layers. In [4] we also plot te time istory for te energy and enstropy during a mes refinement to sow tat te pysical viscosity is dominating te numerics at suc ig Reynolds numbers, according to te decay of energy and enstropy. Tis indicates tat te built-in numerical viscosity of te metods is very small. We refer te reader to [4] for details. For a comparison wit nonlinear ENO scemes, we refer to [6]. EXAMPLE 3. Te vortex patc problem. We solve te Euler equation (.) in [0 ] [0 ] wit te initial condition x y 0 x x 0 oterwise 3 4 y y (4.4) and periodic boundary conditions. Te contour plots of vorticity, wit 30 equally spaced contour lines between and, are given in Fig. 5.5 for t 5 and in Fig. 5.6 for t 0. We can see tat te sceme gives stable results for all runs, and iger-order scemes give better resolutions for vorticity.

17 HIGH-ORDER DISCONTINUOUS GALERKIN METHOD 593 FIG Contour of vorticity at t 5. Tirty equally spaced contour lines between and. Left: results wit 64 mes; rigt: results wit 8 mes. Top: P Q ; middle: P Q, bottom: P 3 Q 3.

18 594 LIU AND SHU FIG Contour of vorticity at t 0. Tirty equally spaced contour lines between and. Left: results wit 64 mes; rigt: results wit 8 mes. Top: P Q ; middle: P Q, bottom: P 3 Q 3.

19 HIGH-ORDER DISCONTINUOUS GALERKIN METHOD CONCLUDING REMARKS We ave developed a ig order discontinuous Galerkin metod for te two-dimensional incompressible Euler and Navier Stokes equations in te vorticity stream-function formulation, coupled wit a standard continuous finite element solution of te Poisson equation for te stream function. A natural matcing between te two finite element spaces allows us to obtain total energy conservation and total enstropy stability. Numerical examples are sown to demonstrate te accuracy and resolution of te metods. ACKNOWLEDGMENTS Tis work was initialized wen bot autors were visiting te Mittag-Leffler Institute in Sweden. We tank te faculty and staff tere for teir warm ospitality. REFERENCES. J. Bell, P. Colella, and H. Glaz, A second order projection metod for te incompressible Navier Stokes equations, J. Comput. Pys. 85, 57 (989).. D. L. Brown and M. Minion, Performances of under-resolved two dimensional incompressible flow simulations, J. Comput. Pys., 65 (995). 3. R. Biswas, K. D. Devine, and J. Flaerty, Parallel, adaptive finite element metods for conservation laws, Appl. Numer. Mat. 4, 55 (994). 4. A. Corin, A numerical metod for solving incompressible viscous flow problems, J. Comput. Pys., (967). 5. A. Corin, Numerical solution of te Navier Stokes equations, Mat. Comp., 745 (968). 6. P. Ciarlet, Te Finite Element Metod for Elliptic Problems (Nort-Holland, Amsterdam, 975). 7. B. Cockburn, An introduction to te discontinuous Galerkin metod for convection-dominated problems, in Advanced Numerical Approximation of Nonlinear Hyperbolic Equations, edited by B. Cockburn, C. Jonson, C.-W. Su, and E. Tadmor, Lecture Notes in Matematics, Vol. 697 (Springer-Varlag, Berlin/New York, 998). 8. B. Cockburn and C.-W. Su, Te Runge Kutta local projection P -discontinuous Galerkin metod for scalar conservation laws, Mat. Model. Numer. Anal. 5, 337 (99). 9. B. Cockburn and C.-W. Su, TVB Runge Kutta local projection discontinuous Galerkin finite element metod for scalar conservation laws. II. General framework, Mat. Comp. 5, 4 (989). 0. B. Cockburn, S.-Y. Lin, and C.-W. Su, TVB Runge Kutta local projection discontinuous Galerkin finite element metod for conservation laws. III. One dimensional systems, J. Comput. Pys. 84, 90 (989).. B. Cockburn, S. Hou, and C.-W. Su, TVB Runge Kutta local projection discontinuous Galerkin finite element metod for conservation laws. IV. Te multidimensional case, Mat. Comp. 54, 545 (990).. B. Cockburn and C.-W. Su, TVB Runge Kutta local projection discontinuous Galerkin finite element metod for scalar conservation laws. V. Multidimensional systems, J. Comput. Pys. 4, 99 (998). 3. B. Cockburn and C.-W. Su, Te local discontinuous Galerkin metod for time-dependent convection diffusion systems, SIAM J. Numer. Anal. 35, 440 (998). 4. W. E and J.-G. Liu, Vorticity boundary condition and related issues for finite difference scemes, J. Comput. Pys. 4, 368 (996). 5. W. E and J.-G. Liu, Essentially compact scemes for unsteady viscous incompressible flows, J. Comput. Pys. 6, (996). 6. W. E and C.-W. Su, A numerical resolution study of ig order essentially nonoscillatory scemes applied to incompressible flow, J. Comput. Pys. 0, 39 (994). 7. V. Girault and P. A. Raviat, Finite Element Metods for Navier Stokes Equations, Teory and Algoritms (Springer-Verlag, Berlin, 986).

20 596 LIU AND SHU 8. P. M. Greso, Some interesting issues in incompressible fluid dynamics, bot in te continuum and in numerical simulation, Adv. Appl. Mec. 8, 45 (99). 9. M. Gunzburger, Finite Element Metods for Viscous Incompressible Flows (Academic Press, Boston, 989). 0. G. Jiang and C.-W. Su, On cell entropy inequality for discontinuous Galerkin metods, Mat. Comp. 6, 53 (994).. C. Jonson and J. Pitkäranta, An analysis of te discontinuous Galerkin metod for a scalar yperbolic equation, Mat. Comp. 46, (986).. D. Levy and E. Tadmor, Non-oscillatory central scemes for te incompressible -D Euler equations, Mat. Res. Lett. 4, (997). 3. J.-G. Liu and W. E, Simple finite element metod in vorticity formulation for incompressible flows, Mat. Comp., to appear. 4. J.-G. Liu and C.-W. Su, A numerical example on te performance of ig order discontinuous Galerkin metod for D incompressible flows, in Discontinuous Galerkin Metods: Teory, Computation and Applications, B. Cockburn, G. Karniadakis, and C.-W. Su, Editors, Lecture Notes in Computational Science and Engineering, volume, 000, Springer-Verlag, Berlin/New York, pp O. A. Pironneau, Finite Element Metods for Fluids (Wiley, New York, 989). 6. L. Quartapelle, Numerical Solution of te Incompressible Navier Stokes Equations (Birkäuser, Berlin, 993). 7. C.-W. Su and S. Oser, Efficient implementation of essentially non-oscillatory sock-capturing scemes, J. Comput. Pys. 77, 439 (988). 8. R. Temam, Navier Stokes Equations, Teory and Numerical Analysis (Nort-Holland, New York, 979).

EXTENSION OF A POSTPROCESSING TECHNIQUE FOR THE DISCONTINUOUS GALERKIN METHOD FOR HYPERBOLIC EQUATIONS WITH APPLICATION TO AN AEROACOUSTIC PROBLEM

EXTENSION OF A POSTPROCESSING TECHNIQUE FOR THE DISCONTINUOUS GALERKIN METHOD FOR HYPERBOLIC EQUATIONS WITH APPLICATION TO AN AEROACOUSTIC PROBLEM SIAM J. SCI. COMPUT. Vol. 26, No. 3, pp. 821 843 c 2005 Society for Industrial and Applied Matematics ETENSION OF A POSTPROCESSING TECHNIQUE FOR THE DISCONTINUOUS GALERKIN METHOD FOR HYPERBOLIC EQUATIONS

More information

1. Introduction. We consider the model problem: seeking an unknown function u satisfying

1. Introduction. We consider the model problem: seeking an unknown function u satisfying A DISCONTINUOUS LEAST-SQUARES FINITE ELEMENT METHOD FOR SECOND ORDER ELLIPTIC EQUATIONS XIU YE AND SHANGYOU ZHANG Abstract In tis paper, a discontinuous least-squares (DLS) finite element metod is introduced

More information

Stability properties of a family of chock capturing methods for hyperbolic conservation laws

Stability properties of a family of chock capturing methods for hyperbolic conservation laws Proceedings of te 3rd IASME/WSEAS Int. Conf. on FLUID DYNAMICS & AERODYNAMICS, Corfu, Greece, August 0-, 005 (pp48-5) Stability properties of a family of cock capturing metods for yperbolic conservation

More information

FEM solution of the ψ-ω equations with explicit viscous diffusion 1

FEM solution of the ψ-ω equations with explicit viscous diffusion 1 FEM solution of te ψ-ω equations wit explicit viscous diffusion J.-L. Guermond and L. Quartapelle 3 Abstract. Tis paper describes a variational formulation for solving te D time-dependent incompressible

More information

Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for Second-Order Elliptic Problems

Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for Second-Order Elliptic Problems Applied Matematics, 06, 7, 74-8 ttp://wwwscirporg/journal/am ISSN Online: 5-7393 ISSN Print: 5-7385 Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for

More information

Superconvergence of energy-conserving discontinuous Galerkin methods for. linear hyperbolic equations. Abstract

Superconvergence of energy-conserving discontinuous Galerkin methods for. linear hyperbolic equations. Abstract Superconvergence of energy-conserving discontinuous Galerkin metods for linear yperbolic equations Yong Liu, Ci-Wang Su and Mengping Zang 3 Abstract In tis paper, we study superconvergence properties of

More information

Arbitrary order exactly divergence-free central discontinuous Galerkin methods for ideal MHD equations

Arbitrary order exactly divergence-free central discontinuous Galerkin methods for ideal MHD equations Arbitrary order exactly divergence-free central discontinuous Galerkin metods for ideal MHD equations Fengyan Li, Liwei Xu Department of Matematical Sciences, Rensselaer Polytecnic Institute, Troy, NY

More information

Fourier Type Super Convergence Study on DDGIC and Symmetric DDG Methods

Fourier Type Super Convergence Study on DDGIC and Symmetric DDG Methods DOI 0.007/s095-07-048- Fourier Type Super Convergence Study on DDGIC and Symmetric DDG Metods Mengping Zang Jue Yan Received: 7 December 06 / Revised: 7 April 07 / Accepted: April 07 Springer Science+Business

More information

ERROR BOUNDS FOR THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BRADLEY J. LUCIER*

ERROR BOUNDS FOR THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BRADLEY J. LUCIER* EO BOUNDS FO THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BADLEY J. LUCIE* Abstract. Te expected error in L ) attimet for Glimm s sceme wen applied to a scalar conservation law is bounded by + 2 ) ) /2 T

More information

New Streamfunction Approach for Magnetohydrodynamics

New Streamfunction Approach for Magnetohydrodynamics New Streamfunction Approac for Magnetoydrodynamics Kab Seo Kang Brooaven National Laboratory, Computational Science Center, Building 63, Room, Upton NY 973, USA. sang@bnl.gov Summary. We apply te finite

More information

LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS

LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS SIAM J. NUMER. ANAL. c 998 Society for Industrial Applied Matematics Vol. 35, No., pp. 393 405, February 998 00 LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS YANZHAO CAO

More information

A New Fifth Order Finite Difference WENO Scheme for Hamilton-Jacobi Equations

A New Fifth Order Finite Difference WENO Scheme for Hamilton-Jacobi Equations A New Fift Order Finite Difference WENO Sceme for Hamilton-Jacobi Equations Jun Zu, 1 Jianxian Qiu 1 College of Science, Nanjing University of Aeronautics and Astronautics, Nanjing, Jiangsu 10016, People

More information

A method of Lagrange Galerkin of second order in time. Une méthode de Lagrange Galerkin d ordre deux en temps

A method of Lagrange Galerkin of second order in time. Une méthode de Lagrange Galerkin d ordre deux en temps A metod of Lagrange Galerkin of second order in time Une métode de Lagrange Galerkin d ordre deux en temps Jocelyn Étienne a a DAMTP, University of Cambridge, Wilberforce Road, Cambridge CB3 0WA, Great-Britain.

More information

arxiv: v1 [physics.flu-dyn] 3 Jun 2015

arxiv: v1 [physics.flu-dyn] 3 Jun 2015 A Convective-like Energy-Stable Open Boundary Condition for Simulations of Incompressible Flows arxiv:156.132v1 [pysics.flu-dyn] 3 Jun 215 S. Dong Center for Computational & Applied Matematics Department

More information

A Demonstration of the Advantage of Asymptotic Preserving Schemes over Standard Finite Volume Schemes

A Demonstration of the Advantage of Asymptotic Preserving Schemes over Standard Finite Volume Schemes A Demonstration of te Advantage of Asymptotic Preserving Scemes over Standard Finite Volume Scemes Jocen Scütz Berict Nr. 366 Juni 213 Key words: conservation laws, asymptotic metods, finite volume metods,

More information

Chapter 5 FINITE DIFFERENCE METHOD (FDM)

Chapter 5 FINITE DIFFERENCE METHOD (FDM) MEE7 Computer Modeling Tecniques in Engineering Capter 5 FINITE DIFFERENCE METHOD (FDM) 5. Introduction to FDM Te finite difference tecniques are based upon approximations wic permit replacing differential

More information

Discontinuous Galerkin Methods for Relativistic Vlasov-Maxwell System

Discontinuous Galerkin Methods for Relativistic Vlasov-Maxwell System Discontinuous Galerkin Metods for Relativistic Vlasov-Maxwell System He Yang and Fengyan Li December 1, 16 Abstract e relativistic Vlasov-Maxwell (RVM) system is a kinetic model tat describes te dynamics

More information

Entropy and the numerical integration of conservation laws

Entropy and the numerical integration of conservation laws Pysics Procedia Pysics Procedia 00 2011) 1 28 Entropy and te numerical integration of conservation laws Gabriella Puppo Dipartimento di Matematica, Politecnico di Torino Italy) Matteo Semplice Dipartimento

More information

A First-Order System Approach for Diffusion Equation. I. Second-Order Residual-Distribution Schemes

A First-Order System Approach for Diffusion Equation. I. Second-Order Residual-Distribution Schemes A First-Order System Approac for Diffusion Equation. I. Second-Order Residual-Distribution Scemes Hiroaki Nisikawa W. M. Keck Foundation Laboratory for Computational Fluid Dynamics, Department of Aerospace

More information

lecture 26: Richardson extrapolation

lecture 26: Richardson extrapolation 43 lecture 26: Ricardson extrapolation 35 Ricardson extrapolation, Romberg integration Trougout numerical analysis, one encounters procedures tat apply some simple approximation (eg, linear interpolation)

More information

Preconditioning in H(div) and Applications

Preconditioning in H(div) and Applications 1 Preconditioning in H(div) and Applications Douglas N. Arnold 1, Ricard S. Falk 2 and Ragnar Winter 3 4 Abstract. Summarizing te work of [AFW97], we sow ow to construct preconditioners using domain decomposition

More information

A Hybridizable Discontinuous Galerkin Method for the Compressible Euler and Navier-Stokes Equations

A Hybridizable Discontinuous Galerkin Method for the Compressible Euler and Navier-Stokes Equations A Hybridizable Discontinuous Galerkin Metod for te Compressible Euler and Navier-Stokes Equations J. Peraire and N. C. Nguyen Massacusetts Institute of Tecnology, Cambridge, MA 02139, USA B. Cockburn University

More information

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx.

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx. Capter 2 Integrals as sums and derivatives as differences We now switc to te simplest metods for integrating or differentiating a function from its function samples. A careful study of Taylor expansions

More information

The Laplace equation, cylindrically or spherically symmetric case

The Laplace equation, cylindrically or spherically symmetric case Numerisce Metoden II, 7 4, und Übungen, 7 5 Course Notes, Summer Term 7 Some material and exercises Te Laplace equation, cylindrically or sperically symmetric case Electric and gravitational potential,

More information

A Numerical Scheme for Particle-Laden Thin Film Flow in Two Dimensions

A Numerical Scheme for Particle-Laden Thin Film Flow in Two Dimensions A Numerical Sceme for Particle-Laden Tin Film Flow in Two Dimensions Mattew R. Mata a,, Andrea L. Bertozzi a a Department of Matematics, University of California Los Angeles, 520 Portola Plaza, Los Angeles,

More information

Explicit Hyperbolic Reconstructed Discontinuous Galerkin Methods for Time-Dependent Problems

Explicit Hyperbolic Reconstructed Discontinuous Galerkin Methods for Time-Dependent Problems AIAA AVIATION Forum June 25-29 218 Atlanta Georgia 218 Fluid Dynamics Conference 1.2514/6.218-427 Explicit Hyperbolic Reconstructed Discontinuous Galerkin Metods for Time-Dependent Problems Jialin Lou

More information

A Polynomial Adaptive LCP Scheme for Viscous Compressible Flows

A Polynomial Adaptive LCP Scheme for Viscous Compressible Flows A Polynomial Adaptive LCP Sceme for Viscous Compressible Flows J.S. Cagnone, B.C. Vermeire, and S.. Nadaraja Department of Mecanical Engineering, McGill University, Montreal, Canada, H3A 2S6 Email: jean-sebastien.cagnone@mail.mcgill.ca

More information

On convergence of the immersed boundary method for elliptic interface problems

On convergence of the immersed boundary method for elliptic interface problems On convergence of te immersed boundary metod for elliptic interface problems Zilin Li January 26, 2012 Abstract Peskin s Immersed Boundary (IB) metod is one of te most popular numerical metods for many

More information

H(div) conforming and DG methods for incompressible Euler s equations

H(div) conforming and DG methods for incompressible Euler s equations H(div) conforming and DG metods for incompressible Euler s equations Jonny Guzmán Filánder A. Sequeira Ci-Wang Su Abstract H(div) conforming and discontinuous Galerkin (DG) metods are designed for incompressible

More information

A Hybrid Mixed Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems

A Hybrid Mixed Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems A Hybrid Mixed Discontinuous Galerkin Finite Element Metod for Convection-Diffusion Problems Herbert Egger Joacim Scöberl We propose and analyse a new finite element metod for convection diffusion problems

More information

Copyright c 2008 Kevin Long

Copyright c 2008 Kevin Long Lecture 4 Numerical solution of initial value problems Te metods you ve learned so far ave obtained closed-form solutions to initial value problems. A closedform solution is an explicit algebriac formula

More information

Journal of Computational and Applied Mathematics

Journal of Computational and Applied Mathematics Journal of Computational and Applied Matematics 94 (6) 75 96 Contents lists available at ScienceDirect Journal of Computational and Applied Matematics journal omepage: www.elsevier.com/locate/cam Smootness-Increasing

More information

Lecture 15. Interpolation II. 2 Piecewise polynomial interpolation Hermite splines

Lecture 15. Interpolation II. 2 Piecewise polynomial interpolation Hermite splines Lecture 5 Interpolation II Introduction In te previous lecture we focused primarily on polynomial interpolation of a set of n points. A difficulty we observed is tat wen n is large, our polynomial as to

More information

arxiv: v1 [math.na] 9 Sep 2015

arxiv: v1 [math.na] 9 Sep 2015 arxiv:509.02595v [mat.na] 9 Sep 205 An Expandable Local and Parallel Two-Grid Finite Element Sceme Yanren ou, GuangZi Du Abstract An expandable local and parallel two-grid finite element sceme based on

More information

Dedicated to the 70th birthday of Professor Lin Qun

Dedicated to the 70th birthday of Professor Lin Qun Journal of Computational Matematics, Vol.4, No.3, 6, 4 44. ACCELERATION METHODS OF NONLINEAR ITERATION FOR NONLINEAR PARABOLIC EQUATIONS Guang-wei Yuan Xu-deng Hang Laboratory of Computational Pysics,

More information

Variational Localizations of the Dual Weighted Residual Estimator

Variational Localizations of the Dual Weighted Residual Estimator Publised in Journal for Computational and Applied Matematics, pp. 192-208, 2015 Variational Localizations of te Dual Weigted Residual Estimator Tomas Ricter Tomas Wick Te dual weigted residual metod (DWR)

More information

Department of Mathematical Sciences University of South Carolina Aiken Aiken, SC 29801

Department of Mathematical Sciences University of South Carolina Aiken Aiken, SC 29801 RESEARCH SUMMARY AND PERSPECTIVES KOFFI B. FADIMBA Department of Matematical Sciences University of Sout Carolina Aiken Aiken, SC 29801 Email: KoffiF@usca.edu 1. Introduction My researc program as focused

More information

HT TURBULENT NATURAL CONVECTION IN A DIFFERENTIALLY HEATED VERTICAL CHANNEL. Proceedings of 2008 ASME Summer Heat Transfer Conference HT2008

HT TURBULENT NATURAL CONVECTION IN A DIFFERENTIALLY HEATED VERTICAL CHANNEL. Proceedings of 2008 ASME Summer Heat Transfer Conference HT2008 Proceedings of 2008 ASME Summer Heat Transfer Conference HT2008 August 10-14, 2008, Jacksonville, Florida USA Proceedings of HT2008 2008 ASME Summer Heat Transfer Conference August 10-14, 2008, Jacksonville,

More information

A Study on Using Hierarchical Basis Error Estimates in Anisotropic Mesh Adaptation for the Finite Element Method

A Study on Using Hierarchical Basis Error Estimates in Anisotropic Mesh Adaptation for the Finite Element Method A Study on Using Hierarcical Basis Error Estimates in Anisotropic Mes Adaptation for te Finite Element Metod Lennard Kamenski arxiv:06.603v3 [mat.na] 20 Jan 202 Abstract: A common approac for generating

More information

Advancements In Finite Element Methods For Newtonian And Non-Newtonian Flows

Advancements In Finite Element Methods For Newtonian And Non-Newtonian Flows Clemson University TigerPrints All Dissertations Dissertations 8-3 Advancements In Finite Element Metods For Newtonian And Non-Newtonian Flows Keit Galvin Clemson University, kjgalvi@clemson.edu Follow

More information

A Weak Galerkin Method with an Over-Relaxed Stabilization for Low Regularity Elliptic Problems

A Weak Galerkin Method with an Over-Relaxed Stabilization for Low Regularity Elliptic Problems J Sci Comput (07 7:95 8 DOI 0.007/s095-06-096-4 A Weak Galerkin Metod wit an Over-Relaxed Stabilization for Low Regularity Elliptic Problems Lunji Song, Kaifang Liu San Zao Received: April 06 / Revised:

More information

Numerical Solution of One Dimensional Nonlinear Longitudinal Oscillations in a Class of Generalized Functions

Numerical Solution of One Dimensional Nonlinear Longitudinal Oscillations in a Class of Generalized Functions Proc. of te 8t WSEAS Int. Conf. on Matematical Metods and Computational Tecniques in Electrical Engineering, Bucarest, October 16-17, 2006 219 Numerical Solution of One Dimensional Nonlinear Longitudinal

More information

arxiv: v1 [math.na] 3 Nov 2011

arxiv: v1 [math.na] 3 Nov 2011 arxiv:.983v [mat.na] 3 Nov 2 A Finite Difference Gost-cell Multigrid approac for Poisson Equation wit mixed Boundary Conditions in Arbitrary Domain Armando Coco, Giovanni Russo November 7, 2 Abstract In

More information

Simulations of the turbulent channel flow at Re τ = 180 with projection-based finite element variational multiscale methods

Simulations of the turbulent channel flow at Re τ = 180 with projection-based finite element variational multiscale methods INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Met. Fluids 7; 55:47 49 Publised online 4 Marc 7 in Wiley InterScience (www.interscience.wiley.com). DOI:./fld.46 Simulations of te

More information

Reynolds number effects in stratified turbulent wakes

Reynolds number effects in stratified turbulent wakes Abstract Reynolds number effects in stratified turbulent wakes Qi Zou 1 and Peter Diamessis 2 1 Department of Applied Matematics and Teoretical Pysics, University of Cambridge 2 Scool of Civil and Environmental

More information

A Mixed-Hybrid-Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems

A Mixed-Hybrid-Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems A Mixed-Hybrid-Discontinuous Galerkin Finite Element Metod for Convection-Diffusion Problems Herbert Egger Joacim Scöberl We propose and analyse a new finite element metod for convection diffusion problems

More information

GRID CONVERGENCE ERROR ANALYSIS FOR MIXED-ORDER NUMERICAL SCHEMES

GRID CONVERGENCE ERROR ANALYSIS FOR MIXED-ORDER NUMERICAL SCHEMES GRID CONVERGENCE ERROR ANALYSIS FOR MIXED-ORDER NUMERICAL SCHEMES Cristoper J. Roy Sandia National Laboratories* P. O. Box 5800, MS 085 Albuquerque, NM 8785-085 AIAA Paper 00-606 Abstract New developments

More information

arxiv: v3 [math.na] 15 Dec 2009

arxiv: v3 [math.na] 15 Dec 2009 THE NAVIER-STOKES-VOIGHT MODEL FOR IMAGE INPAINTING M.A. EBRAHIMI, MICHAEL HOLST, AND EVELYN LUNASIN arxiv:91.4548v3 [mat.na] 15 Dec 9 ABSTRACT. In tis paper we investigate te use of te D Navier-Stokes-Voigt

More information

How to Find the Derivative of a Function: Calculus 1

How to Find the Derivative of a Function: Calculus 1 Introduction How to Find te Derivative of a Function: Calculus 1 Calculus is not an easy matematics course Te fact tat you ave enrolled in suc a difficult subject indicates tat you are interested in te

More information

Simulation and verification of a plate heat exchanger with a built-in tap water accumulator

Simulation and verification of a plate heat exchanger with a built-in tap water accumulator Simulation and verification of a plate eat excanger wit a built-in tap water accumulator Anders Eriksson Abstract In order to test and verify a compact brazed eat excanger (CBE wit a built-in accumulation

More information

CONVERGENCE ANALYSIS OF FINITE ELEMENT SOLUTION OF ONE-DIMENSIONAL SINGULARLY PERTURBED DIFFERENTIAL EQUATIONS ON EQUIDISTRIBUTING MESHES

CONVERGENCE ANALYSIS OF FINITE ELEMENT SOLUTION OF ONE-DIMENSIONAL SINGULARLY PERTURBED DIFFERENTIAL EQUATIONS ON EQUIDISTRIBUTING MESHES INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume, Number, Pages 57 74 c 5 Institute for Scientific Computing and Information CONVERGENCE ANALYSIS OF FINITE ELEMENT SOLUTION OF ONE-DIMENSIONAL

More information

Finite Difference Methods Assignments

Finite Difference Methods Assignments Finite Difference Metods Assignments Anders Söberg and Aay Saxena, Micael Tuné, and Maria Westermarck Revised: Jarmo Rantakokko June 6, 1999 Teknisk databeandling Assignment 1: A one-dimensional eat equation

More information

Order of Accuracy. ũ h u Ch p, (1)

Order of Accuracy. ũ h u Ch p, (1) Order of Accuracy 1 Terminology We consider a numerical approximation of an exact value u. Te approximation depends on a small parameter, wic can be for instance te grid size or time step in a numerical

More information

arxiv: v1 [math.na] 28 Apr 2017

arxiv: v1 [math.na] 28 Apr 2017 THE SCOTT-VOGELIUS FINITE ELEMENTS REVISITED JOHNNY GUZMÁN AND L RIDGWAY SCOTT arxiv:170500020v1 [matna] 28 Apr 2017 Abstract We prove tat te Scott-Vogelius finite elements are inf-sup stable on sape-regular

More information

Inf sup testing of upwind methods

Inf sup testing of upwind methods INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN ENGINEERING Int. J. Numer. Met. Engng 000; 48:745 760 Inf sup testing of upwind metods Klaus-Jurgen Bate 1; ;, Dena Hendriana 1, Franco Brezzi and Giancarlo

More information

A compact upwind second order scheme for the Eikonal equation

A compact upwind second order scheme for the Eikonal equation A compact upwind second order sceme for te Eikonal equation J.-D. Benamou INRIA, INRIA B.P. 05, 7853 Le Cesnay Cedex, France. jean-david.benamou@inria.fr Songting Luo Department of Matematics, Micigan

More information

Flavius Guiaş. X(t + h) = X(t) + F (X(s)) ds.

Flavius Guiaş. X(t + h) = X(t) + F (X(s)) ds. Numerical solvers for large systems of ordinary differential equations based on te stocastic direct simulation metod improved by te and Runge Kutta principles Flavius Guiaş Abstract We present a numerical

More information

Different Approaches to a Posteriori Error Analysis of the Discontinuous Galerkin Method

Different Approaches to a Posteriori Error Analysis of the Discontinuous Galerkin Method WDS'10 Proceedings of Contributed Papers, Part I, 151 156, 2010. ISBN 978-80-7378-139-2 MATFYZPRESS Different Approaces to a Posteriori Error Analysis of te Discontinuous Galerkin Metod I. Šebestová Carles

More information

A compact upwind second order scheme for the Eikonal equation

A compact upwind second order scheme for the Eikonal equation A compact upwind second order sceme for te Eikonal equation Jean-David Benamou Songting Luo Hongkai Zao Abstract We present a compact upwind second order sceme for computing te viscosity solution of te

More information

AN ANALYSIS OF THE EMBEDDED DISCONTINUOUS GALERKIN METHOD FOR SECOND ORDER ELLIPTIC PROBLEMS

AN ANALYSIS OF THE EMBEDDED DISCONTINUOUS GALERKIN METHOD FOR SECOND ORDER ELLIPTIC PROBLEMS AN ANALYSIS OF THE EMBEDDED DISCONTINUOUS GALERKIN METHOD FOR SECOND ORDER ELLIPTIC PROBLEMS BERNARDO COCKBURN, JOHNNY GUZMÁN, SEE-CHEW SOON, AND HENRYK K. STOLARSKI Abstract. Te embedded discontinuous

More information

On the accuracy of the rotation form in simulations of the Navier-Stokes equations

On the accuracy of the rotation form in simulations of the Navier-Stokes equations On te accuracy of te rotation form in simulations of te Navier-Stokes equations William Layton 1 Carolina C. Manica Monika Neda 3 Maxim Olsanskii Leo G. Rebolz 5 Abstract Te rotation form of te Navier-Stokes

More information

Blanca Bujanda, Juan Carlos Jorge NEW EFFICIENT TIME INTEGRATORS FOR NON-LINEAR PARABOLIC PROBLEMS

Blanca Bujanda, Juan Carlos Jorge NEW EFFICIENT TIME INTEGRATORS FOR NON-LINEAR PARABOLIC PROBLEMS Opuscula Matematica Vol. 26 No. 3 26 Blanca Bujanda, Juan Carlos Jorge NEW EFFICIENT TIME INTEGRATORS FOR NON-LINEAR PARABOLIC PROBLEMS Abstract. In tis work a new numerical metod is constructed for time-integrating

More information

An efficient implementation of the divergence free constraint in a discontinuous Galerkin method for magnetohydrodynamics on unstructured meshes

An efficient implementation of the divergence free constraint in a discontinuous Galerkin method for magnetohydrodynamics on unstructured meshes An efficient implementation of te divergence free constraint in a discontinuous Galerkin metod for magnetoydrodynamics on unstructured meses Cristian Klingenberg 1, Frank Pörner 1, and Yinua Xia 2, 1 Department

More information

Math 31A Discussion Notes Week 4 October 20 and October 22, 2015

Math 31A Discussion Notes Week 4 October 20 and October 22, 2015 Mat 3A Discussion Notes Week 4 October 20 and October 22, 205 To prepare for te first midterm, we ll spend tis week working eamples resembling te various problems you ve seen so far tis term. In tese notes

More information

Computers and Mathematics with Applications. A nonlinear weighted least-squares finite element method for Stokes equations

Computers and Mathematics with Applications. A nonlinear weighted least-squares finite element method for Stokes equations Computers Matematics wit Applications 59 () 5 4 Contents lists available at ScienceDirect Computers Matematics wit Applications journal omepage: www.elsevier.com/locate/camwa A nonlinear weigted least-squares

More information

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems 5 Ordinary Differential Equations: Finite Difference Metods for Boundary Problems Read sections 10.1, 10.2, 10.4 Review questions 10.1 10.4, 10.8 10.9, 10.13 5.1 Introduction In te previous capters we

More information

Physically Based Modeling: Principles and Practice Implicit Methods for Differential Equations

Physically Based Modeling: Principles and Practice Implicit Methods for Differential Equations Pysically Based Modeling: Principles and Practice Implicit Metods for Differential Equations David Baraff Robotics Institute Carnegie Mellon University Please note: Tis document is 997 by David Baraff

More information

The derivative function

The derivative function Roberto s Notes on Differential Calculus Capter : Definition of derivative Section Te derivative function Wat you need to know already: f is at a point on its grap and ow to compute it. Wat te derivative

More information

158 Calculus and Structures

158 Calculus and Structures 58 Calculus and Structures CHAPTER PROPERTIES OF DERIVATIVES AND DIFFERENTIATION BY THE EASY WAY. Calculus and Structures 59 Copyrigt Capter PROPERTIES OF DERIVATIVES. INTRODUCTION In te last capter you

More information

Hanieh Mirzaee Jennifer K. Ryan Robert M. Kirby

Hanieh Mirzaee Jennifer K. Ryan Robert M. Kirby J Sci Comput (2010) 45: 447 470 DOI 10.1007/s10915-009-9342-9 Quantification of Errors Introduced in te Numerical Approximation and Implementation of Smootness-Increasing Accuracy Conserving (SIAC) Filtering

More information

Polynomial Interpolation

Polynomial Interpolation Capter 4 Polynomial Interpolation In tis capter, we consider te important problem of approximatinga function fx, wose values at a set of distinct points x, x, x,, x n are known, by a polynomial P x suc

More information

A SYMMETRIC NODAL CONSERVATIVE FINITE ELEMENT METHOD FOR THE DARCY EQUATION

A SYMMETRIC NODAL CONSERVATIVE FINITE ELEMENT METHOD FOR THE DARCY EQUATION A SYMMETRIC NODAL CONSERVATIVE FINITE ELEMENT METHOD FOR THE DARCY EQUATION GABRIEL R. BARRENECHEA, LEOPOLDO P. FRANCA 1 2, AND FRÉDÉRIC VALENTIN Abstract. Tis work introduces and analyzes novel stable

More information

arxiv: v1 [math.na] 20 Jul 2009

arxiv: v1 [math.na] 20 Jul 2009 STABILITY OF LAGRANGE ELEMENTS FOR THE MIXED LAPLACIAN DOUGLAS N. ARNOLD AND MARIE E. ROGNES arxiv:0907.3438v1 [mat.na] 20 Jul 2009 Abstract. Te stability properties of simple element coices for te mixed

More information

Research Article Cubic Spline Iterative Method for Poisson s Equation in Cylindrical Polar Coordinates

Research Article Cubic Spline Iterative Method for Poisson s Equation in Cylindrical Polar Coordinates International Scolarly Researc Network ISRN Matematical Pysics Volume 202, Article ID 2456, pages doi:0.5402/202/2456 Researc Article Cubic Spline Iterative Metod for Poisson s Equation in Cylindrical

More information

AN EFFICIENT AND ROBUST METHOD FOR SIMULATING TWO-PHASE GEL DYNAMICS

AN EFFICIENT AND ROBUST METHOD FOR SIMULATING TWO-PHASE GEL DYNAMICS AN EFFICIENT AND ROBUST METHOD FOR SIMULATING TWO-PHASE GEL DYNAMICS GRADY B. WRIGHT, ROBERT D. GUY, AND AARON L. FOGELSON Abstract. We develop a computational metod for simulating models of gel dynamics

More information

One-Sided Position-Dependent Smoothness-Increasing Accuracy-Conserving (SIAC) Filtering Over Uniform and Non-uniform Meshes

One-Sided Position-Dependent Smoothness-Increasing Accuracy-Conserving (SIAC) Filtering Over Uniform and Non-uniform Meshes DOI 10.1007/s10915-014-9946-6 One-Sided Position-Dependent Smootness-Increasing Accuracy-Conserving (SIAC) Filtering Over Uniform and Non-uniform Meses JenniferK.Ryan Xiaozou Li Robert M. Kirby Kees Vuik

More information

MATH745 Fall MATH745 Fall

MATH745 Fall MATH745 Fall MATH745 Fall 5 MATH745 Fall 5 INTRODUCTION WELCOME TO MATH 745 TOPICS IN NUMERICAL ANALYSIS Instructor: Dr Bartosz Protas Department of Matematics & Statistics Email: bprotas@mcmasterca Office HH 36, Ext

More information

Parameter Fitted Scheme for Singularly Perturbed Delay Differential Equations

Parameter Fitted Scheme for Singularly Perturbed Delay Differential Equations International Journal of Applied Science and Engineering 2013. 11, 4: 361-373 Parameter Fitted Sceme for Singularly Perturbed Delay Differential Equations Awoke Andargiea* and Y. N. Reddyb a b Department

More information

Nonconforming Immersed Finite Element Methods for Interface Problems

Nonconforming Immersed Finite Element Methods for Interface Problems Nonconforming Immersed Finite Element Metods for Interface Problems Xu Zang Dissertation submitted to te Faculty of te Virginia Polytecnic Institute and State University in partial fulfillment of te requirements

More information

arxiv: v1 [math.na] 17 Jul 2014

arxiv: v1 [math.na] 17 Jul 2014 Div First-Order System LL* FOSLL* for Second-Order Elliptic Partial Differential Equations Ziqiang Cai Rob Falgout Sun Zang arxiv:1407.4558v1 [mat.na] 17 Jul 2014 February 13, 2018 Abstract. Te first-order

More information

MIXED DISCONTINUOUS GALERKIN APPROXIMATION OF THE MAXWELL OPERATOR. SIAM J. Numer. Anal., Vol. 42 (2004), pp

MIXED DISCONTINUOUS GALERKIN APPROXIMATION OF THE MAXWELL OPERATOR. SIAM J. Numer. Anal., Vol. 42 (2004), pp MIXED DISCONTINUOUS GALERIN APPROXIMATION OF THE MAXWELL OPERATOR PAUL HOUSTON, ILARIA PERUGIA, AND DOMINI SCHÖTZAU SIAM J. Numer. Anal., Vol. 4 (004), pp. 434 459 Abstract. We introduce and analyze a

More information

Decay of solutions of wave equations with memory

Decay of solutions of wave equations with memory Proceedings of te 14t International Conference on Computational and Matematical Metods in Science and Engineering, CMMSE 14 3 7July, 14. Decay of solutions of wave equations wit memory J. A. Ferreira 1,

More information

Implicit Multistage Two-Derivative Discontinuous Galerkin Schemes for Viscous Conservation Laws Link Peer-reviewed author version

Implicit Multistage Two-Derivative Discontinuous Galerkin Schemes for Viscous Conservation Laws Link Peer-reviewed author version Implicit Multistage Two-Derivative Discontinuous Galerkin Scemes for Viscous Conservation Laws Link Peer-reviewed autor version Made available by Hasselt University Library in Document Server@UHasselt

More information

Numerical analysis of a free piston problem

Numerical analysis of a free piston problem MATHEMATICAL COMMUNICATIONS 573 Mat. Commun., Vol. 15, No. 2, pp. 573-585 (2010) Numerical analysis of a free piston problem Boris Mua 1 and Zvonimir Tutek 1, 1 Department of Matematics, University of

More information

arxiv: v1 [math.na] 20 Nov 2018

arxiv: v1 [math.na] 20 Nov 2018 An HDG Metod for Tangential Boundary Control of Stokes Equations I: Hig Regularity Wei Gong Weiwei Hu Mariano Mateos Jon R. Singler Yangwen Zang arxiv:1811.08522v1 [mat.na] 20 Nov 2018 November 22, 2018

More information

SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY

SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY (Section 3.2: Derivative Functions and Differentiability) 3.2.1 SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY LEARNING OBJECTIVES Know, understand, and apply te Limit Definition of te Derivative

More information

COMPUTATIONAL COMPARISON BETWEEN THE TAYLOR HOOD AND THE CONFORMING CROUZEIX RAVIART ELEMENT

COMPUTATIONAL COMPARISON BETWEEN THE TAYLOR HOOD AND THE CONFORMING CROUZEIX RAVIART ELEMENT Proceedings of ALGORITMY 5 pp. 369 379 COMPUTATIONAL COMPARISON BETWEEN E TAYLOR HOOD AND E CONFORMING OUZEIX RAVIART ELEMENT ROLF KRAHL AND EBERHARD BÄNSCH Abstract. Tis paper is concerned wit te computational

More information

Grad-div stabilization for the evolutionary Oseen problem with inf-sup stable finite elements

Grad-div stabilization for the evolutionary Oseen problem with inf-sup stable finite elements Noname manuscript No. will be inserted by te editor Grad-div stabilization for te evolutionary Oseen problem wit inf-sup stable finite elements Javier de Frutos Bosco García-Arcilla Volker Jon Julia Novo

More information

Unconditionally Energy Stable Numerical Schemes for Hydrodynamics Coupled Fluids Systems

Unconditionally Energy Stable Numerical Schemes for Hydrodynamics Coupled Fluids Systems University of Sout Carolina Scolar Commons Teses and Dissertations 017 Unconditionally Energy Stable Numerical Scemes for Hydrodynamics Coupled Fluids Systems Alexander Yuryevic Brylev University of Sout

More information

arxiv: v2 [cs.na] 22 Dec 2016

arxiv: v2 [cs.na] 22 Dec 2016 MONOTONICITY-PRESERVING FINITE ELEMENT SCHEMES BASED ON DIFFERENTIABLE NONLINEAR STABILIZATION SANTIAGO BADIA AND JESÚS BONILLA arxiv:66.8743v2 [cs.na] 22 Dec 26 Abstract. In tis work, we propose a nonlinear

More information

arxiv: v1 [math.na] 9 Mar 2018

arxiv: v1 [math.na] 9 Mar 2018 A simple embedded discrete fracture-matrix model for a coupled flow and transport problem in porous media Lars H. Odsæter a,, Trond Kvamsdal a, Mats G. Larson b a Department of Matematical Sciences, NTNU

More information

CLEMSON U N I V E R S I T Y

CLEMSON U N I V E R S I T Y A Fractional Step θ-metod for Convection-Diffusion Equations Jon Crispell December, 006 Advisors: Dr. Lea Jenkins and Dr. Vincent Ervin Fractional Step θ-metod Outline Crispell,Ervin,Jenkins Motivation

More information

Mass Lumping for Constant Density Acoustics

Mass Lumping for Constant Density Acoustics Lumping 1 Mass Lumping for Constant Density Acoustics William W. Symes ABSTRACT Mass lumping provides an avenue for efficient time-stepping of time-dependent problems wit conforming finite element spatial

More information

Unconditional long-time stability of a velocity-vorticity method for the 2D Navier-Stokes equations

Unconditional long-time stability of a velocity-vorticity method for the 2D Navier-Stokes equations Numerical Analysis and Scientific Computing Preprint Seria Unconditional long-time stability of a velocity-vorticity metod for te D Navier-Stokes equations T. Heister M.A. Olsanskii L.G. Rebolz Preprint

More information

lecture 35: Linear Multistep Mehods: Truncation Error

lecture 35: Linear Multistep Mehods: Truncation Error 88 lecture 5: Linear Multistep Meods: Truncation Error 5.5 Linear ultistep etods One-step etods construct an approxiate solution x k+ x(t k+ ) using only one previous approxiation, x k. Tis approac enoys

More information

Moving Mesh Methods for Singular Problems on a Sphere Using Perturbed Harmonic Mappings

Moving Mesh Methods for Singular Problems on a Sphere Using Perturbed Harmonic Mappings Moving Mes Metods for Singular Problems on a Spere Using Perturbed Harmonic Mappings Yana Di, Ruo Li, Tao Tang and Pingwen Zang Marc 4, 6 Abstract Tis work is concerned wit developing moving mes strategies

More information

Application of numerical integration methods to continuously variable transmission dynamics models a

Application of numerical integration methods to continuously variable transmission dynamics models a ttps://doi.org/10.1051/ssconf/2018440005 Application of numerical integration metods to continuously variable transmission dynamics models a Orlov Stepan 1 1 Peter te Great St. Petersburg Polytecnic University

More information

arxiv: v1 [math.na] 25 Jul 2014

arxiv: v1 [math.na] 25 Jul 2014 A second order in time, uniquely solvable, unconditionally stable numerical sceme for Can-Hilliard-Navier-Stokes equation Daozi Han, Xiaoming Wang November 5, 016 arxiv:1407.7048v1 [mat.na] 5 Jul 014 Abstract

More information

MANY scientific and engineering problems can be

MANY scientific and engineering problems can be A Domain Decomposition Metod using Elliptical Arc Artificial Boundary for Exterior Problems Yajun Cen, and Qikui Du Abstract In tis paper, a Diriclet-Neumann alternating metod using elliptical arc artificial

More information

Third order Approximation on Icosahedral Great Circle Grids on the Sphere. J. Steppeler, P. Ripodas DWD Langen 2006

Third order Approximation on Icosahedral Great Circle Grids on the Sphere. J. Steppeler, P. Ripodas DWD Langen 2006 Tird order Approximation on Icosaedral Great Circle Grids on te Spere J. Steppeler, P. Ripodas DWD Langen 2006 Deasirable features of discretisation metods on te spere Great circle divisions of te spere:

More information