A Polynomial Adaptive LCP Scheme for Viscous Compressible Flows

Size: px
Start display at page:

Download "A Polynomial Adaptive LCP Scheme for Viscous Compressible Flows"

Transcription

1 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 ABSTRACT Tis paper presents a polynomial-adaptive liftingcollocation-penalty (LCP) formulation for te compressible Navier-Stokes equations. Te problem of non-conforming polynomial approximations is dealt wit an interface element approac. Empasis is put on te treatment of diffusive fluxes, and p-adaptive viscous compressible flow simulations are performed. 1 INTRODUCTION In recent years, a number of very efficient elementbased ig-order unstructured scemes ave been proposed. Tese formulations, collectively referred to as nodal discontinuous metods, strive to improve over te more establised discontinous Galerkin (DG) finite-element formulation. Ways to acieve iger efficiency include employing nodal instead of modal bases, casting te sceme in differential form, and favoring collocated solution/flux point placements. Te lifting collocation penalty (LCP) of Wang et al. [9, 6] combines tese attributes in a single unifying formulation, free of reconstruction step, integral evaluation and mass-matrix inversion. It is applicable to unstructured triangular meses, wit arbitrary-ig order of accuracy. However, tese advantages also come at te expense of flexibility in te application of formulation. Namely, a one-to-one connectivity of te edge flux points is mandatory to adequately evaluate te inter-element flux excange. A direct implication of tis requirement is tat using independent polynomial degree in eac element is no longer straigtforward. In reference [5], we explored te use of specially designed interface elements to tackle spatially-varying polynomial approximations. Tese interface elements ave a different number of nodes on eac face, and are employed to recover conforming flux interpolation at interfaces were te polynomial degrees differ. In tis paper, te applicability of te interface element approac to diffusion problems is studied. Section 2 covers te formulation of te numerical sceme, and section 3 presents results for te Navier-Stokes equations. 2 NUMERICAL FORMULATION 2.1 Inviscid discretization We consider Ω, an approximation to te pysical domain Ω, subdivided by a triangulation T = {} consisting of sape-regular elements. Using standard finite-element notation [2], we introduce te broken polynomial spaces V and Σ associated wit te triangulation T, and denote by P() and Σ() teir restriction to element. In te following, we denote ( ) and ( ) te traces taken from te interior and exterior of element wit boundary. To discuss te inviscid discretization, we start by considering te Euler equations in conservation form u(x, t) t F(u) = 0 in Ω, (1) were u are te state variables and F = (f(u),g(u)) is te inviscid flux vector. We seek an approximate solution to (1) consisting of piecewise polynomial functions by invoking te variational formulation: find u V suc tat for all T v u t dx v ˆF ds v F(u ) dx = 0 v P(), (2) were n denotes te outward normal unit vector to. Here, ˆF denotes a consistent and conservative numer-

