UoB Structured CFD Code

Size: px
Start display at page:

Download "UoB Structured CFD Code"

Transcription

1 UoB Structured CFD Code C.B. Allen April, 2013

2 Contents Background to code formulations Aspects of the coding structure, data structure, and parallel message passing approach Performance figures, serial and scalar Issues to consider for GPU porting; simple and not so! Code not really research area. Used primarily as tool to demonstrate other methods. Main research thrust is universal code- and mesh-independent technology: CFD-CSD coupling, volume and surface control and deformation, optimisation, data taransfer, etc..

3 Introductory Information Structured, multiblock Third-order upwind spatial stencil (convective), 5-points each direction Multigrid acceleration Explicit local time-stepping, steady Implicit pseudo-time, unsteady, with explicit local time-stepping within pseudo-time Aeroelastic coupled, forced and deforming; meshless CFD-CSD coupling Meshless mesh deformation approach Non-matching boundaries, with meshless interpolation Fortran90 and MPI.

4 Example Applications Unsteady rotor simulation: forward-flight with cyclic pitch variation. 4M and 32M cell, 208 block mesh.

5 Example Applications Static aeroelastic simulation, CFD-CSD coupling and mesh deformation via meshless radial basis function approach (details later). Mode 4 demonstration of CFD-CSD coupling. MDO wing static deflection calculation, C L =

6 Example Applications Domain element shape parameterisation and mesh deformation, coupled with parallel gradient-based optimisation. Two-bladed rotor in hover, M Tip = 0.8, 63 parameters, minimise torque. C T = 29.6%.

7 Mesh Format Domain decomposed by blocks No global storage; mesh never considered in entirety. Grid header file: nblocks nsym version number block1filename block2filename etc. Each block separate file: ni nj nk x1 y1 z1 x2 y2 z2.. iminflag neighbour orientation imaxflag neighbour orientation jminflag neighbour orientation jmaxflag neighbour orientation kminflag neighbour orientation kmaxflag neighbour orientation

8 Decomposition Preprocessor processes mesh and control file and produces most of data required: - Moving mesh case, surface data processed and connectivity produced (later) - Aeroelastic case, surface mesh and structural mesh processed and interpolation dependence produced (later) Preproc grid.dims file. Solver initialisation routine splits blocks over processes using sizes in grid.dims: - Sorts block numbers by size then target ncells used to decide block split per process - Currently work split at block level only, for example 16 blocks means nprocs <= 16 - GPU port to allow work split at cell level ideal load balance.

9 Parallelisation and Data Structure Written in Fortran90 Domain decomposed by blocks No global storage; mesh never considered in entirety. Only list of block sizes and process owners built (plus tag data): nblocks(nprocs) blocknum(nprocs,nblocks(nprocs)) numproc(nblock) i1tag(nblock) k2tag(nblock) i1nb(nblock) k2nb(nblock) - number of blocks owned by each process - block number for each block owned by each process - process owner for each block - block boundary flags for each block - neighbour block number for each boundary for each block i1orient(nblock) k2orient(nblock) - orientation of neighbour block for each boundary for each block.

10 Initialisation and Coding Approach Code developed to mimise communication and storage Master performs all initialisation Blocks split over processes and all simulation data processed Global integer arrays and flow data broadcast to all processes Each process then defines its own local workspace length Solution loads and monitoring data processed on each process and sent to master Master collects convergence and load data and outputs Also sends (not broadcast) changed data to slaves Every process outputs its own solution data when required, to unique name No global collection or processing of solution data

11 Coding and Data Structure Each process builds its own storage (no global storage) All data stored in 1D arrays: rho(0:nijknb), x(0:nijknb), etc. NIJKNB local to each process. Sum over mglevels, nblocks, cells. (Different) 1D pointer to each block and multigrid level for each process offset(nb,m) do nbb=1,nblocks(myid) nb=blocknum(myid,nbb) do m=1,mglevels ioff=offset(nb,m) do k=1,nk(nb,m) do j=1,nj(nb,m) do i=1,ni(nb,m) ii=cellid(ioff,i,j,k) vol(ii)=vol(ii) + areas(ii)*dxns(ii)*...

12 Coding for Scalar Functions Code originally developed to minimise storage and number of ops Many local scalars and vectors defined and discarded Many dependencies. Example, cell left and right states (i west and east): F w (i) = F + e(i 1)+F w(i) do k=1,nk(nb,m) do j=1,nj(nb,m) do i=0,ni(nb,m)+1 ii=cellid(ioff,i,j,k) srho = limiter(rho(ii-1),rho(ii),rho(ii+1)) rhow = musclpos(srho,rho(ii-1),rho(ii),rho(ii+1),dsew(ii)...) rhoe = musclneg(srho,rho(ii-1),rho(ii),rho(ii+1),dsew(ii)...)... uw, ue, etc. IF(not solid surface) THEN FE = fluxneg(rhoe,ue,ve,we,ee,ce,pe,dxnw(ii+1),dynw(ii+1),dznw(ii+1)...) FW = FE + fluxpos(rhow,uw,vw,ww,ew,cw,pw,dxnw(ii),dynw(ii),dznw(ii)...) ELSE... RESW(ii) = FW*areaw(ii) enddo enddo enddo

