Alexander Popp* (with contributions by M.W. Gee, W.A. Wall, B.I. Wohlmuth, M. Gitterle, A. Gerstenberger, A. Ehrl and T. Klöppel)

Size: px
Start display at page:

Download "Alexander Popp* (with contributions by M.W. Gee, W.A. Wall, B.I. Wohlmuth, M. Gitterle, A. Gerstenberger, A. Ehrl and T. Klöppel)"

Transcription

1 2nd European Trilinos User Group Meeting Garching, June 4th 2013 Technische Universität München Alexander Popp* (with contributions by M.W. Gee, W.A. Wall, B.I. Wohlmuth, M. Gitterle, A. Gerstenberger, A. Ehrl and T. Klöppel) *Institute for Computational Mechanics Technische Universität München Alexander Popp, Institute for Computational Mechanics, TUM 1/44

2 Agenda Introduction to mortar finite element methods Software framework and implementation Parallel efficiency and dynamic load balancing Application 1: Finite deformation contact and friction Application 2: General interface problems Alexander Popp, Institute for Computational Mechanics, TUM 2/44

3 Motivation Some current project snapshots courtesy of RollsRoyce [Bow 2011] Thermomechanics, friction and wear with M. Gitterle, M.W. Gee and Rolls-Royce plc. Capillary flow of red blood cells with T. Klöppel and W.A. Wall Alexander Popp, Institute for Computational Mechanics, TUM 3/44

4 Motivation Some current project snapshots fluid bearing O-ring seal tire hydroplaning Lubrication, wet contact and FSI with A. Wirtz, J. Gillard and Goodyear S.A. Beam assemblies and biopolymer networks with C. Meier, K.W. Müller and W.A. Wall Alexander Popp, Institute for Computational Mechanics, TUM 4/44

5 Agenda Introduction to mortar finite element methods Software framework and implementation Parallel efficiency and dynamic load balancing Application 1: Finite deformation contact and friction Application 2: General interface problems Alexander Popp, Institute for Computational Mechanics, TUM 5/44

6 Mortar finite element methods Motivation non-conforming discretization methods for partial differential equations originating from domain decomposition coupling of separate, non-matching discretizations (or even different physical fields) on non-overlapping subdomains potential for mathematical optimality (inf-sup stability, a priori error estimates)! mortar methods glue together the subdomain solutions in a variationally consistent manner! corresponding continuity conditions are enforced using Lagrange multipliers Alexander Popp, Institute for Computational Mechanics, TUM 6/44

7 Model problem Solid mechanics mesh tying IBVP of nonlinear 3D elastodynamics (exemplarily for two bodies, i=1,2) u (2) λ Γ c u (1) weak saddle point formulation with interface Lagrange multipliers λ Alexander Popp, Institute for Computational Mechanics, TUM 7/44

8 Model problem Solid mechanics mesh tying kinetic, internal and external virtual work contributions virtual work of Lagrange multipliers (i.e. interface tractions) and weak form of kinematic continuity constraints Alexander Popp, Institute for Computational Mechanics, TUM 8/44

9 Mortar finite element discretization common types of mortar interface elements 2D 3D line2 line3 quad4 tri3 quad9 quad8 tri6 master side slave side (carries LM) u (2) λ u (1) Alexander Popp, Institute for Computational Mechanics, TUM 9/44

10 Dual shape functions Biorthogonality biorthogonality construction how to define these shape functions? e.g. bilinear 3D (quad4)! local support of basis functions [Wohlmuth 2000] 2 2! constraints at the interface can be locally satisfied Φ 1 Φ 2! no a priori definition of dual shape functions 1 N 1 N 2 1 local elementwise construction e.g. linear 2D (line2) -1 Alexander Popp, Institute for Computational Mechanics, TUM 10/44

11 Mortar coupling Mesh imprinting discrete coupling matrices! dual LM make D diagonal! mixed shape functions in M require accurate segmentation, triangulation and projection operations (especially in 3D)! method inspired by [Puso 2004] Alexander Popp, Institute for Computational Mechanics, TUM 11/44

12 Solution algorithm Linearized system! increased system size due to Lagrange multiplier DOFs! typical saddle point system (symmetric but indefinite)! however, conforming discretization yields a linear system that is both symmetric and positive definite u (2) λ u (1) Alexander Popp, Institute for Computational Mechanics, TUM 12/44

13 Condensation of dual Lagrange multipliers extract slave quantities from rows 3 and 4! negligible computational costs due to dual LM approach! leads to condensed linearized system that is again symmetric and positive definite projection operator P Alexander Popp, Institute for Computational Mechanics, TUM 13/44

14 Mesh tying Patch tests treatment of crosspoints! correct transfer of constant stress field across non-conforming interfaces Alexander Popp, Institute for Computational Mechanics, TUM 14/44

15 Mesh tying Convergence! optimal rates of spatial convergence are preserved despite non-conformity Alexander Popp, Institute for Computational Mechanics, TUM 15/44

16 Agenda Introduction to mortar finite element methods Software framework and implementation Parallel efficiency and dynamic load balancing Application 1: Finite deformation contact and friction Application 2: General interface problems Alexander Popp, Institute for Computational Mechanics, TUM 16/44

