FLUID FLOW TOPOLOGY OPTIMIZATION USING POLYGINAL ELEMENTS: STABILITY AND COMPUTATIONAL IMPLEMENTATION IN PolyTop

Size: px
Start display at page:

Download "FLUID FLOW TOPOLOGY OPTIMIZATION USING POLYGINAL ELEMENTS: STABILITY AND COMPUTATIONAL IMPLEMENTATION IN PolyTop"

Transcription

1 FLUID FLOW TOPOLOGY OPTIMIZATION USING POLYGINAL ELEMENTS: STABILITY AND COMPUTATIONAL IMPLEMENTATION IN PolyTop Anderson Pereira (Tecgraf/PUC-Rio) Cameron Talischi (UIUC) - Ivan Menezes (PUC-Rio) - Glaucio Paulino (GATech) Reno, NV, USA, July 20-24, 2015

2 INTRODUCTION PolyMesher & PolyTop Polygonal element mesher and topology optimization implementation in MATLAB PolyTop Geometry & BC s Polygonal Mesh PolyTop Talischi, C., Paulino, G.H., Pereira, A., and Menezes, I.F.M., PolyMesher: a general-purpose mesh generator for polygonal elements written in Matlab, JSMO, 45: , doi: /s z Talischi, C., Paulino, G.H., Pereira, A., and Menezes, I.F.M., PolyTop: a Matlab implementation of a general topology optimization framework using unstructured polygonal finite element meshes, JSMO, 45: , doi: /s x

3 POLYGONAL FINITE ELEMENTS Provide great flexibility in discretizing complex domains Naturally exclude checkerboard layouts and one-node connections Not biased by the standard FEM simplex geometry (triangles and quads)

4 POLYGONAL FINITE ELEMENTS Provide great flexibility in discretizing complex domains Naturally exclude checkerboard layouts and one-node connections Not biased by the standard FEM simplex geometry (triangles and quads) Q4 Elements Polygonal Elements

5 POLYGONAL FINITE ELEMENTS Provide great flexibility in discretizing complex domains Naturally exclude checkerboard layouts and one-node connections Not biased by the standard FEM simplex geometry (triangles and quads) POLYGONAL FINITE ELEMENTS T6 Elements Polygonal Elements Talischi, C., Paulino, G.H., Pereira, A. and Menezes, I.F.M., Polygonal Finite Elements for Topology Optimization: A Unifying Paradigm, IJNME, 82(6): , 2010.

6 CODE EFFICIENCY PolyTop: Efficiency Comparison with the 88-line code* Mesh Size 90x30 150x50 300x x200 PolyTop 88-line (time in sec for 200 optimization iterations) * Andreassen E., Clausen A., Schevenels M., Lazarov B., Sigmund O., Efficient topology optimization in MATLAB using 88 lines of code, JSMO, 43(1):1 16, doi: /s

7 CODE MODULARITY PolyTop: Code Modularity and Flexibility

8 CODE MODULARITY PolyTop: Code Modularity and Flexibility Material interpolation functions (e.g. SIMP, RAMP) Different optimizers (e.g. OC, MMA, SLP) Objective functions (e.g. Compliance, Compliant Mechanism) Different physics (?)

9 CODE MODULARITY PolyTop: Code Modularity and Flexibility Material interpolation functions (e.g. SIMP, RAMP) Different optimizers (e.g. OC, MMA, SLP) Objective functions (e.g. Compliance, Compliant Mechanism) Different physics (?)

10 CODE MODULARITY PolyTop: Code Modularity and Flexibility Material interpolation functions (e.g. SIMP, RAMP) Different optimizers (e.g. OC, MMA, SLP) Objective functions (e.g. Compliance, Compliant Mechanism) Different physics (?) Example (Compliant Mechanism):

11 CODE MODULARITY PolyTop: Code Modularity and Flexibility Material interpolation functions (e.g. SIMP, RAMP) Different optimizers (e.g. OC, MMA, SLP) Objective functions (e.g. Compliance, Compliant Mechanism) Different physics (?)

12 STABILITY OF POLYGONAL FEs Governing equations for Stokes flow Stability is a critical issue concerning mixed FE formulations and it is well-known that it is dictated by the INF-SUP condition It delineates the appropriate balance between the velocity and pressure approximations

13 STABILITY OF POLYGONAL FEs Numerical instabilities such the checkerboard problem could appear in mixed variational formulation (pressure-velocity) of the Stokes flow problems. velocity Lid-driven cavity problem checkerboard on pressure Q4 elements

14 STABILITY OF POLYGONAL FEs Numerical instabilities such the checkerboard problem could appear in mixed variational formulation (pressure-velocity) of the Stokes flow problems. velocity Lid-driven cavity problem pressure Polygonal elements

15 STABILITY OF POLYGONAL FEs ~ INF-SUP Test: compute the stability parameter b h where: is the space of pressure modes for a sequence of progressively finer meshes.

16 STABILITY OF POLYGONAL FEs ~ INF-SUP Test: compute the stability parameter b h where: is the space of pressure modes for a sequence of progressively finer meshes. Families of meshes: Quadrilateral Hexagonal Random Voronoi Centroidal Voronoi (CVT)

17 STABILITY OF POLYGONAL FEs Computed values of the stability parameter ~ b h ~ b h remains bounded away from zero under mesh refinement for polygonal meshes* Talischi, C., Pereira, A., Paulino, G.H., Menezes, I.F.M., and Carvalho, M.S., Polygonal Finite Elements for Incompressible Fluid Flow, IJNMF, 74(2): , 2014.

18 PERFORMANCE AND ACCURACY 1 Stokes flow on a unit square with known analytical solution (smooth problem) Quadrilateral Hexagonal Triangular (MINI) Random Voronoi Centroidal Voronoi (CVT)