13 Updated code more memory intensive: Coding for Scalar Functions ALLOCATE(rhow(0:ni(nb,m)+1,nj(nb,m),nk(nb,m)), ALLOCATE(uw(0:ni(nb,m)+1,nj(nb,m),nk(nb,m)), etc. ALLOCATE(rhoe(0:ni(nb,m)+1,nj(nb,m),nk(nb,m)), ALLOCATE(ue(0:ni(nb,m)+1,nj(nb,m),nk(nb,m)), etc. CALL EASTWEST(rhow,rhoe,...rho,u,v,w...,ni(nb,m),nj(nb,m),nk(nb,m)) -> do i=0,ni(nb,m)+1 cells -> overwrite surface values WALL_CELL() do k=1,nk(nb,m), do j=1,nj(nb,m) do i=1,ni(nb,m)+1 ii=cellid(ioff,i,j,k) RESW(ii)= totalflux(rhow,rhoe,uw,ue,vw,ve...)*areaw(ii) enddo enddo enddo Latest version of code: 800MBytes/million cells, double precision.

14 Parallelisation: Structure and Message Passing Code written such that no message passing in main subroutines: resid(), update(), restrict() etc. Called once per block, so independent of process/block/mg level. At each block boundary, two layers of halo data required for solution vector, for convective term evaluation. Separate subroutine for main message passing, boundarysolution(). One layer for prolong(), velocitygrads(), dtsmooth(). All messages packed into 1D temp arrays. Code written to allow same logic for serial and parallel version All message passing written so serial and parallel logic same. All messages sent as soon as available for efficiency No message ordering, non-blocking MPI calls throughout mpi wait() used to ensure message completion. Minimum use of mpi barrier().

15 Parallelisation: Structure and Message Passing At each block face requiring data passing, data packed into 1D temp arrays: boundxx and boundi/j/kxx XX = face number 1-6, variable number 1-? Consider connected imin face do i=1,2 do k=1,nk(nb,m) bound11(i1,nnn)=rho(ii) enddo do j=1,nj(nb,m) length=2*nj(nb,m)*nk(nb,m) nbn=i1nb(nb) nbb=numproc(nbn) IF(nbb.ne.myid) THEN i_to=nbb-1 if(i1orient(nb).eq.1) then i_tag1=6*nvariables*nbn+1 elseif(i1orient(nb).eq.2) then i_tag1=6*nvariables*nbn+nvariables+1 etc... call mpi_isend(bound11(1,nnn),length,mpi_...,i_to,i_tag1,...) i_tag1=6*nvariables*nb+1 call mpi_irecv(boundi11(1,nnn2),length,mpi_...,i_from,i_tag1,...)

16 Parallelisation: Structure and Message Passing ELSE ENDIF if(i1orient(nb).eq.1) then do ij=1,length boundi11(ij,blockpointer(nbn))=bound11(ij,nnn) elseif(i1orient(nb).eq.2) then do ij=1,length boundi21(ij,blockpointer(nbn))=bound11(ij,nnn) etc...! UNPACK if(i1orient(nb).eq.1) then do i=0,-1,-1 do k=1,nk(nb,m) do j=1,nj(nb,m) ij counter determined by orientation rho(ii)=boundi11(ij,nnn2) elseif(i1orient(nb).eq.2) then do i=0,-1,-1 do k=1,nk(nb,m) do j=1,nj(nb,m) ij counter determined by orientation rho(ii)=boundi21(ij,nnn2) etc. Adds small overhead to scalar code but nicer logic.

17 Solution Methods van Leer and Roe upwind convective fluxes, plus van Albada limited MUSCL 5-stage R-K time-stepping; halo values only set once per step, not every stage V-cycle multigrid used - Restrict residual, solution, error vector all levels. Once per cycle (message passing) - Standard volume weighted restriction - Single solution iteration on way down - 2 m 1 or 3 m 1 iterations on way up, limited at coarsest level - Trilinear interpolation for prolongation; no smoothing - Ramped up from min max min; One layer of Us exchanged at boundaries (message passing).

18 Convergence and Monitoring outprint() routine computes residuals and loads, plus standard deviations. Average flowfield conserved variables and loads stored each cycle σ(flow,loads) = standard deviation of this over nsamp cycles. Example, NACA0012 aerofoil case, mesh. Inviscid case, M=0.5. COST: cells, 6 level MG, serial computation, gfortran -O3. Converge: 10 8, 199 cycles, 30s , 261 cycles, 40s.

19 Code scaled at Daresbury Parallel Performance 996x speed-up for 1024 cores.

20 Profiling Typical mesh size for steady simulation gives following: Serial; Parallel resid() 80% outprint() 5% timestep() 4% boundsol() 4% update() 2% prolong() 2% geometric+initialise 2% restrictalllevels() 1% (calls resid,boundsol) resid() 72% boundsol() 7% outprint() 6% timestep() 5% prolong() 4% +geometric+initialise 3% update() 2% restrictalllevels() 1% (calls resid,boundsol) Consideration for GPUs: Once resid() 20 faster, outprint() most expensive function!

21 Issues for GPU Porting Message passing harness; single harness. Serial/multicore, multicore/gpu Multicore approach now limited to decomposition at block level. GPU to offer decomposition at cell/thread level ideal load balance CPU/GPU load balancing Core numerics no issues at all CFD-CSD coupling requires linear system solutions Mesh deformation requires linear system solutions Meshless interpolation requires expensive searches, complex message passing, AND numerous linear system solutions

22 Meshless Methods Much research performed on mesh independent methods Application areas CFD-CSD coupling, mesh deformation Based on function approximation methods, radial basis functions Global n-dimensional volume control methods: dimensions may be (x,y,z) and function displacement; or (Re,M,α,θ,γ) and function C L,C D etc. Objective: universal code- and mesh-independent methods.

23 Meshless Methods (a) Close surfaces. (b) Wing and beam. First application area CFD-CSD coupling Method sought to interpolate forces and displacements across the fluid-structure interface that satisfies the following requirements: - Mesh connectivity free code and mesh independent and perfectly parallel - Conservation of energy, total force and moment - Exact recovery of translation and rotation - Force and displacement association - Position of aerodynamic nodes a linear function of the position of the structural nodes.

24 Meshless Methods: Radial Basis Function Interpolation Define a coupling matrix, H, that transforms the displacements of the aerodynamic surface nodes according to the displacements of the structural nodes in a linear fashion using energy and force conservation can show that u a = Hu s (1) f s = H T f a (2) Let f(x) be the original function to be modelled, f i known values at N the control points, x i,i = 1,...,N, where x i is the n-dimensional vector at i. φ is the chosen basis function and the Euclidean norm, then an interpolation model s has the form N s(x) = β i φ( x x i )+p(x) (3) i=1 where β i,i = 1,...,N are model coefficients, and p is an optional polynomial.

25 These coefficients are found by requiring exact recovery of the original data, s X = f, for all points in the training data set X. For example, assume training data position of structural nodes, exact recovery of the centres gives, using up to linear polynomial terms X s = C ss a x Y s = C ss a y Z s = C ss a z (4) where X s = x s x s = x s 1. x sn a x = γ x 0 γ x x γ x y γ x z β x s 1. β x s N (5)

26 (Analogous definitions hold for Y s and Z s and their a vectors) C ss = x s1 x s2 x sn y s1 y s2 y sn z s1 z s2 z sn 1 x s1 y s1 z s1 φ s1 s 1 φ s1 s 2 φ s1 s N x sn y sn z sn φ sn s 1 φ sn s 2 φ sn s N (6) with φ s1 s 2 = φ( x s1 x s2 ) (7) To compute the aerodynamic surface points, equation (3) can be applied point by point Perfectly parallel. Either C 1 ss must be computed, or system solved for coefficient vectors.

27 Meshless Methods Much work performed to minimise cost. CFD-CSD not an issue, as system size Nstruct Nstruct, and use set of smaller patches. Mesh deformation, system size is Nsurface Nsurface; could be ! Efficient point reduction and optimisation scheme developed, using greedy point selection, system size < Z X Y Two stages to mesh deformation: 1) system solution; 2) position vector update. 1) System solved on every process no comms 2) Mesh points on each process moved independently no comms Stage 2) ideal for GPU.

28 Mesh Deformation: Code Stages DO NT=1,NREALTIMESTEPS Update surface positions - prescribed Solve linear system -> betax(n) Solve linear system -> betay(n) Solve linear system -> betaz(n) Update mesh; X()=X0()+DeltaX() Update geometric data, gridspeeds, volumes (GCL) DO NIT=1,NMGCYCLES Update solution ENDDO ENDDO DO NT=1,NREALTIMESTEPS DO NC=1,NCOUPLINGCYCLES CFD surface pressures -> structural loads Compute new structural positions CSD displacements -> CFD surface positions Solve linear system -> betax(n) Solve linear system -> betay(n) Solve linear system -> betaz(n) Update mesh: X()=X0()+DeltaX() Update geometric data, gridspeeds (0 for static), volumes (GCL not for static) DO NIT=1,NMGCYCLES Update solution ENDDO ENDDO ENDDO