17 Software framework multiphysics research code BACI mortar toolbox! mesh tying, contact, friction! penalty, Uzawa, standard and dual LM! fully parallel implementation! dynamic load balancing algorithm efficient (self) contact search algorithm! bounding volumes based on k-dops! hierarchical structure with binary tree! parallel version of [Yang and Laursen 2008] Alexander Popp, Institute for Computational Mechanics, TUM 17/44

18 Use of Trilinos Currently using... Teuchos package (helper classes) ParameterList, RefCountPointer, etc. Epetra package (parallel linear algebra) Epetra_MultiVector, Epetra_CrsMatrix, etc. Aztec package (iterative linear solvers) with several preconditioning strategies (ILU, AMG, etc.) ML / MueLo package (multilevel preconditioners) recent work on contact preconditioners by Tobias Wiesner Thinking about using... Sacado package (Automatic differentiation) Zoltan package (Repartitioning and load balancing) Alexander Popp, Institute for Computational Mechanics, TUM 18/44

19 Use of Trilinos Some of you might know......provides capabilities for nonconforming mesh tying and contact formulations in 2 and 3 dimensions using mortar methods... initiated by Michael W. Gee, currently maintained by Glen Hansen all functionalities (and many more) are contained in our BACI libraries Alexander Popp, Institute for Computational Mechanics, TUM 19/44

20 Use of Trilinos Functionality MOERTEL BACI handling of non-conforming interfaces in 2D/3D handling of crosspoints between N subdomains standard Lagrange multipliers (saddle point formulation) dual Lagrange multipliers (condensed formulation) easy interfaces to other Trilinos packages black-box domain decomposition / mesh tying black-box contact and friction algorithms higher-order finite element interpolation efficient search and load balancing algorithms # Alexander Popp, Institute for Computational Mechanics, TUM 20/44

21 Agenda Introduction to mortar finite element methods Software framework and implementation Parallel efficiency and dynamic load balancing Application 1: Finite deformation contact and friction Application 2: General interface problems Alexander Popp, Institute for Computational Mechanics, TUM 21/44

22 High performance computing LNM Cluster Linux cluster (installed 2010) 88 Dual AMD OctCore nodes (1408 processors) in total 2.8 TB RAM High performance interconnect (Infiniband) LRZ SuperMUC new Petascale system (installed 2011/2012) Intel Xeon OctCore nodes ( processors) Gauss Centre for Supercomputing (GCS) alliance LNM one of largest users on predecessor system Alexander Popp, Institute for Computational Mechanics, TUM 22/44

23 Parallel implementation and scalability parallel distribution of finite element mesh based on overlapping domain decomposition non-optimal scalability if contact interfaces are involved parallel distribution optimized for element evaluation, but not efficient for contact evaluation (very localized, variable) " parallel scalability for largescale simulations is limited by contact interfaces Alexander Popp, Institute for Computational Mechanics, TUM 23/44

24 Dynamic load balancing strategy Step 1 (mesh tying and contact)! redistribution of mortar interface with ParMETIS! (independent of the underlying distribution)! non-local assembly of mortar terms (using Epetra_FECrsMatrix) Step 2 (contact only)! restrict redistribution to current contact! proximity (i.e. where work needs to be done)! dynamic redistribution based on some! balance measure (i.e. processor workload) body1 (slave) slave interface body2 redistri- (master) bution redistribute the mortar elements in this zone equally among all processors Alexander Popp, Institute for Computational Mechanics, TUM 24/44

25 Dynamic load balancing strategy model problem: mortar mesh tying 2,136,177 DOFs (15k mortar nodes)! reduction in CPU time up to factor 10! especially important for contact! (re-evaluation in every Newton step) (expensive linearizations) Alexander Popp, Institute for Computational Mechanics, TUM 25/44

26 Self contact and multibody contact! towards a fully nonlinear contact code with optimal parallel scalability Alexander Popp, Institute for Computational Mechanics, TUM 26/44

27 Agenda Introduction to mortar finite element methods Software framework and implementation Parallel efficiency and dynamic load balancing Examples 1: Finite deformation contact and friction Examples 2: General interface problems Alexander Popp, Institute for Computational Mechanics, TUM 27/44

28 Hertzian contact! high accuracy of Lagrange multiplier solution even for coarse meshes Alexander Popp, Institute for Computational Mechanics, TUM 28/44

29 Frictional sliding fully nonlinear computation consideration of frictional sliding results shown for hex20 mesh validation of nonlinear solution scheme (semi-smooth Newton) Alexander Popp, Institute for Computational Mechanics, TUM 29/44

30 Further examples Alexander Popp, Institute for Computational Mechanics, TUM 30/44

31 Torus impact Parallel efficiency impact of two thin-walled structures (13,994,880 DOFs) 500 time steps computed on LRZ SuperMIG cluster, three Intel Xeon nodes (= 120 cores) total computation time approximately 48 hours iterative linear solver with multigrid (AMG) preconditioner! dynamic load balancing assures parallel scalability of mortar coupling Alexander Popp, Institute for Computational Mechanics, TUM 31/44

