Automated Adaptive Finite Element Methods with Applications in Massively Parallel Simulation of Turbulent flow and Fluid-structure Interaction

Size: px
Start display at page:

Download "Automated Adaptive Finite Element Methods with Applications in Massively Parallel Simulation of Turbulent flow and Fluid-structure Interaction"

Transcription

1 Automated Adaptive Finite Element Methods with Applications in Massively Parallel Simulation of Turbulent flow and Fluid-structure Interaction Johan Jansson12 Basque Center for Applied Mathematics (BCAM), Bilbao [1] Computational Technology Laboratory, HPCViz, CSC, KTH, Stockholm [2] (m2 op)iii, BCAM, 24 May 2014

2 Automated High-Performance Scientific Computing (HPSC) FEniCS(-HPC) framework for automated solution of general PDE, give PDE in high-level mathematical notation as input, do Automated discretization (generate linear system from PDE): Automated error control (incl. parallel adaptive mesh refinement): + M(e) TOL with M(e) a functional of the computational error e = u U. Goal: Autom. generate both the solution and program from PDE

3 Turbulent flow and fluid-structure interaction (FSI) Computationa of high and low Reynolds number turbulent flow, also interacting with elastic structures. Open scientific problem. Applications in aerodynamics (aircraft, cars, wind/ocean energy), biomechanics (heart, vocal folds)

4 Automated HPSC Weak form of stationary incompressible Navier-Stokes: r(û, ˆv) = ((u )u + p, v) + (ν u, v) + ( u, q) = 0, ˆv V û = (u, p) (Solution) ˆv = (v, q) (Test function) Stabilized FEM for stationary incompressible Navier-Stokes: r G (Û, ˆv) = ((U )U + P, v) + (ν U, v) + ( U, q) r S (Û, ˆv) = (δr(û), R(ˆv)) (Least-squares stabilization) r(û, ˆv) + rs(û, ˆv) = 0 ˆv V h, U V h ˆv = (v, q) (Test function) r_g = ( grad ( u ) u + inner ( grad ( p ), v ) + \ nu inner ( grad ( u ), grad ( v ) ) + div ( u ) q ) dx r_s = delta inner ( R ( uhat, uhat ), R ( vhat, uhat ) ) dx r = r_g + r_s solve ( r == 0, uhat ) [Jansson, PRACE course notes, 2013]

5 Representation adaptivity - automated adaptive error control We want to adaptively control the error ê = û Û in the functional M(ê) given only the weak residual r and the primal FEM solution Û as input. Adaptive error control directly using the error representation: M(ê) = a(ê, φ) = r(û, φ) = M j=1 r(û, φ) Kj dual problem a(ˆv, φ) = M(ˆv) for the dual solution φ Automated generation (including linearization) of the dual problem: M = q n [ 0 ] ds # Drag ( o n l y p r e s s u r e h e r e ) a_dual = adjoint ( derivative ( r, uhat ) ) L_dual = M solve ( a_dual == L_dual, phi )

6 Representation adaptivity - automated error control With FEM primal and dual in the same space Û, Φ ˆV h we get: r(u, Φ) = 0 (1) Historical approach: work-around by Cauchy-Schwartz (and subtracting an interpolant) to get: hr(û) Φ (2) (other similar approaches also possible, see e.g. Darrigrand) We show that (1) gives an excellent and simple error indicator: E K = r(u, Φ) K (3) We represent (3) as a DG(0) function in space and prove an a priori error estimate for the error indicator: E(U, φ)(x) Ē cg(1) (U, Φ)(x) L2 Ch 2+d (4) E(U, φ)(x) E cg(1) (U, Φ)(x) L2 Ch 1+d (5) [Jansson, Hoffman, Spühler, Degirmenci, preprint 2014]

7 Representation adaptivity - automated error control Test with elliptic model problem comparing between the orthogonal Φ cg(1) (left) and non-orthogonal Φ cg(2) (right) as reference. E 10 K rep E10 K quad T 0 rep T 0 quad

8 Representation adaptivity - automated error control log10(error estimate) log10(eff. index) Representation adaptivity for diffusion, ɛ = 10 1 Error estimate (est) 1 jump 2 jump2 3 rep (P1 dual) 4 quad (P2 dual) log10(number of vertices) Eff. index (est/e) (log10(1)=0 is optimal) jump jump2 rep (P1 dual) quad (P2 dual) log10(number of vertices) log10(error) log10(index) 6 Error (e) jump jump2 rep (P1 dual) rep (P2 dual) uniform log10(number of vertices) (rep) P2 error indicator eff. index rel. diff. abs. diff log10(number of vertices)

9 Representation adaptivity - automated error control Advantages: Generality and simplicity The derivation and source code generation can be completely automated. Simple to understand, teach and implement. Reliability We show that the error indicator converges to the exact error indicator with order 2 + d/1 + d. For the stabilized case we no longer have orthogonality, and the error estimate is also good. Efficiency The method does not require computation of additional constructs such as facet integrals, local problems or modified finite element spaces which can be costly, especially in a parallel framework.

