A GPU Accelerated Adjoint Solver for Shape Optimization

Size: px
Start display at page:

Download "A GPU Accelerated Adjoint Solver for Shape Optimization"

Transcription

1 A GPU Accelerated Adjoint Solver for Shape Optimization Asitav Mishra 1 Asst. Research Scientist Dylan Jude 1 PhD Candidate James D. Baeder 1 Professor 1 Department of Aerospace Engineering, University of Maryland, College Park, MD Funded by:

2 Introduction CFD Vision 2030 emphasizes HPC and GPUs Modern HPC systems support heterogenous (GPU/CPU) computing; e.g. SUMMIT by Oak Ridge NL GPU allows hi-fidelity (RANS, LES, DNS) CFD for complex vortex dominated flows Need to leverage on GPUs for modern complex aerospace computations Figure: CFD Vision 2030 Figure: SUMMIT Supercomputers (image credit: ORNL) 2 / 48

3 Introduction CFD Vision 2030 emphasizes HPC and GPUs Modern HPC systems support heterogenous (GPU/CPU) computing; e.g. SUMMIT by Oak Ridge NL GPU allows hi-fidelity (RANS, LES, DNS) CFD for complex vortex dominated flows Need to leverage on GPUs for modern complex aerospace computations Figure: CFD Vision 2030 Figure: SUMMIT Supercomputers (image credit: ORNL) 3 / 48

4 Introduction Continued... Adjoint-based optimization popular using CFD Design practically independed of number of design variables Efficient (parallel) adjoint for reduced design computational cost GPUs can provide extreme speed up gains GPU ADjoint platforms can be powerful tools for future aerospace design Figure: UH60 adjoint solution Ref: FUN3D Manual, NASA Figure: HART2 blade optimization Ref: Mishra et. al, AIAAJ, / 48

5 Introduction Continued... Adjoint-based optimization popular using CFD Design practically independed of number of design variables Efficient (parallel) adjoint for reduced design computational cost GPUs can provide extreme speed up gains GPU ADjoint platforms can be powerful tools for future aerospace design Figure: UH60 adjoint solution Ref: FUN3D Manual, NASA Figure: HART2 blade optimization Ref: Mishra et. al, AIAAJ, / 48

6 Introduction Background and Motivation GPU CFD Solver: GARFIELD 2D Adjoint Euler Shape Optimization ADGAR: GPU Accelerated 2-D Adjoint Formulation Conclusions 6 / 48

7 Motivation: GPU Accelerated CFD Elsen: 20-40x, hypersonic NS Chander: 60x, incompressible NS overset (CU++) Kajeh-Saeed: 37x, turbulent DNS (GPU cluster) Walden: 6x per node on FUN3D linear solver (6 GPU vs 2 CPU) GPU accelerated CFD holds great potential Figure: Elsen et. al (JCP 2008) Figure: Chander et. al (J. Supercomputer 2014) 7 / 48

8 Recent GPU CFD RANS at UMD Figure: Jung et. al (AHS 2017) Thomas: GPURANS, 55x helicopter brownout, 2013 Jude: GPURANS 17-28x unsteady grid motion, 2016 Jung: GARFIELD, 7x (16 GPU vs 32 CPU cores, per node), 2017 Sufficient background for future adjoint GPU developments 8 / 48

9 Motivation: GPU-Adjoint CFD for Design Optimization Tsiakas: 50x per-node on U-bend duct optimization, continuous adjoint, 2015 Toit: 2x on Monte Carlo kernels using AD, 2013 Laniewski-Wollk: topology opt w/ Lattice Boltzmann AD, linear weak scaling, 2016 No GPU-enabled discrete adjoint (AD) CFD exist Dr. Baeder s funding as an Associate Langley Professor enables such unique technology development Figure: Baseline (a) vs Optimized (b) u-bend Tsiakas (GRACM, 2015) 9 / 48

10 Motivation: GPU-Adjoint CFD for Design Optimization Tsiakas: 50x per-node on U-bend duct optimization, continuous adjoint, 2015 Toit: 2x on Monte Carlo kernels using AD, 2013 Laniewski-Wollk: topology opt w/ Lattice Boltzmann AD, linear weak scaling, 2016 No GPU-enabled discrete adjoint (AD) CFD exist Dr. Baeder s funding as an Associate Langley Professor enables such unique technology development Figure: Baseline (a) vs Optimized (b) u-bend Tsiakas (GRACM, 2015) 10 / 48

11 Objective Step 1: Develop GARFIELD inspired structured 2D Adjoint Euler optimization platform Verifiy discrete adjoint (hand-derived/ad) with finite difference Step 2: Perform GPU acceleration of the 2D hand-derived adjoint solver Verify GPU adjoint, compare solutions with CPU adjoint Conduct GPU speed up studies Perform reverse design optimization on airfoils Figure: Objective of this work 11 / 48

12 Introduction Background and Motivation GPU CFD Solver: GARFIELD 2D Adjoint Euler Shape Optimization ADGAR: GPU Accelerated 2-D Adjoint Formulation Conclusions 12 / 48

13 GPU CFD Solver: GARFIELD GARFIELD: 3D GPU-Accelerated Rotor flow FIELD solver at UMD Multi-GPU and heterogenous CPU/GPU compute capability, Python wrapped 3D RANS solver for compressible unsteady turbulent flows Implicit operator DADI with up-wind dissipation, MUSCL/WENO reconstruction Minimum CPU-GPU communication; most computations in GPU Variable, point, line parallelism using CUDA kernels Figure: GARFIELD flowchart Speedup GARFIELD Linear Number of GPUs Figure: GARFIELD scalability Ref: Jude et. al, Scitech / 48

14 GARFIELD Results Caradonna-Tung rotor in hover: Untwisted rectangular rotor, AR=6, NAC0012 Rey = , Mach = Mesh points: 9.1M (Background) + 2.2M (blade) Table: GARFIELD vs OVERFLOW (7.2M Blade mesh) Code Cores or GPUs Time (s) Speedup over 32 cores OVERFLOW 32 Core GPU GARFIELD 2 GPU GPU GPU GPU Figure: Caradonna-Tung solutions Ref: Jude et. al, Scitech / 48