29 Mesh Deformation Greedy point selection scales as N op N sel n=1 (n3 +n.n surface ) Volume mesh deformation scales as N op N 3 sel +N sel.n volume Typical case: N surface = ,N volume = LAPACK CG method for system solution, single process, Mesh deformation 5-20% of solver cost. GPU solver: system solution dominates need faster system solution.

30 Meshless Methods: Non-Matching Boundaries Discontinuous patch boundary between two mesh blocks (A and B). Similar RBF interpolation used for high-order data transfer across boundary. Third to fifth order of accuracy proven.

31 NACA0012 Mach 0.5, drag coefficient convergence tested for non-matching. 129x65 129x x21 mesh 257x x x49 mesh

32 NACA0012 Mach 0.5, drag coefficient convergence.

33 Non-Matching Boundaries: Nozzle Case Continuous (upper), discontinuous, spacing ratio 1.5 (centre). Every fourth point. Mach contours, continuous mesh, M=0.8 (lower).

34 Mach contours and mesh. Continuous and discontinuous meshes. Entropy contours. Continuous and discontinuous meshes.

35 Mesh Spacing Ratio C d Difference (%) Continuous Discontinuous Discontinuous Discontinuous Discontinuous

36 Non-Matching Interfaces: Issues Preprocessor currently computes cloud lists for each cell adjacent to a tagged interface. For each interface cell, halo point(s) need local cloud of control points ncloud(i,j,k,nb) list of points in terms of i,j,k, and nb values. Need to contruct φ = [ncloud ncloud] for each cloud Then solve φβ ρ = ρ, φβ E = E etc. or construct Aφ 1 where A = [2 ncloud] Point clouds include points from multiple block/processes, and each different size! Proof of concept stage: file I/O used: 2D + 20%; 3D + 50%. PROBLEM 1: Preprocessor performs searches and lists on every MG level For unsteady case, need every timestep need efficient search algorithms. PROBLEM 2: Complex data communication (not system solution and update costs).

CFD Lab Department of Engineering The University of Liverpool

CFD Lab Department of Engineering The University of Liverpool Development of a CFD Method for Aerodynamic Analysis of Large Diameter Horizontal Axis wind turbines S. Gomez-Iradi, G.N. Barakos and X. Munduate 2007 joint meeting of IEA Annex 11 and Annex 20 Risø National

More information

Simulation of Fluid-Structure Interactions in Aeronautical Applications

Simulation of Fluid-Structure Interactions in Aeronautical Applications Simulation of Fluid-Structure Interactions in Aeronautical Applications Martin Kuntz Jorge Carregal Ferreira ANSYS Germany D-83624 Otterfing Martin.Kuntz@ansys.com December 2003 3 rd FENET Annual Industry

More information

ME6130 An introduction to CFD 1-1

ME6130 An introduction to CFD 1-1 ME6130 An introduction to CFD 1-1 What is CFD? Computational fluid dynamics (CFD) is the science of predicting fluid flow, heat and mass transfer, chemical reactions, and related phenomena by solving numerically

More information

Turbomachinery CFD on many-core platforms experiences and strategies

Turbomachinery CFD on many-core platforms experiences and strategies Turbomachinery CFD on many-core platforms experiences and strategies Graham Pullan Whittle Laboratory, Department of Engineering, University of Cambridge MUSAF Colloquium, CERFACS, Toulouse September 27-29

More information

ABSTRACT FOR THE 1ST INTERNATIONAL WORKSHOP ON HIGH ORDER CFD METHODS

ABSTRACT FOR THE 1ST INTERNATIONAL WORKSHOP ON HIGH ORDER CFD METHODS 1 ABSTRACT FOR THE 1ST INTERNATIONAL WORKSHOP ON HIGH ORDER CFD METHODS Sreenivas Varadan a, Kentaro Hara b, Eric Johnsen a, Bram Van Leer b a. Department of Mechanical Engineering, University of Michigan,

More information

Module 6 Case Studies

Module 6 Case Studies Module 6 Case Studies 1 Lecture 6.1 A CFD Code for Turbomachinery Flows 2 Development of a CFD Code The lecture material in the previous Modules help the student to understand the domain knowledge required

More information

Overset Grids Technology in STAR-CCM+: Methodology and Applications

Overset Grids Technology in STAR-CCM+: Methodology and Applications Overset Grids Technology in STAR-CCM+: Methodology and Applications Eberhard Schreck, Milovan Perić and Deryl Snyder eberhard.schreck@cd-adapco.com milovan.peric@cd-adapco.com deryl.snyder@cd-adapco.com

More information

HPC Deployment of OpenFOAM in an Industrial Setting

HPC Deployment of OpenFOAM in an Industrial Setting HPC Deployment of OpenFOAM in an Industrial Setting Hrvoje Jasak h.jasak@wikki.co.uk Wikki Ltd, United Kingdom PRACE Seminar: Industrial Usage of HPC Stockholm, Sweden, 28-29 March 2011 HPC Deployment

More information

Finite Element Formulation for Beams - Handout 2 -

Finite Element Formulation for Beams - Handout 2 - Finite Element Formulation for Beams - Handout 2 - Dr Fehmi Cirak (fc286@) Completed Version Review of Euler-Bernoulli Beam Physical beam model midline Beam domain in three-dimensions Midline, also called

More information

Multi-Block Gridding Technique for FLOW-3D Flow Science, Inc. July 2004

Multi-Block Gridding Technique for FLOW-3D Flow Science, Inc. July 2004 FSI-02-TN59-R2 Multi-Block Gridding Technique for FLOW-3D Flow Science, Inc. July 2004 1. Introduction A major new extension of the capabilities of FLOW-3D -- the multi-block grid model -- has been incorporated

More information

OpenFOAM Optimization Tools

OpenFOAM Optimization Tools OpenFOAM Optimization Tools Henrik Rusche and Aleks Jemcov h.rusche@wikki-gmbh.de and a.jemcov@wikki.co.uk Wikki, Germany and United Kingdom OpenFOAM Optimization Tools p. 1 Agenda Objective Review optimisation

More information

CONVERGE Features, Capabilities and Applications

CONVERGE Features, Capabilities and Applications CONVERGE Features, Capabilities and Applications CONVERGE CONVERGE The industry leading CFD code for complex geometries with moving boundaries. Start using CONVERGE and never make a CFD mesh again. CONVERGE

More information

Express Introductory Training in ANSYS Fluent Lecture 1 Introduction to the CFD Methodology