10 General Galerkin (G2) method / Direct FEM Developed over a 20+ year period by Johnson, Hoffman, Jansson, etc. Space-time FEM with Galerkin/least squares stabilization (R(Û), ˆv) + (δr(û), R(ˆv)) = 0, δ = h, ˆv ˆV h, Û ˆV h Adaptive error control and mesh refinement M(ê) = (R(Û, φ) hr(û) K ˆφ K TOL K T Slip/friction boundary condition as boundary layer model u n = 0 Implicit parameter-free turbulence model based on stabilization Dissipation: D = δ 1/2 R(Û) 2 (similar approach to ILES, VMS) Moving mesh, fluid-structure interaction, shock-capturing, etc.

11 Time-resolved adaptive simulation of aircraft HiLiftPW-2 NASA/Boeing-organized benchmark challenge. Participated with good results, and our adaptive methodology was highlighted in summary. Published paper in proceedings of AIAA SciTech Working on updated paper for AIAA JOA. Our computational results capture both pre-stall and stall well quantitatively (aoa=22.4 (pre-stall) and aoa=24 (stall) in right movie above) at Re Collectively, how well is CFD capturing the stall breaks?, Chris Rumsey, NASA, HiLiftPW-2 organizer

12 Flight simulation: our results Unicorn/FEniCS-HPC (our) results from NASA/Boeing HiLiftPW-2 workshop for full aircraft: CL C L and C D vs. angle of attack num. cfg4 num. cfg5 exp. cfg5 CD angle of attack num. cfg4 num. cfg5 exp. cfg angle of attack [Hoffman, Jansson, Jansson, Vilela, Proc. AIAA 2014]

13 Adaptive mesh refinement - adjoint velocity Goal quantity: drag and lift for right half of airplane

14 Adaptive mesh refinement - mesh sequence mesh0: 700k vertices, note upstream refinement Mesh on surface Mesh slice on target side

15 Adaptive mesh refinement - mesh sequence mesh1: 1.1M vertices, note upstream refinement Mesh on surface Mesh slice on target side

16 Adaptive mesh refinement - mesh sequence mesh2: 1.6M vertices, note upstream refinement Mesh on surface Mesh slice on target side

17 Adaptive mesh refinement - mesh sequence mesh3: 2.2M vertices, note upstream refinement Mesh on surface Mesh slice on target side

18 Adaptive mesh refinement - mesh sequence mesh4: 3.1M vertices, note upstream refinement Mesh on surface Mesh slice on target side

19 Aerodynamic forces α = 12 Lift within 5% of exp., Drag within 0.1% of exp. Use 1536 cores on Lindgren supercomputer, ca. 300k core hours total Would like a few more adaptive iterations C_l degrees angle of attack Unicorn adaptive mesh refinement experiment No. mesh points Unicorn adaptive mesh refinement experiment C_d No. mesh points

20 Adaptive mesh refinement - adjoint velocity Goal quantity: drag and lift for right half of airplane. Left (non-target) side Right (target) side

21 Adaptive mesh refinement - adjoint velocity Residual, recall: M(ê) = ( R(Û), ˆφ)

22 FEniCS-HPC components FEniCS: fenicsproject.org Open source software project for automated solution of PDE with many involved universities/individuals. (see fenicsproject.org for developer info/papers). FEniCS-HPC: branch with focus on good scaling on massively parallel architectures, targeting open/challenging problems in turbulent flow/fsi. Developed mainly by CTL group. Automated generation of finite elements/basis functions (FIAT) e = (K, P, N ) Automated evaluation of variational forms on one cell based on code generation (FFC+UFL) A K = a K (v, U) = v Udx = r(v, U)dx K K Automated assembly of discrete systems on a mesh T Ω (DOLFIN-HPC) A = 0 for all elements K T Ω A += A K Automated turbulent Unified Continuum modeling (Unicorn) r UC (W, v) = (ρ( tu + (u )u) + σ g, v) + SD(W, v) = 0

23 FEniCS-HPC FEniCS-HPC tool chain: FIAT FFC DOLFIN(-HPC) Unicorn Fully distributed unstructured mesh, parallel I/O with MPI Hybrid parallel model MPI-OpenMP/MPI-PGAS LA back-end: PETSc, Janpack (MPI+PGAS) A posteriori error estimation based on adjoint problems Parallel adaptive mesh refinement, ALE moving mesh Turbulent flow, fluid-structure interaction, contact models Installed at supercomputing centers in Sweden, Spain, Germany,... Available for download at: fenicsproject.org or at CTL Forge [ Our research on FEniCS-HPC was awarded a PRACE Tier-0 grant for 20M core hours (ca. 2M EUR) in Florian Rathgeber will present another HPC branch of FEniCS: Firedrake, targeting more architectures in a clever way.

24 Strong scaling verification Strong linear scaling of FEniCS-HPC full adaptive solve of incompressible flow up to at least ca cores on Lindgren (PDC) supercomputer. execution time (seconds) ideal vcc fsi cores [Hoffman, Jansson, et. al., 2012 C&F], [Hoffman, Jansson, Jansson, 2011, SISC]

25 Unified Continuum (UC) formulation for FSI Conservation equations (momentum, mass) in Euler (laboratory) coordinates, stress σ as data, track discontinuous phase function θ with moving mesh/basis functions: ρ( t u + (u )u) σ u t θ + (u )θ u(, 0) = = = = u0 in in in in Q, Q, Q, Ω, Different constitutive equations for phases: σ = σ pi Dt σ s = 2µs + uσ s + σ s u > σ = θσ f + (1 θ)σ s σ f = 2µf Discretize as one domain (exploited in error estimation, robustness):

26 EUNISON: modeling of human voice Assess feasibility of complete model of voice production by a Unified Continuum fluid-structure simulation of the vocal fold mechanics in Unicorn/FEniCS (our software framework). Reynolds number up to : turbulent/transition flow, contact EU FP7 3 year project KTH (Stockholm), Gipsa-Lab (Grenoble), FAU (Erlangen), UPC (Barcelona), lasalle (Barcelona). Formulate the vocal fold FSI system in the Unified Continuum model and FEniCS-HPC framework. Started comparing against [Becker, et. al. JASA 2009] model. [Jansson, et. al., ICA2013]

27 EUNISON: current work General parallel contact detection by computation of distance function based on solving an Eikonal equation Active work on adaptive error control for FSI.

28 Computational Technology research group Adaptive general FEM/software for open/challenging problems in turbulence/fsi Research and software development of Unicorn/FEniCS, international team Johan Jansson - Asst. Prof. (BCAM+KTH) Cristina Pocci - Post doc (BCAM) Josu Izarra - MSc+Intern (BCAM) Sebastian Banzas Baro - MSc+Intern (BCAM) Johan Hoffman - Professor Aurelien Larcher - Post doc Bärbel Janssen - Post doc Rodrigo Vilela de Abreu - Phd student Cem Degirmenci - Phd student Jeannette Spühler - Phd student Kaspar Müller - Phd student + many collaborators bcamath.org/en/research/lines/cfdct ctl.csc.kth.se fenicsproject.org BCAM (Bilbao) KTH (Stockholm) I m recruiting 1 Post-doc (BCAM) and 1-2 PhD students (BCAM+KTH)

29 Summary/Conclusions Overall summary: Our research is a synthesis between Scientific Computing (Mathematics) and HPC (Computer Science) - HPSC Automated HPSC - automated discretization, error control, modeling (turbulence, FSI), from mathematical notation of PDE as input allows researchers to work on abstract level for quick development and formal correctness Advanced grand challenge applications using HPC resources with optimal strong scaling up to at least 5000 cores: full aircraft simulation with novel results (adaptivity, stall), vocal folds in the EUNISON project. Direct FEM enables prediction of turbulent flow cheaply, order of magnitude coarser meshes than RANS/LES and capturing more phenomena (stall, time-resolved). Automated error control: representation adaptivity directly using the error representation - no need for additional estimates, can be fully automated. Good a priori convergence to exact error indicator, good benchmark results.

30 G2 validation: basic benchmarks NACA0012 Re = 10 6 [Jansson/Hoffman/Jansson, 2012] Cube Re = [Hoffman/Jansson/Vilela, CMAME, 2011] Circular cylinder Re = 3900 [Hoffman, IJNMF, 2009] Sphere Re = [Hoffman, JFM, 2006] Square cylinder Re = [Hoffman, SISC, 2005] Surface mounted cube Re = [Hoffman, SISC 2005]

31 Adaptive mesh refinement - adjoint velocity Goal quantity: drag and lift for right half of airplane

32 Adaptive mesh refinement - adjoint velocity Goal quantity: drag and lift for right half of airplane. Left (non-target) side Right (target) side

33 Adaptive mesh refinement - adjoint velocity Residual, recall: M(ê) = ( R(Û), ˆφ)

34 Aerodynamic forces α = 22.4 Lift within 4% of exp., Drag within 13% of exp. Use 1536 cores on Lindgren supercomputer, ca. 300k core hours total Would like a few more adaptive iterations C_l C_d degrees angle of attack Unicorn adaptive mesh refinement experiment No. mesh points Unicorn adaptive mesh refinement experiment No. mesh points

35 Pressure distributions 8 6 cp for HiLiftPW-2 case 2b alpha= eta= geometry (scaled+translated) cp num cp exp geometry exp (scaled+translated) 4 cp x coordinate (m)

36 Pressure distributions 8 6 cp for HiLiftPW-2 case 2b alpha= eta= geometry (scaled+translated) cp num cp exp geometry exp (scaled+translated) 4 cp x coordinate (m)

37 Automated HPSC The stationary incompressible Navier-Stokes equations: { R(û) = (u )u + p ν u = 0 u = 0 û = (u, p) Weak form of stationary incompressible Navier-Stokes: r(û, ˆv) = ((u )u + p, v) + (ν u, v) + ( u, q) = 0 ˆv = (v, q) (Test function)

38 EUNISON project - research driver EUNISON EU project: Extensive UNIfied-domain SimulatiON of the human voice - aim to simulate human voice by fundamental continuum mechanics - started in March 2013, 5 universities in the EU

39 Flight simulation: other group s results EXA results from HiLiftPW-2 workshop for full aircraft: We capture stall phenomenon and uses/develops adaptivity.

40 FEniCS-HPC assembly algorithm A = 0 for all elements K T Ω A += A K The element matrix A K is defined by A K ij = a K ( ˆφ i, φ j ) for all local basis functions ˆφ i and φ j on K Cell based decomposition Dual graph based decomposition Overlap represented as ghosted entities Low data dependency during FE assembly

41 Turbulence modeling Reynolds averaged Navier-Stokes equations (RANS): Compute statistical ensemble average of NSE solutions Result in Reynolds stresses that have to be modeled (turbulent eddy viscosity) closure problem. Large eddy simulation (LES): Compute only largest scales of the flow, model subgrid scales by applying filter Filter width typically connected to mesh size Direct FEM (our approach): No RANS/LES filtering/averaging. No explicit turbulence model/subgrid model (parameter-free), turbulent dissipation only from numerical stabilization.

AUTOMATED ADAPTIVE ERROR CONTROL IN FINITE ELEMENT METHODS USING THE ERROR REPRESENTATION AS ERROR INDICATOR

AUTOMATED ADAPTIVE ERROR CONTROL IN FINITE ELEMENT METHODS USING THE ERROR REPRESENTATION AS ERROR INDICATOR AUTOMATED ADAPTIVE ERROR CONTROL IN FINITE ELEMENT METHODS USING THE ERROR REPRESENTATION AS ERROR INDICATOR JOHAN JANSSON, JOHAN HOFFMAN, CEM DEGIRMENCI, JEANNETTE SPÜHLER Abstract. In this paper we present

More information

FEniCS at KTH: projects, challenges and future plans

FEniCS at KTH: projects, challenges and future plans FEniCS at KTH: projects, challenges and future plans Johan Hoffman jhoffman@csc.kth.se Royal Institute of Technology KTH Johan Hoffman KTH p.1 Overview FEniCS at KTH today A FEniCS prototype Ongoing projects

More information

PRACE Workshop, Worksheet 2

PRACE Workshop, Worksheet 2 PRACE Workshop, Worksheet 2 Stockholm, December 3, 2013. 0 Download files http://csc.kth.se/ rvda/prace files ws2.tar.gz. 1 Introduction In this exercise, you will have the opportunity to work with a real

More information

Simulation of 3D unsteady incompressible flow past a NACA 0012 wing section

Simulation of 3D unsteady incompressible flow past a NACA 0012 wing section 1 Simulation of 3D unsteady incompressible flow past a NACA 0012 wing section Johan Hoffman a, Johan Jansson a,, Niclas Jansson a a Computational Technology Laboratory, CSC/NA, KTH, Royal Institute of

More information

SPH: Why and what for?

SPH: Why and what for? SPH: Why and what for? 4 th SPHERIC training day David Le Touzé, Fluid Mechanics Laboratory, Ecole Centrale de Nantes / CNRS SPH What for and why? How it works? Why not for everything? Duality of SPH SPH

More information

ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving Objects

ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving Objects Tenth International Conference on Computational Fluid Dynamics (ICCFD10), Barcelona,Spain, July 9-13, 2018 ICCFD10-047 ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving

More information

HPC Usage for Aerodynamic Flow Computation with Different Levels of Detail

HPC Usage for Aerodynamic Flow Computation with Different Levels of Detail DLR.de Folie 1 HPCN-Workshop 14./15. Mai 2018 HPC Usage for Aerodynamic Flow Computation with Different Levels of Detail Cornelia Grabe, Marco Burnazzi, Axel Probst, Silvia Probst DLR, Institute of Aerodynamics

More information

Usage of CFX for Aeronautical Simulations

Usage of CFX for Aeronautical Simulations Usage of CFX for Aeronautical Simulations Florian Menter Development Manager Scientific Coordination ANSYS Germany GmbH Overview Elements of CFD Technology for aeronautical simulations: Grid generation

More information

computational Fluid Dynamics - Prof. V. Esfahanian

computational Fluid Dynamics - Prof. V. Esfahanian Three boards categories: Experimental Theoretical Computational Crucial to know all three: Each has their advantages and disadvantages. Require validation and verification. School of Mechanical Engineering

More information

THE EFFECTS OF THE PLANFORM SHAPE ON DRAG POLAR CURVES OF WINGS: FLUID-STRUCTURE INTERACTION ANALYSES RESULTS

THE EFFECTS OF THE PLANFORM SHAPE ON DRAG POLAR CURVES OF WINGS: FLUID-STRUCTURE INTERACTION ANALYSES RESULTS March 18-20, 2013 THE EFFECTS OF THE PLANFORM SHAPE ON DRAG POLAR CURVES OF WINGS: FLUID-STRUCTURE INTERACTION ANALYSES RESULTS Authors: M.R. Chiarelli, M. Ciabattari, M. Cagnoni, G. Lombardi Speaker:

More information

Isogeometric Analysis of Fluid-Structure Interaction

Isogeometric Analysis of Fluid-Structure Interaction Isogeometric Analysis of Fluid-Structure Interaction Y. Bazilevs, V.M. Calo, T.J.R. Hughes Institute for Computational Engineering and Sciences, The University of Texas at Austin, USA e-mail: {bazily,victor,hughes}@ices.utexas.edu

More information

An Optimization Method Based On B-spline Shape Functions & the Knot Insertion Algorithm

An Optimization Method Based On B-spline Shape Functions & the Knot Insertion Algorithm An Optimization Method Based On B-spline Shape Functions & the Knot Insertion Algorithm P.A. Sherar, C.P. Thompson, B. Xu, B. Zhong Abstract A new method is presented to deal with shape optimization problems.

More information

Case C3.1: Turbulent Flow over a Multi-Element MDA Airfoil

Case C3.1: Turbulent Flow over a Multi-Element MDA Airfoil Case C3.1: Turbulent Flow over a Multi-Element MDA Airfoil Masayuki Yano and David L. Darmofal Aerospace Computational Design Laboratory, Massachusetts Institute of Technology I. Code Description ProjectX

More information

Debojyoti Ghosh. Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering

Debojyoti Ghosh. Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering Debojyoti Ghosh Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering To study the Dynamic Stalling of rotor blade cross-sections Unsteady Aerodynamics: Time varying

More information

1.2 Numerical Solutions of Flow Problems

1.2 Numerical Solutions of Flow Problems 1.2 Numerical Solutions of Flow Problems DIFFERENTIAL EQUATIONS OF MOTION FOR A SIMPLIFIED FLOW PROBLEM Continuity equation for incompressible flow: 0 Momentum (Navier-Stokes) equations for a Newtonian

More information

Introduction to CFX. Workshop 2. Transonic Flow Over a NACA 0012 Airfoil. WS2-1. ANSYS, Inc. Proprietary 2009 ANSYS, Inc. All rights reserved.

Introduction to CFX. Workshop 2. Transonic Flow Over a NACA 0012 Airfoil. WS2-1. ANSYS, Inc. Proprietary 2009 ANSYS, Inc. All rights reserved. Workshop 2 Transonic Flow Over a NACA 0012 Airfoil. Introduction to CFX WS2-1 Goals The purpose of this tutorial is to introduce the user to modelling flow in high speed external aerodynamic applications.

More information

Numerical Simulation Study on Aerodynamic Characteristics of the High Speed Train under Crosswind

Numerical Simulation Study on Aerodynamic Characteristics of the High Speed Train under Crosswind 2017 2nd International Conference on Industrial Aerodynamics (ICIA 2017) ISBN: 978-1-60595-481-3 Numerical Simulation Study on Aerodynamic Characteristics of the High Speed Train under Crosswind Fan Zhao,

More information

Digital-X. Towards Virtual Aircraft Design and Testing based on High-Fidelity Methods - Recent Developments at DLR -

Digital-X. Towards Virtual Aircraft Design and Testing based on High-Fidelity Methods - Recent Developments at DLR - Digital-X Towards Virtual Aircraft Design and Testing based on High-Fidelity Methods - Recent Developments at DLR - O. Brodersen, C.-C. Rossow, N. Kroll DLR Institute of Aerodynamics and Flow Technology

More information

Program: Advanced Certificate Program

Program: Advanced Certificate Program Program: Advanced Certificate Program Course: CFD-Vehicle Aerodynamics Directorate of Training and Lifelong Learning #470-P, Peenya Industrial Area, 4th Phase Peenya, Bengaluru 560 058 www.msruas.ac.in

More information

Computational Fluid Dynamics for Engineers

Computational Fluid Dynamics for Engineers Tuncer Cebeci Jian P. Shao Fassi Kafyeke Eric Laurendeau Computational Fluid Dynamics for Engineers From Panel to Navier-Stokes Methods with Computer Programs With 152 Figures, 19 Tables, 84 Problems and

More information

Introduction to ANSYS CFX

Introduction to ANSYS CFX Workshop 03 Fluid flow around the NACA0012 Airfoil 16.0 Release Introduction to ANSYS CFX 2015 ANSYS, Inc. March 13, 2015 1 Release 16.0 Workshop Description: The flow simulated is an external aerodynamics

More information

Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization

Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization Siva Nadarajah Antony Jameson Stanford University 15th AIAA Computational Fluid Dynamics Conference

More information

Optimization with Gradient and Hessian Information Calculated Using Hyper-Dual Numbers

Optimization with Gradient and Hessian Information Calculated Using Hyper-Dual Numbers Optimization with Gradient and Hessian Information Calculated Using Hyper-Dual Numbers Jeffrey A. Fike and Juan J. Alonso Department of Aeronautics and Astronautics, Stanford University, Stanford, CA 94305,

More information

Keywords: flows past a cylinder; detached-eddy-simulations; Spalart-Allmaras model; flow visualizations

Keywords: flows past a cylinder; detached-eddy-simulations; Spalart-Allmaras model; flow visualizations A TURBOLENT FLOW PAST A CYLINDER *Vít HONZEJK, **Karel FRAŇA *Technical University of Liberec Studentská 2, 461 17, Liberec, Czech Republic Phone:+ 420 485 353434 Email: vit.honzejk@seznam.cz **Technical

More information

ANSYS FLUENT. Airfoil Analysis and Tutorial

ANSYS FLUENT. Airfoil Analysis and Tutorial ANSYS FLUENT Airfoil Analysis and Tutorial ENGR083: Fluid Mechanics II Terry Yu 5/11/2017 Abstract The NACA 0012 airfoil was one of the earliest airfoils created. Its mathematically simple shape and age

More information

A COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF LAMINAR TURBULENT INCOMPRESSIBLE AND COMPRESSIBLE FLOWS

A COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF LAMINAR TURBULENT INCOMPRESSIBLE AND COMPRESSIBLE FLOWS A COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF LAMINAR TURBULENT INCOMPRESSIBLE AND COMPRESSIBLE FLOWS L. Mangani Maschinentechnik CC Fluidmechanik und Hydromaschinen Hochschule Luzern Technik& Architektur

More information

Express Introductory Training in ANSYS Fluent Workshop 04 Fluid Flow Around the NACA0012 Airfoil

Express Introductory Training in ANSYS Fluent Workshop 04 Fluid Flow Around the NACA0012 Airfoil Express Introductory Training in ANSYS Fluent Workshop 04 Fluid Flow Around the NACA0012 Airfoil Dimitrios Sofialidis Technical Manager, SimTec Ltd. Mechanical Engineer, PhD PRACE Autumn School 2013 -

More information

Introduction to C omputational F luid Dynamics. D. Murrin

Introduction to C omputational F luid Dynamics. D. Murrin Introduction to C omputational F luid Dynamics D. Murrin Computational fluid dynamics (CFD) is the science of predicting fluid flow, heat transfer, mass transfer, chemical reactions, and related phenomena

More information

NUMERICAL 3D TRANSONIC FLOW SIMULATION OVER A WING

NUMERICAL 3D TRANSONIC FLOW SIMULATION OVER A WING Review of the Air Force Academy No.3 (35)/2017 NUMERICAL 3D TRANSONIC FLOW SIMULATION OVER A WING Cvetelina VELKOVA Department of Technical Mechanics, Naval Academy Nikola Vaptsarov,Varna, Bulgaria (cvetelina.velkova1985@gmail.com)

More information

Chapter 1 Introduction

Chapter 1 Introduction Chapter 1 Introduction Ibrahim Sezai Department of Mechanical Engineering Eastern Mediterranean University Fall 2009-2010 What is CFD? CFD is the simulation of fluids engineering systems using modeling

More information

Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution

Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution P. BURDA a,, J. NOVOTNÝ b,, J. ŠÍSTE a, a Department of Mathematics Czech University of Technology

More information

Case C2.2: Turbulent, Transonic Flow over an RAE 2822 Airfoil

Case C2.2: Turbulent, Transonic Flow over an RAE 2822 Airfoil Case C2.2: Turbulent, Transonic Flow over an RAE 2822 Airfoil Masayuki Yano and David L. Darmofal Aerospace Computational Design Laboratory, Massachusetts Institute of Technology I. Code Description ProjectX

More information

Precise FEM solution of corner singularity using adjusted mesh applied to 2D flow

Precise FEM solution of corner singularity using adjusted mesh applied to 2D flow Precise FEM solution of corner singularity using adjusted mesh applied to 2D flow Jakub Šístek, Pavel Burda, Jaroslav Novotný Department of echnical Mathematics, Czech echnical University in Prague, Faculty

More information

Modeling External Compressible Flow

Modeling External Compressible Flow Tutorial 3. Modeling External Compressible Flow Introduction The purpose of this tutorial is to compute the turbulent flow past a transonic airfoil at a nonzero angle of attack. You will use the Spalart-Allmaras

More information

High-order methods for the next generation of computational engineering software

High-order methods for the next generation of computational engineering software High-order methods for the next generation of computational engineering software Rubén Sevilla Zienkiewicz Centre for Computational Engineering College of Engineering Swansea University Swansea Wales,

More information

Finite Volume Discretization on Irregular Voronoi Grids

Finite Volume Discretization on Irregular Voronoi Grids Finite Volume Discretization on Irregular Voronoi Grids C.Huettig 1, W. Moore 1 1 Hampton University / National Institute of Aerospace Folie 1 The earth and its terrestrial neighbors NASA Colin Rose, Dorling

More information

Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications

Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications Per-Olof Persson (persson@mit.edu) Department of Mathematics Massachusetts Institute of Technology http://www.mit.edu/

More information

Backward facing step Homework. Department of Fluid Mechanics. For Personal Use. Budapest University of Technology and Economics. Budapest, 2010 autumn

Backward facing step Homework. Department of Fluid Mechanics. For Personal Use. Budapest University of Technology and Economics. Budapest, 2010 autumn Backward facing step Homework Department of Fluid Mechanics Budapest University of Technology and Economics Budapest, 2010 autumn Updated: October 26, 2010 CONTENTS i Contents 1 Introduction 1 2 The problem

More information

Verification and Validation in CFD and Heat Transfer: ANSYS Practice and the New ASME Standard

Verification and Validation in CFD and Heat Transfer: ANSYS Practice and the New ASME Standard Verification and Validation in CFD and Heat Transfer: ANSYS Practice and the New ASME Standard Dimitri P. Tselepidakis & Lewis Collins ASME 2012 Verification and Validation Symposium May 3 rd, 2012 1 Outline

More information

SHAPE pilot Monotricat SRL: Hull resistance simulations for an innovative hull using OpenFOAM

SHAPE pilot Monotricat SRL: Hull resistance simulations for an innovative hull using OpenFOAM Available online at www.prace-ri.eu Partnership for Advanced Computing in Europe SHAPE pilot Monotricat SRL: Hull resistance simulations for an innovative hull using OpenFOAM Lilit Axner a,b, Jing Gong

More information

Verification and Validation of Turbulent Flow around a Clark-Y Airfoil

Verification and Validation of Turbulent Flow around a Clark-Y Airfoil Verification and Validation of Turbulent Flow around a Clark-Y Airfoil 1. Purpose 58:160 Intermediate Mechanics of Fluids CFD LAB 2 By Tao Xing and Fred Stern IIHR-Hydroscience & Engineering The University

More information

CFD-1. Introduction: What is CFD? T. J. Craft. Msc CFD-1. CFD: Computational Fluid Dynamics

CFD-1. Introduction: What is CFD? T. J. Craft. Msc CFD-1. CFD: Computational Fluid Dynamics School of Mechanical Aerospace and Civil Engineering CFD-1 T. J. Craft George Begg Building, C41 Msc CFD-1 Reading: J. Ferziger, M. Peric, Computational Methods for Fluid Dynamics H.K. Versteeg, W. Malalasekara,

More information

Estimating Vertical Drag on Helicopter Fuselage during Hovering

Estimating Vertical Drag on Helicopter Fuselage during Hovering Estimating Vertical Drag on Helicopter Fuselage during Hovering A. A. Wahab * and M.Hafiz Ismail ** Aeronautical & Automotive Dept., Faculty of Mechanical Engineering, Universiti Teknologi Malaysia, 81310

More information

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123 2.7 Cloth Animation 320491: Advanced Graphics - Chapter 2 123 Example: Cloth draping Image Michael Kass 320491: Advanced Graphics - Chapter 2 124 Cloth using mass-spring model Network of masses and springs

More information

Shape optimisation using breakthrough technologies

Shape optimisation using breakthrough technologies Shape optimisation using breakthrough technologies Compiled by Mike Slack Ansys Technical Services 2010 ANSYS, Inc. All rights reserved. 1 ANSYS, Inc. Proprietary Introduction Shape optimisation technologies

More information

NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011

NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011 NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011 First-Order Hyperbolic System Method If you have a CFD book for hyperbolic problems, you have a CFD book for all problems.

More information

Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM)

Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM) Computational Methods and Experimental Measurements XVII 235 Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM) K. Rehman Department of Mechanical Engineering,

