5. FVM Discretization and Solution Procedure

Total Page:16

File Type:pdf, Size:1020Kb

5. FVM Discretization and Solution Procedure 5. FVM discretization and Solution Procedure 1. The fluid domain is divided into a finite number of control volumes (cells of a computational grid). 2. Integral form of the conservation equations are discretized and applied to each of the cells. 3. The objective is to obtain a set of linear algebraic equations, where the total number of unknowns in each equation system is equal to the number of cells. 4. Solve the equation system with an solution algorithm with proper equation solvers. 1 Discretization– Solution Methods We want to transform the partial differential equations (PDE) to a set of algebraic equations: With Finite Volume Methods, the equation is first integrated. This is different from Finite Difference Method where the derivatives are approximated by truncated Taylor series expansions. Advantage with FDM is it is easy to use, but is limited to structured grids (simpler geometry). 2 Discretization– FDM vs. FVM The key difference is Gauss’ theorem FDM FVM 1 2 3 1 2 3 2w 2e Δ푥 푑휙 න 푑푉 ≈ 휙퐴 − 휙퐴 푑푥 2푒 2푤 퐶푉2 푑휙 휙2 − 휙1 휙 − 휙 휙 − 휙 ≈ 3 2 2 1 푑푥 Δ푥 = − 2 Δx Δx 3 Conservation Equations We have the conservation equations: - Mass (mass is conserved) - Momentum (The sum of forces equals the time rate of change of momentum) - Energy (Energy can not be created nor destroyed) These equations can be expressed as a single generalized transport equation 4 Discretization– transport equation 휕 휌휙 휕 휕 휕휙 + 휌푢푗휙 = Γ + 푆휙 휕푡 휕푥푗 휕푥푗 휕푥푗 Transient Convective Diffusive Source 휙 = 1 gives continuity (mass) 휙 = 푢 gives momentum 휙 can also be temperature or other scalars, but need to check if the equation is still satisfied. Source terms can be external body forces, like gravity. Observe also that the pressure gradient is included in 푆휙 for momentum 5 Solution procedure – momentum equations Insertion of velocity in the transport equation gives us transport of momentum. The resulting equation requires different treatment than transport of any scalar (like temperature) because of the following reasons: 1. The convective terms are non-linear since they contain 푈2 2. All equations are coupled because velocity component appears in all 3. Momentum equation contain a pressure gradient (inside source term) without an own explicit equation for pressure in the equation set 6 Discretization– Finite Volume Method The equation is first integrated. Discretization is done in the second step. When it’s integrated, Gauss’ theorem is applied and the net fluxes on cell faces must be expressed from values at the cell centers using interpolation. Advantage is flexibility with regard to cell geometry. Advantage in less memory usage. There are also well developed solvers for this method. FVM has the broadest applicability of all CFD methods. 7 Discretization– integration of transport equation Integrated over the cell volume: 휕 휌휙 휕 휕 휕휙 න 푑푉 + න 휌푢푗휙 푑푉 + න Γ 푑푉 + න 푆휙 푑푉 Δ푉 휕푡 Δ푉 휕푥푗 Δ푉 휕푥푗 휕푥푗 Δ푉 The second and third terms can be expressed as fluxes (Gauss’ theorem). That is transport across the CV boundaries. If the time term is included, we must integrate in time as well. 8 Discretization FVM– discrete transport equation 휕 휌휙 휌휙푉 푛+1 − 휌휙푉 푛 න 푑푉 ≈ 퐶푉 휕푡 Δ푡 휕 න 휌풖휙 푑퐴 ≈ ෍ 휌휙풖 ⋅ 풏 푓 휕푥푗 퐴 푓 휕 휕휙 휕휙 න Γ 푑퐴 ≈ ෍ Γ ⋅ 풏 휕푥푗 휕푥푗 휕푥푗 퐴 푓 푓 9 Discretization– system of equations We have already mentioned that we wish to discretize the PDE’s and express them as linear algebraic equations of the form: 푎푃휙푃 = ෍ 푎푛푏휙푛푏 + 푆휙 푛푏 Solving these set of equations (for each cell) requires an equation solver. If the algebraic equations are non-linear they may be linearized. In addition to having an efficient solver for the algebraic equations, we need a solution algorithm solves the equations in the correct order. 10 A simple numerical example (On blackboard) Steady-state one-dimensional diffusion equation: 푇 푑 푑휙 푇 Γ = 0 Solution 퐿 푑푥 푑푥 (if Γ const.) 푇0 휙 can be temperature, and Γ thermal conductivity. 푥 푇 = 푇 0 푇 = 푇퐿 11 A simple numerical example - Physics Classification of the problem: 1. What does this equation describe if 휙 is temperature? 2. 푘 is a function of temperature, but can be taken as constant in many situations Physical boundary conditions: 1. Dirichlet: 푇 = 푐표푛푠푡. -> constant temperature 푑푇 2. Neumann: = 푐표푛푠푡. -> constant heat flux, constant normal temperature 푑푥 gradient 12 Derivative vs. Numerical 푓(푥) Definition derivative of function 푓 = 푓(푥): 휕푓 휕푓 Δ푓 = 퐶 → 푓 푥 = 퐶 ⋅ 푥 + 퐶 → ≈ 휕푥 1 1 2 휕푥 Δ푥 Δ푥 푥푖 휕2푓 휕푓 푥2 2 = 퐶1 → = 퐶1 ⋅ 푥 + 퐶2 → 푓 푥 = 퐶1 ⋅ + 퐶2 ⋅ 푥 + 퐶3 휕푥 휕푥 2 푓(푥) 휕푓 휕푓 휕푓 Δ푓 Δ푓 2 Δ − − Δ푥 휕 푓 휕푥 휕푥 Δ푥/2 Δ푥/2 Δ푥 휕푥 2 1 2 1 2 → ≈ = = 2 휕푥2 Δ푥 Δ푥 Δ푥 푥푖 13 Approximation of the first derivative, the FDM approach st Forward-differences (FD), 1 order accuracy: CD with higher order is 푑휙 휙 − 휙 휙 − 휙 ≈ 푖+1 푖 = 푖+1 푖 normally applied to 푑푥 푥 − 푥 Δ푥 푖 푖+1 푖 diffusion terms Backward-differencing (BD), 1st order: Local interior grid 푑휙 휙 − 휙 휙 − 휙 ≈ 푖 푖−1 = 푖 푖−1 푑푥 푥 − 푥 Δ푥 푖 푖 푖−1 푖 − 1 푖 푖 + 1 Central-differencing (CD), 2nd order: 푑휙 휙푖+1 − 휙푖−1 휙푖+1 − 휙푖−1 ≈ = Δ푥 푑푥 푥 − 푥 2Δ푥 푖 푖+1 푖−1 14 Approximation of the second derivative… Evaluate the inner derivative at half-way between nodes, and central differences with Δ푥 spacing for the outer derivative: 푑휙 푑휙 Γ − Γ 푑 푑휙 푑푥 푖+1/2 푑푥 푖−1/2 Γ ≈ Local interior grid 푑푥 푑푥 Δ푥 푖 Where 푖 − 1 푖 푖 + 1 푑휙 휙 − 휙 푑휙 휙 − 휙 푖 − 1/2 푖 + 1/2 ≈ 푖+1 푖 , ≈ 푖 푖−1 푑푥 Δ푥 푑푥 Δ푥 푖+1/2 푖−1/2 15 Approximation of the second derivative (FDM) Evaluate the inner derivative at half-way between nodes, and central differences with Δ푥 spacing for the outer derivative: 휙 − 휙 휙 − 휙 Γ 푖+1 푖 − Γ 푖 푖−1 푑 푑휙 푖+1/2 Δ푥 푖−1/2 Δ푥 Γ ≈ Local interior grid 푑푥 푑푥 Δ푥 푖 Γ + Γ Γ ≈ 푖 푖+1 푖+1/2 2 푖 − 1 푖 푖 + 1 If Γ = 푐표푛푠푡.: 푖 − 1/2 푖 + 1/2 −2휙 + 휙 + 휙 = 푖 푖+1 푖−1 Δ푥2 16 Resulting equation system We wish to express the resulting system in a form 푎푃휙푃 = ෍ 푎푛푏휙푛푏 + 푆휙 푛푏 With constant Γ we get: 2 ⋅ 휙푖 − 휙푖+1 − 휙푖−1 = 0 퐴푖 = 2, 퐴푛푏 = 1 and 푄푖 = 0 17 Resulting equation system On a structured mesh (FDM), mesh and the 휙1 = 휙0 equation matrix is much of the same thing. 2 휙2 − 휙1 − 휙3 = 0 2 휙3 − 휙2 − 휙4 = 0 … … . 휙푁 = 휙퐿 A x = b 1 0 0 0 0 휙1 휙0 -1 2 -1 0 0 휙2 0 0 -1 2 -1 0 * 휙3 = 0 0 0 -1 2 -1 휙4 0 0 0 0 0 1 휙5 휙퐿 18 Discretization– Finite-Volume Approach 푑 푑휙 푑휙 푑휙 න Γ 푑푉 = Γ퐴 − Γ퐴 = 0 푑푥 푑푥 푑푥 푑푥 Δ푉 푒 푤 Local interior grid Γ + Γ Γ + Γ Γ = 푃 퐸 Γ = 푊 푃 푒 2 푤 2 Fluxes 푊 푤 푃 푒 퐸 푑휙 휙퐸 − 휙푃 Γ퐴 = Γ 퐴 Δ푥 푑푥 푒 푒 Δ푥 푒 푃퐸 푑휙 휙 − 휙 Γ퐴 = Γ 퐴 푃 푊 푑푥 푤 푤 Δ푥 푤 푊푃 Central differences 19 Discretization– Finite-Volume Approach Express on this form (algebraic equation): 푎푃휙푃 = ෍ 푎푛푏휙푛푏 + 푆휙 푛푏 Local interior grid Γ 퐴 Γ 퐴 푒 푒 푤 푤 푊 푃 퐸 휙퐸 − 휙푃 − 휙푃 − 휙푊 = 0 푤 푒 Δ푥푃퐸 Δ푥푊푃 Δ푥 Γ푒퐴푒 Γ푤퐴푤 Γ푒퐴푒 Γ푤퐴푤 + 휙푃 = 휙퐸 + 휙푊 + 0 Δ푥푃퐸 Δ푥푊푃 Δ푥푃퐸 Δ푥푊푃 Fluxes 푎푃 푎퐸 푎푊 푆푃 20 Discretization– 2D Diffusion fluxes 푑 푑휙 푑휙 푑휙 푑휙 푑휙 න Γ 푑푉 = Γ퐴 − Γ퐴 + Γ퐴 − Γ퐴 푑푥 푑푥 푑푥 푑푥 푑푥 푑푥 Δ푉 푒 푤 푛 푠 Its a CV equation just like we showed 푁 earlier. Flux in equals out 푛 Approximating face absolute values and 푊 푤 푒 퐸 derivatives poses similar problems as in FDM. 푠 휕휙 Need discretization of 휕푥 푆 21 Discretization– 1D Convection fluxes 푑 න 휌푢휙 푑푉 = 퐴푒 휌푢휙 푒 − 퐴푤 휌푢휙 푤 Δ푉 푑푥 Dealing with these terms are not straightforward, and central differences as for the diffusion leads to unphysical results for high velocities. Local interior grid Introduction of the Peclet number: 푃 퐸 휌푢 푊 푤 푒 푃푒 = Γ/Δ푥 Δ푥 Expresses ratio between convection and diffusion 22 Discretization– 1D Convection fluxes The right discretization scheme is important for the convective fluxes at high Peclet numbers. Different alternatives: First-order upwind scheme: 휙푒 = 휙푃 (if 휌푢휙 푒 > 0) Second-order upwind Local interior grid Hybrid scheme: Combination of central- and upstream QUICK scheme 푊 푤 푃 푒 퐸 General: Central differences only if 푃푒 < 2 Δ푥 If large Peclet numbers, use the upstream value 23 Solution – Residuals Convergence criteria when solving: σ 푎푛푏휙푛푏 + 푆휙 − 푎푃휙푃 푛푏 < 휖 (small number) 푎푃휙푃 24 Solution – Residuals Decreasing residuals means the solution may not be converged If they flatten out and have a low value, like 1E-4 or lower we may assume that convergence have been reached. But this depends on the case. Increasing residuals is normally a bad sign. Correct residuals only mean that our algebraic equation system have been solved, not that the solution is correct.
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]
  • 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
    [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]