First-Order System Least-Squares for the Oseen Equations

Total Page:16

File Type:pdf, Size:1020Kb

First-Order System Least-Squares for the Oseen Equations FIRST-ORDER SYSTEM LEAST-SQUARES FOR THE OSEEN EQUATIONS SANG DONG KIM¤, CHANG-OCK LEEy , THOMAS A. MANTEUFFELz , STEPHEN F. MCCORMICKx , AND OLIVER ROHRLEÄ { Abstract. Following earlier work for Stokes equations, a least-squares functional is developed for two- and three-dimensional Oseen equations. By introducing a velocity flux variable and associated curl and trace equations, ellipticity is established in an appropriate product norm. The form of Oseen equations examined here is obtained by linearizing the incompressible Navier-Stokes equations. An algorithm is presented for approximately solving steady state, incompressible Navier-Stokes equations with a Nested Iteration-Newton-FOSLS-AMG iterative scheme, which involves solving a sequence of Oseen equations. Some numerical results for Kovasznay flow are provided. Key words. least-squares discretization, Oseen equations, nested iteration AMS(MOS) subject classi¯cations. 65F10, 65F30 1. Introduction. Over the last decade, many successful theories were developed for a ¯rst- order system formulation of Stokes and Navier-Stokes equations (see [1, 2, 3, 4, 5, 6, 7]). The ¯rst- order system introduced in [7] for Stokes equations involved velocity, u, a new dependent variable, U = rut, refer to as velocity flux, and pressure, p. The least-squares functional using L2 and H¡1 norms weighted appropriately by the viscosity constant, ¹, was shown to be elliptic in the sense that 2 2 2 2 2 its homogeneous form is equivalent to squared product norm ¹ kUk +¹ kuk1 +kpk : Furthermore, with the extended ¯rst-order system, which includes equations involving trace and curl related to velocity flux, it was shown that the functionals using an L2 norm weighted by ¹ is elliptic in the sense 2 2 2 2 2 of squared product norm ¹ kUk1 +¹ kuk1 +kpk1 (see [7]). This equivalence of the ¯rst-order system least-squares method enables us to use standard ¯nite element spaces to discretize the equations and multigrid methods to solve the resulting linear systems with respective optimal approximation and solver properties (see, for example, [8]). The purpose of this paper is to apply this methodology to the steady-state, incompressible Navier-Stokes equations with a linearized convection term, which yields the Oseen equations. A method for linearization of the Navier-Stokes equations is to introduce a known function, ¯, con- sidered as an approximation of velocity, u, in the convection terms. Thus, (rut)tu is replaced by (r(ut + ¯t))t(u + ¯), which is linearized as (rut)t¯ + (r¯t)tu + (r¯t)t¯. As in [7], we begin by reformulating the Oseen equations in two or three dimensions as a ¯rst-order system in terms of a velocity flux variable, and then apply least-squares principles to this system using L2 and H¡1 norms, which produces a functional we call G1 (see (3.1)). This system can be further extended to a ¯rst-order system with equations involving the curl and grad trace of the velocity flux variable. 2 The associated least-squares functional, formed by summing L norms of each equation, we call G2 ¤Department of Mathematics Education, Kyungpook National University, Taegu, Korea 702-701 ([email protected]). This work was sponsored by the Korea Research Foundation under grant KRF- 2002-070-C00014. yDivision of Applied Mathematics, KAIST, Daejeon, 305-701, Korea ([email protected]). This work was sponsored by KOSEF R01-2000-00008. zDepartment of Applied Mathematics, Campus Box 526, University of Colorado at Boulder, Boulder, CO 80309- 0526 ([email protected]). This work was sponsored by the Department of Energy under grant numbers DE-FC02-01ER25479 and DE-FG02-03ER25574, Lawrence Livermore National Laboratory under contract number B541045, Sandia National Laboratory under contract number 15268, and the National Science Foundation under grant numbers DMS-0410318.. xDepartment of Applied Mathematics, Campus Box 526, University of Colorado at Boulder, Boulder, CO 80309- 0526 ([email protected]). This work was sponsored by the Department of Energy under grant numbers DE-FC02- 01ER25479 and DE-FG02-03ER25574, Lawrence Livermore National Laboratory under contract number B541045, Sandia National Laboratory under contract number 15268, and the National Science Foundation under grant numbers DMS-0410318. {Bioengineering Institute, The University of Auckland, Private Bag 92019, Auckland 1, New Zealand ([email protected]). This work was sponsored by the Department of Energy under grant numbers DE-FC02- 01ER25479 and DE-FG02-03ER25574, Lawrence Livermore National Laboratory under contract number B533502, Sandia National Laboratory under contract number 15268, and the National Science Foundation under VIGRE grant number DMS-9810751. 1 (see (3.2)). We assume that the Oseen equations have a unique solution, which provides the desired 1 2 H and H regularities (see (3.5) and (3.12)). We are, thus, able to show that G1 is equivalent to 2 1 1 the squared L and H norms and that G2 is equivalent to the squared product H norm. It should be noted that the constants involved in the equivalences we develop in this paper are naturally 1 dependent on the domain, ­, the Reynolds number, ¸ = ¹ , and the approximate velocity, ¯. Incompressible Navier-Stokes equations can be approximately solved by initial triangulation of the physical domain using a ¯nite element grid that is as coarse as possible, but ¯ne enough to roughly resolve the domain. A Newton iteration is employed, which involves solving a sequence of Oseen equations, each of which is discretized using a FOSLS formulation. The resulting discrete equations are solved using an algebraic multigrid method (AMG). Once the Navier-Stokes equations on the initial grid are su±ciently resolved, the solution is used as an initial guess for a re¯ned grid. This Nested-Iteration (NI) algorithm is repeated through a sequence of successively ¯ner grids until su±cient resolution of the Navier-Stokes equations is achieved. Numerical results presented in section 6 show that this approach is highly e®ective. Computation on the ¯nest grid is minimized, which is advantageous because work on the coarse grids is relatively inexpensive. After the ¯rst few grids, the solution on one grid is in the basin of attraction of the next ¯ner grid, where only one Newton step, that is, the solution of one Oseen system, is required. The approach here is similar to the NI-Newton-FOSLS-AMG scheme described in [9] and applied to elliptic grid generation in [10]. It is well known that the basin of attraction for such methods can be very small. To get within the basin of attraction, one often has to use on coarser levels more expensive and problem- speci¯c methods such as the Projection Multilevel (PML) method proposed in [11], which treats the nonlinearity of the Navier-Stokes equations directly and does not appeal to any linearization step. This method tends to be more robust and has typically a larger domain of convergence, but is in its current form limited, for example, by its set-up cost and choice of smoother. A more signi¯cant advantage of global linearization methods, e.g., the NI-Newton-FOSLS-AMG scheme, is that they rely on the solution of large linear systems of equations and, therefore, can draw upon an extensive repertoire on algorithms and knowledge, in particular, since substantial multigrid research is directed on developing robust, fast, and e±cient linear solvers. In section 2, we provide the ¯rst-order system formulation with de¯nitions, notation, and some preliminaries. In section 3, ellipticity and continuity for the functionals are shown. In section 4, H1 and H2 regularity is proved under the assumption of uniqueness of the solution of the Oseen equations. The NI-Newton-FOSLS-AMG algorithm is described in section 5. In section 6, numerical results for Kovasznay flow are presented. 2. The Oseen equations, its ¯rst-order system formulation, and other preliminaries. Let ­ be a bounded, connected domain in <n(n = 2; 3) with Lipschitz continuous (C0;1) boundary, @­. Consider the stationary, incompressible Oseen equations with Dirichlet boundary conditions for t velocity, u = (u1; : : : ; un) , and the usual integral condition for pressure, p, as follows: 8 < ¡¹¢ u + (rut)t¯ + (r¯t)tu + rp = f; in ­; (2.1) r ¢ u = g; in ­; : u = b; on @­; where symbols ¢,r, and r¢ stand for the Laplacian, gradient, and divergence operators, respectively t 1 (¢u is the vector of components ¢ ui); ¯ = (¯1; : : : ; ¯n) is a given C vector function; ¹ is a viscosity constant; f is a given vector function; g is a given scalar function; and b is the value of velocity on the boundary. We further assume that Z p d­ = 0: ­ For convenience, we adopt the notation introduced in [7]. A new independent variable related to 2 the n -vector function of gradients of the displacement vectors, ui, i = 1; : : : ; n, is introduced below. It is convenient to view the original n-vector functions as column vectors and the new n2-vector t functions as either block column vectors or matrices. The velocity variable, u = (u1; : : : ; un) , is a 2 t column vector with scalar components ui, so that the gradient, ru , is a matrix with columns rui. For a function, U, with n vector components Ui, we write t U = ru = (U1; U2;:::; Un) = (Uij )n£n; which is a matrix with entries Uij = @uj=@xi, 1 · i; j · n: We next de¯ne the trace operator, tr, as Xn trU = Uii; i=1 the divergence operator, r¢, as t t (r ¢ U) = (r ¢ U1; r ¢ U2;:::; r ¢ Un) ; and the curl operator, r£, as r£U = (r£U1;:::; r£Un): Note that, in the two-dimensional case, n = 2, the curl of u is naturally de¯ned by means of the scalar function µ ¶ u1 r£ = @1u2 ¡ @2u1: u2 We also de¯ne the tangential operator, n£, componentwise as n £ U = (n £ U1;:::; n £ Un): The inner products and norms on the block column vector functions are de¯ned in the natural componentwise way; for example, Xn Xn 2 2 2 kUk = kUik = kUijk : i=1 i;j=1 We use standard notation and de¯nitions for the Sobolev spaces Hs(­)n, associated inner products 0 n <¢; ¢>s, respective norms, k ¢ ks, and semi-norms, j ¢ js, for s ¸ 0.
Recommended publications
  • Finite Element Methods for the Simulation of Incompressible Flows
    Weierstrass Institute for Applied Analysis and Stochastics Finite Element Methods for the Simulation of Incompressible Flows Volker John Mohrenstrasse 39 · 10117 Berlin · Germany · Tel. +49 30 20372 0 · www.wias-berlin.de · Course at Universidad Autonoma de Madrid, 27.02. – 02.03.2012 Outline of the Lectures 1 The Navier–Stokes Equations as Model for Incompressible Flows 2 Function Spaces For Linear Saddle Point Problems 3 The Stokes Equations 4 The Oseen Equations 5 The Stationary Navier–Stokes Equations 6 The Time-Dependent Navier–Stokes Equations – Laminar Flows Finite Element Methods for the Simulation of Incompressible Flows · Course at Universidad Autonoma de Madrid, 27.02. – 02.03.2012 · Page 2 (151) 1 A Model for Incompressible Flows • conservation laws ◦ conservation of linear momentum ◦ conservation of mass • flow variables ◦ r(t;x) : density [kg=m3] ◦ v(t;x) : velocity [m=s] ◦ P(t;x) : pressure [N=m2] assumed to be sufficiently smooth in • W ⊂ R3 • [0;T] Finite Element Methods for the Simulation of Incompressible Flows · Course at Universidad Autonoma de Madrid, 27.02. – 02.03.2012 · Page 3 (151) 1 Conservation of Mass • change of fluid in arbitrary volume V ¶ Z Z Z − r dx = rv · n ds = ∇ · (rv) dx ¶t V ¶V V | {z } | {z } mass transport through bdry • V arbitrary =) continuity equation rt + ∇ · (rv) = 0 • incompressibility( r = const) ∇ · v = 0 Finite Element Methods for the Simulation of Incompressible Flows · Course at Universidad Autonoma de Madrid, 27.02. – 02.03.2012 · Page 4 (151) • acceleration: using first order Taylor series expansion in time (board) dv (t;x) = ¶ v(t;x) + (v(t;x) · ∇)v(t;x) dt t movement of a particle 1 Newton’s Second Law of Motion • Newton’s second law of motion net force = mass × acceleration Finite Element Methods for the Simulation of Incompressible Flows · Course at Universidad Autonoma de Madrid, 27.02.
    [Show full text]
  • Mechanical Engineering Department Nazarbayev University
    Nazarbayev University, School of Engineering Bachelor of Mechanical Engineering OPTIMUM 2D GEOMETRIES THAT MINIMIZE DRAG FOR LOW REYNOLDS NUMBER FLOW Final Capstone Project Report By: Ilya Lutsenko Manarbek Serikbay Principal Supervisor: Dr.Eng. Konstantinos Kostas Dr.Eng. Marios Fyrillas April 2017 MECHANICAL ENGINEERING DEPARTMENT NAZARBAYEV UNIVERSITY Declaration Form We hereby declare that this report entitled “OPTIMUM 2D GEOMETRIES THAT MINIMIZE DRAG FOR LOW REYNOLDS NUMBER FLOW” is the result of our own project work except for quotations and citations which have been duly acknowledged. We also declare that it has not been previously or concurrently submitted for any other degree at Nazarbayev University. ‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐ Name: Date: ‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐‐ Name: Date: II MECHANICAL ENGINEERING DEPARTMENT NAZARBAYEV UNIVERSITY Abstract In this work, a two-dimensional Oseen’s approximation for Navier-Stokes equations is to be studied. As the theory applies only to low Reynolds numbers, the results are focused in this region of the flow regime, which is of interest in flows appearing in bioengineering applications. The investigation is performed using a boundary element formulation of the Oseen’s equation implemented in Matlab software package. The results are compared with simulations performed in COMSOL software package using a finite element approach for the full Navier-Stokes equations under the assumption of laminar and steady flow. Furthermore, experimental and numerical data from pertinent literature for the flow over a cylinder are used to verify the obtained results. The second part of the project employs the boundary element code in an optimization procedure that aims at drag minimization via body-shape modification with specific area constraints. The optimization results are validated with the aid of finite element simulations in COMSOL.
    [Show full text]
  • An Experimental Test for the Existence of the Euler Wake Velocity, Validating Eulerlet Theory by Using a Bluff Body in a Low-Speed Wind Tunnel
    An experimental test for the existence of the Euler wake velocity, validating Eulerlet theory by using a bluff body in a low-speed wind tunnel By Kiran Chalasani (B. Eng., M.Sc.) Ph.D. Thesis 2020 An experimental test for the existence of the Euler wake velocity, validating Eulerlet theory by using a bluff body in a low-speed wind tunnel Kiran Chalasani School of Computing, Science, and Engineering University of Salford, Manchester, UK Submitted in Partial Fulfilment of the Requirements for the Degree of Doctor of Philosophy, July 2020 ii Abstract The application of manoeuvrability problems in aerodynamics mainly works for Reynolds average Navier-Stokes equations particularly for a uniform, steady flow past a fixed body. Further, consider large Reynolds number such that the flow is not turbulent, and the boundary layer is negligibly small and the impermeability boundary condition holds. Instead of using standard techniques and theory for describing the problem, a new method is employed based upon the concept of matching two different Green’s integral representations over a common boundary, one given by approximations valid in the near-field and the other by approximations in the far-field such that, a near-field Euler flow is matched to a far-field Oseen flow. Far from the body, linearise the velocity to the uniform stream yielding Oseen flow to leading order and match the near-field Euler and far-field Oseen flow on a common matching boundary. In particular, match the Green’s integral representations that use Green’s functions which are point force solutions. This gives new Green’s functions which we call Eulerlets and are obtained by collapsing the diffuse wake of the corresponding Oseenlets onto a wake line represented by Heaviside and delta functions.
    [Show full text]
  • The Method of Fundamental Solutions for the Oseen Steady‐State Viscous
    This is a repository copy of The method of fundamental solutions for the Oseen steady‐ state viscous flow past obstacles of known or unknown shapes. White Rose Research Online URL for this paper: http://eprints.whiterose.ac.uk/146897/ Version: Accepted Version Article: Karageorghis, A and Lesnic, D orcid.org/0000-0003-3025-2770 (2019) The method of fundamental solutions for the Oseen steady‐ state viscous flow past obstacles of known or unknown shapes. Numerical Methods for Partial Differential Equations, 35 (6). pp. 2103-2119. ISSN 0749-159X https://doi.org/10.1002/num.22404 © 2019 Wiley Periodicals, Inc. This is the peer reviewed version of the following article: Karageorghis, A and Lesnic, D (2019) The method of fundamental solutions for the Oseen steady‐ state viscous flow past obstacles of known or unknown shapes. Numerical Methods for Partial Differential Equations, 35 (6). pp. 2103-2119. ISSN 0749-159X, which has been published in final form at https://doi.org/10.1002/num.22404. This article may be used for non-commercial purposes in accordance with Wiley Terms and Conditions for Use of Self-Archived Versions. Reuse Items deposited in White Rose Research Online are protected by copyright, with all rights reserved unless indicated otherwise. They may be downloaded and/or printed for private study, or other acts as permitted by national copyright laws. The publisher or other rights holders may allow further reproduction and re-use of the full text version. This is indicated by the licence information on the White Rose Research Online record for the item. Takedown If you consider content in White Rose Research Online to be in breach of UK law, please notify us by emailing [email protected] including the URL of the record and the reason for the withdrawal request.
    [Show full text]
  • Analysis and Approximation of a Vorticity–Velocity–Pressure Formulation for the Oseen Equations
    Journal of Scientific Computing https://doi.org/10.1007/s10915-019-00990-7 Analysis and Approximation of a Vorticity–Velocity–Pressure Formulation for the Oseen Equations V. Anaya1 · A. Bouharguane2 · D. Mora1,3 · C. Reales4 · R. Ruiz-Baier5 · N. Seloula6 · H. Torres7 Received: 29 August 2018 / Revised: 18 April 2019 / Accepted: 11 June 2019 © The Author(s) 2019 Abstract We introduce a family of mixed methods and discontinuous Galerkin discretisations designed to numerically solve the Oseen equations written in terms of velocity, vorticity, and Bernoulli pressure. The unique solvability of the continuous problem is addressed by invoking a global inf-sup property in an adequate abstract setting for non-symmetric systems. The proposed finite element schemes, which produce exactly divergence-free discrete velocities, are shown to be well-defined and optimal convergence rates are derived in suitable norms. This mixed finite element method is also pressure-robust. In addition, we establish optimal rates of convergence for a class of discontinuous Galerkin schemes, which employ stabilisation. A set of numerical examples serves to illustrate salient features of these methods. Keywords Oseen equations · Vorticity-based formulation · Mixed finite elements · Exactly divergence-free velocity · Discontinuous Galerkin schemes · Numerical fluxes · Apriori error bounds Mathematics Subject Classification 65N30 · 65N12 · 76D07 · 65N15 1 Introduction The Oseen equations stem from linearisation of the steady (or alternatively from the backward Euler time-discretisation of the transient) Navier–Stokes equations. Of particular appeal to us is their formulation in terms of fluid velocity, vorticity vector, and pressure. A diversity of discretisation methods is available to solve incompressible flow problems using these three fields as principal unknowns.
    [Show full text]
  • A Boundary Element Solution of Oseen Flow Past A
    Transactions on Modelling and Simulation vol 9, © 1995 WIT Press, www.witpress.com, ISSN 1743-355X A boundary element solution of Oseen flow past a solid body J. Richardson, H. Power Wessex Institute of Technology, Ashurst Lodge, Ashurst, Southampton SO40 7AA, UK Abstract In this paper, a boundary element formulation is proposed to solve for flow past solid bodies, incorporating the effects of inertia. This will be ac- complished by the use of the Oseen representation formulae. It will also be proved that the Oseen formulation can be represented in the form of a Stokes formulation with the addition of some correcting terms, thus making the problem simpler to handle. The results at this stage are shown. 1 Introduction The low Reynolds number flow past isolated particles of various shapes such as rigid spheres, spheroids, and cylinders have been studied quite extensively by a number of researchers with a wide variety of analytical and numerical methods being used to cover a broad range of both geometric and flow parameters. A compilation of these results has been brought together both in a monograph by Clift et al. (1978) [2] and also by Happel and Brenner [5]. Almost all of the previous numerical tests have been based upon the solution of the Stokes system of equations, which neglect completely the non-linear inertial effects. The aim of this work is to study an Oseen flow which incorporates these inertial effects upon the body in a linear manner. This is achieved by means of a first kind Fred holm integral equation solution. It is known that Oseen's equation gives a first order approximation to the solution of the Navier-Stokes equation, an approximation which is valid for a Reynolds number much less than unity over the whole flow field (see Batchelor [3]).
    [Show full text]
  • 280 Katta Koteswari
    Indian Streams Research Journal ISSN: 2230-7850 Impact Factor : 4.1625 (UIF) Volume - 6 | Issue - 11 | December – 2016 _________________________________________________________________________________ LEMMA AND THEOREM WHICH HELP US TO FIND A REPRESENTATION FOR A SOLENOIDAL VECTOR FIELD IN CARTESIAN CO-ORDINATES IN TERMS OF TWO SCALAR FUNCTIONS. Katta Koteswari Research Scholar , Department of Mathematics , Krishna University. Abstract: boundaries. By In many physical making use of this situations, the representation, we governing equations of establish the motion are usually completeness of some given as a vector general solutions of equation where the Stokes, Brinkman quantity of physical and Oseen equations interest may be a proposed for plane vector, like the fluid boundaries in a later velocity in fluid flows. chapter. Despite the However, it has been similarity in the observed that when very simple form. structure of the these quantities are relations in terms of these Chadwick and solution in both the expressed in terms of a scalars. Trowbridge [6] spherical [7] and scalar field, the scalar In 1967, Chadwick and observed that the plane geometries, the satisfies a much Trowbridge [6] showed that any results can be proof of simpler partial divergence free vector field V extended to an completeness of the differential equation can be expressed as infinitedomain (r2oo) solution in the plane than the given vector. with boundedness boundaries case is not conditions On V. obtained by merely where A and B are scalar KEYWORDS : This extension was mimicking the proof functions on any bounded Lemma and theorem , used in [7] given in [7] and annular domain quantity of physical to prove the requires completely a interest , velocity completeness of a different approach potential.
    [Show full text]
  • Velocity-Vorticity-Pressure Formulation for the Oseen Problem with Variable Viscosity∗
    VELOCITY-VORTICITY-PRESSURE FORMULATION FOR THE OSEEN PROBLEM WITH VARIABLE VISCOSITY∗ V. ANAYAy , R. CARABALLOz , B. GOMEZ-VARGAS´ x , D. MORA{, AND R. RUIZ-BAIERk Abstract. We propose and analyse an augmented mixed finite element method for the Oseen equations written in terms of velocity, vorticity, and pressure with non-constant viscosity and homogeneous Dirichlet boundary condition for the velocity. The weak formulation includes least-squares terms arising from the constitutive equation and from the incompressibility condition, and we show that it satisfies the hypotheses of the Babuˇska-Brezzi theory. Repeating the arguments of the continuous analysis, the stability and solvability of the discrete problem are established. The method is suited for any Stokes inf-sup stable finite element pair for velocity and pressure, while for vorticity any generic discrete space (of arbitrary order) can be used. A priori and a posteriori error estimates are derived using two specific families of discrete subspaces. Finally, we provide a set of numerical tests illustrating the behaviour of the scheme, verifying the theoretical convergence rates, and showing the performance of the adaptive algorithm guided by residual a posteriori error estimation. Key words. Oseen equations, velocity-vorticity-pressure formulation, mixed finite element methods, variable viscosity, a priori and a posteriori error analysis, adaptive mesh refinement. AMS subject classifications. 65N30, 65N12, 76D07, 65N15. 1. Introduction. Using vorticity as additional field in the formulation of incompressible flow equations can be advantageous in a number of applicative problems [47]. Starting from the seminal works [25, 26] that focused on Stokes equations and where vorticity was sought in H(curl; Ω), several different problems including Brinkman, Navier-Stokes, and related flow problems written in terms of vorticity have been studied from the viewpoint of numerical analysis of finite volume and mixed finite element methods exhibiting diverse properties and specific features.
    [Show full text]
  • Eight(Y) Mathematical Questions on Fluids and Structures
    EIGHT(Y) MATHEMATICAL QUESTIONS ON FLUIDS AND STRUCTURES DENIS BONHEURE, FILIPPO GAZZOLA, AND GIANMARCO SPERONE Abstract. Turbulence is a long-standing mystery. We survey some of the existing (and sometimes contradictory) results and suggest eight natural ques- tions whose answers would increase the mathematical understanding of this phenomenon; each of these questions, yet, gives rise to ten sub-questions. Dedicated to Vladimir Maz'ya in occasion of his eightieth birthday, with great esteem, deep admiration, and eight winks to his musical moments [208, Sect. 4.8]. Contents 1. Prelude 2 2. Blowing in the wind 3 3. I believe I can fly 6 4. Soul meets body 16 5. Floating bridge 23 5.1. Troubled bridge over water 23 5.2. Twist and shout 26 6. (I can get now) interaction 29 7. Shape of things to come 32 References 40 2010 Mathematics Subject Classification. Primary 74-02, 76-02, 74F10, 76D05, 35Q30, 49Q10; Secondary 76D07, 76D10, 76D55, 76F06, 76F65. Key words and phrases. turbulence, vortex-shedding, fluid-structure interaction, Navier- Stokes equations, suspension bridge modelling. This research is supported by the Thelam Fund (Belgium), Research proposal FRB 2018- J1150080-210411. D. Bonheure is partially supported by PDR T.1110.14F (FNRS) and ERC Advanced Grant 2013 n. 339958: \Complex Patterns for Strongly Interacting Dynamical Systems - COMPAT". F. Gazzola is also partially supported by the PRIN project Equazioni alle derivate parziali di tipo ellittico e parabolico: aspetti geometrici, disuguaglianze collegate, e applicazioni and by the Gruppo Nazionale per l'Analisi Matematica, la Probabilit`ae le loro Applicazioni (GNAMPA) of the Istituto Nazionale di Alta Matematica (INdAM).
    [Show full text]
  • Algebraic Multigrid Methods for the Numerical Solution of the Incompressible Navier-Stokes Equations
    J O H A N N E S K E P L E R U N I V E R S I T A¨ T L I N Z N e t z w e r k f u¨ r F o r s c h u n g , L e h r e u n d P r a x i s Algebraic Multigrid Methods for the Numerical Solution of the Incompressible Navier-Stokes Equations Dissertation zur Erlangung des akademischen Grades Doktor der Technischen Wissenschaften Angefertigt am Institut fur¨ Numerische Mathematik Begutachter: A.Univ.Prof. Dipl.-Ing. Dr. Walter Zulehner Prof. Dr. Arnold Reusken Eingereicht von: Dipl.-Ing. Markus Wabro Mitbetreuung: O.Univ.Prof. Dipl.-Ing. Dr. Ulrich Langer Linz, August 2003 Johannes Kepler Universit¨at A-4040 Linz Altenbergerstraße 69 Internet: http://www.uni-linz.ac.at DVR 0093696 · · · 2 Eidesstattliche Erkl¨arung Ich erkl¨are an Eides statt, dass ich die vorliegende Dissertation selbstst¨andig und ohne fremde Hilfe verfasst, andere als die angegebenen Quellen und Hilfsmittel nicht benutzt bzw. die w¨ortlich oder sinngem¨aß entnommenen Stellen als solche kenntlich gemacht habe. Diese Dissertation wurde bisher weder im In- noch im Ausland als Prufungsarb¨ eit vorgelegt. Dipl.-Ing. Markus Wabro Linz, August 2003 3 Abstract If the Navier-Stokes equations for incompressible fluids are linearized using fixed point iterations, the Oseen equations arise. In this thesis we provide concepts for the coupled algebraic multigrid (AMG) solution of this saddle point system, where `coupled' here is meant in contrast to methods, where pressure and velocity equations are iteratively decou- pled, and `standard' AMG is used for the solution of the resulting scalar problems.
    [Show full text]
  • 1 the Navier–Stokes Equations
    1 The Navier–Stokes Equations Remark 1.1. Basic principles and variables. The basic equations of fluid dy- namics are called Navier–Stokes equations. In the case of an isothermal flow, a flow at constant temperature, they represent two physical conservation laws – the conservation of mass and the conservation of linear momentum. There are various ways for deriving these equations. Here, the classical one of continuum mechanics will be used. Let the flow variables be • ρ(t, x) : density [kg/m3], • v(t, x) : velocity [m/s], • P (t, x) : pressure [N/m2], which are assumed to be sufficiently smooth functions in the time interval [0, T ] and the domain Ω ⊂ R3. 2 Fig. 1.1. Left: Claude Louis Marie Henri Navier (1785 – 1836), right: George Gabriel Stokes (1819 – 1903). 4 1 The Navier–Stokes Equations 1.1 The Conservation of Mass Remark 1.2. General conservation law. Let V be an arbitrary open volume in Ω with sufficiently smooth surface ∂V which is constant in time and with mass m(t) = ρ(t, x) dx, [kg]. ZV If mass in V is conserved, the rate of change of mass in V must be equal to the flux of mass ρv(t, x) [kg/(m2s)] across the boundary ∂V of V d d m(t) = ρ(t, x) dx = − (ρv)(t, s) · n(s) ds, (1.1) dt dt ZV Z∂V where n(s) is the outward pointing unit normal on s ∈ ∂V . Since all functions are assumed to be sufficiently smooth, the divergence theorem can be applied (integration by parts), which gives ∇ · (ρv)(t, x) dx = (ρv)(t, s) · n(s) ds.
    [Show full text]
  • Fluids Core Courses
    APPENDIX I: CORE COURSES CORE COURSE 1: FLUID DYNAMICS 1 COURSE AIM AND OVERALL DESCRIPTION The aim of this module (and its companion module, Fluid Dynamics – Part 2) is to give students a broad and solid foundation on which to build the ability to understand and appreciate a variety of problems across the fluid dynamics discipline. This module will introduce students to a wide range of important fluid dynamics mechanisms and forces. LEARNING OUTCOMES To demonstrate mastery of the fundamentals of fluid mechanics To describe the different flows past a circular cylinder and derive mathematical models in the case of low Reynolds number flows To understand the relation between incompressible and irrotational flow past a circular cylinder and the Kutta-Joukowski lift theorem To gain familiarity of phenomenology and main parameters of unsteady forcing on aerodynamic surfaces To develop an ability to write simplified models based on vortex dynamics To gain familiarity with linearized and non-linear methods of aero-elasticity To demonstrate understanding and mastery of techniques that can be used to gain insight into the physics and mechanisms underlying behaviour of physical fluid systems To understand the basic ideas underlying the classical boundary layer theory and to be able use them to derive the classical boundary-layer equations, and understand the mathematical nature of these equations To be able to deduce and derive similarity solutions to boundary-layer equations, gain familiarity with numerical marching methods for solving
    [Show full text]