15 Introduction Background and Motivation GPU CFD Solver: GARFIELD 2D Adjoint Euler Shape Optimization ADGAR: GPU Accelerated 2-D Adjoint Formulation Conclusions 15 / 48

16 2D Adjoint Euler Shape Optimization Figure: 2D Optimization Flowchart Euler (forward): GARFIELD inspired 2D Euler Adjoint: Hand-derived, auto-differentiated (AD) Meshgen: Poisson equations (Steger & Sorenson sources) Optimization: Python based framework, SciPy library 16 / 48

17 2D Euler/Forward Formulation q = J 1 ρ ρu 1 ρu 2 e q t + f c,i = 0 (1) ξ i, ρv 1 f c,i = J 1 ρu 1 V i + ξ i,1 p ρu 2 V i + ξ i,2 p (e + p)v i (2) J is Jacobian and contravariant velocity V i = u 1 ξ i,1 + u 2 ξ i,2 Implicit discretization: q n+1 q n ( ) = f n+1 f n+1 D n+1 (3) t c,i+ 1 2 c,i 1 2 1st order in space and time Explicit and implicit (DADI) schemes D is artificial dissipation (Roe-flux or scalar dissipation) 17 / 48

18 2D Adjoint Formulation Adjoint: δi q ψ(δr q ) = 0 Residual: where: δr q n j,k = δh j+ 1 2,k δh j 1 2,k + δh j,k+ 1 δh 2 j,k 1 2 δh j+ 1 2,k = δf j+ 1 2,k δd j+ 1 2,k δh j,k+ 1 2 = δf j,k+ 1 2 δd j,k+ 1 2 The term ψ(δr q ) auto-differentiated or hand-derived. Artificial (scalar) dissipation term: d j+ 1 2,k = ɛσ ( ) q j+1,k q j,k with ɛ 0.25, σ = V + c S j+ 1, and c is speed of sound. 2 Discrete adjoint: jmax kmax j k ψ T j,k δr q n j,k 18 / 48

19 Objective Sensitivity: Tangent vs Adjoint ( ) Ic Tangent: = α ( ) T Ic Adjoint: = α ( ) ( ) ( ) Ic Q X Q X α ( ) T ( ) T ( X Q Ic α X Q ) T Finally, Tangent order: α Ẋ Q İ; () = () α Adjoint order: ᾱ X Q Ī; () = () I c I c = I c α = Q T Q = X T Ẋ = ᾱ T α (4) This work computes adjoint X and finite-difference Ẋ 19 / 48

20 Gradient-based Optimization Adjoint sensitivity of objective I: { I T δi = X ψt [ ]} R δx X Term {} using adjoint δx using finite difference, i.e. mesh re-generation Airfoil optimization using SciPy library (SLSQP, CG) Airfoil geometry parameterization using Hicks-Henne bump functions 20 / 48

21 Grid Generation Two-dimensional mesh generation solves Poisson equations: ξ xx + ξ yy = P s η xx + η yy = Q s P s, Q s are Steger and Sorenson (JCP, 1979) source terms Uniform outer boundaries, orthogonality near wall Figure: Example O-grids 21 / 48

22 2D Euler Results NACA0012 2D Euler vs 3D GARFIELD Euler Mach = 0.8, α = Pressure Coefficient Reference Solver 2D Euler Solver Chord Figure: Transonic Euler validation with GARFIELD 22 / 48

23 2D Adjoint Euler Verification NACA0012, Mach = 0.5, AoA = 5 Hicks-Henne surface parametrization Upper/lower D var : bump 50 and 75%c) I c (α) = N i=0 1 2 (P i P d,i ) 2, P d,i = desired surface pressure Brute-Force AD Adjoint Hand Adjoint α I/ α 1 I/ α 2 I/ α 3 I/ α Table: Adjoint and brute-force gradient comparison. 23 / 48

24 Forward vs Adjoint Information Propagation Figure: Forward vs Adjoint x-momemntum vector Direction of information propagation in adjoint is opposite of forward/euler. 24 / 48

25 2D Adjoint Euler Optimization Baseline: NACA0012, target: NACA2312; Mach = 0.5, AoA = 5 SLSQP and CG optimization techniques Figure: 2D Airfoil Optimization 25 / 48

26 Introduction Background and Motivation GPU CFD Solver: GARFIELD 2D Adjoint Euler Shape Optimization ADGAR: GPU Accelerated 2-D Adjoint Formulation Adjoint-based GPU Accelerated Optimization Conclusions 26 / 48

27 ADGAR: GPU Accelerated 2-D Adjoint Solver ADGAR: ADjoint GARfield GPU acceleration using CUDA kernels DADI in forward/adjoint GPU accelerated Parallelism: variable, point and line Verification with serial forward/adjoint solutions Figure: O-grid used by ADGAR (181 60) 27 / 48

28 ADGAR: Forward/Euler Verification CPU (serial) vs GPU ADGAR Euler solution verified Implicit iterative operator DADI is GPU accelerated NACA0012, Mach = 0.5, AoA = 5, O-grid: Figure: CPU vs GPU Euler/Forward solution 28 / 48

29 ADGAR: Adjoint Verification CPU (serial) vs GPU ADGAR Adjoint solution verified Implicit iterative operator Adjoint DADI is GPU accelerated NACA0012, Mach = 0.5, AoA = 5, O-grid: Figure: CPU vs GPU Adjoint convergence and solution 29 / 48

30 GPU Acceleration Paradigms Line parallel: DADI, each line each grid dimension Point parallel: Flux, BC and most routines Variable parallel: Update routines CUDA library, cublasdnrm2: L2-norm computations GPU acceleration tested on 3 mesh sizes Speed up variable upon compiler flags/machines 30 / 48

31 GPU Acceleration of ADjoint DADI ADjoint DADI: ( T 1 η Three steps: ) T [I + hδη Λ η ] T [ ˆN ] S 2 {}}{ T [I + hδξ Λ ξ ] T Tξ T Ψ = R ψ (5) }{{} S 1 1. [I + hδ η Λ η ] T S 1 = T T η R ψ 2. [I + hδ ξ Λ ξ ] T S 2 = [ ˆN ] T S1 3. Ψ = T T ξ S 2 1. [I + hδ η Λ η ] T S 1 = T T η R ψ : i) MVP : T T η R ψ ii) Compute LDU: [I + hδ η Λ η ] T iii) Invert along η : S 1 = [I + hδ η Λ η ] T [ T T η R ψ ] 31 / 48