More information

A compiler for variational forms - practical results

A compiler for variational forms - practical results A compiler for variational forms - practical results USNCCM8 Johan Jansson johanjan@math.chalmers.se Chalmers University of Technology Acknowledgements: Anders Logg and the FEniCS members A compiler for

More information

Strömningslära Fluid Dynamics. Computer laboratories using COMSOL v4.4

Strömningslära Fluid Dynamics. Computer laboratories using COMSOL v4.4 UMEÅ UNIVERSITY Department of Physics Claude Dion Olexii Iukhymenko May 15, 2015 Strömningslära Fluid Dynamics (5FY144) Computer laboratories using COMSOL v4.4!! Report requirements Computer labs must

More information

Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications

Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications Published in Lecture Notes in Computational Science and Engineering Vol. 103, Proceedings of ENUMATH 2013, pp. 755-762, Springer, 2014 Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications

More information

CFD Analysis of conceptual Aircraft body

CFD Analysis of conceptual Aircraft body CFD Analysis of conceptual Aircraft body Manikantissar 1, Dr.Ankur geete 2 1 M. Tech scholar in Mechanical Engineering, SD Bansal college of technology, Indore, M.P, India 2 Associate professor in Mechanical

More information

Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions. Milovan Perić

Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions. Milovan Perić Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions Milovan Perić Contents The need to couple STAR-CCM+ with other theoretical or numerical solutions Coupling approaches: surface and volume