32 Torus impact Parallel efficiency Alexander Popp, Institute for Computational Mechanics, TUM 32/44

33 Agenda Introduction to mortar finite element methods Software framework and implementation Parallel efficiency and dynamic load balancing Application 1: Finite deformation contact and friction Application 2: General interface problems Alexander Popp, Institute for Computational Mechanics, TUM 33/44

34 Heat conduction over non-matching grids Model setup Temperature over contact traction Temperature distribution at different stages Alexander Popp, Institute for Computational Mechanics, TUM 34/44

35 Thermomechanical contact Sliding # Heating of sliding block due to friction, thermal expansion # Sliding block gets stuck # Block cools due to thermal flux into the plates # Block slides again Alexander Popp, Institute for Computational Mechanics, TUM 35/44

36 Thermomechanical contact Sliding Alexander Popp, Institute for Computational Mechanics, TUM 36/44

37 Mesh tying Fluid dynamics residual-based variational multiscale method for 3D flow (incompressible Navier-Stokes equations) mortar framework similar as in solid mechancics, coupling of non-matching subdomain meshes exemplary convergence study for 3D Beltrami flow Andreas Ehrl, Volker Gravemeier Alexander Popp, Institute for Computational Mechanics, TUM 37/44

38 Mesh tying Fluid dynamics 3D instationary flow past a cylinder Andreas Ehrl, Volker Gravemeier velocity in x-direction Alexander Popp, Institute for Computational Mechanics, TUM 38/44

39 Mesh tying Fluid-structure interaction (FSI) monolithic FSI scheme using and Arbitrary Lagrangian Eulerian (ALE)-based flow description mortar framework similar as in solid mechanics, coupling of non-matching fluid / structure meshes exemplary convergence study for 3D tube relative error of characteristic displacement Thomas Klöppel Alexander Popp, Institute for Computational Mechanics, TUM 39/44

40 Mesh tying Fluid-structure interaction (FSI) T. Klöppel, A. Popp, U. Küttler, W.A. Wall, Fluid-structure interaction for nonconforming interfaces based on a dual mortar formulation, CMAME, 200 (2011), ! efficient treatment of non-matching meshes for moving mesh (ALE) FSI Alexander Popp, Institute for Computational Mechanics, TUM 40/44

41 Contact of fluid-filled vesicles (e.g. RBC) Thomas Klöppel Alexander Popp, Institute for Computational Mechanics, TUM 41/44

42 Fixed-grid approach to FSI and contact # one-body contact (rigid obstacle) # elastic beam (E=500, ν=0.4, ρ=5) # Newtonian fluid (µ=0.01, ρ=1) # parabolic velocity profile at inflow # laminar flow (Re 70) Alexander Popp, Institute for Computational Mechanics, TUM 42/44

43 Fixed-grid approach to FSI and contact U.M. Mayer, A. Popp, A. Gerstenberger, W.A. Wall, 3D fluid-structure-contact interaction based on a combined XFEM FSI and dual mortar contact approach, Computational Mechanics 46, 53 67, 2010 Alexander Popp, Institute for Computational Mechanics, TUM 43/44

44 Summary and outlook A mortar finite element framework for computational contact dynamics and general interface problems in multiphysics environments has been developed $ inherits all desirable mortar FE features w.r.t. accuracy and robustness $ surpasses existing mortar contact methods in terms of efficiency $ first-order and second-order FE interpolation $ dual Lagrange multipliers allow for condensation of saddle point systems $ fully linearized semi-smooth Newton method merges all nonlinearities $ parallel repartitioning and dynamic load balancing for large problems $ applied successfully to frictional contact, self contact, wear,... $ extended successfully to contact simulations multiphysics environments (e.g. fluid-structure interaction, thermo-structure interaction, biophysics) Work in progress % further extensions of multiphysics framework (FSCI, TSI, ) % application to real-world problems involving a broad range of scales Alexander Popp, Institute for Computational Mechanics, TUM 44/44

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

P013 INTRODUCING A NEW GENERATION OF RESERVOIR SIMULATION SOFTWARE

P013 INTRODUCING A NEW GENERATION OF RESERVOIR SIMULATION SOFTWARE 1 P013 INTRODUCING A NEW GENERATION OF RESERVOIR SIMULATION SOFTWARE JEAN-MARC GRATIEN, JEAN-FRANÇOIS MAGRAS, PHILIPPE QUANDALLE, OLIVIER RICOIS 1&4, av. Bois-Préau. 92852 Rueil Malmaison Cedex. France

More information

FUNDAMENTAL FINITE ELEMENT ANALYSIS AND APPLICATIONS

FUNDAMENTAL FINITE ELEMENT ANALYSIS AND APPLICATIONS FUNDAMENTAL FINITE ELEMENT ANALYSIS AND APPLICATIONS With Mathematica and MATLAB Computations M. ASGHAR BHATTI WILEY JOHN WILEY & SONS, INC. CONTENTS OF THE BOOK WEB SITE PREFACE xi xiii 1 FINITE ELEMENT