19 PERFORMANCE AND ACCURACY H 1 - error in Velocity L 2 - error in Pressure

20 PERFORMANCE AND ACCURACY H 1 - error in Velocity L 2 - error in Pressure Given a level of error in pressure, the MINI elements require almost two order of magnitude more DOFs than the CVT

21 PERFORMANCE AND ACCURACY 2 Stokes flow on an L-shaped domain with known analytical solution (non-smooth problem) Representative example of the family of meshes for the L-shaped problem Uniform triangular Uniform Quadrilateral Centroidal Voronoi (CVT) generated by PolyMesher Representative example example example of the of family the of the family of family meshes of meshes of meshes (a) uniform (a) uniform (a) uniform triangular triangular triangular (b) (b) (b) uniform uniform uniform quadrilateral and and (c) centroidal and (c) centroidal (c) centroidal Voronoi Voronoi Voronoi (CVT) (CVT) (CVT)

22 PERFORMANCE AND ACCURACY Low order elements H 1 - error in Velocity L 2 - error in Pressure

23 PERFORMANCE AND ACCURACY High order elements H 1 - error in Velocity L 2 - error in Pressure

24 TOPOLOGY OPTIMIZATION FOR FLUIDS Governing BVP = inverse permeability function (relates design to physics) since r is piecewise constant, this is a discontinuous coefficient porosity approach * Objective Function ( drag minimization problem ): Pereira, A., Talischi, C., Paulino, G.H., Menezes, I.F.M., and Carvalho, M.S., Fluid Flow Topology Optimization in PolyTop: Stability and Computational Implementation, JSMO, 2015, doi: /s z * Borrvall, T., and Petersson, J., Topology optimization of fluids in stokes flow, IJNMF, 41, 1 (2003),

25 189 Lines 206 Lines CHANGES IN POLYTOP CODE Elasticity Problems Fluid Flow Problems 25 (13.0%) Main Loop 25 (12.0%) 20 (10.5%) Objective Function & Constraint 20 (10.0%) 14 (7.5%) Update Scheme (OC) 14 (6.5%) FE Analysis 116 (61.5%) 22 Lines Changed 11 Lines Deleted 28 Lines Added 133 (65.0%) 14 (7.5%) Plotting Results 14 (6.5%)

26 NUMERICAL RESULTS

27 NUMERICAL RESULTS Diffuser - Problem description

28 NUMERICAL RESULTS Diffuser - Solution Optimal solution Velocity Field Pressure Field

29 NUMERICAL RESULTS Bend - Problem description

30 NUMERICAL RESULTS Bend - Solution Optimal solution Velocity Field Pressure Field

31 NUMERICAL RESULTS Double Pipe Problem description Optimal solution

32 NUMERICAL RESULTS Double Pipe Velocity Field Pressure Field

33 NUMERICAL RESULTS Fluid Mechanism (maximize the y-velocity at a specific location) Problem description Optimal solution

34 NUMERICAL RESULTS Fluid Mechanism (maximize the y-velocity at a specific location) Velocity field Pressure field

35 CONCLUDING REMARKS

36 CONCLUDING REMARKS The general framework of PolyTop emphasizes a modular code structure where the analysis routine, including sensitivity calculations with respect to analysis parameters, and the optimization algorithm are kept separated from quantities defining the design field. This separation in turn permits changing the topology optimization formulation, including the choice of material interpolation scheme and the complexity control mechanism (e.g. filters and other manufacturing constraints), without the need for modifying the analysis function. Because polygonal finite elements (from the original PolyTop code) are again employed for the fluid analysis, the basis function construction and element integration routines also remain intact. The PolyTop code, originally written for compliance minimization in elasticity, was easily extended to model the problem of minimizing dissipated power in Stokes flow: only a few lines of codes were involved.

37 QUESTIONS?

38 CODE EFFICIENCY Comparison with the 88-line code* Mesh Size 90x30 150x50 300x x200 PolyTop 88-line (time in sec for 200 optimization iterations) Design Volume (OC Update Function) * Andreassen E., Clausen A., Schevenels M., Lazarov B., Sigmund O., Efficient topology optimization in MATLAB using 88 lines of code, JSMO, 43(1):1 16, doi: /s

39 NUMERICAL RESULTS Diffuser - Results Diffuser Problem 2,500 elements 10,000 elements # iterations objective # iterations objective Present work (curved domain) Present work (square domain) Borwall and Petersson (2003)

40 NUMERICAL RESULTS Bend - Results Bend Problem 2,500 elements 10,000 elements # iterations objective # iterations objective Present work (curved domain) Present work (square domain) Borwall and Petersson (2003)

41 GENERATION OF POLYHEDRAL MESH A polygonal discretization can be obtained from the Voronoi diagram of a given set of seeds and their reflections Talischi, C., Paulino, G.H., Pereira, A., and Menezes, I.F.M., PolyMesher: a general-purpose mesh generator for polygonal elements written in Matlab, JSMO, 45: , doi: /s z Seed and its reflection have a common edge 41 MM&FGM TH INTERNATIONAL SYMPOSIUM ON MULTISCALE, MULTIFUNCTIONAL AND FUNCTIONALLY GRADED MATERIALS

42 STABILITY OF POLYGONAL FEs Families of meshes: Quadrilateral Hexagonal Random Voronoi Centroidal Voronoi (CVT) For meshes consisting of convex polygons, the results by Beirão da Veiga and Lipnikov guarantees the satisfaction of INF-SUP condition if every internal node in the mesh is connected to at most three edges Beirão da Veiga, L. and Lipnikov, K., A mimetic discretization of the Stokes problem with selected edge bubles, SIAM J Sci Comput, 32(2): , 2010.