32 CUDA Kernel: ADjoint DADI Line and Point parallel in Adjoint DADI: // // Eta-inversion // // Custom threads for Tri-Diagonal Inversion thr_line.x = 4; thr_line.y = 4; //h_dim->nvar blk_line.x = (h_dim->kmax-1)/thr_line.x+1; blk_line.y = 1; // 1.MVP (POINT PARALLEL): [T_etaˆT]x[RHS_adj] mvp_eta<<<blk_pt, thr_pt>>>(rhs,...); // 2.Compute LDU of LHS_eta (POINT PARALLEL) LDU<K_DIR><<<blk_pt, thr_pt>>>(); // 3. Tri-diag eta-inversion (LINE PARALLEL) eta_tridiag<<<blk_line, thr_line>>>(rhs,...); 32 / 48

33 CUDA Kernels: Line Parallelism in DADI Figure: Line parallelism in DADI kernel ξ, η tridiagonal inversion in DADI Solves tridiagonal inversion per k-line per variable 33 / 48

34 CUDA Kernels: Variable Parallelism Variable parallel (adjoint vector update): // GPU kernel to update psi: var parallel global void update_psiv(double (*rhs)[4],... ){ //... // update psi d_sol_ad->psi[grid_idx][var] += rhs[grid_idx][var]; } // Update Adj vector kernel (VARIABLE PARALLEL) update_psiv<<<blk_var, thr_var>>>(rhs,...); 34 / 48

35 CUDA Kernels: Race Condition Figure: Race condition in flux computation Race condition: Two threads access same address (cell) in flux computation Solution: split flux computations to two steps 35 / 48

36 GPU Acceleration for Varying Problem Sizes Mesh size CPU Time (s) GPU Time (s) Speed up Forward Adjoint Functional + Jacobian Forward Adjoint Functional + Jacobian Forward Adjoint Functional + Jacobian Table: ADGAR GPU vs CPU speedup (Tesla P100-PCIE-16GB) 36 / 48

37 Speed Up Study: GPU Arch & Flags Table: GPU performance with machines (mesh: ) GPU Arch CPU Time (s) GPU Time (s) Speed up Forward GeForce TitanX (Kepler) Adjoint Total Tesla P100 (Volta) Quadro GV100 (Volta) Forward Adjoint Total Forward Adjoint Total Table: Quadro-GV100 GPU speedup with flags (mesh: ) Compiler Flags CPU Time (s) GPU Time (s) Speed up Debug (-g) Total Optimization (-O3) Total Better performance with newer generation GPU Inappropriate flags misrepresent speed up 37 / 48

38 Introduction Background and Motivation GPU CFD Solver: GARFIELD 2D Adjoint Euler Shape Optimization ADGAR: GPU Accelerated 2-D Adjoint Formulation Adjoint-based GPU Accelerated Optimization Conclusions 38 / 48

39 ADGAR Airfoil Design Optimization Figure: ADGAR Optimization Framework Minimal GPU CPU transfer per time step Major computations done in GPUs 39 / 48

40 ADGAR Airfoil Optimization: Single Variable mod-naca0012, Mach = 0.5, AoA = 5, O-grid: I c (α 1 ) = 1 2 (P 1 P d,1 ) 2 α 1 = location of first Hicks-Henne bump in chords Figure: Comparing α 1 = 0.1 vs α 1 = / 48

41 Single Variable Optimization Continued... Figure: Optimized and target solutions for α 1 = 0.1 CG converges faster than SLSQP for both α 1 = 0.1, 0.7 Both methods yield similar optimization results 41 / 48

42 ADGAR Airfoil Optimization: Multiple Variable I c (α) = N i=0 1 2 (P i P d,i ) 2 α i, i = [1 : 6], upper/lower Hicks-Henne bump 50, 75%) chords Baseline: NACA0012, target: NACA2312, Mach = 0.5 AoA = 5, O-grid: I/ α 1 I/ α 2 I/ α 3 I/ α 4 CPU Adjoint e e e e-02 GPU Adjoint e e e e-02 Table: GPU vs CPU adjoint sensitivities ( α = 10 8 ). 42 / 48

43 Multiple Variable Optimization Continued... Figure: Optimization convergence and solutions 43 / 48

44 Multiple Variable Optimization Continued... Design Iterations Adjoint Calls Function Calls SLSQP CG Table: Optimization function and adjoint calls using SLSQP and CG with six design variables. Summary of ADGAR optimization: GPU sensitivities verified to 14 significant digits wrt CPU SLSQP faster than CG (gradient drop 2 orders) Both methods successfully yield target airfoil and pressure GPU airfoil optimization validated against CPU results 44 / 48

45 Introduction Background and Motivation GPU CFD Solver: GARFIELD 2D Adjoint Euler Shape Optimization ADGAR: GPU Accelerated 2-D Adjoint Formulation Conclusions 45 / 48

46 Conclusions Presented existing capabilities of GARFIELD (multi-gpu, heterogenous CPU/GPU) First step: 2D Adjoint Euler optimizer inspired by GARFIELD developed, verified and tested for inverse design Second step: developed ADGAR - GPU accelerated 2D adjoint Euler shape optimizer DADI for Euler and Adjoint implemented, verified convergence GPU solution verified with CPU to 14 significant digits accuracy Inverse design optimization and speed up studies on NACA-series airfoils Future work: Extend to turbulent flows GPU CUDA kernel optimizations: shared memory, streaming, atomic 46 / 48