More information

COMPUTATIONAL METHODS FOR ENVIRONMENTAL FLUID MECHANICS

COMPUTATIONAL METHODS FOR ENVIRONMENTAL FLUID MECHANICS COMPUTATIONAL METHODS FOR ENVIRONMENTAL FLUID MECHANICS Tayfun Tezduyar tezduyar@rice.edu Team for Advanced Flow Simulation and Modeling (T*AFSM) Mechanical Engineering and Materials Science Rice University

More information

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich 1 Computational Fluid dynamics Computational fluid dynamics (CFD) is the analysis of systems involving fluid flow, heat

More information

Keisuke Sawada. Department of Aerospace Engineering Tohoku University

Keisuke Sawada. Department of Aerospace Engineering Tohoku University March 29th, 213 : Next Generation Aircraft Workshop at Washington University Numerical Study of Wing Deformation Effect in Wind-Tunnel Testing Keisuke Sawada Department of Aerospace Engineering Tohoku

More information

A higher-order finite volume method with collocated grid arrangement for incompressible flows

A higher-order finite volume method with collocated grid arrangement for incompressible flows Computational Methods and Experimental Measurements XVII 109 A higher-order finite volume method with collocated grid arrangement for incompressible flows L. Ramirez 1, X. Nogueira 1, S. Khelladi 2, J.