More information

Domain Decomposition Methods. Partial Differential Equations

Domain Decomposition Methods. Partial Differential Equations Domain Decomposition Methods for Partial Differential Equations ALFIO QUARTERONI Professor ofnumericalanalysis, Politecnico di Milano, Italy, and Ecole Polytechnique Federale de Lausanne, Switzerland ALBERTO

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

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

Benchmark Tests on ANSYS Parallel Processing Technology

Benchmark Tests on ANSYS Parallel Processing Technology Benchmark Tests on ANSYS Parallel Processing Technology Kentaro Suzuki ANSYS JAPAN LTD. Abstract It is extremely important for manufacturing industries to reduce their design process period in order to

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

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

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

Giorgio Bornia. Research statement. Primary interests

Giorgio Bornia. Research statement. Primary interests Giorgio Bornia Research statement 2500 Broadway and Boston 79409-1042 Lubbock, TX +1 806 834 8754 +1 806 742 1112 giorgio.bornia@ttu.edu http://www.math.ttu.edu/~gbornia Primary interests My main research

More information

AN INTERFACE STRIP PRECONDITIONER FOR DOMAIN DECOMPOSITION METHODS

AN INTERFACE STRIP PRECONDITIONER FOR DOMAIN DECOMPOSITION METHODS AN INTERFACE STRIP PRECONDITIONER FOR DOMAIN DECOMPOSITION METHODS by M. Storti, L. Dalcín, R. Paz Centro Internacional de Métodos Numéricos en Ingeniería - CIMEC INTEC, (CONICET-UNL), Santa Fe, Argentina

More information

An Additive Neumann-Neumann Method for Mortar Finite Element for 4th Order Problems

An Additive Neumann-Neumann Method for Mortar Finite Element for 4th Order Problems An Additive eumann-eumann Method for Mortar Finite Element for 4th Order Problems Leszek Marcinkowski Department of Mathematics, University of Warsaw, Banacha 2, 02-097 Warszawa, Poland, Leszek.Marcinkowski@mimuw.edu.pl

More information

A New Unstructured Variable-Resolution Finite Element Ice Sheet Stress-Velocity Solver within the MPAS/Trilinos FELIX Dycore of PISCEES

A New Unstructured Variable-Resolution Finite Element Ice Sheet Stress-Velocity Solver within the MPAS/Trilinos FELIX Dycore of PISCEES A New Unstructured Variable-Resolution Finite Element Ice Sheet Stress-Velocity Solver within the MPAS/Trilinos FELIX Dycore of PISCEES Irina Kalashnikova, Andy G. Salinger, Ray S. Tuminaro Numerical Analysis

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

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

Monifysikaalisten ongelmien simulointi Elmer-ohjelmistolla. Simulation of Multiphysical Problems with Elmer Software

Monifysikaalisten ongelmien simulointi Elmer-ohjelmistolla. Simulation of Multiphysical Problems with Elmer Software Monifysikaalisten ongelmien simulointi Elmer-ohjelmistolla Simulation of Multiphysical Problems with Elmer Software Peter Råback Tieteen CSC 25.11.2004 Definitions for this presentation Model Mathematical

More information

Thermo-Mechanical Coupled Simulation with LS-DYNA

Thermo-Mechanical Coupled Simulation with LS-DYNA DYNAmore GmbH Industriestraße 2, D-70565 Stuttgart andrea.erhart@dynamore.de www.dynamore.de Ingenieurbüro Tobias Loose Herdweg 13, D-75045 Wössingen Lkr. Karlsruhe loose@tl-ing.de www.loose.at Thermo-Mechanical

More information

AeroFluidX: A Next Generation GPU-Based CFD Solver for Engineering Applications

AeroFluidX: A Next Generation GPU-Based CFD Solver for Engineering Applications AeroFluidX: A Next Generation GPU-Based CFD Solver for Engineering Applications Dr. Bjoern Landmann Dr. Kerstin Wieczorek Stefan Bachschuster 18.03.2015 FluiDyna GmbH, Lichtenbergstr. 8, 85748 Garching

More information

Back to Elements - Tetrahedra vs. Hexahedra

Back to Elements - Tetrahedra vs. Hexahedra Back to Elements - Tetrahedra vs. Hexahedra Erke Wang, Thomas Nelson, Rainer Rauch CAD-FEM GmbH, Munich, Germany Abstract This paper presents some analytical results and some test results for different

More information

CHAPTER 4 4 NUMERICAL ANALYSIS

CHAPTER 4 4 NUMERICAL ANALYSIS 41 CHAPTER 4 4 NUMERICAL ANALYSIS Simulation is a powerful tool that engineers use to predict the result of a phenomenon or to simulate the working situation in which a part or machine will perform in

More information

Model Order Reduction for Linear Convective Thermal Flow

Model Order Reduction for Linear Convective Thermal Flow Model Order Reduction for Linear Convective Thermal Flow Christian Moosmann, Evgenii B. Rudnyi, Andreas Greiner, Jan G. Korvink IMTEK, April 24 Abstract Simulation of the heat exchange between a solid