PolyMesher: A General-Purpose Mesh Generator for Polygonal Elements Written in Matlab

PolyMesher: A General-Purpose Mesh Generator for Polygonal Elements Written in Matlab PolyMesher: A General-Purpose Mesh Generator for Polygonal Elements Written in Matlab Anderson Pereira, Cameron Talischi, Ivan F. M. Menezes and Glaucio H. Paulino Motivation Voronoi diagrams offer a simple

More information

Polygonal Finite Elements for Finite Elasticity

Polygonal Finite Elements for Finite Elasticity Polygonal Finite Elements for Finite Elasticity Heng Chi a, Cameron Talischi b, Oscar Lopez-Pamies b, Glaucio H. Paulino a a: Georgia Institute of Technology b: University of Illinois at Urbana-Champaign

More information

PolyTop: AMatlabimplementationofageneraltopologyoptimization framework using unstructured polygonal finite element meshes

PolyTop: AMatlabimplementationofageneraltopologyoptimization framework using unstructured polygonal finite element meshes 11th US National Congress on Computational Mechanics: PolyTop: AMatlabimplementationofageneraltopologyoptimization framework using unstructured polygonal finite element meshes Ivan Menezes b,camerontalischi

More information

Adaptive dynamic fracture simulation using potential-based cohesive zone modeling and polygonal finite elements

Adaptive dynamic fracture simulation using potential-based cohesive zone modeling and polygonal finite elements Adaptive dynamic fracture simulation using potential-based cohesive zone modeling and polygonal finite elements Sofie Leon University of Illinois Department of Civil and Environmental Engineering July

More information

Pattern Gradation and Repetition with Application to High-Rise Building Design

Pattern Gradation and Repetition with Application to High-Rise Building Design Pattern Gradation and Repetition with Application to High-Rise Building Design Lauren L. Stromberg, Glaucio H. Paulino, William F. Baker 10 th US National Congress on Computational Mechanics Columbus,

More information

1.2 Numerical Solutions of Flow Problems

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

More information

PolyTop++: an efficient alternative for serial and parallel topology optimization on CPUs & GPUs

PolyTop++: an efficient alternative for serial and parallel topology optimization on CPUs & GPUs Struct Multidisc Optim (2015) 52:845 859 DOI 10.1007/s00158-015-1252-x RESEARCH PAPER PolyTop++: an efficient alternative for serial and parallel topology optimization on CPUs & GPUs Leonardo S. Duarte

More information

Element energy based method for topology optimization

Element energy based method for topology optimization th World Congress on Structural and Multidisciplinary Optimization May 9-24, 23, Orlando, Florida, USA Element energy based method for topology optimization Vladimir Uskov Central Aerohydrodynamic Institute

More information

Isogeometric Analysis of Fluid-Structure Interaction

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

More information

Barycentric Finite Element Methods

Barycentric Finite Element Methods University of California, Davis Barycentric Finite Element Methods N. Sukumar UC Davis Workshop on Generalized Barycentric Coordinates, Columbia University July 26, 2012 Collaborators and Acknowledgements

More information

A NURBS-BASED APPROACH FOR SHAPE AND TOPOLOGY OPTIMIZATION OF FLOW DOMAINS

A NURBS-BASED APPROACH FOR SHAPE AND TOPOLOGY OPTIMIZATION OF FLOW DOMAINS 6th European Conference on Computational Mechanics (ECCM 6) 7th European Conference on Computational Fluid Dynamics (ECFD 7) 11 15 June 2018, Glasgow, UK A NURBS-BASED APPROACH FOR SHAPE AND TOPOLOGY OPTIMIZATION

More information

Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications

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

More information

Key words. weak Galerkin, finite element methods, second-order elliptic problems, a posteriori error estimate, polytopal meshes

Key words. weak Galerkin, finite element methods, second-order elliptic problems, a posteriori error estimate, polytopal meshes A POSTERIORI ERROR ESTIMATES FOR THE WEAK GALERKIN FINITE ELEMENT METHODS ON POLYTOPAL MESHES HENGGUANG LI, LIN MU, AND XIU YE Abstract. In this paper, we present a simple a posteriori error estimate for

More information

Comparative Study of Topological Optimization of Beam and Ring Type Structures under static Loading Condition

Comparative Study of Topological Optimization of Beam and Ring Type Structures under static Loading Condition Comparative Study of Topological Optimization of Beam and Ring Type Structures under static Loading Condition Vani Taklikar 1, Anadi Misra 2 P.G. Student, Department of Mechanical Engineering, G.B.P.U.A.T,

More information

Topology optimization of heat conduction problems

Topology optimization of heat conduction problems Topology optimization of heat conduction problems Workshop on industrial design optimization for fluid flow 23 September 2010 Misha Marie Gregersen Anton Evgrafov Mads Peter Sørensen Technical University

More information

1 Exercise: Heat equation in 2-D with FE

