Research Paper Finite Element Modelling of a Flow-Acoustic

Total Page:16

File Type:pdf, Size:1020Kb

Research Paper Finite Element Modelling of a Flow-Acoustic ARCHIVES OF ACOUSTICS Vol. 45, No. 4, pp. 633–645 (2020) DOI: 10.24425/aoa.2020.135251 Research Paper Finite Element Modelling of a Flow-Acoustic Coupling in Unbounded Domains Paweł ŁOJEK∗, Ireneusz CZAJKA, Andrzej GOŁAŚ AGH – University of Science and Technology Department of Power Systems and Environmental Protection Facilities Kraków, Poland ∗Corresponding Author e-mail: [email protected] (received June 29, 2020; accepted August 17, 2020 ) One of the main issues of design process of HVAC systems and ventilation ducts in particular is correct modelling of coupling of the flow field and acoustic field of the air flowing in such systems. Such a coupling can be modelled in many ways, one of them is using linearised Euler equations (LEE). In this paper, the method of solving these equations using finite element method and open source tools is decribed. Equations were transformed into functional and solved using Python language and FEniCS software. The non-reflective boundary condition called buffer layer was also implemented into equations, which allowed modelling of unbounded domains. The issue, influence of flow on wave propagation, could be adressed using LEE equations, as they take non-uniform mean flow into account. The developed tool was verified and results of simulations were compared with analytical solutions, both in one- and two-dimensional cases. The obtained numerical results are very consistent with analytical ones. Furthermore, this paper describes the use of the developed tool for analysing a more complex model. Acoustic wave propagation for the backward-facing step in the presence of flow calculated using Navier-Stokes equations was studied. Keywords: linearised Euler equations (LEE); FEniCS; finite element method; non-reflective boundary conditions; open source. 1. Introduction phenomena, associated with both the flow of fluid and the propagation of the wave. However, according When using HVAC systems in buildings, acoustic to (Colonius, 1997), the computational complexity comfort is one of the crucial features from the user’s of the DNS method is too large to be used in engineer- point of view. One of the main factors affecting acous- ing applications. Computational aeroacoustic (CAA) tic comfort is ambient noise caused in modern build- methods are often used for this purpose. The classi- ings by components of HVAC systems, such as fans, cal approach is to use large eddy simulation (LES) ventilation units, and air conditioning systems. The method, which is less accurate (and computationally noise that is produced by these devices could be further complex) than DNS, to compute the fluid flow. Then, enhanced by air ducts. Understanding the behaviour acoustic analogies are used to calculate the sound pres- of acoustic wave in the presence of the flow in ducts sure level in the far field (Wagner et al., 2006). Most is important in the design and operation of such sys- of the acoustic analogies are based on the acoustic tems. It requires experimental or numerical analysis, analogy derived by Lighthill (1952). The disadvan- of which the latter is more often used, because of eco- tage of this method is the lack of information about nomical reasons. phenomena occurring in the near field. This classi- The most widely used model for the behaviour cal, hybrid approach is implemented in state-of-the- of the fluid and the acoustic wave are Navier-Stokes art numerical software, such as Actran, ANSYS Flu- equations. However, using them involves many prob- ent, Comsol, or OpenFOAM (Epikhin et al., 2015). lems resulting from the lack of their exact solution for An alternative method used for computational aeroa- the general case (Wagner et al., 2006). The most ac- coustics is called Kirchoff’s integral method. It con- curate method is direct numerical simulation (DNS) sists of calculating the nonlinear near (flow) field using of the equations, which provides a full picture of the Navier-Stokes equations and then using Kirchhoff sur- 634 Archives of Acoustics – Volume 45, Number 4, 2020 face integral to find the acoustic pressures at far field 2. Mathematical model (Lyrintzis, George, 1989). Another hybrid method is to use Navier-Stokes Continuity (1) and Navier-Stokes (2) equations are equations to simulate the fluid flow, and then cou- mainly used to describe the behaviour of the fluid ple the fluid velocity field described by them with (Rienstra, Hirschberg, 2004): acoustic field described by one of the propagation @ρ @ρvi models. The most used acoustic propagation mod- 0; (1) @t @xi els are well known linearised Euler equations (LEE) + = described for example in (Bailly, Juvé, 2000) and @vi @Pji @vi Ewert, ρ ρvj fi; (2) acoustic perturbation equations proposed by ( @t @xj @xj Schröder, 2003). In this paper, this modelling ap- + + = proach was used. Acoustic propagation model given where p is the pressure, vi is the velocity, t is the time, by linearised Euler equations was used in combina- ρ is the density, fi is the external force density, Pij tion with Navier-Stokes equations. From the mathe- pδij τij is the fluid stress tensor, τij is the viscous matical point of view, linearised Euler equations are stress tensor, i; j 1; 2; 3 are dimensions. = a system of partial differential equations. The ex- Euler− equations can be derived from Navier-Stokes act solution of the equations are known only for ba- equations by the= assumption of inviscid and homoen- sic, one or two-dimensional cases. For more complex tropic flow (Åbom, 2006; Mechel, 2008): cases and geometries, approximate methods, such as @ρ @ρvi 0; (3) finite element (FEM), difference (FDM), and volume @t @x (FVM) methods are commonly used. The paper pro- + = poses the implementation of solver for linearised Euler @ρvi @ ρvivj pδij 0: (4) equations in Python using the finite element software @t @xj FEniCS (Alnaes et al., 2015). Linearised Euler equa- + ( + ) = tions in the form which takes the non-uniform veloc- Equations can be linearised around the mean value ity field into account were implemented, which ulti- of the parameters describing the flow, such as pressure, mately allowed describing the coupling of flow and density, or velocity. This allows to obtain linearised Eu- acoustic fields. This represents the suitability of the ler equations which allow determining acoustic wave tool for modelling the behaviour of HVAC systems propagation (Rienstra, Hirschberg, 2004). and air in ducts. In order for created tool to be used Assuming that each variable describing the flow more widely, for modelling unbounded domains, it was can be divided into a mean and acoustic component, necessary to propose and implement a non-reflecting it can be written (Dykas et al., 2010): boundary condition. A buffer zone condition has been ′ ′ ′ p p p ; vi vi v ; ρ ρ ρ ; (5) selected for this purpose. i ′ ′ ′ The created tool has been tested and verified in two where p; =v; ρ+are mean variables,= + p ; vi;= ρ are+ acoustic test cases for which analytical solution is known. It variables (pressure, velocity in i-th direction, density). was then used to calculate the behaviour of a sinu- Inserting the above into the equations (3) and (4), soidal acoustic wave in the presence of a non-uniform assuming the mean values p; vi 0; ρ const and using flow, calculated using the Navier-Stokes equations. The ideal gas equation of state given by: chosen geometric model for these simulations is a well = = p′ c2ρ′ known and researched backward-facing step. This ge- (6) ometry can be used to model, for example, channel allows to derive linearised= Euler equations which de- discontinuity. scribes acoustic wave propagation without a mean FEniCS software was chosen due to the fact that flow. The equations are written below: it is open source software, easy to use from a pro- ′ ′ gramming point of view, and allowing connection with @p 2 @vj c ρ 0; (7) pre- and post-processing tools. Due to its structure @t @xj and workflow, FEniCS allows to focus on the parts + = of mathematical and physical modelling, it is not ne- @v′ @p′ ρ i 0; (8) cessary to go into the details of the implementation @t @xi of FEM. For pre-processing, i.e. geometry and mesh Linearised Euler equations+ can= be reduced to the generation, the Salome software was used (Ribes, classic wave equation by taking the time derivative of Caremoli, 2007). The post-processing of the results Eq. (7), divergence of Eq. (8), and combining them was performed using self-developed Python scripts and (Rienstra, Hirschberg, 2004): Paraview tool (Ahrens et al., 2005). Paraview was also used for visualisation of results. @2p′ 1 @2p′ 0: 2 2 2 (9) @t c @xi − = P. Łojek et al. – Finite Element Modelling of a Flow-Acoustic Coupling in Unbounded Domains 635 ′ 2.1. Non-uniform mean flow ′ @p n p 0; (15) @n Equations (7) and (8) allow for description of wave • non-reflective boundary⋅ ∇ = – the= wave is damped/ propagation without a mean flow. If the derivation as- absorbed, the definition of non-reflective bound- sumes the presence of mean velocity distribution vi, ary condition is more complicated and cannot be equations take on a more complex form. reduced to simple Dirichlet or Neumann condi- In one-dimensional case equations take the form ′ ′ tions. (v1 u, v1 U, p p, p 0, x1 x): The main purpose of non-reflective boundary con- @p′ @u @p @U = = ρc=2 =U =p ; (10) dition (NRBC) is to mimic unlimited physical domain @t @x @x @x in bounded numerical domain. It can be done in many ways, including characteristic NRBC (Giles, 1990; @u = −1 @p − @u − @U pU @U U u ; Atkins, Casper, 1994; Koloszár et al., 2019), ra- 2 (11) @t ρ @x @x @x c ρ @x diation boundary condition (Hagstrom, Goodrich, ′ ′ while in two-dimensional= − − case− (v1 −u, v2 v, v1 U, 2003), absorbing boundary conditions (Givoli, 2008; ′ v2 V , p p, p 0, x1 x, x2 y)(Povitsky, 2000): Kosloff, Kosloff, 1986), not to mention Perfectly = = = Matched Layer (Berenger, 1994; Bermudez et al., @p @u @v @p @p = = ρc2= = U= V 2008).
Recommended publications
  • Fenics-Shells Release 2018.1.0
    FEniCS-Shells Release 2018.1.0 Aug 02, 2021 Contents 1 Subpackages 1 2 Module contents 13 3 Documented demos 15 4 FEniCS-Shells 61 Bibliography 65 Python Module Index 67 Index 69 i ii CHAPTER 1 Subpackages 1.1 fenics_shells.analytical package 1.1.1 Submodules 1.1.2 fenics_shells.analytical.lovadina_clamped module Analytical solution for clamped Reissner-Mindlin plate problem from Lovadina et al. 1.1.3 fenics_shells.analytical.simply_supported module Analytical solution for simply-supported Reissner-Mindlin square plate under a uniform transverse load. 1.1.4 fenics_shells.analytical.vonkarman_heated module Analytical solution for elliptic orthotropic von Karman plate with lenticular thickness subject to a uniform field of inelastic curvatures. fenics_shells.analytical.vonkarman_heated.analytical_solution(Ai, Di, a_rad, b_rad) 1 FEniCS-Shells, Release 2018.1.0 1.1.5 Module contents 1.2 fenics_shells.common package 1.2.1 Submodules 1.2.2 fenics_shells.common.constitutive_models module fenics_shells.common.constitutive_models.psi_M(k, **kwargs) Returns bending moment energy density calculated from the curvature k using: Isotropic case: .. math:: D = frac{E*t^3}{24(1 - nu^2)} W_m(k, ldots) = D*((1 - nu)*tr(k**2) + nu*(tr(k))**2) Parameters • k – Curvature, typically UFL form with shape (2,2) (tensor). • **kwargs – Isotropic case: E: Young’s modulus, Constant or Expression. nu: Poisson’s ratio, Constant or Expression. t: Thickness, Constant or Expression. Returns UFL form of bending stress tensor with shape (2,2) (tensor). fenics_shells.common.constitutive_models.psi_N(e, **kwargs) Returns membrane energy density calculated from e using: Isotropic case: .. math:: B = frac{E*t}{2(1 - nu^2)} N(e, ldots) = B(1 - nu)e + nu mathrm{tr}(e)I Parameters • e – Membrane strain, typically UFL form with shape (2,2) (tensor).
    [Show full text]
  • Fenics-HPC: Automated Predictive High-Performance Finite Element
    FEniCS-HPC: Automated predictive high-performance finite element computing with applications in aerodynamics Johan Hoffman1, Johan Jansson2, and Niclas Jansson3 1 Computational Technology Laboratory, School of Computer Science and Communication, KTH, Stockholm, Sweden and BCAM - Basque Center for Applied Mathematics, Bilbao, Spain [email protected] 2 BCAM - Basque Center for Applied Mathematics, Bilbao, Spain and Computational Technology Laboratory, School of Computer Science and Communication, KTH, Stockholm, Sweden [email protected] 3 RIKEN Advanced Institute for Computational Science, Kobe, Japan [email protected] Abstract. Developing multiphysics finite element methods (FEM) and scalable HPC implementations can be very challenging in terms of soft- ware complexity and performance, even more so with the addition of goal-oriented adaptive mesh refinement. To manage the complexity we in this work present general adaptive stabilized methods with automated implementation in the FEniCS-HPC automated open source software framework. This allows taking the weak form of a partial differential equation (PDE) as input in near-mathematical notation and automati- cally generating the low-level implementation source code and auxiliary equations and quantities necessary for the adaptivity. We demonstrate new optimal strong scaling results for the whole adaptive framework applied to turbulent flow on massively parallel architectures down to 25000 vertices per core with ca. 5000 cores with the MPI-based PETSc backend and for assembly down to 500 vertices per core with ca. 20000 cores with the PGAS-based JANPACK backend. As a demonstration of the high impact of the combination of the scalability together with the adaptive methodology allowing prediction of gross quantities in turbulent flow we present an application in aerodynamics of a full DLR-F11 aircraft in connection with the HiLift-PW2 benchmarking workshop with good match to experiments.
    [Show full text]
  • The DUNE-Fem-DG Framework
    Extendible and Efficient Python Framework for Solving Evolution Equations with Stabilized Discontinuous Galerkin Methods Andreas Dedner, Robert Klofkorn¨ ∗ Abstract This paper discusses a Python interface for the recently published DUNE-FEM- DG module which provides highly efficient implementations of the Discontinuous Galerkin (DG) method for solving a wide range of non linear partial differential equations (PDE). Although the C++ interfaces of DUNE-FEM-DG are highly flexible and customizable, a solid knowledge of C++ is necessary to make use of this powerful tool. With this work easier user interfaces based on Python and the Unified Form Language are provided to open DUNE-FEM-DG for a broader audience. The Python interfaces are demonstrated for both parabolic and first order hyperbolic PDEs. Keywords DUNE,DUNE-FEM, Discontinuous Galerkin, Finite Volume, Python, Advection-Diffusion, Euler, Navier-Stokes MSC (2010): 65M08, 65M60, 35Q31, 35Q90, 68N99 In this paper we introduce a Python layer for the DUNE-FEM-DG1 module [14] which is available open-source. The DUNE-FEM-DG module is based on DUNE [5] and DUNE- FEM [20] in particular and makes use of the infrastructure implemented by DUNE-FEM for seamless integration of parallel-adaptive Finite Element based discretization methods. DUNE-FEM-DG focuses exclusively on Discontinuous Galerkin (DG) methods for var- ious types of problems. The discretizations used in this module are described by two main papers, [17] where we introduced a generic stabilization for convection dominated problems that works on generally unstructured and non-conforming grids and [9] where we introduced a parameter independent DG flux discretization for diffusive operators.
    [Show full text]
  • Universidade Federal Do Rio Grande Do Sul
    UNIVERSIDADE FEDERAL DO RIO GRANDE DO SUL ESCOLA DE ENGENHARIA FACULDADE DE ARQUITETURA PROGRAMA DE PÓS-GRADUAÇÃO EM DESIGN Eduardo da Cunda Fernandes DESIGN NO DESENVOLVIMENTO DE UM PROJETO DE INTERFACE: Aprimorando o processo de modelagem em programas de análise de estruturas tridimensionais por barras Dissertação de Mestrado Porto Alegre 2020 EDUARDO DA CUNDA FERNANDES Design no desenvolvimento de um projeto de interface: aprimorando o processo de modelagem em programas de estruturas tridimensionais por barras Dissertação apresentada ao Programa de Pós- Graduação em Design da Universidade Federal do Rio Grande do Sul, como requisito parcial à obtenção do título de Mestre em Design. Orientador: Prof. Dr. Fábio Gonçalves Teixeira Porto Alegre 2020 Catalogação da Publicação Fernandes, Eduardo da Cunda DESIGN NO DESENVOLVIMENTO DE UM PROJETO DEINTERFACE: Aprimorando o processo de modelagem em programas de análise de estruturas tridimensionais por barras / Eduardo da Cunda Fernandes. -- 2020. 230 f. Orientador: Fábio Gonçalves Teixeira. Dissertação (Mestrado) -- Universidade Federal do Rio Grande do Sul, Escola de Engenharia, Programa de Pós- Graduação em Design, Porto Alegre, BR-RS, 2020. 1. Design de Interface. 2. Análise Estrutural. 3.Modelagem Preditiva do Comportamento Humano. 4.Heurísticas da Usabilidade. 5. KLM-GOMS. I. Teixeira, Fábio Gonçalves, orient. II. Título. FERNANDES, E. C. Design no desenvolvimento de um projeto de interface: aprimorando o processo de modelagem em programas de análise de estruturas tridimensionais por barras. 2020. 142 f. Dissertação (Mestrado em Design) – Escola de Engenharia / Faculdade de Arquitetura, Universidade Federal do Rio Grande do Sul, Porto Alegre, 2020. Eduardo da Cunda Fernandes DESIGN NO DESENVOLVIMENTO DE UM PROJETO DED INTERFACE: aprimorando o processo de modelagem em programas de análise de estruturas tridimensionais por barras Esta Dissertação foi julgada adequada para a obtenção do Título de Mestre em Design, e aprovada em sua forma final pelo Programa de Pós-Graduação em Design da UFRGS.
    [Show full text]
  • Abstractions and Automated Algorithms for Mixed Domain Finite Element Methods
    Abstractions and automated algorithms for mixed domain finite element methods CÉCILE DAVERSIN-CATTY, Simula Research Laboratory, Norway CHRIS N. RICHARDSON, BP Institute, University of Cambridge, United Kingdom ADA J. ELLINGSRUD, Simula Research Laboratory, Norway MARIE E. ROGNES, Simula Research Laboratory, Norway Mixed dimensional partial differential equations (PDEs) are equations coupling unknown fields defined over domains of differing topological dimension. Such equations naturally arise in a wide range of scientific fields including geology, physiology, biology and fracture mechanics. Mixed dimensional PDEs arealso commonly encountered when imposing non-standard conditions over a subspace of lower dimension e.g. through a Lagrange multiplier. In this paper, we present general abstractions and algorithms for finite element discretizations of mixed domain and mixed dimensional PDEs of co-dimension up to one (i.e. nD-mD with jn −mj 6 1). We introduce high level mathematical software abstractions together with lower level algorithms for expressing and efficiently solving such coupled systems. The concepts introduced here have alsobeen implemented in the context of the FEniCS finite element software. We illustrate the new features through a range of examples, including a constrained Poisson problem, a set of Stokes-type flow models and a model for ionic electrodiffusion. CCS Concepts: • Mathematics of computing → Solvers; Partial differential equations; • Computing methodologies → Modeling methodologies. Additional Key Words and Phrases: FEniCS project, mixed dimensional, mixed domains, mixed finite elements 1 INTRODUCTION Mixed dimensional partial differential equations (PDEs) are systems of differential equations coupling solution fields defined over domains of different topological dimensions. Problem settings that call for such equations are in abundance across the natural sciences [27, 47], in multi-physics problems [13, 48], and in mathematics [8, 29].
    [Show full text]
  • Coupling Fenics and Openfoam Via Precice
    MUNICH SCHOOL OF ENGINEERING TECHNICAL UNIVERSITY OF MUNICH Bachelor’s Thesis in Engineering Science Chair of Scientific Computing, Department of Informatics Partitioned Fluid Structure Interaction: Coupling FEniCS and OpenFOAM via preCICE Richard Hertrich MUNICH SCHOOL OF ENGINEERING TECHNICAL UNIVERSITY OF MUNICH Bachelor’s Thesis in Engineering Science Chair of Scientific Computing, Department of Informatics Partitioned Fluid Structure Interaction: Coupling FEniCS and OpenFOAM via preCICE Partitionierte Fluid Struktur Wechselwirkung: Ein gekoppelter Ansatz mit FEniCS, OpenFOAM und preCICE Author: Richard Hertrich Supervisor: Prof. Dr. Hans-Joachim Bungartz Advisor: M.Sc. (hons) Benjamin Rüth Submission Date: September 27, 2019 I confirm that this bachelor’s thesis in engineering science is my own work and I have documented all sources and material used. Munich, September 27, 2019 Richard Hertrich Abstract In partitioned fluid structure interaction, a structure solver and a fluid solver are coupled via boundary conditions at the interface. This thesis presents partitioned FSI simulations using OpenFOAM for the fluid, preCICE as a coupling tool, and a structure solver I developed with the FEM library FEniCS. I extended the preCICE- FEniCS adapter to match the requirements for FSI, such that users can couple FEniCS simulations with vector functions and read conservatively mapped quantities from preCICE to a FEniCS solver. Plus, the adapter now features a mapping between pseudo-3D OpenFOAM and 2D FEniCS. The setup is tested with two FSI scenarios: An elastic flap in a channel and the FSI3 benchmark. I compare the results to validated partitioned FSI methods and reference results in literature to validate the preCICE-FEniCS adapter and the structure solver.
    [Show full text]
  • Loads, Load Factors and Load Combinations
    Overall Outline 1000. Introduction 4000. Federal Regulations, Guides, and Reports Training Course on 3000. Site Investigation Civil/Structural Codes and Inspection 4000. Loads, Load Factors, and Load Combinations 5000. Concrete Structures and Construction 6000. Steel Structures and Construction 7000. General Construction Methods BMA Engineering, Inc. 8000. Exams and Course Evaluation 9000. References and Sources BMA Engineering, Inc. – 4000 1 BMA Engineering, Inc. – 4000 2 4000. Loads, Load Factors, and Load Scope: Primary Documents Covered Combinations • Objective and Scope • Minimum Design Loads for Buildings and – Introduce loads, load factors, and load Other Structures [ASCE Standard 7‐05] combinations for nuclear‐related civil & structural •Seismic Analysis of Safety‐Related Nuclear design and construction Structures and Commentary [ASCE – Present and discuss Standard 4‐98] • Types of loads and their computational principles • Load factors •Design Loads on Structures During • Load combinations Construction [ASCE Standard 37‐02] • Focus on seismic loads • Computer aided analysis and design (brief) BMA Engineering, Inc. – 4000 3 BMA Engineering, Inc. – 4000 4 Load Types (ASCE 7‐05) Load Types (ASCE 7‐05) • D = dead load • Lr = roof live load • Di = weight of ice • R = rain load • E = earthquake load • S = snow load • F = load due to fluids with well‐defined pressures and • T = self‐straining force maximum heights • W = wind load • F = flood load a • Wi = wind‐on‐ice loads • H = ldload due to lllateral earth pressure, ground water pressure,
    [Show full text]
  • Hierarchical a Posteriori Error Estimation of Bank-Weiser Type in the Fenics Project Raphaël Bulle, Jack Hale, Alexei Lozinski, Stéphane Bordas, Franz Chouly
    Hierarchical a posteriori error estimation of Bank-Weiser type in the FEniCS Project Raphaël Bulle, Jack Hale, Alexei Lozinski, Stéphane Bordas, Franz Chouly To cite this version: Raphaël Bulle, Jack Hale, Alexei Lozinski, Stéphane Bordas, Franz Chouly. Hierarchical a posteriori error estimation of Bank-Weiser type in the FEniCS Project. 2021. hal-03137595 HAL Id: hal-03137595 https://hal.archives-ouvertes.fr/hal-03137595 Preprint submitted on 10 Feb 2021 HAL is a multi-disciplinary open access L’archive ouverte pluridisciplinaire HAL, est archive for the deposit and dissemination of sci- destinée au dépôt et à la diffusion de documents entific research documents, whether they are pub- scientifiques de niveau recherche, publiés ou non, lished or not. The documents may come from émanant des établissements d’enseignement et de teaching and research institutions in France or recherche français ou étrangers, des laboratoires abroad, or from public or private research centers. publics ou privés. Hierarchical a posteriori error estimation of Bank–Weiser type in the FEniCS Project∗ Raphaël Bulle† Jack S. Hale† Alexei Lozinski‡ Stéphane P. A. Bordas† Franz Chouly§ February 10, 2021 Abstract. In the seminal paper of Bank and Weiser [Math. Comp., 44 (1985), pp. 283–301] a new a posteriori estimator was introduced. This estimator requires the solution of a local Neumann problem on every cell of the finite element mesh. Despite the promise of Bank– Weiser type estimators, namely locality, computational efficiency, and asymptotic sharpness, they have seen little use in practical computational problems. The focus of this contribution is to describe a novel implementation of hierarchical estimators of the Bank–Weiser type in a modern high-level finite element software with automatic code generation capabilities.
    [Show full text]
  • A Cross-Sectional Aeroelastic Analysis and Structural Optimization Tool For
    Composite Structures 253 (2020) 112755 Contents lists available at ScienceDirect Composite Structures journal homepage: www.elsevier.com/locate/compstruct A cross-sectional aeroelastic analysis and structural optimization tool for slender composite structures ⇑ Roland Feil a, , Tobias Pflumm b, Pietro Bortolotti a, Marco Morandini c a National Renewable Energy Laboratory, Boulder, Colorado, USA b Technical University of Munich, Germany c Politecnico di Milano, Italy ARTICLE INFO ABSTRACT Keywords: A fully open‐source available framework for the parametric cross‐sectional analysis and design optimization of SONATA slender composite structures, such as helicopter or wind turbine blades, is presented. The framework— VABS Structural Optimization and Aeroelastic Analysis (SONATA)—incorporates two structural solvers, the commer- ANBA4 cial tool VABS, and the novel open‐source code ANBA4. SONATA also parameterizes the design inputs, post- Parametric design framework processes and visualizes the results, and generates the structural inputs to a variety of aeroelastic analysis Composite structures tools. It is linked to the optimization library OpenMDAO. This work presents the methodology and explains the fundamental approaches of SONATA. Structural characteristics were successfully verified for both VABS and ANBA4 using box beam examples from literature, thereby verifying the parametric approach to generating the topology and mesh in a cross section as well as the solver integration. The framework was furthermore exercised by analyzing and evaluating a fully resolved highly flexible wind turbine blade. Computed structural characteristics correlated between VABS and ANBA4, including off‐diagonal terms. Stresses, strains, and defor- mations were recovered from loads derived through coupling with aeroelastic analysis. The framework, there- fore, proves effective in accurately analyzing and optimizing slender composite structures on a high‐fidelity level that is close to a three‐dimensional finite element model.
    [Show full text]
  • Numerical Modeling and Experimental Investigation of Fine Particle Coagulation and Dispersion in Dilute Flows Bart Janssens
    Numerical modeling and experimental investigation of fine particle coagulation and dispersion in dilute flows Bart Janssens To cite this version: Bart Janssens. Numerical modeling and experimental investigation of fine particle coagulation and dispersion in dilute flows. Mechanics [physics.med-ph]. Université de La Rochelle, 2014. English. NNT : 2014LAROS014. tel-01175006 HAL Id: tel-01175006 https://tel.archives-ouvertes.fr/tel-01175006 Submitted on 10 Jul 2015 HAL is a multi-disciplinary open access L’archive ouverte pluridisciplinaire HAL, est archive for the deposit and dissemination of sci- destinée au dépôt et à la diffusion de documents entific research documents, whether they are pub- scientifiques de niveau recherche, publiés ou non, lished or not. The documents may come from émanant des établissements d’enseignement et de teaching and research institutions in France or recherche français ou étrangers, des laboratoires abroad, or from public or private research centers. publics ou privés. VON KARMAN INSTITUTE FOR FLUID DYNAMICS TURBOMACHINERY &PROPULSION DEPARTMENT UNIVERSITE´ DE LA ROCHELLE - UFR SCIENCE ET TECHNOLOGIE ECOLE DOCTORALE SCIENCES ET INGENIERIE´ EN MATERIAU´ ,MECANIQUE´ , ENERG´ ETIQUE´ ET AERONAUTIQUE´ LABORATOIRE DES SCIENCES DE L’INGENIEUR´ POUR L’ENVIRONNEMENT ROYAL MILITARY ACADEMY DEPARTMENT OF MECHANICAL ENGINEERING Numerical modeling and experimental investigation of fine particle coagulation and dispersion in dilute flows Cover art: Particle-laden turbulent channel flow, with vertical cuts and streamlines colored by streamwise particle velocity and the bottom wall colored by particle concentration. Thesis presented by Bart Janssens in order to obtain the degree of “Doctor of Philosophy in Applied Sciences - Mechanics”, Universite´ de la Rochelle, France and Royal Military Academy, Belgium, 10th of July 2014.
    [Show full text]
  • Automated Computational Modelling for Complicated Partial Differential Equations
    Automated computational modelling for complicated partial differential equations Automated computational modelling for complicated partial differential equations Proefschrift ter verkrijging van de graad van doctor aan de Technische Universiteit Delft, op gezag van de Rector Magnificus prof. ir. K.C.A.M. Luyben, voorzitter van het College voor Promoties, in het openbaar te verdedigen op dinsdag 3 december 2013 om 12.30 uur door Kristian Breum ØLGAARD Master of Science in Civil Engineering, Aalborg Universitet Esbjerg geboren te Ringkøbing, Denemarken Dit proefschrift is goedgekeurd door de promotor: Prof. dr. ir. L. J. Sluys Copromotor: Dr. G. N. Wells Samenstelling promotiecommissie: Rector Magnificus Voorzitter Prof. dr. ir. L. J. Sluys Technische Universiteit Delft, promotor Dr. G. N. Wells University of Cambridge, copromotor Dr. ir. M. B. van Gijzen Technische Universiteit Delft Prof. dr. P. H. J. Kelly Imperial College London Prof. dr. R. Larsson Chalmers University of Technology Prof. dr. L. R. Scott University of Chicago Prof. dr. ir. C. Vuik Technische Universiteit Delft Prof. dr. A. Scarpas Technische Universiteit Delft, reservelid Copyright © 2013 by K. B. Ølgaard Printed by Ipskamp Drukkers B.V., Enschede, The Netherlands ISBN 978-94-6191-990-8 Foreword This thesis represents the formal end of my long and interesting journey as a PhD student. The sum of many experiences over the past years has increased my knowledge and contributed to my personal development. All these experiences originate from the interaction with many people to whom I would like to express my gratitude. I am most grateful to Garth Wells for giving me the opportunity to come to Delft and to study under his competent supervision.
    [Show full text]
  • Numerical Analysis, Modelling and Simulation
    Numerical Analysis, Modelling and Simulation Griffin Cook Numerical Analysis, Modelling and Simulation Numerical Analysis, Modelling and Simulation Edited by Griffin Cook Numerical Analysis, Modelling and Simulation Edited by Griffin Cook ISBN: 978-1-9789-1530-5 © 2018 Library Press Published by Library Press, 5 Penn Plaza, 19th Floor, New York, NY 10001, USA Cataloging-in-Publication Data Numerical analysis, modelling and simulation / edited by Griffin Cook. p. cm. Includes bibliographical references and index. ISBN 978-1-9789-1530-5 1. Numerical analysis. 2. Mathematical models. 3. Simulation methods. I. Cook, Griffin. QA297 .N86 2018 518--dc23 This book contains information obtained from authentic and highly regarded sources. All chapters are published with permission under the Creative Commons Attribution Share Alike License or equivalent. A wide variety of references are listed. Permissions and sources are indicated; for detailed attributions, please refer to the permissions page. Reasonable efforts have been made to publish reliable data and information, but the authors, editors and publisher cannot assume any responsibility for the validity of all materials or the consequences of their use. Copyright of this ebook is with Library Press, rights acquired from the original print publisher, Larsen and Keller Education. Trademark Notice: All trademarks used herein are the property of their respective owners. The use of any trademark in this text does not vest in the author or publisher any trademark ownership rights in such trademarks, nor does the use of such trademarks imply any affiliation with or endorsement of this book by such owners. The publisher’s policy is to use permanent paper from mills that operate a sustainable forestry policy.
    [Show full text]