More information

Plates and Shells: Theory and Computation - 4D9 - Dr Fehmi Cirak (fc286@) Office: Inglis building mezzanine level (INO 31)

Plates and Shells: Theory and Computation - 4D9 - Dr Fehmi Cirak (fc286@) Office: Inglis building mezzanine level (INO 31) Plates and Shells: Theory and Computation - 4D9 - Dr Fehmi Cirak (fc286@) Office: Inglis building mezzanine level (INO 31) Outline -1-! This part of the module consists of seven lectures and will focus

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

Graduate Courses in Mechanical Engineering

Graduate Courses in Mechanical Engineering Graduate Courses in Mechanical Engineering MEEG 501 ADVANCED MECHANICAL ENGINEERING ANALYSIS An advanced, unified approach to the solution of mechanical engineering problems, with emphasis on the formulation

More information

Vista: A Multi-field Object Oriented CFD-package

Vista: A Multi-field Object Oriented CFD-package Vista: A Multi-field Object Oriented CFD-package T. Kvamsdal 1, R. Holdahl 1 and P. Böhm 2 1 SINTEF ICT, Applied Mathematics, Norway 2 inutech GmbH, Germany Outline inutech & SINTEF VISTA a CFD Solver

More information

Feature Commercial codes In-house codes

Feature Commercial codes In-house codes A simple finite element solver for thermo-mechanical problems Keywords: Scilab, Open source software, thermo-elasticity Introduction In this paper we would like to show how it is possible to develop a

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

Efficient numerical simulation of time-harmonic wave equations

Efficient numerical simulation of time-harmonic wave equations Efficient numerical simulation of time-harmonic wave equations Prof. Tuomo Rossi Dr. Dirk Pauly Ph.Lic. Sami Kähkönen Ph.Lic. Sanna Mönkölä M.Sc. Tuomas Airaksinen M.Sc. Anssi Pennanen M.Sc. Jukka Räbinä

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

ACCELERATING COMMERCIAL LINEAR DYNAMIC AND NONLINEAR IMPLICIT FEA SOFTWARE THROUGH HIGH- PERFORMANCE COMPUTING

ACCELERATING COMMERCIAL LINEAR DYNAMIC AND NONLINEAR IMPLICIT FEA SOFTWARE THROUGH HIGH- PERFORMANCE COMPUTING ACCELERATING COMMERCIAL LINEAR DYNAMIC AND Vladimir Belsky Director of Solver Development* Luis Crivelli Director of Solver Development* Matt Dunbar Chief Architect* Mikhail Belyi Development Group Manager*

More information

Numerical Calculation of Laminar Flame Propagation with Parallelism Assignment ZERO, CS 267, UC Berkeley, Spring 2015

Numerical Calculation of Laminar Flame Propagation with Parallelism Assignment ZERO, CS 267, UC Berkeley, Spring 2015 Numerical Calculation of Laminar Flame Propagation with Parallelism Assignment ZERO, CS 267, UC Berkeley, Spring 2015 Xian Shi 1 bio I am a second-year Ph.D. student from Combustion Analysis/Modeling Lab,

More information

Mixed Precision Iterative Refinement Methods Energy Efficiency on Hybrid Hardware Platforms

Mixed Precision Iterative Refinement Methods Energy Efficiency on Hybrid Hardware Platforms Mixed Precision Iterative Refinement Methods Energy Efficiency on Hybrid Hardware Platforms Björn Rocker Hamburg, June 17th 2010 Engineering Mathematics and Computing Lab (EMCL) KIT University of the State

More information

Finite Element Methods (in Solid and Structural Mechanics)

Finite Element Methods (in Solid and Structural Mechanics) CEE570 / CSE 551 Class #1 Finite Element Methods (in Solid and Structural Mechanics) Spring 2014 Prof. Glaucio H. Paulino Donald Biggar Willett Professor of Engineering Department of Civil and Environmental

More information

Fast Multipole Method for particle interactions: an open source parallel library component

Fast Multipole Method for particle interactions: an open source parallel library component Fast Multipole Method for particle interactions: an open source parallel library component F. A. Cruz 1,M.G.Knepley 2,andL.A.Barba 1 1 Department of Mathematics, University of Bristol, University Walk,

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

Paper Pulp Dewatering

Paper Pulp Dewatering Paper Pulp Dewatering Dr. Stefan Rief stefan.rief@itwm.fraunhofer.de Flow and Transport in Industrial Porous Media November 12-16, 2007 Utrecht University Overview Introduction and Motivation Derivation

More information

CFD Applications using CFD++ Paul Batten & Vedat Akdag

CFD Applications using CFD++ Paul Batten & Vedat Akdag CFD Applications using CFD++ Paul Batten & Vedat Akdag Metacomp Products available under Altair Partner Program CFD++ Introduction Accurate multi dimensional polynomial framework Robust on wide variety

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

Benchmarking COMSOL Multiphysics 3.5a CFD problems

Benchmarking COMSOL Multiphysics 3.5a CFD problems Presented at the COMSOL Conference 2009 Boston Benchmarking COMSOL Multiphysics 3.5a CFD problems Darrell W. Pepper Xiuling Wang* Nevada Center for Advanced Computational Methods University of Nevada Las