2 ical flux approximating F(u) n on. In our implementation, te Roe flux [8] is retained for tat purpose. Integrating by parts equation (2) leads to te strong variational statement v u t dx v F(u ) dx v ( ˆF F(u ) n) ds = 0. (3) In tis alternative formulation, te differential operator is sifted from te test function to te fluxes. Moreover, te boundary integrand now consists of te difference between te desired Riemann flux and te internal normal flux. In te LCP sceme, te influence of tis normal flux difference is extended from te boundary to te volume of eac element by considering a correction field δ (x) V defined by te following lifting operator vδ dx = v ( ˆF F(u ) n) ds v P(). () Substituting () into (3) allows to factor and eliminate te test fuction v, giving te differential formulation u t F(u ) δ = 0. (5) In te practical implementation of te sceme of order p 1, te unknowns are stored at N p = (p 2)(p 1)/2 solution points. Te numerical fluxes are ten calculated at N fp = 3(p1) flux points, collocated wit te edge solution points. Te interpolation witin te element is performed using N p twodimensional Lagrange basis functions denoted ϕ i (x). Likewise, te numerical fluxes are interpolated along all tree edges using N fp one-dimensional basis functions denoted φ k (s). Using tis nodal format, te semidiscrete sceme can be expressed from te vectors of nodal values as d dt u D x f D y g L[ ˆF F(u ) n] = 0, (6) were D x and D y are N p N p differentiation matrices and L = M 1 N is te N p N fp algebraic lift operator. Here, M and N denote te mass and edge-mass matricies given by M i j = ϕ i (x)ϕ j (x) dx, N ik = ϕ i (x)φ k (s) ds. 2.2 Viscous discretization edge In order to develop a discretization suitable for diffusion problems, we introduce an auxiliary gradient variable q = u and cast te Navier-Stokes equations as a first-order system q u = 0, Euler F v (u,q ) = 0. (7a) (7b) Applying te ideas presented in te previous section, we consider (7a) in strong variational form: find u V and q Σ suc tat for all T, τ Σ() and v P() τ q dx τ u dx (8a) τ (û u )n ds = 0 τ Σ(), Euler v F v (u,q ) dx v ( ( ˆF v F v u,q ) ) (8b) n ds = 0 v P(), were û and ˆF v are numerical fluxes approximating u and F v n on. Te next step consists of defining operators to lift te jump in fluxes at te boundary. We introduce te necessary correction fields R Σ and δ v V τ R dx = τ (û u )n ds, (9a) vδ v dx = v ( ( ˆF v F v u,q ) ) n ds. (9b) Te LCP discretization of te gradient and viscous term is tus q = u R, Euler F v (u, u R ) δ v = 0. (10a) (10b) Since te correction fields R and δ v are completely analogous to δ, te algebraic operators used to lift te inviscid fluxes can be utilized in (10) as well. Te formulation is complete once te numerical fluxes û and ˆF v are specified in terms of u and q. Here, te second metod of Bassi and Rebay (BR2) is employed [3, ]. To make te sceme compact, tey suggest splitting te gradient correction field into edge-wise contributions R = r, were τ r dx = τ (û u )nds τ Σ(). (11) edge Te BR2 numerical fluxes are ten given by û = 1 ( 2 u u ), ˆF v = 1 ( ( 2 Fv u, u ) ( r Fv u, u )) r n. Te key aspect of te BR2 formulation is tat ˆF v is evaluated from partially corrected edge gradients. Using te fully corrected gradients q and q is referred to as te BR1 metod, wic leads to sub-optimal convergence rates and an extended stencil connecting nonneigbor elements.

3 2.3 Non-conforming polynomial approximations Te LCP formulation presented in te preceding section is only directly applicable to conforming polynomial approximations were te degree of eac element is te same trougout te domain. In order to andle non-conforming polynomial approximations, an interface element approac is used. Tese specially designed elements ave a variable number of nodes per face, and are inserted at junctions between zones were te interpolation degree differs. Teir construction guarantees C 0 -continuity of te fluxes along eac edge, tus ensuring local conservation. Tis approac also retains te efficient collocated nodal formulation of te original sceme, and is free of additional interpolation or projection operations. Construction of tese interface elements is possible since te LCP formulation is not strictly dependent on te element type, or coice of nodal support. Consequently, we are free to consider elements wit supplementary edge nodes, as long as a proper interpolation basis can be defined. To transition from degree p to p 1, we consider te nodal set wit N p points, and add a new node along one, or possibly two faces of te element. Tis leads to six possible configurations, as illustrated by Fig. 1 sowing te linear-to-quadratic interface elements. Next, te interpolation polynomial space is defined in terms of monomial expansion in (ξ, η), te usual local coordinates of te canonical reference element. Starting from te order-complete basis ψ(ξ,η) = {1,ξ,η,ξ 2,ξη,η 2,...,η p } T, additional components needed by te supplementary face-nodes are included. Tese components, cosen to avoid a singular Vandermonde matrix, are determined as follows ξ p1 for face 1 ξ n η m, n m = p 1, (n,m) > 0 for face 2 η p1 for face 3 Te Lagrange interpolation functions are ten obtained by te relation provided by te Vandermonde matrix V V T ϕ = ψ, V i j = ψ j (ξ i,η i ). A Gram-Scmidt ortonormalization of te monomial expansion can be employed to improve te conditioning of te Vandermonde matrix. Finally, wit te nodes and polynomial basis properly defined, te differentiation and lift matrices are computed, leading to a seamless integration of te interface element approac in te original framework (a) < 1 ξ η ξ 2 > (c) < 1 ξ η η 2 > 2 3 (e) < 1 ξ η ξ 2 η 2 > (b) < 1 ξ η ξη > 2 3 (d) < 1 ξ η ξ 2 ξη > (f) < 1 ξ η ξη η 2 > Figure 1: Interface elements for te P1-P2 interface 3 NUMERICAL RESULTS 3.1 Laminar NACA0012 airfoil We evaluate our p-adaptive sceme on by considering laminar flow around a NACA0012 airfoil. Te free stream conditions cosen are M = 0.5, α = 0 o and Re = An interesting aspect of tis flow is te presence of a small recirculation bubble aft of te airfoil caused by laminar separation. We begin by studying te impact of te discretization s order on te flow solution. Figure 2 presents te computed Mac contours using te P1, P and p-adaptive scemes. It is seen tat te P1 solution in Fig. 2a is unsatisfactory. Specifically, te boundary layer and wake ticknesses are severely under-predicted, and te solution displays a general lack of smootness. Tis situation is corrected wen employing te fift-order sceme (P) wic recovers smoot Mac contours and sows an increased resolution of te viscous effects. It is also verified tat te solution obtained wit