47 Acknowledgements Funded by the National Institute of Aerospace (NIA), Hampton, VA through the Langley Professor Program. University of Maryland s DeepThought 2 supercomputing facility ( and other computational resources at the university. 47 / 48

48 Thank you 48 / 48

Analysis of the Adjoint Euler Equations as used for Gradient-based Aerodynamic Shape Optimization

Analysis of the Adjoint Euler Equations as used for Gradient-based Aerodynamic Shape Optimization Analysis of the Adjoint Euler Equations as used for Gradient-based Aerodynamic Shape Optimization Final Presentation Dylan Jude Graduate Research Assistant University of Maryland AMSC 663/664 May 4, 2017

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

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

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

SENSEI / SENSEI-Lite / SENEI-LDC Updates

SENSEI / SENSEI-Lite / SENEI-LDC Updates SENSEI / SENSEI-Lite / SENEI-LDC Updates Chris Roy and Brent Pickering Aerospace and Ocean Engineering Dept. Virginia Tech July 23, 2014 Collaborations with Math Collaboration on the implicit SENSEI-LDC

More information

Adjoint-Based Sensitivity Analysis for Computational Fluid Dynamics

Adjoint-Based Sensitivity Analysis for Computational Fluid Dynamics Adjoint-Based Sensitivity Analysis for Computational Fluid Dynamics Dimitri J. Mavriplis Max Castagne Professor Department of Mechanical Engineering University of Wyoming Laramie, WY USA Motivation Computational

More information

The Spalart Allmaras turbulence model

The Spalart Allmaras turbulence model The Spalart Allmaras turbulence model The main equation The Spallart Allmaras turbulence model is a one equation model designed especially for aerospace applications; it solves a modelled transport equation

More information

Rotorcraft Noise Prediction with Multi-disciplinary Coupling Methods. Yi Liu NIA CFD Seminar, April 10, 2012

Rotorcraft Noise Prediction with Multi-disciplinary Coupling Methods. Yi Liu NIA CFD Seminar, April 10, 2012 Rotorcraft Noise Prediction with Multi-disciplinary Coupling Methods Yi Liu NIA CFD Seminar, April 10, 2012 Outline Introduction and Background Multi-disciplinary Analysis Approaches Computational Fluid

More information

A Scalable GPU-Based Compressible Fluid Flow Solver for Unstructured Grids

A Scalable GPU-Based Compressible Fluid Flow Solver for Unstructured Grids A Scalable GPU-Based Compressible Fluid Flow Solver for Unstructured Grids Patrice Castonguay and Antony Jameson Aerospace Computing Lab, Stanford University GTC Asia, Beijing, China December 15 th, 2011

More information

Application of STAR-CCM+ to Helicopter Rotors in Hover

Application of STAR-CCM+ to Helicopter Rotors in Hover Application of STAR-CCM+ to Helicopter Rotors in Hover Lakshmi N. Sankar and Chong Zhou School of Aerospace Engineering, Georgia Institute of Technology, Atlanta, GA Ritu Marpu Eschol CD-Adapco, Inc.,

More information

Development of a Consistent Discrete Adjoint Solver for the SU 2 Framework

Development of a Consistent Discrete Adjoint Solver for the SU 2 Framework Development of a Consistent Discrete Adjoint Solver for the SU 2 Framework Tim Albring, Max Sagebaum, Nicolas Gauger Chair for Scientific Computing TU Kaiserslautern 16th Euro-AD Workshop, Jena December

More information

Development of a CFD Capability for Full Helicopter Engineering Analysis

Development of a CFD Capability for Full Helicopter Engineering Analysis Development of a CFD Capability for Full Helicopter Engineering Analysis George Barakos Department of Engineering University of Liverpool 5/6 April 2006 Loughborough University Collective effort of more

More information

ACCELERATION OF A COMPUTATIONAL FLUID DYNAMICS CODE WITH GPU USING OPENACC

ACCELERATION OF A COMPUTATIONAL FLUID DYNAMICS CODE WITH GPU USING OPENACC Nonlinear Computational Aeroelasticity Lab ACCELERATION OF A COMPUTATIONAL FLUID DYNAMICS CODE WITH GPU USING OPENACC N I C H O L S O N K. KO U K PA I Z A N P H D. C A N D I D AT E GPU Technology Conference

More information

GTC 2017 S7672. OpenACC Best Practices: Accelerating the C++ NUMECA FINE/Open CFD Solver

GTC 2017 S7672. OpenACC Best Practices: Accelerating the C++ NUMECA FINE/Open CFD Solver David Gutzwiller, NUMECA USA (david.gutzwiller@numeca.com) Dr. Ravi Srinivasan, Dresser-Rand Alain Demeulenaere, NUMECA USA 5/9/2017 GTC 2017 S7672 OpenACC Best Practices: Accelerating the C++ NUMECA FINE/Open

More information

Direct Numerical Simulation of a Low Pressure Turbine Cascade. Christoph Müller

Direct Numerical Simulation of a Low Pressure Turbine Cascade. Christoph Müller Low Pressure NOFUN 2015, Braunschweig, Overview PostProcessing Experimental test facility Grid generation Inflow turbulence Conclusion and slide 2 / 16 Project Scale resolving Simulations give insight

More information

Airfoil shape optimization using adjoint method and automatic differentiation. Praveen. C

Airfoil shape optimization using adjoint method and automatic differentiation. Praveen. C 'th Annual AeSI CFD Symposium, -2 August 2009, Bangalore Airfoil shape optimization using adjoint method and automatic differentiation Praveen. C TIFR Center for Applicable Mathematics Post Bag No. 6503,

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

Multi-Element High-Lift Configuration Design Optimization Using Viscous Continuous Adjoint Method

Multi-Element High-Lift Configuration Design Optimization Using Viscous Continuous Adjoint Method JOURNAL OF AIRCRAFT Vol. 41, No. 5, September October 2004 Multi-Element High-Lift Configuration Design Optimization Using Viscous Continuous Adjoint Method Sangho Kim, Juan J. Alonso, and Antony Jameson

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

Aerodynamic Design Optimization of UAV Rotor Blades using a Genetic Algorithm

Aerodynamic Design Optimization of UAV Rotor Blades using a Genetic Algorithm Aerodynamic Design Optimization of UAV Rotor Blades using a Genetic Algorithm Hak-Min Lee 1), Nahm-Keon Hur 2) and *Oh-Joon Kwon 3) 1), 3) Department of Aerospace Engineering, KAIST, Daejeon 305-600, Korea

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

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