More information

Study of Swept Angle Effects on Grid Fins Aerodynamics Performance

Study of Swept Angle Effects on Grid Fins Aerodynamics Performance Journal of Physics: Conference Series PAPER OPEN ACCESS Study of Swept Angle Effects on Grid Fins Aerodynamics Performance To cite this article: G A Faza et al 2018 J. Phys.: Conf. Ser. 1005 012013 View

More information

PROTECTION AGAINST MODELING AND SIMULATION UNCERTAINTIES IN DESIGN OPTIMIZATION NSF GRANT DMI

PROTECTION AGAINST MODELING AND SIMULATION UNCERTAINTIES IN DESIGN OPTIMIZATION NSF GRANT DMI PROTECTION AGAINST MODELING AND SIMULATION UNCERTAINTIES IN DESIGN OPTIMIZATION NSF GRANT DMI-9979711 Bernard Grossman, William H. Mason, Layne T. Watson, Serhat Hosder, and Hongman Kim Virginia Polytechnic

More information

cuibm A GPU Accelerated Immersed Boundary Method

cuibm A GPU Accelerated Immersed Boundary Method cuibm A GPU Accelerated Immersed Boundary Method S. K. Layton, A. Krishnan and L. A. Barba Corresponding author: labarba@bu.edu Department of Mechanical Engineering, Boston University, Boston, MA, 225,