4 (a) (b) (c) Figure 2: Laminar NACA0012: Mac number contours. (a) P1 solution. (b) P solution. (c) Adapted solution using levels of refinement (P1-P). P1 P2 P P P3 P3 (a) (b) Figure 3: Laminar NACA0012: adapted polynomial pattern. (a) General view. (b) oom around te airfoil. Te coloring sceme corresponds to P1 (blue) troug P (red), wit te interface elements sown in intermediate sading. te four level p-adaptive solution (P1-P) is essentially identical to te uniformly refined one. Tis agreement confirms te effectiveness of te adaptation procedure and te appropriate treatment of te interfaces were te order of te discretization varies. Indeed, Fig. 3 sows tat polynomial refinement occurs mainly around te stagnation point, boundary layer and wake regions, wic are te crucial features of tis particular flow. A quantitative comparison of te errors in te pressure (c dp ) and viscous drag coefficients (c dv ) is sown in Fig.. A fift-order fine grid solution is employed as reference to estimate te error level of eac computation. We notice tat te uniformly and adaptively refined solutions ave te same error levels, but te adaptation procedure offers a two-fold reduction in total number of degrees of freedom. Turning to table 1, it is seen tat computing te full P solution necessitates 76 seconds, against 176 for te adapted solution, corresponding to a speedup factor of about 2.7. Table 1 also details te location of te laminar separation point for eac calculation. Due to te relatively coarse grid employed, te P1 sceme fails to capture te recirculation region completely. Increasing te sceme s order gives progressively better results, wit te P computation in close agreement wit te reference solution. Once more, it is noticed tat te full-refinement and p- adaptive strategies give essentially identical results at eac refinement level. Finally, te convergence of te Newton-rylov solver is examined in Fig. 5. Macinezero convergence is acieved in four to six iterations for bot uniformly and adaptively refined computations. Te fact tat bot strategies display similar con-