Express Introductory Training in ANSYS Fluent Lecture 1 Introduction to the CFD Methodology Express Introductory Training in ANSYS Fluent Lecture 1 Introduction to the CFD Methodology Dimitrios Sofialidis Technical Manager, SimTec Ltd. Mechanical Engineer, PhD PRACE Autumn School 2013 - Industry

More information

Lecture 16 - Free Surface Flows. Applied Computational Fluid Dynamics

Lecture 16 - Free Surface Flows. Applied Computational Fluid Dynamics Lecture 16 - Free Surface Flows Applied Computational Fluid Dynamics Instructor: André Bakker http://www.bakker.org André Bakker (2002-2006) Fluent Inc. (2002) 1 Example: spinning bowl Example: flow in

More information

Introductory FLUENT Training

Introductory FLUENT Training Chapter 10 Transient Flow Modeling Introductory FLUENT Training www.ptecgroup.ir 10-1 Motivation Nearly all flows in nature are transient! Steady-state assumption is possible if we: Ignore transient fluctuations

More information

Computational Modeling of Wind Turbines in OpenFOAM

Computational Modeling of Wind Turbines in OpenFOAM Computational Modeling of Wind Turbines in OpenFOAM Hamid Rahimi hamid.rahimi@uni-oldenburg.de ForWind - Center for Wind Energy Research Institute of Physics, University of Oldenburg, Germany Outline Computational

More information

C3.8 CRM wing/body Case

C3.8 CRM wing/body Case C3.8 CRM wing/body Case 1. Code description XFlow is a high-order discontinuous Galerkin (DG) finite element solver written in ANSI C, intended to be run on Linux-type platforms. Relevant supported equation

More information

PyFR: Bringing Next Generation Computational Fluid Dynamics to GPU Platforms

PyFR: Bringing Next Generation Computational Fluid Dynamics to GPU Platforms PyFR: Bringing Next Generation Computational Fluid Dynamics to GPU Platforms P. E. Vincent! Department of Aeronautics Imperial College London! 25 th March 2014 Overview Motivation Flux Reconstruction Many-Core

More information

Introduction to CFD Analysis

Introduction to CFD Analysis Introduction to CFD Analysis 2-1 What is CFD? Computational Fluid Dynamics (CFD) is the science of predicting fluid flow, heat and mass transfer, chemical reactions, and related phenomena by solving numerically

More information

Aeroelastic Investigation of the Sandia 100m Blade Using Computational Fluid Dynamics

Aeroelastic Investigation of the Sandia 100m Blade Using Computational Fluid Dynamics Aeroelastic Investigation of the Sandia 100m Blade Using Computational Fluid Dynamics David Corson Altair Engineering, Inc. Todd Griffith Sandia National Laboratories Tom Ashwill (Retired) Sandia National

More information

Overset and Adaptive Meshes for Stabilized Finite-Element Scheme

Overset and Adaptive Meshes for Stabilized Finite-Element Scheme Overset and Adaptive Meshes for Stabilized Finite-Element Scheme W. Kyle Anderson, Behzad Ahrabi, and Chao Liu 2014 CFD Summer School Modern Techniques for Aerodynamic Analysis and Design Beijing Computational

More information

CFD Based Reduced Order Models for T-tail flutter

CFD Based Reduced Order Models for T-tail flutter CFD Based Reduced Order Models for T-tail flutter A. Attorni, L. Cavagna, G. Quaranta Dipartimento di Ingegneria Aerospaziale Outline NAEMO-CFD software Test bench: Piaggio Avanti P180 T-Tail flutter problem

More information

Aerodynamic Department Institute of Aviation. Adam Dziubiński CFD group FLUENT

Aerodynamic Department Institute of Aviation. Adam Dziubiński CFD group FLUENT Adam Dziubiński CFD group IoA FLUENT Content Fluent CFD software 1. Short description of main features of Fluent 2. Examples of usage in CESAR Analysis of flow around an airfoil with a flap: VZLU + ILL4xx

More information

Part II: Finite Difference/Volume Discretisation for CFD

Part II: Finite Difference/Volume Discretisation for CFD Part II: Finite Difference/Volume Discretisation for CFD Finite Volume Metod of te Advection-Diffusion Equation A Finite Difference/Volume Metod for te Incompressible Navier-Stokes Equations Marker-and-Cell

More information

Advanced CFD Methods 1

Advanced CFD Methods 1 Advanced CFD Methods 1 Prof. Patrick Jenny, FS 2014 Date: 15.08.14, Time: 13:00, Student: Federico Danieli Summary The exam took place in Prof. Jenny s office, with his assistant taking notes on the answers.

More information

TIME-ACCURATE SIMULATION OF THE FLOW AROUND THE COMPLETE BO105 WIND TUNNEL MODEL

TIME-ACCURATE SIMULATION OF THE FLOW AROUND THE COMPLETE BO105 WIND TUNNEL MODEL TIME-ACCURATE SIMULATION OF THE FLOW AROUND THE COMPLETE BO105 WIND TUNNEL MODEL Walid Khier, Thorsten Schwarz, Jochen Raddatz presented by Andreas Schütte DLR, Institute of Aerodynamics and Flow Technology

More information

Lecture 7 - Meshing. Applied Computational Fluid Dynamics

Lecture 7 - Meshing. Applied Computational Fluid Dynamics Lecture 7 - Meshing Applied Computational Fluid Dynamics Instructor: André Bakker http://www.bakker.org André Bakker (2002-2006) Fluent Inc. (2002) 1 Outline Why is a grid needed? Element types. Grid types.

More information

Differentiating a Time-dependent CFD Solver

Differentiating a Time-dependent CFD Solver Differentiating a Time-dependent CFD Solver Presented to The AD Workshop, Nice, April 2005 Mohamed Tadjouddine & Shaun Forth Engineering Systems Department Cranfield University (Shrivenham Campus) Swindon

More information

Advanced discretisation techniques (a collection of first and second order schemes); Innovative algorithms and robust solvers for fast convergence.

Advanced discretisation techniques (a collection of first and second order schemes); Innovative algorithms and robust solvers for fast convergence. New generation CFD Software APUS-CFD APUS-CFD is a fully interactive Arbitrary Polyhedral Unstructured Solver. APUS-CFD is a new generation of CFD software for modelling fluid flow and heat transfer in

More information

Divergence-Free Elements for Incompressible Flow on Cartesian Grids

Divergence-Free Elements for Incompressible Flow on Cartesian Grids Divergence-Free Elements for Incompressible Flow on Cartesian Grids Tobias Neckel, Marion Bendig, Hans-Joachim Bungartz, Miriam Mehl, and Christoph Zenger, Fakultät für Informatik TU München Outline The

More information

Customer Training Material. Lecture 2. Introduction to. Methodology ANSYS FLUENT. ANSYS, Inc. Proprietary 2010 ANSYS, Inc. All rights reserved.

Customer Training Material. Lecture 2. Introduction to. Methodology ANSYS FLUENT. ANSYS, Inc. Proprietary 2010 ANSYS, Inc. All rights reserved. Lecture 2 Introduction to CFD Methodology Introduction to ANSYS FLUENT L2-1 What is CFD? Computational Fluid Dynamics (CFD) is the science of predicting fluid flow, heat and mass transfer, chemical reactions,

