From Finite Volumes to Discontinuous Galerkin and Flux Reconstruction

Total Page:16

File Type:pdf, Size:1020Kb

From Finite Volumes to Discontinuous Galerkin and Flux Reconstruction From Finite Volumes to Discontinuous Galerkin and Flux Reconstruction Sigrun Ortleb Department of Mathematics and Natural Sciences, University of Kassel GOFUN 2017 OpenFOAM user meeting March 21, 2017 Numerical simulation of fluid flow This includes flows of liquids and gases such as flow of air or flow of water src: NCTR src: NOAA src: NASA Goddard Spreading of Tsunami waves Weather prediction Flow through sea gates Requirements on numerical solvers High accuracy of computation Detailed resolution of physical phenomena Stability and efficiency, robustness Compliance with physical laws CC BY 3.0 (e.g. conservation) Flow around airplanes 1 Contents 1 The Finite Volume Method 2 The Discontinuous Galerkin Scheme 3 SBP Operators & Flux Reconstruction 4 Current High Performance DG / FR Schemes Derivation of fluid equations Based on physical principles: conservation of quantities & balance of forces mathematical tools: Reynolds transport & Gauß divergence theorem Different formulations: Integral conservation law d Z Z Z u dx + F(u; ru) · n dσ = s(u; x; t) dx dt V @V V Partial differential equation @u n + r · F = s @t V embodies the physical principles 2 Physical principle: conservation of mass dm d Z Z @ρ Z = ρ dx = dx + ρv · n dσ = 0 dt dt Vt Vt @t @Vt Divergence theorem yields Z @ρ @ρ + r · (ρv) dx = 0 ) + r · (ρv) = 0 V ≡Vt @t @t continuity equation Derivation of the continuity equation Based on Reynolds transport theorem d Z Z @u(x; t) Z u(x; t) dx = dx + u(x; t) v · n dσ dt Vt Vt @t @Vt rate of change rate of change convective transfer = + in moving volume in fixed volume through surface (Vt control volume of fluid particles) 3 Divergence theorem yields Z @ρ @ρ + r · (ρv) dx = 0 ) + r · (ρv) = 0 V ≡Vt @t @t continuity equation Derivation of the continuity equation Based on Reynolds transport theorem d Z Z @u(x; t) Z u(x; t) dx = dx + u(x; t) v · n dσ dt Vt Vt @t @Vt rate of change rate of change convective transfer = + in moving volume in fixed volume through surface (Vt control volume of fluid particles) Physical principle: conservation of mass dm d Z Z @ρ Z = ρ dx = dx + ρv · n dσ = 0 dt dt Vt Vt @t @Vt 3 Derivation of the continuity equation Based on Reynolds transport theorem d Z Z @u(x; t) Z u(x; t) dx = dx + u(x; t) v · n dσ dt Vt Vt @t @Vt rate of change rate of change convective transfer = + in moving volume in fixed volume through surface (Vt control volume of fluid particles) Physical principle: conservation of mass dm d Z Z @ρ Z = ρ dx = dx + ρv · n dσ = 0 dt dt Vt Vt @t @Vt Divergence theorem yields Z @ρ @ρ + r · (ρv) dx = 0 ) + r · (ρv) = 0 V ≡Vt @t @t continuity equation 3 The compressible Navier-Stokes equations ... are based on conservation of mass, momentum and energy @u @u + r · F = s + r · Finv + r · (A(u)ru) = s @t @t inviscid & viscous fluxes 5 3×5 5 Conservative variables u 2 R , fluxes F 2 R and sources s 2 R 0 ρ 1 0 ρv 1 0 0 1 u = @ ρv A; F = @ ρv ⊗ v + pI − τ A; s = @ ρg A ρE (ρE + p)v − κrT − τ · v ρ(q + g · v) convective fluxes, body forces heat fluxes & surface forces & heat sources p pressure, T temperature g gravitational & τ viscous stress tensor electromag. forces κ thermal conductivity q intern. heat sources ! simplified programming by representation in same generic form ! sufficient to develop discretization schemes for generic conservation law 4 General discretization techniques Finite differences / differential form xi;j+1 approximation of nodal values and nodal x x x derivatives i−1;j i;j i+1;j easy to derive, efficient xi;j−1 essentially limited to structured meshes Finite volumes / integral form approximation of cell means and integrals conservative by construction suitable for arbitrary meshes difficult to extend to higher order Finite elements / weak form weighted residual formulation quite flexible and general suitable for arbitrary meshes 5 Finite volume schemes ... based on the integral rather than the differential form Integral conservation enforced for small control volumes Vi defined by computational mesh K [ V¯ = V¯i i=1 Degrees of freedom: cell means 1 Z ui (t) = u(x; t) dx cell-centered vs. vertex-centered jVi j Vi possibly staggered for different variables To be specified: concrete definition of control volumes type of approximation inside these numerical method for evaluation of integrals and fluxes 6 It is important to ensure correct shock speed Characteristic curves are straight lines and cross ! smooth solution breaks down integral form (time integrated) still holds Why the integral form? Because this is the form directly obtained from physics. 1 2 @u @u 1D scalar hyperbolic f (u) = 2 u ) @t + u @x = 0 conservation law (Burgers equation) 8 < 1; x < 0; @u @f (u) init. cond.: u0(x) = cos(πx); 0 ≤ x ≤ 1; + = 0 @t @x : −1; x > 1: PDE theory tells us: As long as the exact solution is smooth, it is constant along charactereristic curves 7 It is important to ensure correct shock speed Why the integral form? Because this is the form directly obtained from physics. 1 2 @u @u 1D scalar hyperbolic f (u) = 2 u ) @t + u @x = 0 conservation law (Burgers equation) 8 < 1; x < 0; @u @f (u) init. cond.: u0(x) = cos(πx); 0 ≤ x ≤ 1; + = 0 @t @x : −1; x > 1: PDE theory tells us: As long as the exact solution is smooth, it is constant along charactereristic curves Characteristic curves are straight lines and cross ! smooth solution breaks down integral form (time integrated) still holds 7 Why the integral form? Because this is the form directly obtained from physics. 1 2 @u @u 1D scalar hyperbolic f (u) = 2 u ) @t + u @x = 0 conservation law (Burgers equation) 8 < 1; x < 0; @u @f (u) init. cond.: u0(x) = cos(πx); 0 ≤ x ≤ 1; + = 0 @t @x : −1; x > 1: PDE theory tells us: As long as the exact solution is smooth, it is constant along charactereristic curves It is important to ensure correct shock speed Characteristic curves are straight lines and cross ! smooth solution breaks down integral form (time integrated) still holds 7 On a control volume V = [xi−1=2; xi+1=2], the exact solution fulfills x d Z i+1=2 x u dx + [f (u)] i+1=2 = 0 dt xi−1=2 xi−1=2 un+1 − un discretized: ∆x i i + f (un ) − f (un ) = 0 i ∆t i+1=2 i−1=2 flux values f (ui±1=2) depending on unknown face quantities ui−1=2; ui+1=2 ! reconstruction necessary from available data :::; ui−1; ui ; ui+1;::: ! Introduction of numerical flux functions f ∗ ∆x un+1 = un − i f ∗(un; un ) − f ∗(un ; un) i i ∆t i i+1 i−1 i Discretization in conservative form In 1D, the FV scheme can be regarded as a FD scheme in conservative form 1 Z xi+1=2 ui (t) = u(x; t) dx ∆xi xi−1=2 8 flux values f (ui±1=2) depending on unknown face quantities ui−1=2; ui+1=2 ! reconstruction necessary from available data :::; ui−1; ui ; ui+1;::: ! Introduction of numerical flux functions f ∗ ∆x un+1 = un − i f ∗(un; un ) − f ∗(un ; un) i i ∆t i i+1 i−1 i Discretization in conservative form In 1D, the FV scheme can be regarded as a FD scheme in conservative form 1 Z xi+1=2 ui (t) = u(x; t) dx ∆xi xi−1=2 On a control volume V = [xi−1=2; xi+1=2], the exact solution fulfills x d Z i+1=2 x u dx + [f (u)] i+1=2 = 0 dt xi−1=2 xi−1=2 un+1 − un discretized: ∆x i i + f (un ) − f (un ) = 0 i ∆t i+1=2 i−1=2 8 Discretization in conservative form In 1D, the FV scheme can be regarded as a FD scheme in conservative form 1 Z xi+1=2 ui (t) = u(x; t) dx ∆xi xi−1=2 On a control volume V = [xi−1=2; xi+1=2], the exact solution fulfills x d Z i+1=2 x u dx + [f (u)] i+1=2 = 0 dt xi−1=2 xi−1=2 un+1 − un discretized: ∆x i i + f (un ) − f (un ) = 0 i ∆t i+1=2 i−1=2 flux values f (ui±1=2) depending on unknown face quantities ui−1=2; ui+1=2 ! reconstruction necessary from available data :::; ui−1; ui ; ui+1;::: ! Introduction of numerical flux functions f ∗ ∆x un+1 = un − i f ∗(un; un ) − f ∗(un ; un) i i ∆t i i+1 i−1 i 8 Discretization in conservative form In 1D, the FV scheme can be regarded as a FD scheme in conservative form 1 Z xi+1=2 ui (t) = u(x; t) dx ∆xi xi−1=2 On a control volume V = [xi−1=2; xi+1=2], the exact solution fulfills x d Z i+1=2 x u dx + [f (u)] i+1=2 = 0 dt xi−1=2 xi−1=2 un+1 − un discretized: ∆x i i + f (un ) − f (un ) = 0 i ∆t i+1=2 i−1=2 flux values f (ui±1=2) depending on unknown face quantities ui−1=2; ui+1=2 ! reconstruction necessary from available data :::; ui−1; ui ; ui+1;::: ! Introduction of numerical flux functions f ∗ The heart of FV schemes ∆x un+1 = un − i f ∗(un; un ) − f ∗(un ; un) i i ∆t i i+1 i−1 i 8 Upwind methods @u @u Scalar linear equation a > 0 ( @t + a @x = 0) ∆x un+1 = un − (aun − aun )(f ∗(u ; u ) = au ) i i ∆t i i−1 i i+1 i ∗ + − Linear system of equations ! f (ui ; ui+1) = A ui + A ui+1 ∆t un+1 = un − A+(un − un ) + A−(un − un) i i ∆x i i−1 i+1 i Nonlinear systems ! Flux vector splitting + − ∗ + − f(u) = f (u) + f (u) ) f (ui ; ui+1) = f (ui ) + f (ui+1) Steger & Warming, van Leer, AUSM and variants Classical numerical flux functions linked to Riemann problems & characteristic directions 9 Classical numerical flux functions linked to Riemann problems & characteristic directions Upwind methods @u @u Scalar linear equation a > 0 ( @t + a @x = 0) ∆x un+1 = un − (aun − aun )(f ∗(u ; u ) = au ) i i ∆t i i−1 i i+1 i ∗ + − Linear system of equations ! f (ui ; ui+1) = A ui + A ui+1 ∆t un+1 = un − A+(un − un ) + A−(un − un) i i ∆x i i−1 i+1 i Nonlinear systems ! Flux vector splitting + − ∗ + − f(u) = f (u) + f (u) ) f (ui ; ui+1) = f (ui ) + f (ui+1) Steger & Warming, van Leer, AUSM and variants 9 Properties of Roe matrix ALR ALR ≈ A(u) = Df(u) ALR (u; u) = A(u) ALR is diagonalizable f(uR )−f(uL) = ALR (uR −uL) (mean value property) entropy-fix needed HLL scheme Godunov-type scheme approximates only one
Recommended publications
  • A Parallel Preconditioner for a FETI-DP Method for the Crouzeix-Raviart finite Element
    A parallel preconditioner for a FETI-DP method for the Crouzeix-Raviart finite element Leszek Marcinkowski∗1 Talal Rahman2 1 Introduction In this paper, we present a Neumann-Dirichlet type parallel preconditioner for a FETI-DP method for the nonconforming Crouzeix-Raviart (CR) finite element dis- cretization of a model second order elliptic problem. The proposed method is almost optimal, in fact, the condition number of the preconditioned problem grows poly- logarithmically with respect to the mesh parameters of the local triangulations. In many scientific applications, where partial differential equations are used to model, the Crouzeix-Raviart (CR) finite element has been one of the most com- monly used nonconforming finite element for the numerical solution. This includes applications like the Poisson equation (cf. [11, 23]), the Darcy-Stokes problem (cf. [8]), the elasticity problem (cf. [3]). We also would like to add that there is a close relationship between mixed finite elements and the nonconforming finite element for the second order elliptic problem; cf. [1, 2]. The CR element has also been used in the framework of finite volume element method; cf. [9]. There exists quite a number of works focusing on iterative methods for the CR finite element for second order problems; cf. [4, 5, 10, 13, 16, 18, 19, 20, 21, 22] and references therein. The purpose of this paper is to propose a parallel algorithm based on a Neumann-Dirichlet preconditioner for a FETI-DP formulation of the CR finite element method for the second order elliptic problem. To our knowledge, this is apparently the first work on such preconditioner for the FETI-DP method for the Crouzeix-Raviart (CR) finite element.
    [Show full text]
  • Coupling of the Finite Volume Element Method and the Boundary Element Method – an a Priori Convergence Result
    COUPLING OF THE FINITE VOLUME ELEMENT METHOD AND THE BOUNDARY ELEMENT METHOD – AN A PRIORI CONVERGENCE RESULT CHRISTOPH ERATH∗ Abstract. The coupling of the finite volume element method and the boundary element method is an interesting approach to simulate a coupled system of a diffusion convection reaction process in an interior domain and a diffusion process in the corresponding unbounded exterior domain. This discrete system maintains naturally local conservation and a possible weighted upwind scheme guarantees the stability of the discrete system also for convection dominated problems. We show existence and uniqueness of the continuous system with appropriate transmission conditions on the coupling boundary, provide a convergence and an a priori analysis in an energy (semi-) norm, and an existence and an uniqueness result for the discrete system. All results are also valid for the upwind version. Numerical experiments show that our coupling is an efficient method for the numerical treatment of transmission problems, which can be also convection dominated. Key words. finite volume element method, boundary element method, coupling, existence and uniqueness, convergence, a priori estimate 1. Introduction. The transport of a concentration in a fluid or the heat propa- gation in an interior domain often follows a diffusion convection reaction process. The influence of such a system to the corresponding unbounded exterior domain can be described by a homogeneous diffusion process. Such a coupled system is usually solved by a numerical scheme and therefore, a method which ensures local conservation and stability with respect to the convection term is preferable. In the literature one can find various discretization schemes to solve similar prob- lems.
    [Show full text]
  • Hp-Finite Element Methods for Hyperbolic Problems
    ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ Eidgen¨ossische Ecole polytechnique f´ed´erale de Zurich ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ Technische Hochschule Politecnico federale di Zurigo ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ Z¨urich Swiss Federal Institute of Technology Zurich hp-Finite Element Methods for Hyperbolic Problems E. S¨uli†, P. Houston† and C. Schwab ∗ Research Report No. 99-14 July 1999 Seminar f¨urAngewandte Mathematik Eidgen¨ossische Technische Hochschule CH-8092 Z¨urich Switzerland †Oxford University Computing Laboratory, Wolfson Building, Parks Road, Oxford OX1 3QD, United Kingdom ∗E. S¨uliand P. Houston acknowledge the financial support of the EPSRC (Grant GR/K76221) hp-Finite Element Methods for Hyperbolic Problems E. S¨uli†, P. Houston† and C. Schwab ∗ Seminar f¨urAngewandte Mathematik Eidgen¨ossische Technische Hochschule CH-8092 Z¨urich Switzerland Research Report No. 99-14 July 1999 Abstract This paper is devoted to the a priori and a posteriori error analysis of the hp-version of the discontinuous Galerkin finite element method for partial differential equations of hyperbolic and nearly-hyperbolic character. We consider second-order partial dif- ferential equations with nonnegative characteristic form, a large class of equations which includes convection-dominated diffusion problems, degenerate elliptic equa- tions and second-order problems of mixed elliptic-hyperbolic-parabolic type. An a priori error bound is derived for the method in the so-called DG-norm which is optimal in terms of the mesh size h; the error bound is either 1 degree or 1/2 de- gree below optimal in terms of the polynomial degree p, depending on whether the problem is convection-dominated, or diffusion-dominated, respectively. In the case of a first-order hyperbolic equation the error bound is hp-optimal in the DG-norm.
    [Show full text]
  • A Face-Centred Finite Volume Method for Second-Order Elliptic Problems
    A face-centred finite volume method for second-order elliptic problems Ruben Sevilla Zienkiewicz Centre for Computational Engineering, College of Engineering, Swansea University, Wales, UK Matteo Giacomini, and Antonio Huerta Laboratori de C`alculNum`eric(LaC`aN), ETS de Ingenieros de Caminos, Canales y Puertos, Universitat Polit`ecnicade Catalunya, Barcelona, Spain December 19, 2017 Abstract This work proposes a novel finite volume paradigm, the face-centred finite volume (FCFV) method. Contrary to the popular vertex (VCFV) and cell (CCFV) centred finite volume methods, the novel FCFV defines the solution on the mesh faces (edges in 2D) to construct locally-conservative numerical schemes. The idea of the FCFV method stems from a hybridisable discontinuous Galerkin (HDG) formulation with constant degree of approximation, thus inheriting the convergence properties of the classical HDG. The resulting FCFV features a global problem in terms of a piecewise constant function defined on the faces of the mesh. The solution and its gradient in each element are then recovered by solving a set of independent element-by-element problems. The mathematical formulation of FCFV for Poisson and Stokes equation is derived and numerical evidence of optimal convergence in 2D and 3D is provided. Numerical examples are presented to illustrate the accuracy, efficiency and robustness of the proposed methodology. The results show that, contrary to other FV methods, arXiv:1712.06173v1 [math.NA] 17 Dec 2017 the accuracy of the FCFV method is not sensitive to mesh distortion and stretching. In addition, the FCFV method shows its better performance, accuracy and robustness using simplicial elements, facilitating its application to problems involving complex geometries in 3D.
    [Show full text]
  • A Three-Dimensional Electrostatic Particle-In-Cell Methodology on Unstructured Delaunay–Voronoi Grids
    Journal of Computational Physics 228 (2009) 3742–3761 Contents lists available at ScienceDirect Journal of Computational Physics journal homepage: www.elsevier.com/locate/jcp A three-dimensional electrostatic particle-in-cell methodology on unstructured Delaunay–Voronoi grids Nikolaos A. Gatsonis *, Anton Spirkin Mechanical Engineering Department, Worcester Polytechnic Institute, 100 Institute Road, Worcester, MA 01609, USA article info abstract Article history: The mathematical formulation and computational implementation of a three-dimensional Received 20 March 2008 particle-in-cell methodology on unstructured Delaunay–Voronoi tetrahedral grids is pre- Received in revised form 30 January 2009 sented. The method allows simulation of plasmas in complex domains and incorporates Accepted 3 February 2009 the duality of the Delaunay–Voronoi in all aspects of the particle-in-cell cycle. Charge Available online 12 February 2009 assignment and field interpolation weighting schemes of zero- and first-order are formu- lated based on the theory of long-range constraints. Electric potential and fields are derived from a finite-volume formulation of Gauss’ law using the Voronoi–Delaunay dual. Bound- Keywords: ary conditions and the algorithms for injection, particle loading, particle motion, and par- Three-dimensional particle-in-cell (PIC) Unstructured PIC ticle tracking are implemented for unstructured Delaunay grids. Error and sensitivity Delaunay–Voronoi analysis examines the effects of particles/cell, grid scaling, and timestep on the numerical heating, the slowing-down time, and the deflection times. The problem of current collec- tion by cylindrical Langmuir probes in collisionless plasmas is used for validation. Numer- ical results compare favorably with previous numerical and analytical solutions for a wide range of probe radius to Debye length ratios, probe potentials, and electron to ion temper- ature ratios.
    [Show full text]
  • Short Communication on Methods for Nonlinear
    Mathematica Eterna Short Communication 2020 Short Communication on Methods for non- linear Alexander S* Associate Professor, Emeritus-Ankara University, E-mail: [email protected], Turkey There are no generally appropriate methods to solve nonlinear Semianalytical methods PDEs. Still, subsistence and distinctiveness results (such as the The Adomian putrefaction method, the Lyapunov simulated Cauchy–Kowalevski theorem) are recurrently possible, as are small constraint method, and his homotopy perturbation mode proofs of significant qualitative and quantitative properties of are all individual cases of the more wide-ranging homotopy solutions (attainment these results is a major part of study). scrutiny method. These are sequence extension methods, and Computational solution to the nonlinear PDEs, the split-step excluding for the Lyapunov method, are self-determining of small technique, exists for specific equations like nonlinear corporal parameters as compared to the well known perturbation Schrödinger equation. theory, thus generous these methods greater litheness and However, some techniques can be used for several types of resolution simplification. equations. The h-principle is the most powerful method to resolve under gritty equations. The Riquier–Janet theory is an Numerical Solutions effective method for obtaining information about many logical The three most extensively used mathematical methods to resolve over determined systems. PDEs are the limited element method (FEM), finite volume The method of description can be used in some very methods (FVM) and finite distinction methods (FDM), as well exceptional cases to solve partial discrepancy equations. other kind of methods called net free, which were completed to In some cases, a PDE can be solved via perturbation analysis in solve trouble where the above mentioned methods are limited.
    [Show full text]
  • Finite Volume Methods
    Chapter 16 Finite Volume Methods In the previous chapter we have discussed finite difference methods for the discretization of PDEs. In developing finite difference methods we started from the differential form of the conservation law and approximated the partial derivatives using finite difference approximations. In the finite volume method we will work directly with the integral form of the conservation law 75. 57 Self-Assessment Before reading this chapter, you may wish to review... • Integral form of conservation laws 11 • Convection Equation 11 • Upwinding 13 After reading this chapter you should be able to... • Understand the difference between finite difference and finite volume methods • Relevant self-assessment exercises: [LIST SELF-ASSESSMENT EXERCISES HERE] 58 Finite Volume Method in 1-D The basis of the finite volume method is the integral conservation law. The essential idea is to divide the domain into many control volumes (or cells) and approximate the integral conservation law on each of the control volumes. Figure 28 shows an example of a partition of a one-dimensional domain into cells. By convention cell i lies between the points x 1 and x 1 . (Notice that the cells do not need to be of equal size.) i− 2 i+ 2 1 i − 1 i i +1 Nx x 1 x 3 xi− 1 xi 1 xN − 1 xN 1 2 2 2 + 2 x 2 x+ 2 Fig. 28 Mesh and notation for one-dimensional finite volume method. Recall the integral form of the conservation law (i.e. Equation 75). The one-dimensional form of Equation 75 is 89 90 d xR xR U dx + F(U)| − F(U)| = S(U,t)dx.
    [Show full text]
  • Effect of Boundary Condition Approximation On
    HFF 25,4 Effect of boundary condition approximation on convergence and accuracy of a finite volume 950 discretization of the transient Received 10 February 2014 Revised 12 August 2014 heat conduction equation Accepted 13 August 2014 Martin Joseph Guillot Department of Mechanical Engineering, University of New Orleans, Louisiana, USA, and Steve C. McCool Department of Engineering, Novacentrix, Inc., Austin, Texas, USA Abstract Purpose – The purpose of this paper is to investigate the effect of numerical boundary condition implementation on local error and convergence in L2-norm of a finite volume discretization of the transient heat conduction equation subject to several boundary conditions, and for cases with volumetric heat generation, using both fully implicit and Crank-Nicolson time discretizations. The goal is to determine which combination of numerical boundary condition implementation and time discretization produces the most accurate solutions with the least computational effort. Design/methodology/approach – The paper studies several benchmark cases including constant temperature, convective heating, constant heat flux, time-varying heat flux, and volumetric heating, and compares the convergence rates and local to analytical or semi-analytical solutions. Findings – The Crank-Nicolson method coupled with second-order expression for the boundary derivatives produces the most accurate solutions on the coarsest meshes with the least computation times. The Crank-Nicolson method allows up to 16X larger time step for similar accuracy, with nearly negligible additional computational effort compared with the implicit method. Practical implications – The findings can be used by researchers writing similar codes for quantitative guidance concerning the effect of various numerical boundary condition approximations for a large class of boundary condition types for two common time discretization methods.
    [Show full text]
  • Numerical Analysis of Convection–Diffusion Using a Modified Upwind
    mathematics Article Numerical Analysis of Convection–Diffusion Using a Modified Upwind Approach in the Finite Volume Method Arafat Hussain 1, Zhoushun Zheng 1,* and Eyaya Fekadie Anley 1,2 1 School of Mathematics and Statistics, Central South University, Changsha 410083, China; [email protected] (A.H.); [email protected] (E.F.A.) 2 Department of Mathematics, College of Natural and Computational Science, Arba-Minch University, Arba-Minch 21, Ethiopia * Correspondence: [email protected] Received: 14 September 2020; Accepted: 5 October 2020; Published: 28 October 2020 Abstract: The main focus of this study was to develop a numerical scheme with new expressions for interface flux approximations based on the upwind approach in the finite volume method. Our new proposed numerical scheme is unconditionally stable with second-order accuracy in both space and time. The method is based on the second-order formulation for the temporal approximation, and an upwind approach of the finite volume method is used for spatial interface approximation. Some numerical experiments have been conducted to illustrate the performance of the new numerical scheme for a convection–diffusion problem. For the phenomena of convection dominance and diffusion dominance, we developed a comparative study of this new upwind finite volume method with an existing upwind form and central difference scheme of the finite volume method. The modified numerical scheme shows highly accurate results as compared to both numerical schemes. Keywords: finite volume method; second-order; convection–diffusion problem; stability; convergence order MSC: 26A33; 35R11; 65M12 1. Introduction Partial differential equations (PDEs) have a vital role in describing different phenomena in real life.
    [Show full text]
  • A Numerical Technique Finite Volume Method for Solving Diffusion 2D Problem
    The International Journal Of Engineering And Science (IJES) || Volume || 4 || Issue || 10 || Pages || PP -35-41|| 2015 || ISSN (e): 2319 – 1813 ISSN (p): 2319 – 1805 A numerical Technique Finite Volume Method for Solving Diffusion 2D Problem 1Mohammed Hasnat, 2Nourddine Kaid, 3Mohammed Bensafi, 4Abdellah Belkacem 1,2,3,4Laboratory of energy in arid areas (ENERGARID), Faculty of Science and Technology, University of BECHAR, BP 417, 08000 BECHAR --------------------------------------------------------ABSTRACT----------------------------------------------------------- In this paper, a numerical finite volume technique was used to solve transient partial differential equations for heat transfer in two dimensions with the boundary condition of mixed Dirichlet (constant, not constant) in a rectangular field. We explained the procedures step by step, for the digital solution we used our Fortran code and a line by line TDMA solver for algebraic equations. Finally, the numerical results are compared with the exact solution. Keywords – Conduction, Dirichlet boundary condition, finite volume method, heat transfer, TDMA. ------------------------------------------------------------------------------------------------------------------------------------------- Date of Submission: 10 September 2015 Date of Accepted: 30 October 2015 ------------------------------------------------------------------------------------------------------------------------------------------- I. INTRODUCTION The partial derivative equations are very often used in science and
    [Show full text]
  • An Element-Based Finite Volume Method for Solid Mechanics Problems
    V European Conference on Computational Fluid Dynamics ECCOMAS CFD 2010 J. C. F. Pereira and A. Sequeira (Eds) Lisbon, Portugal, 14–17 June 2010 AN ELEMENT-BASED FINITE VOLUME METHOD FOR SOLID MECHANICS PROBLEMS Gerson Filippini*, Clovis R. Maliska†, Miguel Vaz Jr†† *Federal Technological University of Paraná, Av. Brazil, 4232, 85884-000 Medianeira, PR, Brazil e-mail: [email protected] †Dept. of Mechanical Engineering, Federal University of Santa Catarina – Computational Fluid Dynamics Laboratory – SINMEC, 88040-900 - Florianopolis, SC, Brazil. e-mail: [email protected] ††Department of Mechanical Engineering, Centre for Technological Sciences, State University of Santa Catarina, UDESC, Campus Universitário Prof. Avelino Marcante, 89223-100 Joinville, Brazil e-mail: [email protected] Key words: Finite Volume Method, Plane Elasticity, Fluid-Structure Interaction. Abstract. Recently, in terms of investigation and in a minor scale for the solution of structural mechanics problems, Finite Volume (FV) techniques has been frequently considered [1]. Recently, finite volume methods has been tested in several structural problems, such as elasticity [3,5,6], thermo-elasticity [4], visco-plasticity [7], axi- symmetric structures [8.12], incompressible materials [10.11], plates [9], orthotropy [13], welding process [15], fluid-structure interaction [14], extrusion and forging [16], among others. The results were always very promising, since the method demonstrated to be robust and always following consistently the reference solutions available, considering both, the primitive variables (displacements) and recovered variables (stresses) [2,17]. Besides its inherent robustness due to its conservative approach, another strong factor that favors the advancement of the method has been its ability in dealing with complex geometries using meshes similar to the ones used by finite element methods (FEM).
    [Show full text]
  • A Three-Dimensional Particle-In-Cell Methodology on Unstructured Voronoi Grids with Applications to Plasma Microdevices
    A Three-dimensional Particle-in-Cell Methodology on Unstructured Voronoi Grids with Applications to Plasma Microdevices by Anton M. Spirkin A Dissertation Submitted to the Faculty of the WORCESTER POLYTECHNIC INSTITUTE in partial fulfillment of the requirement for the degree of Doctor of Philosophy in Mechanical Engineering By ____________________________________ April 2006 APPROVED: ______________________________________________ Dr. Nikolaos A. Gatsonis, Advisor Professor, Mechanical Engineering Department ______________________________________________ Dr. Gretar Tryggvason, Committee Member Professor, Mechanical Engineering Department ______________________________________________ Dr. John J. Blandino, Committee Member Assistant Professor, Mechanical Engineering Department ______________________________________________ Dr. George E. Karniadakis, Committee Member Professor, Applied Mathematics Department, Brown University ______________________________________________ Dr. Mark W. Richman, Graduate Committee Representative Associate Professor, Mechanical Engineering Department ABSTRACT The development and numerical implementation of a three-dimensional Particle-In-Cell (3D PIC) methodology on unstructured Voronoi-Delauney tetrahedral grids is presented. Charge assignment and field interpolation weighting schemes of zero- and first-order are formulated based on the theory of long-range constraints for three-dimensional unstructured grids. The algorithms for particle motion, particle tracing, particle injection, and loading are discussed.
    [Show full text]