5 Discretization DOF c dp c dv Separation point Wall clock time (sec.) P none 13 P % 6 P % 222 P % 76 P1-P % 0 P1-P % 79 P1-P % 176 Fine grid % Table 1: Summary of te laminar NACA0012 simulations. vergence rates confirms te stability of te interface element approac Uniform p refinement Adaptive p refinement Uniform p refinement Adaptive p refinement Density residual c dp error Newton iterations Degrees of freedom x 10 Figure 5: Laminar NACA0012: convergence of te Newton-rylov solver for four levels of uniform and adaptive p-refinement Uniform p refinement Adaptive p refinement 3.2 Unsteady vortex sedding c dv error Degrees of freedom x 10 Figure : Laminar NACA0012: Pressure (c d p ) and viscous (c dv ) drag error as a function of number of degrees of freedom. Tis second example demonstrates te application of our p-adaptive strategy to unsteady viscous flows. Te problem considered is unsteady vortex sedding occurring beind a cylindrical body of unit diameter. Te flow conditions are given as M = 0.1 and Re = 150. Te simulations are performed on a computational mes consisting of 2810 elements, wit stretced triangles in te boundary layer region and moderately refined wake region beind te cylinder. Time integration is carried-out wit te second-order BDF2 sceme. For all simulations, te time increment is fixed to t = 0.5, corresponding to a Courant- Friedrics-Lewy (CFL) number of about 100. Tis time step was verified to be sufficiently small to let te spatial error dominate For p-adaptive calculations, te polynomial distribution at a new timestep is iteratively determined in a similar fasion as Alauzet et

6 P1 P2 P3 P Figure 6: Unsteady vortex sedding: Mac contours and polynomial adaptation pattern for te four-level adaptive computation (P1-P). Te snapsots sown correspond instants of maximal (top) and minimal (bottom) lift value. al. [1]. A new refinement pattern is recomputed eac five time steps. Te simulation results are compared in terms of lift and total drag coefficients, as well as non-dimensional sedding frequency expressed by te Stroual number St = L/(TU ), were L is te caracteristic lengt, U te free steam velocity, and T te sedding period. Figure 6 sows te Mac contours and polynomial pattern for te four-level adaptive simulation (P1-P). Te two snapsots presented correspond to instants of maximal and minimal lift value. Most of te P elements are employed in te boundary layer and in te unsteady wake immediately beind te cylinder. Refinement employing P2 and P3 elements also occurs furter downstream, leaving only te farfield region discretized wit P1 elements. Comparing te two time instants also provides visual evidence of te dynamic adaptation occurring conjointly wit te flow evolution. It is verified tat te algoritm successfully follows te location of te primary vortex being sed alternatively above and below te cylinder. To evaluate te impact of te number of adaptation levels, we turn to Fig. 7 sowing te evolution of te lift and total drag coefficients. Te integrated forces are plotted against time units (t t 0 ), were t 0 is a time of a peak value. It is observed tat te resolution of te P1 discretization is insufficient to accurately capture te viscous effects, tus under-predicting te forces exerted on te cylinder. Increasing te number of adaptation levels gradually improves te predictions, eventually leading to close agreement between te tree- and four-levels simulations. Moreover, it is also noticed tat te additional adaptation levels reduce te errors caused by te non-consistent interpolation of te solution at eac time step. Specifically, te drag istory predicted by te P1-P2 simulation presents some unpysical oscillations and oversoots wic disappear completely as te number of refinement steps is increased. To furter examine te accuracy of te different scemes, te output of eac simulation is presented in table 2, along wit te sixt-order finite-difference results of Inoue and Hatakeyama [7]. Te uniform and adaptive refinement strategies bot sow good agreement wit te data reported by tese autors. For bot ap-

7 Table 2: Summary of te unsteady vortex sedding simulations. Discretization DOF c l c d c d St Wall clock time (sec.) P P P P P1-P P1-P P1-P Reference [7] tus acieving a speedup factor of about 2.6. c l P1 P1 P2 P1 P3 P1 P Time (t t ) 0 CONCLUSION Tis paper studied te applicability of te LCP interface elements approac to p-adaptive compressible Navier-Stokes simulations. Tese interface elements ensure te required continuity of te flux interpolation, and tus local conservation. Te efficiency and robustness of te approac was demonstrated for a steady flow over te NACA0012 airfoil, and for an unsteady laminar vortex sedding problem, were a speedup of about 2.7 was reported. c d Time (t t 0 ) Figure 7: Unsteady vortex sedding: lift and drag coefficient istory for p-adaptive simulations. proaces, a converged Stroual number is obtained after te second refinement step, wereas lift and drag require tree levels to settle to teir final values. To close, we note tat te P1-P adaptive strategy predicts similar outputs as te uniformly refined solution, but offers a two-fold reduction in degrees of freedom, REFERENCES [1] F. Alauzet, P. L. George, B. Moammadi, P. Frey, and H. Boroucaki. Transient fixed point-based unstructured mes adaptation. Int. J. Numer. Met. Fluids, 3:729 75, [2] D. N. Arnold, F. Brezzi, B. Cockburn, and L. D. Marini. Unified analysis of discontinuous Galerkin metods for elliptic problems. SIAM J. Numer. Anal., 39(5): , [3] F. Bassi, A. Crivellini, S. Rebay, and M. Savini. Discontinuous Galerkin solution of te Reynoldsaveraged Navier-Stokes and k-ω turbulence model equations. Comput. Fluids, 3:507 50, [] F. Bassi and S. Rebay. A ig order discontinuous Galerkin metod for compressible turbulent flows. In B. Cockburn and G. arniadakis, editors, Discontinuous Galerkin metods. Teory, computation and applications., volume 11 of Lecture Notes in Computational science and engineering. Springer-Verlag, 2000.