Semi-automatic transition from simulation to one-shot optimization with equality constraints

Semi-automatic transition from simulation to one-shot optimization with equality constraints Semi-automatic transition from simulation to one-shot optimization with equality constraints Lisa Kusch, Tim Albring, Andrea Walther, Nicolas Gauger Chair for Scientific Computing, TU Kaiserslautern, www.scicomp.uni-kl.de

More information

Mid-Year Report. Discontinuous Galerkin Euler Equation Solver. Friday, December 14, Andrey Andreyev. Advisor: Dr.

Mid-Year Report. Discontinuous Galerkin Euler Equation Solver. Friday, December 14, Andrey Andreyev. Advisor: Dr. Mid-Year Report Discontinuous Galerkin Euler Equation Solver Friday, December 14, 2012 Andrey Andreyev Advisor: Dr. James Baeder Abstract: The focus of this effort is to produce a two dimensional inviscid,

More information

Helicopter Rotor Design Using a Time-Spectral and Adjoint-Based Method

Helicopter Rotor Design Using a Time-Spectral and Adjoint-Based Method 12th AIAA/ISSMO Multidisciplinary Analysis and Optimization Conference 1-12 September 28, Victoria, British Columbia Canada AIAA 28-581 12th AIAA/ISSMO Multidisciplinary Analysis and Optimization Conference

More information

Maximize automotive simulation productivity with ANSYS HPC and NVIDIA GPUs

Maximize automotive simulation productivity with ANSYS HPC and NVIDIA GPUs Presented at the 2014 ANSYS Regional Conference- Detroit, June 5, 2014 Maximize automotive simulation productivity with ANSYS HPC and NVIDIA GPUs Bhushan Desam, Ph.D. NVIDIA Corporation 1 NVIDIA Enterprise

More information

Adjoint Solver Workshop

Adjoint Solver Workshop Adjoint Solver Workshop Why is an Adjoint Solver useful? Design and manufacture for better performance: e.g. airfoil, combustor, rotor blade, ducts, body shape, etc. by optimising a certain characteristic

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

Grid Dependence Study of Transonic/Supersonic Flow Past NACA Air-foil using CFD Hemanth Kotaru, B.Tech (Civil Engineering)

Grid Dependence Study of Transonic/Supersonic Flow Past NACA Air-foil using CFD Hemanth Kotaru, B.Tech (Civil Engineering) Grid Dependence Study of Transonic/Supersonic Flow Past NACA Air-foil using CFD Hemanth Kotaru, B.Tech (Civil Engineering) Abstract Computational fluid dynamics is a relatively young field in engineering.

More information

Study and implementation of computational methods for Differential Equations in heterogeneous systems. Asimina Vouronikoy - Eleni Zisiou

Study and implementation of computational methods for Differential Equations in heterogeneous systems. Asimina Vouronikoy - Eleni Zisiou Study and implementation of computational methods for Differential Equations in heterogeneous systems Asimina Vouronikoy - Eleni Zisiou Outline Introduction Review of related work Cyclic Reduction Algorithm

More information

41st AIAA Aerospace Sciences Meeting and Exhibit Jan 6 9, 2003/Reno, Nevada

41st AIAA Aerospace Sciences Meeting and Exhibit Jan 6 9, 2003/Reno, Nevada AIAA 23 68 Aerodynamic Design of Cascades by Using an Adjoint Equation Method Shuchi Yang, Hsiao-Yuan Wu, and Feng Liu Department of Mechanical and Aerospace Engineering University of California, Irvine,

More information

The Continuous Adjoint Method for the Computation of First- and Higher-Order Sensitivities