More information

Multiphase Flow - Appendices

Multiphase Flow - Appendices Discovery Laboratory Multiphase Flow - Appendices 1. Creating a Mesh 1.1. What is a geometry? The geometry used in a CFD simulation defines the problem domain and boundaries; it is the area (2D) or volume

More information

Multicore Parallel Computing with OpenMP

Multicore Parallel Computing with OpenMP Multicore Parallel Computing with OpenMP Tan Chee Chiang (SVU/Academic Computing, Computer Centre) 1. OpenMP Programming The death of OpenMP was anticipated when cluster systems rapidly replaced large

More information

Efficient Convergence Acceleration for a Parallel CFD Code

Efficient Convergence Acceleration for a Parallel CFD Code Efficient Convergence Acceleration for a Parallel CFD Code R.D. Williams a, J. Häuser b, and R. Winkelmann b a California Institute of Technology, Pasadena, California b Center of Logistics and Expert

More information

Grid adaptivity for systems of conservation laws

Grid adaptivity for systems of conservation laws Grid adaptivity for systems of conservation laws M. Semplice 1 G. Puppo 2 1 Dipartimento di Matematica Università di Torino 2 Dipartimento di Scienze Matematiche Politecnico di Torino Numerical Aspects

More information

STCE. Outline. Introduction. Applications. Ongoing work. Summary. STCE RWTH-Aachen, Industrial Applications of discrete adjoint OpenFOAM, EuroAD 2014

STCE. Outline. Introduction. Applications. Ongoing work. Summary. STCE RWTH-Aachen, Industrial Applications of discrete adjoint OpenFOAM, EuroAD 2014 Industrial Applications of discrete adjoint OpenFOAM Arindam Sen Software and Tools for Computational Engineering Science RWTH Aachen University EuroAD 2014, Nice, 16-17. June 2014 Outline Introduction

More information

Performance Comparison and Analysis of Different Schemes and Limiters

Performance Comparison and Analysis of Different Schemes and Limiters International Journal of Mathematical, Computational, Physical, Electrical and Computer Engineering Vol:5, No:7, 0 Performance Comparison and Analysis of Different Schemes and Limiters Wang Wen-long, Li

More information

MEL 807 Computational Heat Transfer (2-0-4) Dr. Prabal Talukdar Assistant Professor Department of Mechanical Engineering IIT Delhi

MEL 807 Computational Heat Transfer (2-0-4) Dr. Prabal Talukdar Assistant Professor Department of Mechanical Engineering IIT Delhi MEL 807 Computational Heat Transfer (2-0-4) Dr. Prabal Talukdar Assistant Professor Department of Mechanical Engineering IIT Delhi Time and Venue Course Coordinator: Dr. Prabal Talukdar Room No: III, 357

More information

HIGH ORDER WENO SCHEMES ON UNSTRUCTURED TETRAHEDRAL MESHES

HIGH ORDER WENO SCHEMES ON UNSTRUCTURED TETRAHEDRAL MESHES European Conference on Computational Fluid Dynamics ECCOMAS CFD 26 P. Wesseling, E. Oñate and J. Périaux (Eds) c TU Delft, The Netherlands, 26 HIGH ORDER WENO SCHEMES ON UNSTRUCTURED TETRAHEDRAL MESHES

More information

CSE Case Study: Optimising the CFD code DG-DES