8 [5] J. S. Cagnone and S.. Nadaraja. A stable interface element sceme for te p-adaptive lifting collocation penalty formulation. J. Comput. Pys., 231: , [6] H. Gao and. J. Wang. A ig-order lifting collocation penalty formulation for te Navier-Stokes equation on 2D mixed grids. AIAA Paper , [7] O. Inoue and N. Hatakeyama. Sound generation by a two-dimensional circular cylinder in a uniform flow. J. Fluid Mec., 71:285 31, [8] P. L. Roe. Approximate Riemann solvers, parameter vector and difference scemes. J. Comput. Pys., 3: , [9]. J. Wang and H. Gao. A unifying lifting collocation penalty formulation including te discontinuous Galerkin, spectral volume/difference metods for conservation laws on mixed grids. J. Comput. Pys., 228: , also AIAA paper

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

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

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

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

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

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

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

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

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

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

Jian-Guo Liu 1 and Chi-Wang Shu 2

Jian-Guo Liu 1 and Chi-Wang Shu 2 Journal of Computational Pysics 60, 577 596 (000) doi:0.006/jcp.000.6475, available online at ttp://www.idealibrary.com on Jian-Guo Liu and Ci-Wang Su Institute for Pysical Science and Tecnology and Department

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

Polynomial Interpolation

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

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

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

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

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

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

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

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

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

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

LECTURE 14 NUMERICAL INTEGRATION. Find

LECTURE 14 NUMERICAL INTEGRATION. Find LECTURE 14 NUMERCAL NTEGRATON Find b a fxdx or b a vx ux fx ydy dx Often integration is required. However te form of fx may be suc tat analytical integration would be very difficult or impossible. Use

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

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

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

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

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

RANS Solutions Using High Order Discontinuous Galerkin Methods

RANS Solutions Using High Order Discontinuous Galerkin Methods RANS Solutions Using High Order Discontinuous Galerkin Methods Ngoc Cuong Nguyen, Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology, Cambridge, MA 2139, U.S.A. We present a practical

More information

A h u h = f h. 4.1 The CoarseGrid SystemandtheResidual Equation

A h u h = f h. 4.1 The CoarseGrid SystemandtheResidual Equation Capter Grid Transfer Remark. Contents of tis capter. Consider a grid wit grid size and te corresponding linear system of equations A u = f. Te summary given in Section 3. leads to te idea tat tere migt

More information

arxiv: v2 [math.na] 11 Dec 2016

arxiv: v2 [math.na] 11 Dec 2016 Noname manuscript No. will be inserted by te editor Sallow water equations: Split-form, entropy stable, well-balanced, and positivity preserving numerical metods Hendrik Ranoca arxiv:609.009v [mat.na]

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

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

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

The Verlet Algorithm for Molecular Dynamics Simulations

The Verlet Algorithm for Molecular Dynamics Simulations Cemistry 380.37 Fall 2015 Dr. Jean M. Standard November 9, 2015 Te Verlet Algoritm for Molecular Dynamics Simulations Equations of motion For a many-body system consisting of N particles, Newton's classical

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

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows F. Bassi, A. Crivellini, D. A. Di Pietro, S. Rebay Dipartimento di Ingegneria Industriale, Università di Bergamo CERMICS-ENPC

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

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

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

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