More information

State of the art at DLR in solving aerodynamic shape optimization problems using the discrete viscous adjoint method

State of the art at DLR in solving aerodynamic shape optimization problems using the discrete viscous adjoint method DLR - German Aerospace Center State of the art at DLR in solving aerodynamic shape optimization problems using the discrete viscous adjoint method J. Brezillon, C. Ilic, M. Abu-Zurayk, F. Ma, M. Widhalm

More information

Inviscid Flows. Introduction. T. J. Craft George Begg Building, C41. The Euler Equations. 3rd Year Fluid Mechanics

Inviscid Flows. Introduction. T. J. Craft George Begg Building, C41. The Euler Equations. 3rd Year Fluid Mechanics Contents: Navier-Stokes equations Inviscid flows Boundary layers Transition, Reynolds averaging Mixing-length models of turbulence Turbulent kinetic energy equation One- and Two-equation models Flow management

More information

Keywords: CFD, aerofoil, URANS modeling, flapping, reciprocating movement

Keywords: CFD, aerofoil, URANS modeling, flapping, reciprocating movement L.I. Garipova *, A.N. Kusyumov *, G. Barakos ** * Kazan National Research Technical University n.a. A.N.Tupolev, ** School of Engineering - The University of Liverpool Keywords: CFD, aerofoil, URANS modeling,

More information

Case C1.3: Flow Over the NACA 0012 Airfoil: Subsonic Inviscid, Transonic Inviscid, and Subsonic Laminar Flows

Case C1.3: Flow Over the NACA 0012 Airfoil: Subsonic Inviscid, Transonic Inviscid, and Subsonic Laminar Flows Case C1.3: Flow Over the NACA 0012 Airfoil: Subsonic Inviscid, Transonic Inviscid, and Subsonic Laminar Flows Masayuki Yano and David L. Darmofal Aerospace Computational Design Laboratory, Massachusetts

More information

FEM techniques for interfacial flows

FEM techniques for interfacial flows FEM techniques for interfacial flows How to avoid the explicit reconstruction of interfaces Stefan Turek, Shu-Ren Hysing (ture@featflow.de) Institute for Applied Mathematics University of Dortmund Int.

More information

High-Order Numerical Algorithms for Steady and Unsteady Simulation of Viscous Compressible Flow with Shocks (Grant FA )

High-Order Numerical Algorithms for Steady and Unsteady Simulation of Viscous Compressible Flow with Shocks (Grant FA ) High-Order Numerical Algorithms for Steady and Unsteady Simulation of Viscous Compressible Flow with Shocks (Grant FA9550-07-0195) Sachin Premasuthan, Kui Ou, Patrice Castonguay, Lala Li, Yves Allaneau,

More information

SPC 307 Aerodynamics. Lecture 1. February 10, 2018

SPC 307 Aerodynamics. Lecture 1. February 10, 2018 SPC 307 Aerodynamics Lecture 1 February 10, 2018 Sep. 18, 2016 1 Course Materials drahmednagib.com 2 COURSE OUTLINE Introduction to Aerodynamics Review on the Fundamentals of Fluid Mechanics Euler and

More information