The Continuous Adjoint Method for the Computation of First- and Higher-Order Sensitivities NATIONAL TECHNICAL UNIVERSITY OF ATHENS Parallel CFD & Optimization Unit Laboratory of Thermal Turbomachines The Continuous Adjoint Method for the Computation of First- and Higher-Order Sensitivities (Activities,

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

NASA Rotor 67 Validation Studies

NASA Rotor 67 Validation Studies NASA Rotor 67 Validation Studies ADS CFD is used to predict and analyze the performance of the first stage rotor (NASA Rotor 67) of a two stage transonic fan designed and tested at the NASA Glenn center

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

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

Recent & Upcoming Features in STAR-CCM+ for Aerospace Applications Deryl Snyder, Ph.D.

Recent & Upcoming Features in STAR-CCM+ for Aerospace Applications Deryl Snyder, Ph.D. Recent & Upcoming Features in STAR-CCM+ for Aerospace Applications Deryl Snyder, Ph.D. Outline Introduction Aerospace Applications Summary New Capabilities for Aerospace Continuity Convergence Accelerator

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

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

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

Recent developments for the multigrid scheme of the DLR TAU-Code

Recent developments for the multigrid scheme of the DLR TAU-Code www.dlr.de Chart 1 > 21st NIA CFD Seminar > Axel Schwöppe Recent development s for the multigrid scheme of the DLR TAU-Code > Apr 11, 2013 Recent developments for the multigrid scheme of the DLR TAU-Code

More information

Turbostream: A CFD solver for manycore

Turbostream: A CFD solver for manycore Turbostream: A CFD solver for manycore processors Tobias Brandvik Whittle Laboratory University of Cambridge Aim To produce an order of magnitude reduction in the run-time of CFD solvers for the same hardware

More information

Solution of 2D Euler Equations and Application to Airfoil Design

Solution of 2D Euler Equations and Application to Airfoil Design WDS'6 Proceedings of Contributed Papers, Part I, 47 52, 26. ISBN 8-86732-84-3 MATFYZPRESS Solution of 2D Euler Equations and Application to Airfoil Design J. Šimák Charles University, Faculty of Mathematics

More information

Combining source transformation and operator overloading approaches for adjoint CFD solvers

Combining source transformation and operator overloading approaches for adjoint CFD solvers Combining source transformation and operator overloading approaches for adjoint CFD solvers Azar Dastouri Sinan Gezgin Prof. Uwe Naumann Software and Tools for Computational Engineering, RWTH Aachen University,

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

Sensitivity Analysis for the Compressible Navier-Stokes Equations Using a Discontinuous Galerkin Method

Sensitivity Analysis for the Compressible Navier-Stokes Equations Using a Discontinuous Galerkin Method 2th AIAA Computational Fluid Dynamics Conference 27-3 June 2, Honolulu, Hawaii AIAA 2-348 Sensitivity Analysis for the Compressible Navier-Stokes Equations Using a Discontinuous Galerkin Method Li Wang

More information

Ail implicit finite volume nodal point scheme for the solution of two-dimensional compressible Navier-Stokes equations

Ail implicit finite volume nodal point scheme for the solution of two-dimensional compressible Navier-Stokes equations Ail implicit finite volume nodal point scheme for the solution of two-dimensional compressible Navier-Stokes equations Vimala Dutta Computational and Theoretical Fluid Dynamics Division National Aerospace

More information

Efficient Tridiagonal Solvers for ADI methods and Fluid Simulation

Efficient Tridiagonal Solvers for ADI methods and Fluid Simulation Efficient Tridiagonal Solvers for ADI methods and Fluid Simulation Nikolai Sakharnykh - NVIDIA San Jose Convention Center, San Jose, CA September 21, 2010 Introduction Tridiagonal solvers very popular

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

Module 3 Mesh Generation

Module 3 Mesh Generation Module 3 Mesh Generation 1 Lecture 3.1 Introduction 2 Mesh Generation Strategy Mesh generation is an important pre-processing step in CFD of turbomachinery, quite analogous to the development of solid

More information

How to Enter and Analyze a Wing

How to Enter and Analyze a Wing How to Enter and Analyze a Wing Entering the Wing The Stallion 3-D built-in geometry creation tool can be used to model wings and bodies of revolution. In this example, a simple rectangular wing is modeled

More information

CUDA. Fluid simulation Lattice Boltzmann Models Cellular Automata

CUDA. Fluid simulation Lattice Boltzmann Models Cellular Automata CUDA Fluid simulation Lattice Boltzmann Models Cellular Automata Please excuse my layout of slides for the remaining part of the talk! Fluid Simulation Navier Stokes equations for incompressible fluids

More information

An Unsteady Discrete Adjoint Formulation for Two-Dimensional Flow Problems with Deforming Meshes

An Unsteady Discrete Adjoint Formulation for Two-Dimensional Flow Problems with Deforming Meshes 45th AIAA Aerospace Sciences Meeting and Exhibit, January 8, 27, Reno, NV An Unsteady Discrete Adjo Formulation for wo-dimensional Flow Problems with Deforming Meshes Karthik Mani Department of Mechanical

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

A reduced-order model for NS equations from boundary matching and OT

A reduced-order model for NS equations from boundary matching and OT A reduced-order model for NS equations from boundary matching and OT Angelo Iollo Michel Bergmann Andrea Ferrero Institut de Mathématiques de Bordeaux Inria Memphis Team Haysam Telib Optimad Engineering,

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

EFFICIENT SOLUTION ALGORITHMS FOR HIGH-ACCURACY CENTRAL DIFFERENCE CFD SCHEMES

EFFICIENT SOLUTION ALGORITHMS FOR HIGH-ACCURACY CENTRAL DIFFERENCE CFD SCHEMES EFFICIENT SOLUTION ALGORITHMS FOR HIGH-ACCURACY CENTRAL DIFFERENCE CFD SCHEMES B. Treidler, J.A. Ekaterineris and R.E. Childs Nielsen Engineering & Research, Inc. Mountain View, CA, 94043 Abstract Preliminary

More information

High-order solutions of transitional flow over the SD7003 airfoil using compact finite-differencing and filtering

High-order solutions of transitional flow over the SD7003 airfoil using compact finite-differencing and filtering High-order solutions of transitional flow over the SD7003 airfoil using compact finite-differencing and filtering Daniel J. Garmann and Miguel R. Visbal Air Force Research Laboratory, Wright-Patterson

More information

Flux Vector Splitting Methods for the Euler Equations on 3D Unstructured Meshes for CPU/GPU Clusters

Flux Vector Splitting Methods for the Euler Equations on 3D Unstructured Meshes for CPU/GPU Clusters Flux Vector Splitting Methods for the Euler Equations on 3D Unstructured Meshes for CPU/GPU Clusters Manfred Liebmann Technische Universität München Chair of Optimal Control Center for Mathematical Sciences,

More information

High Scalability of Lattice Boltzmann Simulations with Turbulence Models using Heterogeneous Clusters

High Scalability of Lattice Boltzmann Simulations with Turbulence Models using Heterogeneous Clusters SIAM PP 2014 High Scalability of Lattice Boltzmann Simulations with Turbulence Models using Heterogeneous Clusters C. Riesinger, A. Bakhtiari, M. Schreiber Technische Universität München February 20, 2014

More information

Multigrid Algorithms for Three-Dimensional RANS Calculations - The SUmb Solver

Multigrid Algorithms for Three-Dimensional RANS Calculations - The SUmb Solver Multigrid Algorithms for Three-Dimensional RANS Calculations - The SUmb Solver Juan J. Alonso Department of Aeronautics & Astronautics Stanford University CME342 Lecture 14 May 26, 2014 Outline Non-linear

More information

Efficient Unstructured Mesh Flow Solver Using Hamiltonian Paths and Strand Grids

Efficient Unstructured Mesh Flow Solver Using Hamiltonian Paths and Strand Grids Efficient Unstructured Mesh Flow Solver Using Hamiltonian Paths and Strand Grids *Yong Su Jung 1), Bharath Govindarajan 2) and James Baeder 3) 1), 2), 3) Department of Aerospace Engineering, University

More information

Unstructured CFD for Wind Turbine Analysis

Unstructured CFD for Wind Turbine Analysis Unstructured CFD for Wind Turbine Analysis C. Eric Lynch and Marilyn Smith Daniel Guggenheim School of Aerospace Engineering Georgia Institute of Technology Atlanta, USA Wind availability: Egypt Extremely

More information

Flux Vector Splitting Methods for the Euler Equations on 3D Unstructured Meshes for CPU/GPU Clusters