Solving Poisson s equations by the Discrete Least Square meshless method

Solving Poisson s equations by the Discrete Least Square meshless method Boundary Elements and Oter Mes eduction Metods XXV 3 Solving Poisson s equations by te Discrete Least Square mesless metod H. Arzani & M. H. Afsar Said aaee University, Lavizan, eran, ran Department of

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

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

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

Optimal Shape Design of a Two-dimensional Asymmetric Diffsuer in Turbulent Flow

Optimal Shape Design of a Two-dimensional Asymmetric Diffsuer in Turbulent Flow THE 5 TH ASIAN COMPUTAITIONAL FLUID DYNAMICS BUSAN, KOREA, OCTOBER 7 ~ OCTOBER 30, 003 Optimal Sape Design of a Two-dimensional Asymmetric Diffsuer in Turbulent Flow Seokyun Lim and Haeceon Coi. Center

More information

Numerical performance of discontinuous and stabilized continuous Galerkin methods for convection diffusion problems

Numerical performance of discontinuous and stabilized continuous Galerkin methods for convection diffusion problems Numerical performance of discontinuous and stabilized continuous Galerkin metods for convection diffusion problems Paola F. Antonietti MOX, Dipartimento di Matematica, Politecnico di Milano, Piazza Leonardo

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

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

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

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells Abstract We present a shock capturing procedure for high order Discontinuous Galerkin methods, by which shock regions are refined in sub-cells and treated by finite volume techniques Hence, our approach

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

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

Large eddy simulation of turbulent flow downstream of a backward-facing step

Large eddy simulation of turbulent flow downstream of a backward-facing step Available online at www.sciencedirect.com Procedia Engineering 31 (01) 16 International Conference on Advances in Computational Modeling and Simulation Large eddy simulation of turbulent flow downstream

More information

Is My CFD Mesh Adequate? A Quantitative Answer

Is My CFD Mesh Adequate? A Quantitative Answer Is My CFD Mesh Adequate? A Quantitative Answer Krzysztof J. Fidkowski Gas Dynamics Research Colloqium Aerospace Engineering Department University of Michigan January 26, 2011 K.J. Fidkowski (UM) GDRC 2011

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

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

Quantum Numbers and Rules

Quantum Numbers and Rules OpenStax-CNX module: m42614 1 Quantum Numbers and Rules OpenStax College Tis work is produced by OpenStax-CNX and licensed under te Creative Commons Attribution License 3.0 Abstract Dene quantum number.

More information

Discontinuous Galerkin methods for nonlinear elasticity

Discontinuous Galerkin methods for nonlinear elasticity Discontinuous Galerkin methods for nonlinear elasticity Preprint submitted to lsevier Science 8 January 2008 The goal of this paper is to introduce Discontinuous Galerkin (DG) methods for nonlinear elasticity

More information

Finite Element Methods for Linear Elasticity

Finite Element Methods for Linear Elasticity Finite Element Metods for Linear Elasticity Ricard S. Falk Department of Matematics - Hill Center Rutgers, Te State University of New Jersey 110 Frelinguysen Rd., Piscataway, NJ 08854-8019 falk@mat.rutgers.edu

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

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

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 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

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

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

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

arxiv: v1 [math.na] 12 Mar 2018