Multigrid Solvers in CFD. David Emerson. Scientific Computing Department STFC Daresbury Laboratory Daresbury, Warrington, WA4 4AD, UK

Multigrid Solvers in CFD. David Emerson. Scientific Computing Department STFC Daresbury Laboratory Daresbury, Warrington, WA4 4AD, UK Multigrid Solvers in CFD David Emerson Scientific Computing Department STFC Daresbury Laboratory Daresbury, Warrington, WA4 4AD, UK david.emerson@stfc.ac.uk 1 Outline Multigrid: general comments Incompressible

More information

Recent applications of overset mesh technology in SC/Tetra

Recent applications of overset mesh technology in SC/Tetra Recent applications of overset mesh technology in SC/Tetra NIA CFD Seminar October 6, 2014 Tomohiro Irie Software Cradle Co., Ltd. 1 Contents Introduction Software Cradle SC/Tetra Background of Demands

More information

Reproducibility of Complex Turbulent Flow Using Commercially-Available CFD Software

Reproducibility of Complex Turbulent Flow Using Commercially-Available CFD Software Reports of Research Institute for Applied Mechanics, Kyushu University No.150 (71 83) March 2016 Reproducibility of Complex Turbulent Flow Using Commercially-Available CFD Software Report 3: For the Case

More information

High-Lift Aerodynamics: STAR-CCM+ Applied to AIAA HiLiftWS1 D. Snyder

High-Lift Aerodynamics: STAR-CCM+ Applied to AIAA HiLiftWS1 D. Snyder High-Lift Aerodynamics: STAR-CCM+ Applied to AIAA HiLiftWS1 D. Snyder Aerospace Application Areas Aerodynamics Subsonic through Hypersonic Aeroacoustics Store release & weapons bay analysis High lift devices

More information

Two-Phase flows on massively parallel multi-gpu clusters

Two-Phase flows on massively parallel multi-gpu clusters Two-Phase flows on massively parallel multi-gpu clusters Peter Zaspel Michael Griebel Institute for Numerical Simulation Rheinische Friedrich-Wilhelms-Universität Bonn Workshop Programming of Heterogeneous

More information

DNV GL s 16th Technology Week

DNV GL s 16th Technology Week OIL & GAS DNV GL s 16th Technology Week Advanced Simulation for Offshore Application: Application of CFD for Computing VIM of Floating Structures 1 SAFER, SMARTER, GREENER OUTLINE Introduction Elements

More information

LES Applications in Aerodynamics

LES Applications in Aerodynamics LES Applications in Aerodynamics Kyle D. Squires Arizona State University Tempe, Arizona, USA 2010 Tutorial School on Fluid Dynamics: Topics in Turbulence Center for Scientific Computation and Mathematical

More information

Numerical Methods for PDEs. SSC Workgroup Meetings Juan J. Alonso October 8, SSC Working Group Meetings, JJA 1

Numerical Methods for PDEs. SSC Workgroup Meetings Juan J. Alonso October 8, SSC Working Group Meetings, JJA 1 Numerical Methods for PDEs SSC Workgroup Meetings Juan J. Alonso October 8, 2001 SSC Working Group Meetings, JJA 1 Overview These notes are meant to be an overview of the various memory access patterns

More information

Team 194: Aerodynamic Study of Airflow around an Airfoil in the EGI Cloud

Team 194: Aerodynamic Study of Airflow around an Airfoil in the EGI Cloud Team 194: Aerodynamic Study of Airflow around an Airfoil in the EGI Cloud CFD Support s OpenFOAM and UberCloud Containers enable efficient, effective, and easy access and use of MEET THE TEAM End-User/CFD

More information

Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics

Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics I. Pantle Fachgebiet Strömungsmaschinen Karlsruher Institut für Technologie KIT Motivation

More information

Final drive lubrication modeling

Final drive lubrication modeling Final drive lubrication modeling E. Avdeev a,b 1, V. Ovchinnikov b a Samara University, b Laduga Automotive Engineering Abstract. In this paper we describe the method, which is the composition of finite

More information

Improvement of Reduced Order Modeling based on POD

Improvement of Reduced Order Modeling based on POD Author manuscript, published in "The Fifth International Conference on Computational Fluid Dynamics (28)" Improvement of Reduced Order Modeling based on POD M. Bergmann 1, C.-H. Bruneau 2, and A. Iollo

More information

Numerical Investigation of Transonic Shock Oscillations on Stationary Aerofoils

Numerical Investigation of Transonic Shock Oscillations on Stationary Aerofoils Numerical Investigation of Transonic Shock Oscillations on Stationary Aerofoils A. Soda, T. Knopp, K. Weinman German Aerospace Center DLR, Göttingen/Germany Symposium on Hybrid RANS-LES Methods Stockholm/Sweden,

More information

Analysis, extensions and applications of the Finite-Volume Particle Method (FVPM) PN-II-RU-TE Synthesis of the technical report -

Analysis, extensions and applications of the Finite-Volume Particle Method (FVPM) PN-II-RU-TE Synthesis of the technical report - Analysis, extensions and applications of the Finite-Volume Particle Method (FVPM) PN-II-RU-TE-2011-3-0256 - Synthesis of the technical report - Phase 1: Preparation phase Authors: Delia Teleaga, Eliza

More information

Validation of a Multi-physics Simulation Approach for Insertion Electromagnetic Flowmeter Design Application

Validation of a Multi-physics Simulation Approach for Insertion Electromagnetic Flowmeter Design Application Validation of a Multi-physics Simulation Approach for Insertion Electromagnetic Flowmeter Design Application Setup Numerical Turbulence ing by March 15, 2015 Markets Insertion electromagnetic flowmeters

More information

Driven Cavity Example

Driven Cavity Example BMAppendixI.qxd 11/14/12 6:55 PM Page I-1 I CFD Driven Cavity Example I.1 Problem One of the classic benchmarks in CFD is the driven cavity problem. Consider steady, incompressible, viscous flow in a square

More information

Three-dimensional numerical simulations of flapping wings at low Reynolds numbers

Three-dimensional numerical simulations of flapping wings at low Reynolds numbers Three-dimensional numerical simulations of flapping wings at low Reynolds numbers OpenFOAM Workshop, Zagreb Frank Bos, Bas van Oudheusden, Hester Bijl 7-9 June 2007 1/22 Delft University of Technology

More information

Interdisciplinary practical course on parallel finite element method using HiFlow 3

Interdisciplinary practical course on parallel finite element method using HiFlow 3 Interdisciplinary practical course on parallel finite element method using HiFlow 3 E. Treiber, S. Gawlok, M. Hoffmann, V. Heuveline, W. Karl EuroEDUPAR, 2015/08/24 KARLSRUHE INSTITUTE OF TECHNOLOGY -