Flux Vector Splitting Methods for the Euler Equations on 3D Unstructured Meshes for CPU/GPU Clusters Flux Vector Splitting Methods for the Euler Equations on 3D Unstructured Meshes for CPU/GPU Clusters Manfred Liebmann Technische Universität München Chair of Optimal Control Center for Mathematical Sciences,

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

I. Introduction. Optimization Algorithm Components. Abstract for the 5 th OpenFOAM User Conference 2017, Wiesbaden - Germany

I. Introduction. Optimization Algorithm Components. Abstract for the 5 th OpenFOAM User Conference 2017, Wiesbaden - Germany An Aerodynamic Optimization Framework for the Automotive Industry, based on Continuous Adjoint and OpenFOAM E. Papoutsis-Kiachagias 1, V. Asouti 1, K. Giannakoglou 1, K. Gkagkas 2 1) National Technical

More information

Acceleration of Turbomachinery steady CFD Simulations on GPU

Acceleration of Turbomachinery steady CFD Simulations on GPU Acceleration of Turbomachinery steady CFD Simulations on GPU Mohamed H. Aissa 1,2 Dr. Tom Verstraete 1 Prof. Cornelis Vuik 2 1 Turbomachinery Department, Von Karman Institute, Belgium 2 Delft Institute

More information

The gas-kinetic methods have become popular for the simulation of compressible fluid flows in the last

The gas-kinetic methods have become popular for the simulation of compressible fluid flows in the last Parallel Implementation of Gas-Kinetic BGK Scheme on Unstructured Hybrid Grids Murat Ilgaz Defense Industries Research and Development Institute, Ankara, 626, Turkey and Ismail H. Tuncer Middle East Technical

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

Single and multi-point aerodynamic optimizations of a supersonic transport aircraft using strategies involving adjoint equations and genetic algorithm