More information

Modeling of Earth Surface Dynamics and Related Problems Using OpenFOAM

Modeling of Earth Surface Dynamics and Related Problems Using OpenFOAM CSDMS 2013 Meeting Modeling of Earth Surface Dynamics and Related Problems Using OpenFOAM Xiaofeng Liu, Ph.D., P.E. Assistant Professor Department of Civil and Environmental Engineering University of Texas

More information

The Application of a Black-Box Solver with Error Estimate to Different Systems of PDEs

The Application of a Black-Box Solver with Error Estimate to Different Systems of PDEs The Application of a Black-Bo Solver with Error Estimate to Different Systems of PDEs Torsten Adolph and Willi Schönauer Forschungszentrum Karlsruhe Institute for Scientific Computing Karlsruhe, Germany

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

Multigrid preconditioning for nonlinear (degenerate) parabolic equations with application to monument degradation

Multigrid preconditioning for nonlinear (degenerate) parabolic equations with application to monument degradation Multigrid preconditioning for nonlinear (degenerate) parabolic equations with application to monument degradation M. Donatelli 1 M. Semplice S. Serra-Capizzano 1 1 Department of Science and High Technology

More information

Laminar Flow in a Baffled Stirred Mixer

Laminar Flow in a Baffled Stirred Mixer Laminar Flow in a Baffled Stirred Mixer Introduction This exercise exemplifies the use of the rotating machinery feature in the CFD Module. The Rotating Machinery interface allows you to model moving rotating

More information

Course Outline for the Masters Programme in Computational Engineering

Course Outline for the Masters Programme in Computational Engineering Course Outline for the Masters Programme in Computational Engineering Compulsory Courses CP-501 Mathematical Methods for Computational 3 Engineering-I CP-502 Mathematical Methods for Computational 3 Engineering-II

More information

Pushing the limits. Turbine simulation for next-generation turbochargers

Pushing the limits. Turbine simulation for next-generation turbochargers Pushing the limits Turbine simulation for next-generation turbochargers KWOK-KAI SO, BENT PHILLIPSEN, MAGNUS FISCHER Computational fluid dynamics (CFD) has matured and is now an indispensable tool for

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

FINITE ELEMENT : MATRIX FORMULATION. Georges Cailletaud Ecole des Mines de Paris, Centre des Matériaux UMR CNRS 7633

FINITE ELEMENT : MATRIX FORMULATION. Georges Cailletaud Ecole des Mines de Paris, Centre des Matériaux UMR CNRS 7633 FINITE ELEMENT : MATRIX FORMULATION Georges Cailletaud Ecole des Mines de Paris, Centre des Matériaux UMR CNRS 76 FINITE ELEMENT : MATRIX FORMULATION Discrete vs continuous Element type Polynomial approximation

More information

Introduction to the Finite Element Method

Introduction to the Finite Element Method Introduction to the Finite Element Method 09.06.2009 Outline Motivation Partial Differential Equations (PDEs) Finite Difference Method (FDM) Finite Element Method (FEM) References Motivation Figure: cross

More information

Basin simulation for complex geological settings

Basin simulation for complex geological settings Énergies renouvelables Production éco-responsable Transports innovants Procédés éco-efficients Ressources durables Basin simulation for complex geological settings Towards a realistic modeling P. Havé*,

More information

CFD modelling of floating body response to regular waves

CFD modelling of floating body response to regular waves CFD modelling of floating body response to regular waves Dr Yann Delauré School of Mechanical and Manufacturing Engineering Dublin City University Ocean Energy Workshop NUI Maynooth, October 21, 2010 Table

More information

Which strategy to move the mesh in the Computational Fluid Dynamic code OpenFOAM

Which strategy to move the mesh in the Computational Fluid Dynamic code OpenFOAM Which strategy to move the mesh in the Computational Fluid Dynamic code OpenFOAM Christophe Kassiotis April 12, 2008 École Normale Supérieure de Cachan, Laboratoire de Mécanique et Technologies (LMT) Secteur

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

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

Benchmark Computations of 3D Laminar Flow Around a Cylinder with CFX, OpenFOAM and FeatFlow

Benchmark Computations of 3D Laminar Flow Around a Cylinder with CFX, OpenFOAM and FeatFlow Benchmark Computations of 3D Laminar Flow Around a Cylinder with CFX, OpenFOAM and FeatFlow E. Bayraktar, O. Mierka and S. Turek Institute of Applied Mathematics (LS III), TU Dortmund Vogelpothsweg 87,

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

On the State of Finite Element Procedures for Forming Processes

On the State of Finite Element Procedures for Forming Processes On the State of Finite Element Procedures for Forming Processes Klaus-Jurgen Bathe Massachusetts Institute of Technology, Cambridge, M USA Abstract. The solution of forming processes requires reliable

More information

Mesh Generation and Load Balancing