1 Exercise: Heat equation in 2-D with FE 1 Exercise: Heat equation in 2-D with FE Reading Hughes (2000, sec. 2.3-2.6 Dabrowski et al. (2008, sec. 1-3, 4.1.1, 4.1.3, 4.2.1 This FE exercise and most of the following ones are based on the MILAMIN

More information

Contents. I The Basic Framework for Stationary Problems 1

Contents. I The Basic Framework for Stationary Problems 1 page v Preface xiii I The Basic Framework for Stationary Problems 1 1 Some model PDEs 3 1.1 Laplace s equation; elliptic BVPs... 3 1.1.1 Physical experiments modeled by Laplace s equation... 5 1.2 Other

More information

Topology Optimization of Multiple Load Case Structures

Topology Optimization of Multiple Load Case Structures Topology Optimization of Multiple Load Case Structures Rafael Santos Iwamura Exectuive Aviation Engineering Department EMBRAER S.A. rafael.iwamura@embraer.com.br Alfredo Rocha de Faria Department of Mechanical

More information

Global and clustered approaches for stress constrained topology optimization and deactivation of design variables

Global and clustered approaches for stress constrained topology optimization and deactivation of design variables th World Congress on Structural and Multidisciplinary Optimization May 9-24, 23, Orlando, Florida, USA Global and clustered approaches for stress constrained topology optimization and deactivation of design

More information

Meshing of flow and heat transfer problems

Meshing of flow and heat transfer problems Meshing of flow and heat transfer problems Luyao Zou a, Zhe Li b, Qiqi Fu c and Lujie Sun d School of, Shandong University of science and technology, Shandong 266590, China. a zouluyaoxf@163.com, b 1214164853@qq.com,

More information

Finite Element Method. Chapter 7. Practical considerations in FEM modeling

Finite Element Method. Chapter 7. Practical considerations in FEM modeling Finite Element Method Chapter 7 Practical considerations in FEM modeling Finite Element Modeling General Consideration The following are some of the difficult tasks (or decisions) that face the engineer

More information

CHAPTER 1. Introduction

CHAPTER 1. Introduction ME 475: Computer-Aided Design of Structures 1-1 CHAPTER 1 Introduction 1.1 Analysis versus Design 1.2 Basic Steps in Analysis 1.3 What is the Finite Element Method? 1.4 Geometrical Representation, Discretization

More information

Hydro-elastic analysis of a propeller using CFD and FEM co-simulation

Hydro-elastic analysis of a propeller using CFD and FEM co-simulation Fifth International Symposium on Marine Propulsors smp 17, Espoo, Finland, June 2017 Hydro-elastic analysis of a propeller using CFD and FEM co-simulation Vesa Nieminen 1 1 VTT Technical Research Centre

More information

In topology optimization, the parameterization of design and approximation of its response are closely linked through the discretization process

In topology optimization, the parameterization of design and approximation of its response are closely linked through the discretization process In topology optimization, the parameterization of design and approximation of its response are closely linked through the discretization process For example, in the element-based approach, the design variables

More information

FOURTH ORDER COMPACT FORMULATION OF STEADY NAVIER-STOKES EQUATIONS ON NON-UNIFORM GRIDS

FOURTH ORDER COMPACT FORMULATION OF STEADY NAVIER-STOKES EQUATIONS ON NON-UNIFORM GRIDS International Journal of Mechanical Engineering and Technology (IJMET Volume 9 Issue 10 October 2018 pp. 179 189 Article ID: IJMET_09_10_11 Available online at http://www.iaeme.com/ijmet/issues.asp?jtypeijmet&vtype9&itype10

More information

TOPOLOGY OPTIMIZATION OF ELASTOMER DAMPING DEVICES FOR STRUCTURAL VIBRATION REDUCTION

TOPOLOGY OPTIMIZATION OF ELASTOMER DAMPING DEVICES FOR STRUCTURAL VIBRATION REDUCTION 6th European Conference on Computational Mechanics (ECCM 6) 7th European Conference on Computational Fluid Dynamics (ECFD 7) 1115 June 2018, Glasgow, UK TOPOLOGY OPTIMIZATION OF ELASTOMER DAMPING DEVICES

More information

Steady Flow: Lid-Driven Cavity Flow

Steady Flow: Lid-Driven Cavity Flow STAR-CCM+ User Guide Steady Flow: Lid-Driven Cavity Flow 2 Steady Flow: Lid-Driven Cavity Flow This tutorial demonstrates the performance of STAR-CCM+ in solving a traditional square lid-driven cavity

More information

An Interface-fitted Mesh Generator and Polytopal Element Methods for Elliptic Interface Problems

An Interface-fitted Mesh Generator and Polytopal Element Methods for Elliptic Interface Problems An Interface-fitted Mesh Generator and Polytopal Element Methods for Elliptic Interface Problems Long Chen University of California, Irvine chenlong@math.uci.edu Joint work with: Huayi Wei (Xiangtan University),

More information

Polygonal multiresolution topology optimization (PolyMTOP) for structural dynamics

Polygonal multiresolution topology optimization (PolyMTOP) for structural dynamics Struct Multidisc Optim (2016) 53:673 694 DOI 10.1007/s00158-015-1309-x RESEARCH PAPER Polygonal multiresolution topology optimization (PolyMTOP) for structural dynamics Evgueni T. Filipov Junho Chun Glaucio

More information

arxiv: v1 [math.na] 20 Sep 2016

arxiv: v1 [math.na] 20 Sep 2016 arxiv:1609.06236v1 [math.na] 20 Sep 2016 A Local Mesh Modification Strategy for Interface Problems with Application to Shape and Topology Optimization P. Gangl 1,2 and U. Langer 3 1 Doctoral Program Comp.

More information

Critical study of design parameterization in topology optimization; The influence of design parameterization on local minima

Critical study of design parameterization in topology optimization; The influence of design parameterization on local minima 2 nd International Conference on Engineering Optimization September 6-9, 21, Lisbon, Portugal Critical study of design parameterization in topology optimization; The influence of design parameterization

More information

TOPOLOGY OPTIMIZATION: AN INTRODUCTION. Pierre DUYSINX LTAS Automotive Engineering Academic year

TOPOLOGY OPTIMIZATION: AN INTRODUCTION. Pierre DUYSINX LTAS Automotive Engineering Academic year TOPOLOGY OPTIMIZATION: AN INTRODUCTION Pierre DUYSINX LTAS Automotive Engineering Academic year 2017-2018 1 LAY-OUT Introduction Topology problem formulation Problem statement Compliance minimization Homogenization

More information

STRUCTURAL TOPOLOGY OPTIMIZATION SUBJECTED TO RELAXED STRESS AND DESIGN VARIABLES

STRUCTURAL TOPOLOGY OPTIMIZATION SUBJECTED TO RELAXED STRESS AND DESIGN VARIABLES STRUCTURAL TOPOLOGY OPTIMIZATION SUBJECTED TO RELAXED STRESS AND DESIGN VARIABLES Hailu Shimels Gebremedhen, Dereje Engida Woldemichael and Fakhruldin M. Hashim Mechanical Engineering Department, Universiti

More information

13.472J/1.128J/2.158J/16.940J COMPUTATIONAL GEOMETRY

13.472J/1.128J/2.158J/16.940J COMPUTATIONAL GEOMETRY 13.472J/1.128J/2.158J/16.940J COMPUTATIONAL GEOMETRY Lecture 23 Dr. W. Cho Prof. N. M. Patrikalakis Copyright c 2003 Massachusetts Institute of Technology Contents 23 F.E. and B.E. Meshing Algorithms 2

More information

Topology Optimization using Polytopes

Topology Optimization using Polytopes Topology Optimization using Polytopes Arun L. Gain Advisor: Prof. Glaucio H. Paulino Department of Civil and nvironmental ngineering University of Illinois at Urbana Champaign PhD Dissertation Defense

More information

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

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

More information

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

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

More information

Introduction to C omputational F luid Dynamics. D. Murrin

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

More information

Topological Optimization of Continuum Structures Using Optimality Criterion in ANSYS

Topological Optimization of Continuum Structures Using Optimality Criterion in ANSYS Topological Optimization of Continuum Structures Using Optimality Criterion in ANSYS Sudhanshu Tamta 1, Rakesh Saxena 2 1P.G. Student, Department of Mechanical Engineering, G.B.P.U.A.T., Pantnagar, U.S.Nagar,

More information

Implementation of a Low Order Mimetic Elements in freefem++

Implementation of a Low Order Mimetic Elements in freefem++ J. Numer. Math., Vol. 0, No. 0, pp. 1 11 (2012) DOI 10.1515/ JNUM.2012.000 c de Gruyter 2012 Prepared using jnm.sty [Version: 20.02.2007 v1.3] Implementation of a Low Order Mimetic lements in freefem++

More information

A nodal based evolutionary structural optimisation algorithm

A nodal based evolutionary structural optimisation algorithm Computer Aided Optimum Design in Engineering IX 55 A dal based evolutionary structural optimisation algorithm Y.-M. Chen 1, A. J. Keane 2 & C. Hsiao 1 1 ational Space Program Office (SPO), Taiwan 2 Computational

More information

IN-PLANE MATERIAL CONTINUITY FOR THE DISCRETE MATERIAL OPTIMIZATION METHOD

IN-PLANE MATERIAL CONTINUITY FOR THE DISCRETE MATERIAL OPTIMIZATION METHOD IN-PLANE MATERIAL CONTINUITY FOR THE DISCRETE MATERIAL OPTIMIZATION METHOD René Sørensen1 and Erik Lund2 1,2 Department of Mechanical and Manufacturing Engineering, Aalborg University Fibigerstraede 16,

More information

Tutorial 3 Comparing Biological Shapes Patrice Koehl and Joel Hass

Tutorial 3 Comparing Biological Shapes Patrice Koehl and Joel Hass Tutorial 3 Comparing Biological Shapes Patrice Koehl and Joel Hass University of California, Davis, USA http://www.cs.ucdavis.edu/~koehl/ims2017/ What is a shape? A shape is a 2-manifold with a Riemannian

More information

Guidelines for proper use of Plate elements

Guidelines for proper use of Plate elements Guidelines for proper use of Plate elements In structural analysis using finite element method, the analysis model is created by dividing the entire structure into finite elements. This procedure is known

More information

Finite Element Modeling Techniques (2) دانشگاه صنعتي اصفهان- دانشكده مكانيك

Finite Element Modeling Techniques (2) دانشگاه صنعتي اصفهان- دانشكده مكانيك Finite Element Modeling Techniques (2) 1 Where Finer Meshes Should be Used GEOMETRY MODELLING 2 GEOMETRY MODELLING Reduction of a complex geometry to a manageable one. 3D? 2D? 1D? Combination? Bulky solids

More information

Natural Inclusion of Boundary Points in a Mesh

Natural Inclusion of Boundary Points in a Mesh http://people.sc.fsu.edu/ jburkardt/presentations/ new orleans 2005.pdf... John 1 Max Gunzburger 2 Hoa Nguyen 2 Yuki Saka 2 1 School of Computational Science Florida State University 2 Department of Mathematics

More information

Interactive topology optimization on hand-held devices

Interactive topology optimization on hand-held devices Noname manuscript No. (will be inserted by the editor) Interactive topology optimization on hand-held devices Niels Aage Morten N. Jørgensen Casper S. Andreasen Ole Sigmund Received: date / Accepted: date

More information

Pressure Correction Scheme for Incompressible Fluid Flow

Pressure Correction Scheme for Incompressible Fluid Flow AALTO UNIVERSITY School of Chemical Technology CHEM-E7160 Fluid Flow in Process Units Pressure Correction Scheme for Incompressible Fluid Flow Ong Chin Kai 620503 Lee De Ming Benedict 620448 Page 1 Abstract

More information

An Introduction to Structural Optimization

An Introduction to Structural Optimization An Introduction to Structural Optimization SOLID MECHANICS AND ITS APPLICATIONS Volume 153 Series Editor: G.M.L. GLADWELL Department of Civil Engineering University of Waterloo Waterloo, Ontario, Canada

More information

Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, Politecnico di Milano, February 3, 2017, Lesson 1

Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, Politecnico di Milano, February 3, 2017, Lesson 1 Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, attilio.frangi@polimi.it Politecnico di Milano, February 3, 2017, Lesson 1 1 Politecnico di Milano, February 3, 2017, Lesson 1 2 Outline

More information

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

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

More information

Diamonds: Finite Element/Discrete Mechanics schemes with guaranteed optimal convergence

Diamonds: Finite Element/Discrete Mechanics schemes with guaranteed optimal convergence Diamonds: Finite Element/Discrete Mechanics schemes with guaranteed optimal convergence M. Ortiz California Institute of Technology In collaboration with: P. Hauret and E. Kuhl International Conference

More information

NUMERICAL VISCOSITY. Convergent Science White Paper. COPYRIGHT 2017 CONVERGENT SCIENCE. All rights reserved.

NUMERICAL VISCOSITY. Convergent Science White Paper. COPYRIGHT 2017 CONVERGENT SCIENCE. All rights reserved. Convergent Science White Paper COPYRIGHT 2017 CONVERGENT SCIENCE. All rights reserved. This document contains information that is proprietary to Convergent Science. Public dissemination of this document

More information

Lecture 2 Unstructured Mesh Generation

Lecture 2 Unstructured Mesh Generation Lecture 2 Unstructured Mesh Generation MIT 16.930 Advanced Topics in Numerical Methods for Partial Differential Equations Per-Olof Persson (persson@mit.edu) February 13, 2006 1 Mesh Generation Given a

More information

Tiling Three-Dimensional Space with Simplices. Shankar Krishnan AT&T Labs - Research

Tiling Three-Dimensional Space with Simplices. Shankar Krishnan AT&T Labs - Research Tiling Three-Dimensional Space with Simplices Shankar Krishnan AT&T Labs - Research What is a Tiling? Partition of an infinite space into pieces having a finite number of distinct shapes usually Euclidean

More information

The Finite Element Method

The Finite Element Method The Finite Element Method A Practical Course G. R. Liu and S. S. Quek Chapter 1: Computational modeling An overview 1 CONTENTS INTRODUCTION PHYSICAL PROBLEMS IN ENGINEERING COMPUTATIONAL MODELLING USING

More information

Large scale structural optimization - insight through HPC

Large scale structural optimization - insight through HPC Classes of structural optimization Large scale structural optimization - insight through HPC Casper Schousboe Andreasen Associate Professor, DTU Mechanical Engineering @National Supercomputing Day Classes

More information

Level-set and ALE Based Topology Optimization Using Nonlinear Programming

Level-set and ALE Based Topology Optimization Using Nonlinear Programming 10 th World Congress on Structural and Multidisciplinary Optimization May 19-24, 2013, Orlando, Florida, USA Level-set and ALE Based Topology Optimization Using Nonlinear Programming Shintaro Yamasaki

More information

Control Volume Finite Difference On Adaptive Meshes

Control Volume Finite Difference On Adaptive Meshes Control Volume Finite Difference On Adaptive Meshes Sanjay Kumar Khattri, Gunnar E. Fladmark, Helge K. Dahle Department of Mathematics, University Bergen, Norway. sanjay@mi.uib.no Summary. In this work

More information

Scientific Visualization Example exam questions with commented answers

Scientific Visualization Example exam questions with commented answers Scientific Visualization Example exam questions with commented answers The theoretical part of this course is evaluated by means of a multiple- choice exam. The questions cover the material mentioned during

More information

Efficient Numerical Integration in. Polygonal Finite Element Method. S. E. Mousavi a and N. Sukumar b. University of Texas, Austin

Efficient Numerical Integration in. Polygonal Finite Element Method. S. E. Mousavi a and N. Sukumar b. University of Texas, Austin Efficient Numerical Integration in Polygonal Finite Element Method S. E. Mousavi a and N. Sukumar b a University of Texas, Austin b University of California, Davis NSF Workshop on Barycentric Coordinates

More information

A numerical grid and grid less (Mesh less) techniques for the solution of 2D Laplace equation

A numerical grid and grid less (Mesh less) techniques for the solution of 2D Laplace equation Available online at www.pelagiaresearchlibrary.com Advances in Applied Science Research, 2014, 5(1):150-155 ISSN: 0976-8610 CODEN (USA): AASRFC A numerical grid and grid less (Mesh less) techniques for

More information

Solving Partial Differential Equations on Overlapping Grids

Solving Partial Differential Equations on Overlapping Grids **FULL TITLE** ASP Conference Series, Vol. **VOLUME**, **YEAR OF PUBLICATION** **NAMES OF EDITORS** Solving Partial Differential Equations on Overlapping Grids William D. Henshaw Centre for Applied Scientific

More information

TOPOLOGY DESIGN USING B-SPLINE FINITE ELEMENTS

TOPOLOGY DESIGN USING B-SPLINE FINITE ELEMENTS TOPOLOGY DESIGN USING B-SPLINE FINITE ELEMENTS By ANAND PARTHASARATHY A THESIS PRESENTED TO THE GRADUATE SCHOOL OF THE UNIVERSITY OF FLORIDA IN PARTIAL FULFILLMENT OF THE REQUIREMENTS FOR THE DEGREE OF

More information

Reduction strategies for shape dependent inverse problems in haemodynamics

Reduction strategies for shape dependent inverse problems in haemodynamics Reduction strategies for shape dependent inverse problems in haemodynamics Toni Lassila, Andrea Manzoni, and Gianluigi Rozza EPFL, École Polytechnique Fédérale de Lausanne CMCS, Chair of Modelling and

More information

Polygonal, Polyhedral, and Serendipity Finite Element Methods

Polygonal, Polyhedral, and Serendipity Finite Element Methods Polygonal, Polyhedral, and Serendipity Finite Element Methods Andrew Gillette Department of Mathematics University of Arizona ASU Computational and Applied Math Seminar Slides and more info at: http://math.arizona.edu/

More information

A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation

A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation Amir Nejat * and Carl Ollivier-Gooch Department of Mechanical Engineering, The University of British Columbia, BC V6T 1Z4, Canada

More information

FEMLAB Exercise 1 for ChE366

FEMLAB Exercise 1 for ChE366 FEMLAB Exercise 1 for ChE366 Problem statement Consider a spherical particle of radius r s moving with constant velocity U in an infinitely long cylinder of radius R that contains a Newtonian fluid. Let

More information

The Immersed Interface Method

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

More information

Generative Part Structural Analysis Fundamentals

Generative Part Structural Analysis Fundamentals CATIA V5 Training Foils Generative Part Structural Analysis Fundamentals Version 5 Release 19 September 2008 EDU_CAT_EN_GPF_FI_V5R19 About this course Objectives of the course Upon completion of this course

More information

A modified Q4/Q4 element for topology optimization

A modified Q4/Q4 element for topology optimization Struct Multidisc Optim (009) 7:55 6 DOI 0.007/s0058-008-08-5 RESEARCH PAPER A modified Q/Q element for topology optimization Glaucio H. Paulino Chau H. Le Received: November 005 / Revised: 9 November 007

More information

ArchitecturAl AnD structural Design collaboration At som. Keith BesseruD, neil KAtZ AnD AlessAnDro Beghini

ArchitecturAl AnD structural Design collaboration At som. Keith BesseruD, neil KAtZ AnD AlessAnDro Beghini Article 05 48 structural emergence ArchitecturAl AnD structural Design collaboration At som Keith BesseruD, neil KAtZ AnD AlessAnDro Beghini At Skidmore, Owings & Merrill (SOM) there is a strong culture

More information

Parallel High-Order Geometric Multigrid Methods on Adaptive Meshes for Highly Heterogeneous Nonlinear Stokes Flow Simulations of Earth s Mantle

Parallel High-Order Geometric Multigrid Methods on Adaptive Meshes for Highly Heterogeneous Nonlinear Stokes Flow Simulations of Earth s Mantle ICES Student Forum The University of Texas at Austin, USA November 4, 204 Parallel High-Order Geometric Multigrid Methods on Adaptive Meshes for Highly Heterogeneous Nonlinear Stokes Flow Simulations of

More information

Discrete geometry. Lecture 2. Alexander & Michael Bronstein tosca.cs.technion.ac.il/book

Discrete geometry. Lecture 2. Alexander & Michael Bronstein tosca.cs.technion.ac.il/book Discrete geometry Lecture 2 Alexander & Michael Bronstein tosca.cs.technion.ac.il/book Numerical geometry of non-rigid shapes Stanford University, Winter 2009 The world is continuous, but the mind is discrete

More information

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 36

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 36 Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras Lecture - 36 In last class, we have derived element equations for two d elasticity problems

More information

In this problem, we will demonstrate the following topics:

In this problem, we will demonstrate the following topics: Z Periodic boundary condition 1 1 0.001 Periodic boundary condition 2 Y v V cos t, V 1 0 0 The second Stokes problem is 2D fluid flow above a plate that moves horizontally in a harmonic manner, schematically

More information

Internal Forces and Moments

Internal Forces and Moments Introduction Internal Forces and Moments To a very large extend this chapter is simply an extension of Section 6.3, The Method of Sections. The section on curved cables is new material. The section on

More information

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

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

More information

Driven Cavity Example

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

More information

AS 5850 Finite Element Analysis

AS 5850 Finite Element Analysis AS 5850 Finite Element Analysis INTRODUCTION Prof. IIT Madras Goal of engineering computations Perform analysis and design of physical systems and processes subjected to imposed conditions (or loads) and

More information

Application of Finite Volume Method for Structural Analysis

Application of Finite Volume Method for Structural Analysis Application of Finite Volume Method for Structural Analysis Saeed-Reza Sabbagh-Yazdi and Milad Bayatlou Associate Professor, Civil Engineering Department of KNToosi University of Technology, PostGraduate

More information

Explicit and Implicit Coupling Strategies for Overset Grids. Jörg Brunswig, Manuel Manzke, Thomas Rung

Explicit and Implicit Coupling Strategies for Overset Grids. Jörg Brunswig, Manuel Manzke, Thomas Rung Explicit and Implicit Coupling Strategies for s Outline FreSCo+ Grid Coupling Interpolation Schemes Implementation Mass Conservation Examples Lid-driven Cavity Flow Cylinder in a Channel Oscillating Cylinder

More information

Introduction to Design Optimization

Introduction to Design Optimization Introduction to Design Optimization First Edition Krishnan Suresh i Dedicated to my family. They mean the world to me. ii Origins of this Text Preface Like many other textbooks, this text has evolved from

More information

Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models. C. Aberle, A. Hakim, and U. Shumlak

Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models. C. Aberle, A. Hakim, and U. Shumlak Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models C. Aberle, A. Hakim, and U. Shumlak Aerospace and Astronautics University of Washington, Seattle American Physical Society

More information

Numerical studies for Flow Around a Sphere regarding different flow regimes caused by various Reynolds numbers

Numerical studies for Flow Around a Sphere regarding different flow regimes caused by various Reynolds numbers Numerical studies for Flow Around a Sphere regarding different flow regimes caused by various Reynolds numbers R. Jendrny, H. Damanik, O. Mierka, S. Turek Institute of Applied Mathematics (LS III), TU

More information

Comparisons of Compressible and Incompressible Solvers: Flat Plate Boundary Layer and NACA airfoils

Comparisons of Compressible and Incompressible Solvers: Flat Plate Boundary Layer and NACA airfoils Comparisons of Compressible and Incompressible Solvers: Flat Plate Boundary Layer and NACA airfoils Moritz Kompenhans 1, Esteban Ferrer 2, Gonzalo Rubio, Eusebio Valero E.T.S.I.A. (School of Aeronautics)

More information

Two Algorithms for Approximation in Highly Complicated Planar Domains

Two Algorithms for Approximation in Highly Complicated Planar Domains Two Algorithms for Approximation in Highly Complicated Planar Domains Nira Dyn and Roman Kazinnik School of Mathematical Sciences, Tel-Aviv University, Tel-Aviv 69978, Israel, {niradyn,romank}@post.tau.ac.il

More information

Lab - Introduction to Finite Element Methods and MATLAB s PDEtoolbox

Lab - Introduction to Finite Element Methods and MATLAB s PDEtoolbox Scientific Computing III 1 (15) Institutionen för informationsteknologi Beräkningsvetenskap Besöksadress: ITC hus 2, Polacksbacken Lägerhyddsvägen 2 Postadress: Box 337 751 05 Uppsala Telefon: 018 471

More information

iric Software Changing River Science River2D Tutorials

iric Software Changing River Science River2D Tutorials iric Software Changing River Science River2D Tutorials iric Software Changing River Science Confluence of the Colorado River, Blue River and Indian Creek, Colorado, USA 1 TUTORIAL 1: RIVER2D STEADY SOLUTION

More information

Computational Fluid Dynamics in OpenFOAM

Computational Fluid Dynamics in OpenFOAM Computational Fluid Dynamics in OpenFOAM Mesh Generation and Quality Rebecca Gullberg December 1, 2017 TKP 4555 Advanced Process Simulation Abstract In this report, three different mesh generation methods

More information

NUMERICAL COUPLING BETWEEN DEM (DISCRETE ELEMENT METHOD) AND FEA (FINITE ELEMENTS ANALYSIS).

NUMERICAL COUPLING BETWEEN DEM (DISCRETE ELEMENT METHOD) AND FEA (FINITE ELEMENTS ANALYSIS). NUMERICAL COUPLING BETWEEN DEM (DISCRETE ELEMENT METHOD) AND FEA (FINITE ELEMENTS ANALYSIS). Daniel Schiochet Nasato - ESSS Prof. Dr. José Roberto Nunhez Unicamp Dr. Nicolas Spogis - ESSS Fabiano Nunes

More information

Stabilized Finite Element Method for 3D Navier-Stokes Equations with Physical Boundary Conditions

Stabilized Finite Element Method for 3D Navier-Stokes Equations with Physical Boundary Conditions Stabilized Finite Element Method for 3D Navier-Stokes Equations with Physical Boundary Conditions Mohamed Amara, Daniela Capatina, David Trujillo Université de Pau et des Pays de l Adour Laboratoire de

More information

COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE METERING SITUATIONS UNDER ABNORMAL CONFIGURATIONS

COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE METERING SITUATIONS UNDER ABNORMAL CONFIGURATIONS COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE METERING SITUATIONS UNDER ABNORMAL CONFIGURATIONS Dr W. Malalasekera Version 3.0 August 2013 1 COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE

More information

INTERPRETRATION OF DENSITY-BASED TOPOLOGY OPTIMIZATION RESULTS BY MEANS OF A TOPOLOGICAL DATA STRUCTURE

INTERPRETRATION OF DENSITY-BASED TOPOLOGY OPTIMIZATION RESULTS BY MEANS OF A TOPOLOGICAL DATA STRUCTURE INTERPRETRATION OF DENSITY-BASED TOPOLOGY OPTIMIZATION RESULTS BY MEANS OF A TOPOLOGICAL DATA STRUCTURE Hugo B. S. Bruno Department of Civil Engineering PUC-Rio hugobastos@id.uff.br Guilherme C. G. Barros

More information

Outline. Level Set Methods. For Inverse Obstacle Problems 4. Introduction. Introduction. Martin Burger

Outline. Level Set Methods. For Inverse Obstacle Problems 4. Introduction. Introduction. Martin Burger For Inverse Obstacle Problems Martin Burger Outline Introduction Optimal Geometries Inverse Obstacle Problems & Shape Optimization Sensitivity Analysis based on Gradient Flows Numerical Methods University

More information

Outline. follows the structure of the report

Outline. follows the structure of the report Outline follows the structure of the report Introduction Mesh-based Modeling of Cuts Finite Element Simulation for Virtual Cutting Numerical Solvers Meshfree Methods Summary & Application Study Discussion

More information

Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon

Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon Tamal Pramanick 1,a) 1 Department of Mathematics, Indian Institute of Technology Guwahati, Guwahati

More information

STRUCTURAL & MULTIDISCIPLINARY OPTIMIZATION

STRUCTURAL & MULTIDISCIPLINARY OPTIMIZATION STRUCTURAL & MULTIDISCIPLINARY OPTIMIZATION Pierre DUYSINX Patricia TOSSINGS Department of Aerospace and Mechanical Engineering Academic year 2018-2019 1 Course objectives To become familiar with the introduction

More information

AREPO: a moving-mesh code for cosmological hydrodynamical simulations

AREPO: a moving-mesh code for cosmological hydrodynamical simulations AREPO: a moving-mesh code for cosmological hydrodynamical simulations E pur si muove: Galiliean-invariant cosmological hydrodynamical simulations on a moving mesh Springel, 2010 arxiv:0901.4107 Rubens

More information

The Level Set Method applied to Structural Topology Optimization

The Level Set Method applied to Structural Topology Optimization The Level Set Method applied to Structural Topology Optimization Dr Peter Dunning 22-Jan-2013 Structural Optimization Sizing Optimization Shape Optimization Increasing: No. design variables Opportunity

More information