CSE Case Study: Optimising the CFD code DG-DES CSE Case Study: Optimising the CFD code DG-DES CSE Team NAG Ltd., support@hector.ac.uk Naveed Durrani University of Sheffield June 2008 Introduction One of the activities of the NAG CSE (Computational

More information

MPI Hands-On List of the exercises

MPI Hands-On List of the exercises MPI Hands-On List of the exercises 1 MPI Hands-On Exercise 1: MPI Environment.... 2 2 MPI Hands-On Exercise 2: Ping-pong...3 3 MPI Hands-On Exercise 3: Collective communications and reductions... 5 4 MPI

More information

Modeling Rotor Wakes with a Hybrid OVERFLOW-Vortex Method on a GPU Cluster

Modeling Rotor Wakes with a Hybrid OVERFLOW-Vortex Method on a GPU Cluster Modeling Rotor Wakes with a Hybrid OVERFLOW-Vortex Method on a GPU Cluster Mark J. Stock, Ph.D., Adrin Gharakhani, Sc.D. Applied Scientific Research, Santa Ana, CA Christopher P. Stone, Ph.D. Computational

More information

NUMERICAL ANALYSIS OF WELLS TURBINE FOR WAVE POWER CONVERSION

NUMERICAL ANALYSIS OF WELLS TURBINE FOR WAVE POWER CONVERSION Engineering Review Vol. 32, Issue 3, 141-146, 2012. 141 NUMERICAL ANALYSIS OF WELLS TURBINE FOR WAVE POWER CONVERSION Z. 1* L. 1 V. 2 M. 1 1 Department of Fluid Mechanics and Computational Engineering,

More information

TFAWS AUGUST 2003 VULCAN CFD CODE OVERVIEW / DEMO. Jeffery A. White. Hypersonic Airbreathing Propulsion Branch

TFAWS AUGUST 2003 VULCAN CFD CODE OVERVIEW / DEMO. Jeffery A. White. Hypersonic Airbreathing Propulsion Branch TFAWS AUGUST 2003 VULCAN CFD CODE OVERVIEW / DEMO Jeffery A. White Hypersonic Airbreathing Propulsion Branch VULCAN DEVELOPMENT HISTORY Evolved from the LARCK code development project (1993-1996). LARCK

More information

TWO-DIMENSIONAL FINITE ELEMENT ANALYSIS OF FORCED CONVECTION FLOW AND HEAT TRANSFER IN A LAMINAR CHANNEL FLOW

TWO-DIMENSIONAL FINITE ELEMENT ANALYSIS OF FORCED CONVECTION FLOW AND HEAT TRANSFER IN A LAMINAR CHANNEL FLOW TWO-DIMENSIONAL FINITE ELEMENT ANALYSIS OF FORCED CONVECTION FLOW AND HEAT TRANSFER IN A LAMINAR CHANNEL FLOW Rajesh Khatri 1, 1 M.Tech Scholar, Department of Mechanical Engineering, S.A.T.I., vidisha

More information

AERODYNAMIC ANALYSIS OF BLADE 1.5 KW OF DUAL ROTOR HORIZONTAL AXIS WIND TURBINE

AERODYNAMIC ANALYSIS OF BLADE 1.5 KW OF DUAL ROTOR HORIZONTAL AXIS WIND TURBINE AERODYNAMIC ANALYSIS OF BLADE 1.5 KW OF DUAL ROTOR HORIZONTAL AXIS WIND TURBINE HITENDRA KURMI Research scholar, School of Energy and Environmental Managment,UTD, RGPV Bhopal,MP,INDIA htr.ptl@gmail.com

More information

CCTech TM. ICEM-CFD & FLUENT Software Training. Course Brochure. Simulation is The Future

CCTech TM. ICEM-CFD & FLUENT Software Training. Course Brochure. Simulation is The Future . CCTech TM Simulation is The Future ICEM-CFD & FLUENT Software Training Course Brochure About. CCTech Established in 2006 by alumni of IIT Bombay. Our motive is to establish a knowledge centric organization

More information

Finite Element Method (ENGC 6321) Syllabus. Second Semester 2013-2014

Finite Element Method (ENGC 6321) Syllabus. Second Semester 2013-2014 Finite Element Method Finite Element Method (ENGC 6321) Syllabus Second Semester 2013-2014 Objectives Understand the basic theory of the FEM Know the behaviour and usage of each type of elements covered

More information

Customer Training Material. Lecture 5. Solver Settings ANSYS FLUENT. ANSYS, Inc. Proprietary 2010 ANSYS, Inc. All rights reserved.

Customer Training Material. Lecture 5. Solver Settings ANSYS FLUENT. ANSYS, Inc. Proprietary 2010 ANSYS, Inc. All rights reserved. Lecture 5 Solver Settings Introduction to ANSYS FLUENT L5-1 Solver Settings - Introduction So far we have looked at how to setup a basic flow simulation in FLUENT. However you should not assume that just

More information

A New Solution Adaption Capability for the OVERFLOW CFD Code

A New Solution Adaption Capability for the OVERFLOW CFD Code A New Solution Adaption Capability for the OVERFLOW CFD Code Pieter G. Buning NASA Langley Research Center, Hampton, VA 10 th Symposium on Overset Composite Grid and Solution Technology September 20-23,

More information

Introduction to ANSYS

Introduction to ANSYS Lecture 3 Introduction to ANSYS Meshing 14. 5 Release Introduction to ANSYS Meshing 2012 ANSYS, Inc. March 27, 2014 1 Release 14.5 Introduction to ANSYS Meshing What you will learn from this presentation

More information

Large-Scale Reservoir Simulation and Big Data Visualization

Large-Scale Reservoir Simulation and Big Data Visualization Large-Scale Reservoir Simulation and Big Data Visualization Dr. Zhangxing John Chen NSERC/Alberta Innovates Energy Environment Solutions/Foundation CMG Chair Alberta Innovates Technology Future (icore)

More information

Introduction to CFD Analysis

Introduction to CFD Analysis Introduction to CFD Analysis Introductory FLUENT Training 2006 ANSYS, Inc. All rights reserved. 2006 ANSYS, Inc. All rights reserved. 2-2 What is CFD? Computational fluid dynamics (CFD) is the science

More information

Hardware-Aware Analysis and. Presentation Date: Sep 15 th 2009 Chrissie C. Cui

Hardware-Aware Analysis and. Presentation Date: Sep 15 th 2009 Chrissie C. Cui Hardware-Aware Analysis and Optimization of Stable Fluids Presentation Date: Sep 15 th 2009 Chrissie C. Cui Outline Introduction Highlights Flop and Bandwidth Analysis Mehrstellen Schemes Advection Caching

More information

THE CFD SIMULATION OF THE FLOW AROUND THE AIRCRAFT USING OPENFOAM AND ANSA

THE CFD SIMULATION OF THE FLOW AROUND THE AIRCRAFT USING OPENFOAM AND ANSA THE CFD SIMULATION OF THE FLOW AROUND THE AIRCRAFT USING OPENFOAM AND ANSA Adam Kosík Evektor s.r.o., Czech Republic KEYWORDS CFD simulation, mesh generation, OpenFOAM, ANSA ABSTRACT In this paper we describe

More information

Mesh Moving Techniques for Fluid-Structure Interactions With Large Displacements

Mesh Moving Techniques for Fluid-Structure Interactions With Large Displacements K. Stein Department of Physics, Bethel College, St. Paul, MN 55112 T. Tezduyar Mechanical Engineering, Rice University, MS 321, Houston, TX 77005 R. Benney Natick Soldier Center, Natick, MA 01760 Mesh

More information

Trace Layer Import for Printed Circuit Boards Under Icepak

Trace Layer Import for Printed Circuit Boards Under Icepak Tutorial 13. Trace Layer Import for Printed Circuit Boards Under Icepak Introduction: A printed circuit board (PCB) is generally a multi-layered board made of dielectric material and several layers of

More information

Finite Element Formulation for Plates - Handout 3 -

Finite Element Formulation for Plates - Handout 3 - Finite Element Formulation for Plates - Handout 3 - Dr Fehmi Cirak (fc286@) Completed Version Definitions A plate is a three dimensional solid body with one of the plate dimensions much smaller than the

More information

CUDA for Real Time Multigrid Finite Element Simulation of

CUDA for Real Time Multigrid Finite Element Simulation of CUDA for Real Time Multigrid Finite Element Simulation of SoftTissue Deformations Christian Dick Computer Graphics and Visualization Group Technische Universität München, Germany Motivation Real time physics

More information

Spatial Discretisation Schemes in the PDE framework Peano for Fluid-Structure Interactions

Spatial Discretisation Schemes in the PDE framework Peano for Fluid-Structure Interactions Spatial Discretisation Schemes in the PDE framework Peano for Fluid-Structure Interactions T. Neckel, H.-J. Bungartz, B. Gatzhammer, M. Mehl, C. Zenger TUM Department of Informatics Chair of Scientific

More information

Design and Optimization of OpenFOAM-based CFD Applications for Hybrid and Heterogeneous HPC Platforms

Design and Optimization of OpenFOAM-based CFD Applications for Hybrid and Heterogeneous HPC Platforms Design and Optimization of OpenFOAM-based CFD Applications for Hybrid and Heterogeneous HPC Platforms Amani AlOnazi, David E. Keyes, Alexey Lastovetsky, Vladimir Rychkov Extreme Computing Research Center,

More information

Best practices for efficient HPC performance with large models

Best practices for efficient HPC performance with large models Best practices for efficient HPC performance with large models Dr. Hößl Bernhard, CADFEM (Austria) GmbH PRACE Autumn School 2013 - Industry Oriented HPC Simulations, September 21-27, University of Ljubljana,

More information

GPU Acceleration of the SENSEI CFD Code Suite

GPU Acceleration of the SENSEI CFD Code Suite GPU Acceleration of the SENSEI CFD Code Suite Chris Roy, Brent Pickering, Chip Jackson, Joe Derlaga, Xiao Xu Aerospace and Ocean Engineering Primary Collaborators: Tom Scogland, Wu Feng (Computer Science)

More information

NUMERICAL ANALYSIS OF THE EFFECTS OF WIND ON BUILDING STRUCTURES

NUMERICAL ANALYSIS OF THE EFFECTS OF WIND ON BUILDING STRUCTURES Vol. XX 2012 No. 4 28 34 J. ŠIMIČEK O. HUBOVÁ NUMERICAL ANALYSIS OF THE EFFECTS OF WIND ON BUILDING STRUCTURES Jozef ŠIMIČEK email: jozef.simicek@stuba.sk Research field: Statics and Dynamics Fluids mechanics

More information

Gas Handling and Power Consumption of High Solidity Hydrofoils:

Gas Handling and Power Consumption of High Solidity Hydrofoils: Gas Handling and Power Consumption of High Solidity Hydrofoils: Philadelphia Mixing Solution's HS Lightnin's A315 Keith E. Johnson1, Keith T McDermott2, Thomas A. Post3 1Independent Consultant, North Canton,

More information

1 Finite difference example: 1D implicit heat equation

1 Finite difference example: 1D implicit heat equation 1 Finite difference example: 1D implicit heat equation 1.1 Boundary conditions Neumann and Dirichlet We solve the transient heat equation ρc p t = ( k ) (1) on the domain L/2 x L/2 subject to the following

More information

Parallel Programming at the Exascale Era: A Case Study on Parallelizing Matrix Assembly For Unstructured Meshes

Parallel Programming at the Exascale Era: A Case Study on Parallelizing Matrix Assembly For Unstructured Meshes Parallel Programming at the Exascale Era: A Case Study on Parallelizing Matrix Assembly For Unstructured Meshes Eric Petit, Loïc Thebault, Quang V. Dinh May 2014 EXA2CT Consortium 2 WPs Organization Proto-Applications

More information

A Load Balancing Tool for Structured Multi-Block Grid CFD Applications

A Load Balancing Tool for Structured Multi-Block Grid CFD Applications A Load Balancing Tool for Structured Multi-Block Grid CFD Applications K. P. Apponsah and D. W. Zingg University of Toronto Institute for Aerospace Studies (UTIAS), Toronto, ON, M3H 5T6, Canada Email:

More information

CFD SIMULATION OF SDHW STORAGE TANK WITH AND WITHOUT HEATER

CFD SIMULATION OF SDHW STORAGE TANK WITH AND WITHOUT HEATER International Journal of Advancements in Research & Technology, Volume 1, Issue2, July-2012 1 CFD SIMULATION OF SDHW STORAGE TANK WITH AND WITHOUT HEATER ABSTRACT (1) Mr. Mainak Bhaumik M.E. (Thermal Engg.)

More information

The Influence of Aerodynamics on the Design of High-Performance Road Vehicles

The Influence of Aerodynamics on the Design of High-Performance Road Vehicles The Influence of Aerodynamics on the Design of High-Performance Road Vehicles Guido Buresti Department of Aerospace Engineering University of Pisa (Italy) 1 CONTENTS ELEMENTS OF AERODYNAMICS AERODYNAMICS

More information

Interactive comment on A parallelization scheme to simulate reactive transport in the subsurface environment with OGS#IPhreeqc by W. He et al.

Interactive comment on A parallelization scheme to simulate reactive transport in the subsurface environment with OGS#IPhreeqc by W. He et al. Geosci. Model Dev. Discuss., 8, C1166 C1176, 2015 www.geosci-model-dev-discuss.net/8/c1166/2015/ Author(s) 2015. This work is distributed under the Creative Commons Attribute 3.0 License. Geoscientific

More information

Automated moving mesh techniques in CFD

Automated moving mesh techniques in CFD Unione Europea Repubblica Italiana Regione Autonoma della Sardegna Automated moving mesh techniques in CFD Application to fluid-structure interactions and rigid motions problems MANUELA PROFIR manuela@crs4.it

More information

Lecture 6 - Boundary Conditions. Applied Computational Fluid Dynamics

Lecture 6 - Boundary Conditions. Applied Computational Fluid Dynamics Lecture 6 - Boundary Conditions Applied Computational Fluid Dynamics Instructor: André Bakker http://www.bakker.org André Bakker (2002-2006) Fluent Inc. (2002) 1 Outline Overview. Inlet and outlet boundaries.

More information

COMPUTATIONAL ENGINEERING OF FINITE ELEMENT MODELLING FOR AUTOMOTIVE APPLICATION USING ABAQUS

COMPUTATIONAL ENGINEERING OF FINITE ELEMENT MODELLING FOR AUTOMOTIVE APPLICATION USING ABAQUS International Journal of Advanced Research in Engineering and Technology (IJARET) Volume 7, Issue 2, March-April 2016, pp. 30 52, Article ID: IJARET_07_02_004 Available online at http://www.iaeme.com/ijaret/issues.asp?jtype=ijaret&vtype=7&itype=2

More information

The simulation of machine tools can be divided into two stages. In the first stage the mechanical behavior of a machine tool is simulated with FEM

The simulation of machine tools can be divided into two stages. In the first stage the mechanical behavior of a machine tool is simulated with FEM 1 The simulation of machine tools can be divided into two stages. In the first stage the mechanical behavior of a machine tool is simulated with FEM tools. The approach to this simulation is different

More information

COMPUTATIONAL FLUID DYNAMICS (CFD) ANALYSIS OF INTERMEDIATE PRESSURE STEAM TURBINE

COMPUTATIONAL FLUID DYNAMICS (CFD) ANALYSIS OF INTERMEDIATE PRESSURE STEAM TURBINE Research Paper ISSN 2278 0149 www.ijmerr.com Vol. 3, No. 4, October, 2014 2014 IJMERR. All Rights Reserved COMPUTATIONAL FLUID DYNAMICS (CFD) ANALYSIS OF INTERMEDIATE PRESSURE STEAM TURBINE Shivakumar

More information

Numerical methods for American options

Numerical methods for American options Lecture 9 Numerical methods for American options Lecture Notes by Andrzej Palczewski Computational Finance p. 1 American options The holder of an American option has the right to exercise it at any moment

More information

OpenFOAM: Year in Review

OpenFOAM: Year in Review OpenFOAM: Year in Review Hrvoje Jasak h.jasak@wikki.co.uk, hrvoje.jasak@fsb.hr Wikki Ltd, United Kingdom Faculty of Mechanical Engineering and Naval Architecture University of Zagreb, Croatia 5th OpenFOAM

More information

Customer Training Material. Lecture 4. Meshing in Mechanical. Mechanical. ANSYS, Inc. Proprietary 2010 ANSYS, Inc. All rights reserved.

Customer Training Material. Lecture 4. Meshing in Mechanical. Mechanical. ANSYS, Inc. Proprietary 2010 ANSYS, Inc. All rights reserved. Lecture 4 Meshing in Mechanical Introduction to ANSYS Mechanical L4-1 Chapter Overview In this chapter controlling meshing operations is described. Topics: A. Global Meshing Controls B. Local Meshing Controls

More information

Computational Fluid Dynamics Research Projects at Cenaero (2011)

Computational Fluid Dynamics Research Projects at Cenaero (2011) Computational Fluid Dynamics Research Projects at Cenaero (2011) Cenaero (www.cenaero.be) is an applied research center focused on the development of advanced simulation technologies for aeronautics. Located

More information

CFD ANALYSIS OF CONTROLLABLE PITCH PROPELLER USED IN MARINE VEHICLE

CFD ANALYSIS OF CONTROLLABLE PITCH PROPELLER USED IN MARINE VEHICLE CFD ANALYSIS OF CONROLLABLE PICH PROPELLER USED IN MARINE VEHICLE Aditya Kolakoti 1,.V.K.Bhanuprakash 2 & H.N.Das 3 1 M.E in Marine Engineering And Mechanical Handling, Dept of Marine Engineering, Andhra

More information

This tutorial provides a recipe for simulating L

This tutorial provides a recipe for simulating L Pipe Flow Tutorial for STAR-CCM+ ME 448/548 February 5, 2014 Gerald Recktenwald gerry@me.pdx.edu 1 Overview This tutorial provides a recipe for simulating laminar flow in a pipe with STAR- L CCM+. The

More information

State of Stress at Point

State of Stress at Point State of Stress at Point Einstein Notation The basic idea of Einstein notation is that a covector and a vector can form a scalar: This is typically written as an explicit sum: According to this convention,

More information

EXPERIENCES WITH PORTING THE PARALLEL CFD CODE N3S TO FORTRAN 90

EXPERIENCES WITH PORTING THE PARALLEL CFD CODE N3S TO FORTRAN 90 EXPERIENCES WITH PORTING THE PARALLEL CFD CODE N3S TO FORTRAN 90 J.P. GREGOIRE D.E.R. Electricité de France Département MMN 1, avenue du Général de Gaulle 92141 CLAMART CEDEX-France jean-pierre.gregoire@edf.fr

More information

Unleashing the Performance Potential of GPUs for Atmospheric Dynamic Solvers

Unleashing the Performance Potential of GPUs for Atmospheric Dynamic Solvers Unleashing the Performance Potential of GPUs for Atmospheric Dynamic Solvers Haohuan Fu haohuan@tsinghua.edu.cn High Performance Geo-Computing (HPGC) Group Center for Earth System Science Tsinghua University

More information

8. Linear least-squares

8. Linear least-squares 8. Linear least-squares EE13 (Fall 211-12) definition examples and applications solution of a least-squares problem, normal equations 8-1 Definition overdetermined linear equations if b range(a), cannot

More information

TwinMesh for Positive Displacement Machines: Structured Meshes and reliable CFD Simulations

TwinMesh for Positive Displacement Machines: Structured Meshes and reliable CFD Simulations TwinMesh for Positive Displacement Machines: Structured Meshes and reliable CFD Simulations 05.06.2014 Dipl.-Ing. Jan Hesse, Dr. Andreas Spille-Kohoff CFX Berlin Software GmbH Karl-Marx-Allee 90 A 10243

More information

Harvesting-Combine-Flow Simulation Technique

Harvesting-Combine-Flow Simulation Technique Page 1/14 Madhur Bhaiya, Prof. Dr.-Ing. Andreas Jahr, B.Eng. Holger Happel FH Düsseldorf 1 ABSTRACT CFX 11.0 is a Computational Fluid Dynamics (CFD) program for simulating the behavior of systems involving

More information

High Performance Computing in CST STUDIO SUITE

High Performance Computing in CST STUDIO SUITE High Performance Computing in CST STUDIO SUITE Felix Wolfheimer GPU Computing Performance Speedup 18 16 14 12 10 8 6 4 2 0 Promo offer for EUC participants: 25% discount for K40 cards Speedup of Solver

More information

How To Write A Program For The Pd Framework

How To Write A Program For The Pd Framework Enhanced divergence-free elements for efficient incompressible flow simulations in the PDE framework Peano, Miriam Mehl, Christoph Zenger, Fakultät für Informatik TU München Germany Outline Derivation

More information

HPC enabling of OpenFOAM R for CFD applications

HPC enabling of OpenFOAM R for CFD applications HPC enabling of OpenFOAM R for CFD applications Towards the exascale: OpenFOAM perspective Ivan Spisso 25-27 March 2015, Casalecchio di Reno, BOLOGNA. SuperComputing Applications and Innovation Department,

More information

APPLIED MATHEMATICS ADVANCED LEVEL

APPLIED MATHEMATICS ADVANCED LEVEL APPLIED MATHEMATICS ADVANCED LEVEL INTRODUCTION This syllabus serves to examine candidates knowledge and skills in introductory mathematical and statistical methods, and their applications. For applications

More information

CBE 6333, R. Levicky 1 Differential Balance Equations

CBE 6333, R. Levicky 1 Differential Balance Equations CBE 6333, R. Levicky 1 Differential Balance Equations We have previously derived integral balances for mass, momentum, and energy for a control volume. The control volume was assumed to be some large object,

More information

Behavioral Animation Simulation of Flocking Birds

Behavioral Animation Simulation of Flocking Birds Behavioral Animation Simulation of Flocking Birds Autonomous characters determine their actions Simulating the paths of individuals in: flocks of birds, schools of fish, herds of animals crowd scenes 1.

More information

Operation Count; Numerical Linear Algebra

Operation Count; Numerical Linear Algebra 10 Operation Count; Numerical Linear Algebra 10.1 Introduction Many computations are limited simply by the sheer number of required additions, multiplications, or function evaluations. If floating-point

More information

Coupled CFD and Vortex Methods for Modelling Hydro- and Aerodynamics of Tidal Current Turbines and On- and Offshore Wind Turbines

Coupled CFD and Vortex Methods for Modelling Hydro- and Aerodynamics of Tidal Current Turbines and On- and Offshore Wind Turbines Coupled CFD and Vortex Methods for Modelling Hydro- and Aerodynamics of Tidal Current Turbines and On- and Offshore Wind Turbines SIMPACK User Meeting 2014 Augsburg, Germany October 9 th, 2014 Dipl.-Ing.

More information

Ridgeway Kite Innova've Technology for Reservoir Engineers A Massively Parallel Architecture for Reservoir Simula'on

Ridgeway Kite Innova've Technology for Reservoir Engineers A Massively Parallel Architecture for Reservoir Simula'on Innova've Technology for Reservoir Engineers A Massively Parallel Architecture for Reservoir Simula'on Garf Bowen 16 th Dec 2013 Summary Introduce RKS Reservoir Simula@on HPC goals Implementa@on Simple

More information

Introduction. 1.1 Motivation. Chapter 1

Introduction. 1.1 Motivation. Chapter 1 Chapter 1 Introduction The automotive, aerospace and building sectors have traditionally used simulation programs to improve their products or services, focusing their computations in a few major physical

More information

Aerodynamic Design Optimization Discussion Group Case 4: Single- and multi-point optimization problems based on the CRM wing

Aerodynamic Design Optimization Discussion Group Case 4: Single- and multi-point optimization problems based on the CRM wing Aerodynamic Design Optimization Discussion Group Case 4: Single- and multi-point optimization problems based on the CRM wing Lana Osusky, Howard Buckley, and David W. Zingg University of Toronto Institute

More information