Single and multi-point aerodynamic optimizations of a supersonic transport aircraft using strategies involving adjoint equations and genetic algorithm Single and multi-point aerodynamic optimizations of a supersonic transport aircraft using strategies involving adjoint equations and genetic algorithm Prepared by : G. Carrier (ONERA, Applied Aerodynamics/Civil

More information

Summary of the C2.3 test case results

Summary of the C2.3 test case results 1st International Workshop on High-Order CFD Methods, Nashville, January 7-8, 2012 Institute of Aerodynamics and Flow Technology German Aerospace Center 8. Jan. 2012 1 / 19 Test case C2.3 Compressible

More information

Aerofoil Optimisation Using CST Parameterisation in SU2

Aerofoil Optimisation Using CST Parameterisation in SU2 Aerofoil Optimisation Using CST Parameterisation in SU2 Marques, S., & Hewitt, P. (2014). Aerofoil Optimisation Using CST Parameterisation in SU2. Paper presented at Royal Aeronautical Society Applied

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

3D ADI Method for Fluid Simulation on Multiple GPUs. Nikolai Sakharnykh, NVIDIA Nikolay Markovskiy, NVIDIA

3D ADI Method for Fluid Simulation on Multiple GPUs. Nikolai Sakharnykh, NVIDIA Nikolay Markovskiy, NVIDIA 3D ADI Method for Fluid Simulation on Multiple GPUs Nikolai Sakharnykh, NVIDIA Nikolay Markovskiy, NVIDIA Introduction Fluid simulation using direct numerical methods Gives the most accurate result Requires

More information

Faculty of Mechanical and Manufacturing Engineering, University Tun Hussein Onn Malaysia (UTHM), Parit Raja, Batu Pahat, Johor, Malaysia

Faculty of Mechanical and Manufacturing Engineering, University Tun Hussein Onn Malaysia (UTHM), Parit Raja, Batu Pahat, Johor, Malaysia Applied Mechanics and Materials Vol. 393 (2013) pp 305-310 (2013) Trans Tech Publications, Switzerland doi:10.4028/www.scientific.net/amm.393.305 The Implementation of Cell-Centred Finite Volume Method

More information

Final Report. Discontinuous Galerkin Compressible Euler Equation Solver. May 14, Andrey Andreyev. Adviser: Dr. James Baeder

Final Report. Discontinuous Galerkin Compressible Euler Equation Solver. May 14, Andrey Andreyev. Adviser: Dr. James Baeder Final Report Discontinuous Galerkin Compressible Euler Equation Solver May 14, 2013 Andrey Andreyev Adviser: Dr. James Baeder Abstract: In this work a Discontinuous Galerkin Method is developed for compressible

More information

Aerodynamic optimization using Adjoint methods and parametric CAD models

Aerodynamic optimization using Adjoint methods and parametric CAD models Aerodynamic optimization using Adjoint methods and parametric CAD models ECCOMAS Congress 2016 P. Hewitt S. Marques T. Robinson D. Agarwal @qub.ac.uk School of Mechanical and Aerospace Engineering Queen

More information

CPU/GPU COMPUTING FOR AN IMPLICIT MULTI-BLOCK COMPRESSIBLE NAVIER-STOKES SOLVER ON HETEROGENEOUS PLATFORM

CPU/GPU COMPUTING FOR AN IMPLICIT MULTI-BLOCK COMPRESSIBLE NAVIER-STOKES SOLVER ON HETEROGENEOUS PLATFORM Sixth International Symposium on Physics of Fluids (ISPF6) International Journal of Modern Physics: Conference Series Vol. 42 (2016) 1660163 (14 pages) The Author(s) DOI: 10.1142/S2010194516601630 CPU/GPU

More information

Prediction of Helicopter Blade- Vortex Interaction Noise using Motion Data from Experiment

Prediction of Helicopter Blade- Vortex Interaction Noise using Motion Data from Experiment Prediction of Helicopter Blade- Vortex Interaction Noise using Motion Data from Experiment Yoshinobu Inada, Choongmo Yang, and Takashi Aoyama Computational Science Research Group (CSRG) Institute of Aerospace

More information

Porting a parallel rotor wake simulation to GPGPU accelerators using OpenACC

Porting a parallel rotor wake simulation to GPGPU accelerators using OpenACC DLR.de Chart 1 Porting a parallel rotor wake simulation to GPGPU accelerators using OpenACC Melven Röhrig-Zöllner DLR, Simulations- und Softwaretechnik DLR.de Chart 2 Outline Hardware-Architecture (CPU+GPU)

More information

Numerical Methods in Aerodynamics. Fluid Structure Interaction. Lecture 4: Fluid Structure Interaction

Numerical Methods in Aerodynamics. Fluid Structure Interaction. Lecture 4: Fluid Structure Interaction Fluid Structure Interaction Niels N. Sørensen Professor MSO, Ph.D. Department of Civil Engineering, Alborg University & Wind Energy Department, Risø National Laboratory Technical University of Denmark

More information

International Supercomputing Conference 2009

International Supercomputing Conference 2009 International Supercomputing Conference 2009 Implementation of a Lattice-Boltzmann-Method for Numerical Fluid Mechanics Using the nvidia CUDA Technology E. Riegel, T. Indinger, N.A. Adams Technische Universität

More information

Large scale Imaging on Current Many- Core Platforms

Large scale Imaging on Current Many- Core Platforms Large scale Imaging on Current Many- Core Platforms SIAM Conf. on Imaging Science 2012 May 20, 2012 Dr. Harald Köstler Chair for System Simulation Friedrich-Alexander-Universität Erlangen-Nürnberg, Erlangen,

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

STCE. An (more) effective Discrete Adjoint Model for OpenFOAM

STCE. An (more) effective Discrete Adjoint Model for OpenFOAM An (more) effective Discrete Adjoint Model for OpenFOAM Markus Towara, Uwe Naumann Software and Tools for Computational Engineering Science RWTH Aachen University EuroAD 2013, Oxford, 10. December 2013

More information

Constrained Aero-elastic Multi-Point Optimization Using the Coupled Adjoint Approach

Constrained Aero-elastic Multi-Point Optimization Using the Coupled Adjoint Approach www.dlr.de Chart 1 Aero-elastic Multi-point Optimization, M.Abu-Zurayk, MUSAF II, 20.09.2013 Constrained Aero-elastic Multi-Point Optimization Using the Coupled Adjoint Approach M. Abu-Zurayk MUSAF II

More information

Computational Fluid Dynamics using OpenCL a Practical Introduction

Computational Fluid Dynamics using OpenCL a Practical Introduction 19th International Congress on Modelling and Simulation, Perth, Australia, 12 16 December 2011 http://mssanz.org.au/modsim2011 Computational Fluid Dynamics using OpenCL a Practical Introduction T Bednarz

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

Center for Computational Science

Center for Computational Science Center for Computational Science Toward GPU-accelerated meshfree fluids simulation using the fast multipole method Lorena A Barba Boston University Department of Mechanical Engineering with: Felipe Cruz,

More information

High-Fidelity Simulation of Unsteady Flow Problems using a 3rd Order Hybrid MUSCL/CD scheme. A. West & D. Caraeni

High-Fidelity Simulation of Unsteady Flow Problems using a 3rd Order Hybrid MUSCL/CD scheme. A. West & D. Caraeni High-Fidelity Simulation of Unsteady Flow Problems using a 3rd Order Hybrid MUSCL/CD scheme ECCOMAS, June 6 th -11 th 2016, Crete Island, Greece A. West & D. Caraeni Outline Industrial Motivation Numerical

More information

Unstructured Mesh Solution Techniques using the NSU3D Solver

Unstructured Mesh Solution Techniques using the NSU3D Solver Unstructured Mesh Solution echniques using the NSU3D Solver Dimitri J. Mavriplis Karthik Mani Department of Mechanical Engineering, University of Wyoming, Laramie, WY 82071 NSU3D is an unstructured mesh

More information

The Uintah Framework: A Unified Heterogeneous Task Scheduling and Runtime System

The Uintah Framework: A Unified Heterogeneous Task Scheduling and Runtime System The Uintah Framework: A Unified Heterogeneous Task Scheduling and Runtime System Alan Humphrey, Qingyu Meng, Martin Berzins Scientific Computing and Imaging Institute & University of Utah I. Uintah Overview

More information

High-Order Finite-Element Earthquake Modeling on very Large Clusters of CPUs or GPUs

High-Order Finite-Element Earthquake Modeling on very Large Clusters of CPUs or GPUs High-Order Finite-Element Earthquake Modeling on very Large Clusters of CPUs or GPUs Gordon Erlebacher Department of Scientific Computing Sept. 28, 2012 with Dimitri Komatitsch (Pau,France) David Michea

More information

Gradient Free Design of Microfluidic Structures on a GPU Cluster

Gradient Free Design of Microfluidic Structures on a GPU Cluster Gradient Free Design of Microfluidic Structures on a GPU Cluster Austen Duffy - Florida State University SIAM Conference on Computational Science and Engineering March 2, 2011 Acknowledgements This work

More information

Large Scale Aerodynamic Calculation on Pleiades

Large Scale Aerodynamic Calculation on Pleiades Large Scale Aerodynamic Calculation on Pleiades Thomas H. Pulliam, Dennis C. Jespesen ABSTRACT A very large scale aerodynamic calculation on the NASA Pleiades supercomputer using the three-dimensional

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

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

Lecture 2.2 Cubic Splines

Lecture 2.2 Cubic Splines Lecture. Cubic Splines Cubic Spline The equation for a single parametric cubic spline segment is given by 4 i t Bit t t t i (..) where t and t are the parameter values at the beginning and end of the segment.

More information

Accelerating Double Precision FEM Simulations with GPUs

Accelerating Double Precision FEM Simulations with GPUs Accelerating Double Precision FEM Simulations with GPUs Dominik Göddeke 1 3 Robert Strzodka 2 Stefan Turek 1 dominik.goeddeke@math.uni-dortmund.de 1 Mathematics III: Applied Mathematics and Numerics, University

More information

Computation of Fictitious Gas Flow with Euler Equations

Computation of Fictitious Gas Flow with Euler Equations 1 Computation of Fictitious Gas Flow with Euler Equations Pei Li and Helmut Sobieczky DLR Göttingen, Germany Abstract The Fictitious Gas Concept supports some computational design methods to construct

More information