Mesh Generation and Load Balancing Mesh Generation and Load Balancing Stan Tomov Innovative Computing Laboratory Computer Science Department The University of Tennessee April 04, 2012 CS 594 04/04/2012 Slide 1 / 19 Outline Motivation Reliable

More information

Coupling Forced Convection in Air Gaps with Heat and Moisture Transfer inside Constructions

Coupling Forced Convection in Air Gaps with Heat and Moisture Transfer inside Constructions Coupling Forced Convection in Air Gaps with Heat and Moisture Transfer inside Constructions M. Bianchi Janetti 1, F. Ochs 1 and R. Pfluger 1 1 University of Innsbruck, Unit for Energy Efficient Buildings,

More information

Experiences Extending the CFD Solver of the PDE Framework Peano

Experiences Extending the CFD Solver of the PDE Framework Peano Experiences Extending the CFD Solver of the PDE Framework Peano T. Neckel, M. Lieb, R. Sangl TUM, Department of Informatics, Chair of Scientific Computing in Computer Science P. Schoeffel, F. Weyermann

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

How To Write A Pde Framework For A Jubilian (Jubilians)

How To Write A Pde Framework For A Jubilian (Jubilians) FEM Simulations of Incompressible Flow using AD in the PDE Framework Peano Hans-Joachim Bungartz,, Fakultät für Informatik TU München Germany Outline The PDE Framework Peano Different Approaches for Jacobians

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

How To Run A Cdef Simulation

How To Run A Cdef Simulation Simple CFD Simulations and Visualisation using OpenFOAM and ParaView Sachiko Arvelius, PhD Purpose of this presentation To show my competence in CFD (Computational Fluid Dynamics) simulation and visualisation

More information

Parameter Estimation for Bingham Models

Parameter Estimation for Bingham Models Dr. Volker Schulz, Dmitriy Logashenko Parameter Estimation for Bingham Models supported by BMBF Parameter Estimation for Bingham Models Industrial application of ceramic pastes Material laws for Bingham

More information

High Performance Computing for Operation Research

High Performance Computing for Operation Research High Performance Computing for Operation Research IEF - Paris Sud University claude.tadonki@u-psud.fr INRIA-Alchemy seminar, Thursday March 17 Research topics Fundamental Aspects of Algorithms and Complexity

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

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

FEM Software Automation, with a case study on the Stokes Equations

FEM Software Automation, with a case study on the Stokes Equations FEM Automation, with a case study on the Stokes Equations FEM Andy R Terrel Advisors: L R Scott and R C Kirby Numerical from Department of Computer Science University of Chicago March 1, 2006 Masters Presentation

More information

CastNet: Modelling platform for open source solver technology

CastNet: Modelling platform for open source solver technology CastNet: Modelling platform for open source solver technology. DHCAE Tools GmbH Address: Friedrich-Ebert-Str. 368, 47800 Krefeld, Germany / Company site: Alte Rather Str. 207 / 47802 Krefeld Phone +49

More information

List of Problems Solved Introduction p. 1 Concept p. 1 Nodes p. 3 Elements p. 4 Direct Approach p. 5 Linear Spring p. 5 Heat Flow p.

List of Problems Solved Introduction p. 1 Concept p. 1 Nodes p. 3 Elements p. 4 Direct Approach p. 5 Linear Spring p. 5 Heat Flow p. Preface p. v List of Problems Solved p. xiii Introduction p. 1 Concept p. 1 Nodes p. 3 Elements p. 4 Direct Approach p. 5 Linear Spring p. 5 Heat Flow p. 6 Assembly of the Global System of Equations p.

More information

FRIEDRICH-ALEXANDER-UNIVERSITÄT ERLANGEN-NÜRNBERG

FRIEDRICH-ALEXANDER-UNIVERSITÄT ERLANGEN-NÜRNBERG FRIEDRICH-ALEXANDER-UNIVERSITÄT ERLANGEN-NÜRNBERG INSTITUT FÜR INFORMATIK (MATHEMATISCHE MASCHINEN UND DATENVERARBEITUNG) Lehrstuhl für Informatik 10 (Systemsimulation) Massively Parallel Multilevel Finite

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

walberla: A software framework for CFD applications