arxiv: v1 [math.na] 12 Mar 2018 ON PRESSURE ESTIMATES FOR THE NAVIER-STOKES EQUATIONS J A FIORDILINO arxiv:180304366v1 [matna 12 Mar 2018 Abstract Tis paper presents a simple, general tecnique to prove finite element metod (FEM) pressure

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

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

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

SMAI-JCM SMAI Journal of Computational Mathematics

SMAI-JCM SMAI Journal of Computational Mathematics SMAI-JCM SMAI Journal of Computational Matematics Compatible Maxwell solvers wit particles II: conforming and non-conforming 2D scemes wit a strong Faraday law Martin Campos Pinto & Eric Sonnendrücker

More information

A-posteriori error estimates for Discontinuous Galerkin approximations of second order elliptic problems

A-posteriori error estimates for Discontinuous Galerkin approximations of second order elliptic problems A-posteriori error estimates for Discontinuous Galerkin approximations of second order elliptic problems Carlo Lovadina, and L. Donatella Marini Abstract Using te weigted residual formulation we derive

More information

THE STURM-LIOUVILLE-TRANSFORMATION FOR THE SOLUTION OF VECTOR PARTIAL DIFFERENTIAL EQUATIONS. L. Trautmann, R. Rabenstein

THE STURM-LIOUVILLE-TRANSFORMATION FOR THE SOLUTION OF VECTOR PARTIAL DIFFERENTIAL EQUATIONS. L. Trautmann, R. Rabenstein Worksop on Transforms and Filter Banks (WTFB),Brandenburg, Germany, Marc 999 THE STURM-LIOUVILLE-TRANSFORMATION FOR THE SOLUTION OF VECTOR PARTIAL DIFFERENTIAL EQUATIONS L. Trautmann, R. Rabenstein Lerstul

More information

APPROXIMATION OF CRYSTALLINE DENDRITE GROWTH IN TWO SPACE DIMENSIONS. Introduction

APPROXIMATION OF CRYSTALLINE DENDRITE GROWTH IN TWO SPACE DIMENSIONS. Introduction Acta Mat. Univ. Comenianae Vol. LXVII, 1(1998), pp. 57 68 57 APPROXIMATION OF CRYSTALLINE DENDRITE GROWTH IN TWO SPACE DIMENSIONS A. SCHMIDT Abstract. Te pase transition between solid and liquid in an

More information

Numerical Analysis MTH603. dy dt = = (0) , y n+1. We obtain yn. Therefore. and. Copyright Virtual University of Pakistan 1

Numerical Analysis MTH603. dy dt = = (0) , y n+1. We obtain yn. Therefore. and. Copyright Virtual University of Pakistan 1 Numerical Analysis MTH60 PREDICTOR CORRECTOR METHOD Te metods presented so far are called single-step metods, were we ave seen tat te computation of y at t n+ tat is y n+ requires te knowledge of y n only.

More information

HP-MULTIGRID AS SMOOTHER ALGORITHM FOR HIGHER ORDER DISCONTINUOUS GALERKIN DISCRETIZATIONS OF ADVECTION DOMINATED FLOWS PART I. MULTILEVEL ANALYSIS

HP-MULTIGRID AS SMOOTHER ALGORITHM FOR HIGHER ORDER DISCONTINUOUS GALERKIN DISCRETIZATIONS OF ADVECTION DOMINATED FLOWS PART I. MULTILEVEL ANALYSIS HP-MULTIGRID AS SMOOTHER ALGORITHM FOR HIGHER ORDER DISCONTINUOUS GALERKIN DISCRETIZATIONS OF ADVECTION DOMINATED FLOWS PART I. MULTILEVEL ANALYSIS J.J.W. VAN DER VEGT AND S. RHEBERGEN AMS subect classifications.

More information

AMS 147 Computational Methods and Applications Lecture 09 Copyright by Hongyun Wang, UCSC. Exact value. Effect of round-off error.

AMS 147 Computational Methods and Applications Lecture 09 Copyright by Hongyun Wang, UCSC. Exact value. Effect of round-off error. Lecture 09 Copyrigt by Hongyun Wang, UCSC Recap: Te total error in numerical differentiation fl( f ( x + fl( f ( x E T ( = f ( x Numerical result from a computer Exact value = e + f x+ Discretization error

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

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

The entransy dissipation minimization principle under given heat duty and heat transfer area conditions

The entransy dissipation minimization principle under given heat duty and heat transfer area conditions Article Engineering Termopysics July 2011 Vol.56 No.19: 2071 2076 doi: 10.1007/s11434-010-4189-x SPECIAL TOPICS: Te entransy dissipation minimization principle under given eat duty and eat transfer area

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

An Adaptive Model Switching and Discretization Algorithm for Gas Flow on Networks

An Adaptive Model Switching and Discretization Algorithm for Gas Flow on Networks Procedia Computer Science 1 (21) (212) 1 1 1331 134 Procedia Computer Science www.elsevier.com/locate/procedia International Conference on Computational Science, ICCS 21 An Adaptive Model Switcing and

More information

A = h w (1) Error Analysis Physics 141

A = h w (1) Error Analysis Physics 141 Introduction In all brances of pysical science and engineering one deals constantly wit numbers wic results more or less directly from experimental observations. Experimental observations always ave inaccuracies.

More information

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation Faheem Ahmed, Fareed Ahmed, Yongheng Guo, Yong Yang Abstract This paper deals with

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

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

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

NON STANDARD FITTED FINITE DIFFERENCE METHOD FOR SINGULAR PERTURBATION PROBLEMS USING CUBIC SPLINE

NON STANDARD FITTED FINITE DIFFERENCE METHOD FOR SINGULAR PERTURBATION PROBLEMS USING CUBIC SPLINE Global and Stocastic Analysis Vol. 4 No. 1, January 2017, 1-10 NON STANDARD FITTED FINITE DIFFERENCE METHOD FOR SINGULAR PERTURBATION PROBLEMS USING CUBIC SPLINE K. PHANEENDRA AND E. SIVA PRASAD Abstract.

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

Hybridized Discontinuous Galerkin Methods

Hybridized Discontinuous Galerkin Methods Hybridized Discontinuous Galerkin Methods Theory and Christian Waluga Joint work with Herbert Egger (Uni Graz) 1st DUNE User Meeting, Stuttgart Christian Waluga (AICES) HDG Methods October 6-8, 2010 1

More information

Discontinuous Galerkin Methods

Discontinuous Galerkin Methods Discontinuous Galerkin Methods Joachim Schöberl May 20, 206 Discontinuous Galerkin (DG) methods approximate the solution with piecewise functions (polynomials), which are discontinuous across element interfaces.

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

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

Chapters 19 & 20 Heat and the First Law of Thermodynamics

Chapters 19 & 20 Heat and the First Law of Thermodynamics Capters 19 & 20 Heat and te First Law of Termodynamics Te Zerot Law of Termodynamics Te First Law of Termodynamics Termal Processes Te Second Law of Termodynamics Heat Engines and te Carnot Cycle Refrigerators,

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

HOMEWORK HELP 2 FOR MATH 151

HOMEWORK HELP 2 FOR MATH 151 HOMEWORK HELP 2 FOR MATH 151 Here we go; te second round of omework elp. If tere are oters you would like to see, let me know! 2.4, 43 and 44 At wat points are te functions f(x) and g(x) = xf(x)continuous,

More information

A MESH ADAPTATION METHOD FOR 1D-BOUNDARY LAYER PROBLEMS

A MESH ADAPTATION METHOD FOR 1D-BOUNDARY LAYER PROBLEMS INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING, SERIES B Volume 3, Number 4, Pages 408 428 c 2012 Institute for Scientific Computing and Information A MESH ADAPTATION METHOD FOR 1D-BOUNDARY LAYER

More information

A New Class of Zienkiewicz-Type Nonconforming Element in Any Dimensions

A New Class of Zienkiewicz-Type Nonconforming Element in Any Dimensions Numerisce Matematik manuscript No. will be inserted by te editor A New Class of Zienkiewicz-Type Nonconforming Element in Any Dimensions Wang Ming 1, Zong-ci Si 2, Jincao Xu1,3 1 LMAM, Scool of Matematical

More information

DELFT UNIVERSITY OF TECHNOLOGY Faculty of Electrical Engineering, Mathematics and Computer Science

DELFT UNIVERSITY OF TECHNOLOGY Faculty of Electrical Engineering, Mathematics and Computer Science DELFT UNIVERSITY OF TECHNOLOGY Faculty of Electrical Engineering, Matematics and Computer Science. ANSWERS OF THE TEST NUMERICAL METHODS FOR DIFFERENTIAL EQUATIONS (WI3097 TU) Tuesday January 9 008, 9:00-:00

More information