More information

Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes

Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes Stefan Vater 1 Kaveh Rahnema 2 Jörn Behrens 1 Michael Bader 2 1 Universität Hamburg 2014 PDES Workshop 2 TU München Partial

More information

S-ducts and Nozzles: STAR-CCM+ at the Propulsion Aerodynamics Workshop. Peter Burns, CD-adapco

S-ducts and Nozzles: STAR-CCM+ at the Propulsion Aerodynamics Workshop. Peter Burns, CD-adapco S-ducts and Nozzles: STAR-CCM+ at the Propulsion Aerodynamics Workshop Peter Burns, CD-adapco Background The Propulsion Aerodynamics Workshop (PAW) has been held twice PAW01: 2012 at the 48 th AIAA JPC

More information

Interpreted programming in FEniCS

Interpreted programming in FEniCS Interpreted programming in FEniCS Johan Jansson jjan@csc.kth.se CSC (old NADA) KTH Interpreted programming in FEniCS p. 1 Contents Motivate higher-level programming languages (abstraction) Overview of

More information

Solutions of 3D Navier-Stokes benchmark problems with adaptive finite elements 1

Solutions of 3D Navier-Stokes benchmark problems with adaptive finite elements 1 Solutions of 3D Navier-Stokes benchmark problems with adaptive finite elements 1 M. Braack a T. Richter b a Institute of Applied Mathematics, University of Heidelberg, INF 294, 69120 Heidelberg, Germany

More information

Incompressible Viscous Flow Simulations Using the Petrov-Galerkin Finite Element Method

Incompressible Viscous Flow Simulations Using the Petrov-Galerkin Finite Element Method Copyright c 2007 ICCES ICCES, vol.4, no.1, pp.11-18, 2007 Incompressible Viscous Flow Simulations Using the Petrov-Galerkin Finite Element Method Kazuhiko Kakuda 1, Tomohiro Aiso 1 and Shinichiro Miura

More information

AERODYNAMICS CHARACTERISTICS AROUND SIMPLIFIED HIGH SPEED TRAIN MODEL UNDER THE EFFECT OF CROSSWINDS

AERODYNAMICS CHARACTERISTICS AROUND SIMPLIFIED HIGH SPEED TRAIN MODEL UNDER THE EFFECT OF CROSSWINDS AERODYNAMICS CHARACTERISTICS AROUND SIMPLIFIED HIGH SPEED TRAIN MODEL UNDER THE EFFECT OF CROSSWINDS Sufiah Mohd Salleh 1, Mohamed Sukri Mat Ali 1, Sheikh Ahmad Zaki Shaikh Salim 1, Izuan Amin Ishak 1,

More information

Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs)

Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs) OBJECTIVE FLUID SIMULATIONS Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs) The basic objective of the project is the implementation of the paper Stable Fluids (Jos Stam, SIGGRAPH 99). The final

More information

The Immersed Interface Method

The Immersed Interface Method The Immersed Interface Method Numerical Solutions of PDEs Involving Interfaces and Irregular Domains Zhiiin Li Kazufumi Ito North Carolina State University Raleigh, North Carolina Society for Industrial

More information

Airfoil Design Optimization Using Reduced Order Models Based on Proper Orthogonal Decomposition

Airfoil Design Optimization Using Reduced Order Models Based on Proper Orthogonal Decomposition Airfoil Design Optimization Using Reduced Order Models Based on Proper Orthogonal Decomposition.5.5.5.5.5.5.5..5.95.9.85.8.75.7 Patrick A. LeGresley and Juan J. Alonso Dept. of Aeronautics & Astronautics

More information

Progress and Future Prospect of CFD in Aerospace

Progress and Future Prospect of CFD in Aerospace Progress and Future Prospect of CFD in Aerospace - Observation from 30 years research - Kozo Fujii Institute of Space and Astronautical Science (ISAS) Japan Aerospace Exploration Agency (JAXA) Japan JAXA:

More information

LS-DYNA 980 : Recent Developments, Application Areas and Validation Process of the Incompressible fluid solver (ICFD) in LS-DYNA.

LS-DYNA 980 : Recent Developments, Application Areas and Validation Process of the Incompressible fluid solver (ICFD) in LS-DYNA. 12 th International LS-DYNA Users Conference FSI/ALE(1) LS-DYNA 980 : Recent Developments, Application Areas and Validation Process of the Incompressible fluid solver (ICFD) in LS-DYNA Part 1 Facundo Del

More information

Funded by the European Union INRIA. AEROGUST Workshop 27 th - 28 th April 2017, University of Liverpool. Presented by Andrea Ferrero and Angelo Iollo

Funded by the European Union INRIA. AEROGUST Workshop 27 th - 28 th April 2017, University of Liverpool. Presented by Andrea Ferrero and Angelo Iollo INRIA AEROGUST Workshop 27 th - 28 th April 2017, University of Liverpool Presented by Andrea Ferrero and Angelo Iollo Aero-elastic study of a wind turbine subjected to a gust Development of high-fidelity

More information

Multi-Mesh CFD. Chris Roy Chip Jackson (1 st year PhD student) Aerospace and Ocean Engineering Department Virginia Tech

Multi-Mesh CFD. Chris Roy Chip Jackson (1 st year PhD student) Aerospace and Ocean Engineering Department Virginia Tech Multi-Mesh CFD Chris Roy Chip Jackson (1 st year PhD student) Aerospace and Ocean Engineering Department Virginia Tech cjroy@vt.edu May 21, 2014 CCAS Program Review, Columbus, OH 1 Motivation Automated

More information

Flow Structures Extracted from Visualization Images: Vector Fields and Topology

Flow Structures Extracted from Visualization Images: Vector Fields and Topology Flow Structures Extracted from Visualization Images: Vector Fields and Topology Tianshu Liu Department of Mechanical & Aerospace Engineering Western Michigan University, Kalamazoo, MI 49008, USA We live

More information

NUMERICAL INVESTIGATION OF THE FLOW BEHAVIOR INTO THE INLET GUIDE VANE SYSTEM (IGV)

NUMERICAL INVESTIGATION OF THE FLOW BEHAVIOR INTO THE INLET GUIDE VANE SYSTEM (IGV) University of West Bohemia» Department of Power System Engineering NUMERICAL INVESTIGATION OF THE FLOW BEHAVIOR INTO THE INLET GUIDE VANE SYSTEM (IGV) Publication was supported by project: Budování excelentního

More information

Numerical Study of Turbulent Flow over Backward-Facing Step with Different Turbulence Models

Numerical Study of Turbulent Flow over Backward-Facing Step with Different Turbulence Models Numerical Study of Turbulent Flow over Backward-Facing Step with Different Turbulence Models D. G. Jehad *,a, G. A. Hashim b, A. K. Zarzoor c and C. S. Nor Azwadi d Department of Thermo-Fluids, Faculty

More information