walberla: A software framework for CFD applications walberla: A software framework for CFD applications U. Rüde, S. Donath, C. Feichtinger, K. Iglberger, F. Deserno, M. Stürmer, C. Mihoubi, T. Preclic, D. Haspel (all LSS Erlangen), N. Thürey (LSS Erlangen/

More information

Geometric multiscaling in the circulatory system

Geometric multiscaling in the circulatory system Geometric multiscaling in the circulatory system Local: 3D FSI flow model Global: 1D network of arteries and veins (Euler hyperbolic system) Global: 0D capillary network (DAE system) Geometric multiscaling

More information

Advanced Computational Software

Advanced Computational Software Advanced Computational Software Scientific Libraries: Part 2 Blue Waters Undergraduate Petascale Education Program May 29 June 10 2011 Outline Quick review Fancy Linear Algebra libraries - ScaLAPACK -PETSc

More information

M. Cross, T.N. Croft, D. McBride, A.K. Slone, and A.J. Williams Centre for Civil and Computational Engineering School of Engineering University of

M. Cross, T.N. Croft, D. McBride, A.K. Slone, and A.J. Williams Centre for Civil and Computational Engineering School of Engineering University of M. Cross, T.N. Croft, D. McBride, A.K. Slone, and A.J. Williams Centre for Civil and Computational Engineering School of Engineering University of Wales, Swansea m.cross@swan.ac.uk 1 !"# $% #"&" " ' ("

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

Finite Elements Infinite Possibilities. Virtual Simulation and High-Performance Computing

Finite Elements Infinite Possibilities. Virtual Simulation and High-Performance Computing Microsoft Windows Compute Cluster Server 2003 Partner Solution Brief Finite Elements Infinite Possibilities. Virtual Simulation and High-Performance Computing Microsoft Windows Compute Cluster Server Runs

More information

Model of a flow in intersecting microchannels. Denis Semyonov

Model of a flow in intersecting microchannels. Denis Semyonov Model of a flow in intersecting microchannels Denis Semyonov LUT 2012 Content Objectives Motivation Model implementation Simulation Results Conclusion Objectives A flow and a reaction model is required

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

Introduction to COMSOL. The Navier-Stokes Equations

Introduction to COMSOL. The Navier-Stokes Equations Flow Between Parallel Plates Modified from the COMSOL ChE Library module rev 10/13/08 Modified by Robert P. Hesketh, Chemical Engineering, Rowan University Fall 2008 Introduction to COMSOL The following

More information

Nonlinear Analysis Using Femap with NX Nastran

Nonlinear Analysis Using Femap with NX Nastran Nonlinear Analysis Using Femap with NX Nastran Chip Fricke, Principal Applications Engineer, Agenda Nonlinear Analysis Using Femap with NX Nastran Who am I? Overview of Nonlinear Analysis Comparison of

More information

CFD simulations using an AMR-like approach in the PDE Framework Peano

CFD simulations using an AMR-like approach in the PDE Framework Peano CFD simulations using an AMR-like approach in the PDE Framework Peano, Fakultät für Informatik Technische Universität München Germany Miriam Mehl, Hans-Joachim Bungartz, Takayuki Aoki Outline PDE Framework

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

A Posteriori Error Estimation for Predictive Models

A Posteriori Error Estimation for Predictive Models A Posteriori Error Estimation for Predictive Models James R. Stewart jrstewa@sandia.gov Engineering Sciences Center Advanced Computational Mechanics Architectures Dept (9143) Sandia National Laboratories

More information

Accelerating CFD using OpenFOAM with GPUs

Accelerating CFD using OpenFOAM with GPUs Accelerating CFD using OpenFOAM with GPUs Authors: Saeed Iqbal and Kevin Tubbs The OpenFOAM CFD Toolbox is a free, open source CFD software package produced by OpenCFD Ltd. Its user base represents a wide

More information

Iterative Solvers for Linear Systems

Iterative Solvers for Linear Systems 9th SimLab Course on Parallel Numerical Simulation, 4.10 8.10.2010 Iterative Solvers for Linear Systems Bernhard Gatzhammer Chair of Scientific Computing in Computer Science Technische Universität München

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

T-FLEX ANALYSIS USER MANUAL

T-FLEX ANALYSIS USER MANUAL T-FLEX ANALYSIS USER MANUAL «Top Systems» Moscow, 2009 Copyright 2009 Top Systems This Software and Related Documentation are proprietary to Top Systems. Any copying of this documentation, except as permitted

More information

Adaptation and validation of OpenFOAM CFD-solvers for nuclear safety related flow simulations

Adaptation and validation of OpenFOAM CFD-solvers for nuclear safety related flow simulations Adaptation and validation of OpenFOAM CFD-solvers for nuclear safety related flow simulations SAFIR2010 Seminar, 10.-11.3.2011, Espoo Juho Peltola, Timo Pättikangas (VTT) Tomas Brockmann, Timo Siikonen

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

Hierarchically Parallel FE Software for Assembly Structures : FrontISTR - Parallel Performance Evaluation and Its Industrial Applications

Hierarchically Parallel FE Software for Assembly Structures : FrontISTR - Parallel Performance Evaluation and Its Industrial Applications CO-DESIGN 2012, October 23-25, 2012 Peing University, Beijing Hierarchically Parallel FE Software for Assembly Structures : FrontISTR - Parallel Performance Evaluation and Its Industrial Applications Hiroshi

More information

High-fidelity electromagnetic modeling of large multi-scale naval structures

High-fidelity electromagnetic modeling of large multi-scale naval structures High-fidelity electromagnetic modeling of large multi-scale naval structures F. Vipiana, M. A. Francavilla, S. Arianos, and G. Vecchi (LACE), and Politecnico di Torino 1 Outline ISMB and Antenna/EMC Lab

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

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

Optimization of Supply Chain Networks

Optimization of Supply Chain Networks Optimization of Supply Chain Networks M. Herty TU Kaiserslautern September 2006 (2006) 1 / 41 Contents 1 Supply Chain Modeling 2 Networks 3 Optimization Continuous optimal control problem Discrete optimal

More information