Coupling OpenFOAM and MBDyn with precice coupling tool

Size: px
Start display at page:

Download "Coupling OpenFOAM and MBDyn with precice coupling tool"

Transcription

1 Cite as: Folkersma, M.: Coupling OpenFOAM and MBDyn with precice coupling tool. In Proceedings of CFD with OpenSource Software, 2018, Edited by Nilsson. H., CFD with OpenSource software A course at Chalmers University of Technology Taught by Håkan Nilsson Coupling OpenFOAM and MBDyn with precice coupling tool Developed for foam-extend 3.2 Requires: FOAM-FSI, precice, MBDyn and GMSH Author: Mikko Folkersma Delft University of Technology m.a.m.folkersma@tudelft.nl Peer reviewed by: Anand Ramesh Babu Mohammad Arabnejad Licensed under CC-BY-NC-SA, Disclaimer: This is a student project work, done as part of a course where OpenFOAM and some other OpenSource software are introduced to the students. Any reader should be aware that it might not be free of errors. Still, it might be useful for someone who would like learn some details similar to the ones presented in the report and in the accompanying files. The material has gone through a review process. The role of the reviewer is to go through the tutorial and make sure that it works, that it is possible to follow, and to some extent correct the writing. The reviewer has no responsibility for the contents. January 21, 2019

2 Learning outcomes The reader will learn: How to use it: how to use precice coupling tool how to run multiphysics simulations with precice coupling tool The theory of it: what is a precice adapter and how to implement one How it is implemented: short introduction to the tools that are used for the coupling How to modify it: how to implement a MBDyn adapter to precice. 1

3 Prerequisites The reader is expected to know the following in order to get maximum benefit out of this report: Basic OpenFOAM usage Basic knowledge of Python programming language Basics of fluid-structure interaction (FSI) 2

4 Contents 1 Introduction MBDyn FOAM-FSI library precice precice adapter for MBDyn 6 3 Test problem MBDyn settings FOAM-FSI settings precice settings Results Conclusions 16 3

5 Chapter 1 Introduction In this work, we show how to couple OpenFOAM (foam-extend) and MBDyn [5] softwares with precice coupling tool [2] to form a strongly coupled fluid-structure interaction (FSI) framework for membrane structures. We use an already existing precice adapter for foam-extend and we develop an adapter for MBDyn in this work. The coupled FSI framework is verified by carrying out a simulation on a modified cavity test case which has a flexible membrane at the bottom of the domain. The results are compared with the results of other authors. The solvers and the coupling tool are introduced here briefly. 1.1 MBDyn MBDyn [5] is a multibody dynamics software which supports both rigid and flexible bodies. In this work, we use only the flexible membrane elements to model thin structures which have negligible bending stiffness. MBDyn supports 4-node quadrilateral membrane elements with large (non-linear) displacements which are based on formulation by Witkowski [8]. The supported material models are linear isotropic and orthotropic. The source code can be downloaded from MBDyn s website Download. The membrane elements require an additional UMFPACK package. On Ubuntu system, it is part of the libsuitesparse-dev package which can be installed by executing following command sudo apt install libsuitesparse-dev and by defining the path of the library when executing the configure script CPPFLAGS=-I/usr/include/suitesparse./configure make After the library has been compiled the location of the MBDyn Python interface should be added to $PYTHONPATH environmental variable. If MBDyn is installed to the default location then following path should be added to the environmental variable export PYTHONPATH=$PYTHONPATH:/usr/local/mbdyn/libexec/mbpy 1.2 FOAM-FSI library FOAM-FSI is an FSI extension to the foam-extend project (version 3.2) developed by Blom et al. [1]. In this work, we mainly use the radial-basis function (RBF) based mesh deformation and the precice adapter of the library. The library can be installed by downloading the GitHub repository from and by following the installation guide in it. 4

6 1.3. PRECICE CHAPTER 1. INTRODUCTION 1.3 precice Coupling tool precice [2] allows to couple arbitrary amount of solvers to form a partitioned multiphysics framework. FOAM-FSI library includes an old version of precice which is compiled in its installation script. However, a small change is required in the compile precice script (FOAM- FSI/src/thirdParty/compile precice) to compile the Python interface. The Python flags in the file should be changed from python=false to python=true. To carry out a multiphysics simulations with precice, an adapter for each participant solver is required. The adapter is a small piece of code which interfaces the participating solvers with precice. It can be written in any of the supported languages (C/C++, Fortran and Python) and usually requires only minimal changes to the solver s source code, if any at all. In the following Chapter 2, we show how to develop such an adapter for MBDyn. Additionally, a configuration file is required for precice. The configuration file is a simple XML-file which defines the participant solvers, interface meshes, mapping schemes for non-conforming meshes and coupling schemes. An example of a configuration file is given in Chapter 3. 5

7 Chapter 2 precice adapter for MBDyn Although MBDyn is written in C++ programming language, we use the Python interface to couple it with precice. The source code consists of two files, adapter.py and helper.py. Each file has one class declaration: MBDynAdapter and MBDynHelper. MBDynHelper class contains all the functionality to interact with MBDyn and MBDynAdapter is the actual precice adapter. The main member functions of MBDynHelper are following: readmsh (filename): Reads GMSH file (.msh) and creates a Mesh container which has the information about the mesh nodes, the connectivity and the named regions. initializembdyn(): Calls writembdynscript function, executes MBDyn and gives the path to the MBDyn script file as a parameter, creates the MBDyn Python interface, initializes the socket connection to MBDyn. writembdynscript(filename): Writes out the MBDyn script file. The script depends on the Mesh container and two dictionaries: controldict and materialdict. getcellcenters(): Splits each quadrangle element into two triangles and returns their face center coordinates. getnodes(): Returns the current node coordinates of the mesh. setloads(pressure, stresses): Sets the distributed loads. Either uniform loads or an array of loads can be given for each element s face center. Pressure acts always to the normal of each elements face. Stresses are vectors. calcloads(): MBDyn does not support distributed loads so the nodal forces are calculated in this function. solve(converged): Calls calcloads function and executes MBDyn. If converged parameter is set to True then move to the next time step, otherwise continues the current same time step. writevtk(): Writes out a VTK file. The MBDynAdapter class consists of two member functions. The constructor function ( init ) initializes MBDyn and precice. It is given by 1 def init (self, mbdhelper, configfilename = "precice.xml"): 2 self.mbd = mbdhelper 3 self.intf = precice.pysolverinterface("structure_solver", 0, 1) 4 self.intf.configure(configfilename) 5 self.dim = self.intf.getdimensions() 6 nodes = self.mbd.getnodes() 7 6

8 CHAPTER 2. PRECICE ADAPTER FOR MBDYN 8 if self.dim == 2: 9 self.nodesid = np.where(nodes[:,2] < 1e-6) 10 nodes = nodes[self.nodesid] 11 self.nnodes = len(nodes) nmeshid = self.intf.getmeshid("structure_nodes") 14 self.nodevertexids = self.nnodes*[0.0] 15 self.intf.setmeshvertices(nmeshid, self.nnodes,\ 16 np.ravel(nodes[:,:self.dim]), self.nodevertexids) ccs = self.mbd.getcellcenters() 19 self.ncells = len(ccs) 20 cmeshid = self.intf.getmeshid("structure_cellcenters") 21 self.cellvertexids = self.ncells*[0.0] 22 self.intf.setmeshvertices(cmeshid, self.ncells,\ 23 np.ravel(ccs[:,:self.dim]), self.cellvertexids) self.stressesid = self.intf.getdataid("stresses", cmeshid) 26 self.displacementsid = self.intf.getdataid("displacements", nmeshid) self.dt = self.intf.initialize() 29 self.mbd.controldict["timestep"] = self.dt 30 self.mbd.initializembdyn() self.displacements = np.array(self.dim*self.nnodes*[0.0]) if (self.intf.isactionrequired(precice.pyactionwriteinitialdata())): 35 self.intf.writeblockvectordata(self.displacementsid, self.nnodes,\ 36 self.nodevertexids, self.displacements) 37 self.intf.fulfilledaction(precice.pyactionwriteinitialdata()) self.intf.initializedata(); self.stresses = np.array(self.dim*self.ncells*[0.0]) if (self.intf.isreaddataavailable()): 44 self.intf.readblockvectordata(self.stressesid, self.ncells,\ 45 self.cellvertexids, self.stresses) The function takes two parameters mbdhelper and configfilename (line 1). mbdhelper is an instance of MBDynHelper class which initializes the MBDyn case and configfilename is the path to the precice configuration file. The precice interface is created in line 3. The PySolverInterface object takes as an argument the solver name which is defined in the configuration file. In this case it refers to MBDyn. This adapter works only in serial mode and therefore the other two parameters, rank and size are set to 0 and 1. Two meshes are used at the interface. MBDyn calculates the displacements at the nodes and the adapter calculates the nodal forces from the stresses that are acting at the face centers (CellCenters). In case of quasi two-dimensional problem such as the present test problem 3, the nodes outside z = 0 plane and the z-coordinates of the nodes are deleted (lines 8-10). The nodes and the face center coordinates are passed to the precice interface as one-dimensional arrays (lines 15-23). The displacements array is initialized with zero values and passed to the precice interface (lines 34-39). The initial stresses are read from the interface (lines 43-45). The runprecice member function begins the simulation. The function is given by 7

9 CHAPTER 2. PRECICE ADAPTER FOR MBDYN 1 def runprecice(self): 2 iteration = 0 3 previousdisplacements = self.mbd.getdisplacements() 4 while (self.intf.iscouplingongoing()): 5 if (self.intf.isactionrequired(precice.pyactionwriteiterationcheckpoint())): 6 self.intf.fulfilledaction(precice.pyactionwriteiterationcheckpoint()) 7 8 if self.dim == 2: 9 s = np.zeros((self.ncells,3)) 10 s[:,:self.dim] = np.reshape(self.stresses,(-1,self.dim)) 11 else: 12 s = np.reshape(self.stresses,(-1,3)) 13 self.mbd.setloads(0,s) if self.mbd.solve(false): 16 break displacements = self.mbd.getdisplacements() 19 reldisplacements = displacements - previousdisplacements 20 if self.dim == 2: 21 reldisplacements = displacements[self.nodesid][:,:self.dim] 22 self.intf.writeblockvectordata(self.displacementsid, self.nnodes,\ 23 self.nodevertexids, np.ravel(reldisplacements)) self.intf.advance(self.dt) 26 self.intf.readblockvectordata(self.stressesid, self.ncells,\ 27 1self.cellVertexIDs, self.stresses) if (self.intf.isactionrequired(precice.pyactionreaditerationcheckpoint())): 30 self.intf.fulfilledaction(precice.pyactionreaditerationcheckpoint()) 31 else: 32 previousdisplacements = displacements.copy() 33 iteration += 1 34 if self.mbd.solve(true): 35 break 36 if iteration % self.mbd.controldict["output frequency"] == 0: 37 self.mbd.writevtk(iteration) 38 mbd.finalize() FOAM-FSI works with relative displacements to the previous time step and therefore the initial displacements are saved (Line 3). The main iteration loop of the simulation is a while loop with an end condition that asks from the precice interface if the simulation should still continue (line 4). In implicit coupling the initial state of the time step is saved (lines 5-6). MBDyn does not have save/recover solution functionality and therefore nothing is saved. The implicit coupling is handled by a simple boolean parameter which is passed with the solve function call (Line 15). MBDyn works only with three-dimensional space coordinates and therefore the stresses have to be also always given in three-dimension (lines 8-10). Also, the third-dimension is removed from the displacements array (lines 20-21). The stress loads are set with setloads function (line 13) and the solution is calculated with solve function (15-16) which takes one boolean parameter. The False parameter means that the solver did not converge in the previous iteration and the True parameter means that the solver has converged and MBDyn will start a new time step. If the return value of the solve function is True then the socket connection to MBDyn has been lost. The resulting displacements are read from the MBDyn solver and passed to the precice interface (lines 18-23). The advance function communicates the coupling data (line 25) and the new stresses are read 8

10 CHAPTER 2. PRECICE ADAPTER FOR MBDYN from the interface (line 26-27). At the end of the loop, the convergence of the implicit coupling is checked (lines 29-37). If the solver has converged, the solve function is called with True parameter and the output is written to the disk (lines 31-37). The adapter can be used in any location by adding the mbdynadapter folder to $PYTHONPATH environmental variable. 9

11 Chapter 3 Test problem We verify the MBDyn adapter implementation by carrying out a modified cavity flow test problem. The problem is shown in Figure 3.1. In the conventional cavity test case, the top wall of the square has a constant velocity and the three other walls have zero velocity. In this modified version, the bottom wall is a flexible membrane which deforms. Additionally, the top part of the left wall has an inflow with linear velocity profile and the top part of the right wall has a small outflow. The velocity of the top wall and the inlet is changing sinusoidally which is given by ( ) 2πt v = 1 cos (3.1) 5 v=v x v=v, x v=0 y p= v=0 x v=0 y v=0 x v=0 y v= 0, v= 0 x y bottommembrane Figure 3.1: Modified cavity problem with membrane [7]. The directory tree of the problem is following 10

12 3.1. MBDYN SETTINGS CHAPTER 3. TEST PROBLEM Allclean Allrun fluid 0 p U constant couplingproperties dynamicmeshdict fsi.yaml polymesh blockmeshdict precice.xml transportproperties turbulenceproperties system controldict fvschemes fvsolution structure cavityfsi.py membrane.geo precice.xml ->../fluid/constant/precice.xml 3.1 MBDyn settings The structural mesh is generated with GMSH software [4]. Although the problem could be solved by using one-dimensional beam elements, we are using membrane elements and therefore the mesh is two-dimensional and expands in z-direction. The mesh is divided into 23 cells in x-direction. The boundary conditions for the structure are given in the GMSH script file by giving names for the physical entities. Following names are recognized: fixx, fixy, fixz, fixxy, fixxz, fixyz, fixall. The membrane.geo file located in the case directory is given as follows Point(1) = {0, 0, 0, 1}; Point(2) = {1, 0, 0, 1}; Point(3) = {1, 0, 1, 1}; Point(4) = {0, 0, 1, 1}; Line(1) = {1, 2}; Line(2) = {2, 3}; Line(3) = {3, 4}; Line(4) = {4, 1}; Line Loop(6) = {1, 2, 3, 4}; Plane Surface(6) = {6}; Transfinite Surface {6}; Transfinite Line {1,3} = 24 Using Progression 1; Transfinite Line {2,4} = 2 Using Progression 1; Recombine Surface {6}; Physical Line("fixAll") = {2,4}; Physical Surface("Membrane") = {6}; The Python script (cavityfsi.py) for the MBDyn adapter is following 1 from mbdynadapter import MBDynHelper, MBDynAdapter 2 mbd = MBDynHelper() 3 mbd.readmsh('membrane.msh') 4 mbd.controldict = {'initialtime':0,'finaltime':100,'output frequency':10} 11

13 3.2. FOAM-FSI SETTINGS CHAPTER 3. TEST PROBLEM 5 mbd.materialdict = {'E':250, 'nu':0, 't':0.002, 'rho':500, 'C': } 6 adapter = MBDynAdapter(mbd) 7 adapter.runprecice() where E is the Young s modulus, nu is the Poisson s ratio (ν), t is the thickness, rho is the density (ρ) of the membrane and C is the damping coefficient. 3.2 FOAM-FSI settings The CFD mesh for the fluid is generated with the blockmesh utility which is part of the foam-extend package. blockmesh generates structured multi-block hexahedron meshes and it is controlled by a dictionary file blockmeshdict which is located in fluid/constant/polymesh/ folder. The mesh for the cavity case is a simple cartesian mesh which is divided in two blocks for the two boundary conditions at the side walls. The sinusoidally changing velocity boundary condition is implemented by using groovybc library which is also part of the foam-extend package. The velocity boundary conditions for inlet, top wall and bottom wall are given in file fluid/0/u as follows inlet { type groovybc; valueexpression "vector((pos().y-0.875)/0.125*(1.0-cos(2.0*pi*time()/5.0)),0.0,0.0)"; value uniform (0 0 0); } movingwall { type groovybc; valueexpression "vector(1.0-cos(2.0*pi*time()/5.0),0.0,0.0)"; value uniform (0 0 0); } bottomwall { type mymovingwallvelocity; value uniform (0 0 0); } For moving walls, FOAM-FSI has a mymovingwallvelocity boundary condition. Radial basis function based mesh deformation algorithm with adaptive coarsening is used. The mesh deformation settings are defined in fluid/constant/dynamicmeshdict as follows dynamicfvmesh dynamicmotionsolverfvmesh; solver ElRBFMeshMotionSolver; movingpatches ( bottomwall ); staticpatches ( inlet outlet movingwall fixedwalls ); coarseningstrategy AdaptiveCoarsening; interpolation { function TPS; } AdaptiveCoarsening { tol 1e-3; reselectiontol 1e-2; minpoints 100; maxpoints 500; } 12

14 3.3. PRECICE SETTINGS CHAPTER 3. TEST PROBLEM 3.3 precice settings In addition a precice configuration file is needed which is placed for to fluid/constant/precice.xml. The configuration file of the present problem is given by 1 <?xml version="1.0"?> 2 <precice-configuration> 3 4 <solver-interface dimensions="2"> 5 6 <data:vector name="stresses" /> 7 <data:vector name="displacements" /> 8 9 <mesh name="fluid_nodes"> 10 <use-data name="displacements" /> 11 </mesh> <mesh name="fluid_cellcenters"> 14 <use-data name="stresses" /> 15 </mesh> <mesh name="structure_nodes"> 18 <use-data name="displacements" /> 19 </mesh> 20 <mesh name="structure_cellcenters"> 21 <use-data name="stresses" /> 22 </mesh> <participant name="fluid_solver"> 25 <use-mesh name="fluid_nodes" provide="yes" /> 26 <use-mesh name="fluid_cellcenters" provide="yes" /> 27 <use-mesh name="structure_nodes" from="structure_solver" /> 28 <use-mesh name="structure_cellcenters" from="structure_solver" /> 29 <write-data mesh="fluid_cellcenters" name="stresses" /> 30 <read-data mesh="fluid_nodes" name="displacements" /> 31 <mapping:rbf-thin-plate-splines direction="read" from="structure_nodes" 32 to="fluid_nodes" constraint="consistent" timing="initial" y-dead="1" /> 33 <mapping:rbf-thin-plate-splines direction="write" from="fluid_cellcenters" 34 to="structure_cellcenters" constraint="consistent" timing="initial" y-dead="1"/> 35 </participant> <participant name="structure_solver"> 38 <use-mesh name="structure_nodes" provide="yes"/> 39 <use-mesh name="structure_cellcenters" provide="yes"/> 40 <write-data mesh="structure_nodes" name="displacements" /> 41 <read-data mesh="structure_cellcenters" name="stresses" /> 42 </participant> <m2n:sockets from="fluid_solver" to="structure_solver" distribution-type="gather-scatter" /> <coupling-scheme:serial-implicit> 47 <timestep-length value="0.05" /> 48 <max-timesteps value="20000" /> 49 <participants first="fluid_solver" second="structure_solver" /> 50 <exchange data="stresses" from="fluid_solver" mesh="structure_cellcenters" 13

15 3.4. RESULTS CHAPTER 3. TEST PROBLEM 51 to="structure_solver" /> 52 <exchange data="displacements" from="structure_solver" mesh="structure_nodes" 53 to="fluid_solver" /> 54 <relative-convergence-measure limit="1e-4" data="displacements" mesh="structure_nodes" /> 55 <max-iterations value="20" /> 56 <extrapolation-order value="2" /> <post-processing:iqn-ils> 59 <data mesh="structure_nodes" name="displacements" /> 60 <initial-relaxation value="0.001" /> 61 <max-used-iterations value="20" /> 62 <timesteps-reused value="2" /> 63 <filter type="qr1" limit="1e-8" /> 64 </post-processing:iqn-ils> 65 </coupling-scheme:serial-implicit> 66 </solver-interface> 67 </precice-configuration> The dimensions defines the dimension of the coordinates and the variables (line 4). Lines 6 and 7 define the exchanged variables and lines 9-22 define the meshes and which variables are used on them. Four meshes are defined. The displacements are calculated by MBDyn at the nodes and FOAM-FSI deforms the mesh based on the node locations. FOAM-FSI calculates the stresses at the cell centers and therefore the stresses are passed on the face centers. MBDyn adapter calculates the nodal forces from the total force that is acting on an element given by F e = σ e A e (3.2) where σ e is the stress at the center of the face and A e is the area of the face. The participating solvers are defined in the following blocks (Lines 24-43). Fluid Solver and Structure Solver refer to FOAM-FSI and MBDyn respectively. The solver names are given as an argument in the adapter when the interface to precice is generated. The fluid solver uses all the four meshes because the variables are mapped from one mesh to the other on its side. Both solvers provide the coordinates of their meshes. The mapping algorithm is calculated only at the beginning of the simulation and here thin-plate-splines type RBF mapping is used with consistent approach. The mapping is calculated only once at the beginning of the simulation and therefore only the x-direction is used (initially the interface is planar). The mapping in y-direction is neglected by setting y-dead = 1. The structure solver uses only its own two meshes (lines 37-42). The last block defines the coupling scheme (lines 46-65). Here we use an implicit coupling scheme which uses several sub-iterations at each time-step to ensure that the coupled solver has converged. The convergence criteria is the relative displacement with tolerance of The convergence is enhanced by using interface quasi-newton with inverse of the Jacobian from a least-squares model (IQN-ILS) [3] algorithm. 3.4 Results The vertical displacement of the middle node of the present simulation is shown in Figure 3.2. The results are in a good agreement with the simulation results of Valdes [7] and Mok [6]. 14

16 3.4. RESULTS CHAPTER 3. TEST PROBLEM Figure 3.2: Middle node vertical displacement. 15

17 Chapter 4 Conclusions In this work a precice adapter for MBDyn software has been developed. Currently, it only supports membrane elements but it can be rather easily extended for other element supported by MBDyn as well. The implementation was verified by carrying out FSI simulation on modified cavity test case where the bottom of the domain is a flexible membrane. For the fluid side an already existing precice adapter for foam-extend was used. The results showed good agreement. 16

18 Bibliography [1] D. Blom. https: // github. com/ davidsblom/ FOAM-FSI. Accessed: 27 November [2] H. Bungartz et al. precice A fully parallel library for multi-physics surface coupling. In: Computers and Fluids 141 (2016). Advances in Fluid-Structure Interaction, pp issn: doi: url: http: // [3] J. Degroote, K. Bathe, and J. Vierendeels. Performance of a new partitioned procedure versus a monolithic procedure in fluid structure interaction. In: Computers & Structures 87 (2009), pp [4] C. Geuzaine and J. Remacle. Gmsh: a three-dimensional finite element mesh generator with built-in pre- and post-processing facilities. In: International Journal for Numerical Methods in Engineering (2009). [5] P. Masarati, M. Morandini, and P. Mantegazza. An Efficient Formulation for General-Purpose Multibody/Multiphysics Analysis. In: ASME J. Comput. Nonlinear Dyn. 9.4 (2014). [6] D. Mok. Partitionierte Lösungsansätze in der Strukturdynamik und der Fluid-Struktur-Interaktion. PhD thesis. Universität Stuttgart, [7] G. Valdés. Nonlinear Analysis of Orthotropic Membrane and Shell Structures Including Fluid- Structure Interaction. PhD thesis. Universitat Politècnica de Catalunya, [8] W. Witkowski. 4-Node combined shell element with semi-eas-ans strain interpolations in 6-parameter shell theories with drilling degrees of freedom. In: Computational Mechanics 43.2 (2009), pp

19 Study questions and answers 1. Why is it beneficial to use precice for multiphysics coupling? 2. What are the requirements to carry out a multiphysics simulation with precice? 3. What is a precice adapter? 18

Coupling OpenFOAM and MBDyn with precice coupling tool

Coupling OpenFOAM and MBDyn with precice coupling tool Coupling OpenFOAM and MBDyn with precice coupling tool Mikko Folkersma Faculty of Aerospace Engineering Section of Wind Energy Delft University of Technology Delft, The Netherlands Outline 1. Introduction

More information

CFD with OpenFOAM Andreu Oliver González 14/12/2009

CFD with OpenFOAM Andreu Oliver González 14/12/2009 CFD with OpenFOAM Andreu Oliver González 14/12/2009 Introduction Mesh motion approaches and classes Procedure to define a mesh with motion Explanation of dynamicinkjetfvmesh class Modification of dynamicinkjetfvmesh

More information

Problem description. The FCBI-C element is used in the fluid part of the model.

Problem description. The FCBI-C element is used in the fluid part of the model. Problem description This tutorial illustrates the use of ADINA for analyzing the fluid-structure interaction (FSI) behavior of a flexible splitter behind a 2D cylinder and the surrounding fluid in a channel.

More information

OpenFOAM and Third Party Structural Solver for Fluid Structure Interaction Simulations

OpenFOAM and Third Party Structural Solver for Fluid Structure Interaction Simulations OpenFOAM and Third Party Structural Solver for Fluid Structure Interaction Simulations Robert L. Campbell rlc138@arl.psu.edu Fluids and Structural Mechanics Office Applied Research Laboratory The Pennsylvania

More information

Introduction to the Computer Exercices Turbulence: Theory and Modelling R.Z. Szasz, Energy Sciences, LTH Lund University

Introduction to the Computer Exercices Turbulence: Theory and Modelling R.Z. Szasz, Energy Sciences, LTH Lund University Introduction to the Computer Exercices Turbulence: Theory and Modelling R.Z. Szasz, Energy Sciences, LTH Lund University Outline VERY short CFD introduction Steps of problem solving The software used:

More information

Example 24 Spring-back

Example 24 Spring-back Example 24 Spring-back Summary The spring-back simulation of sheet metal bent into a hat-shape is studied. The problem is one of the famous tests from the Numisheet 93. As spring-back is generally a quasi-static

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

Presentation slides for the course CFD with OpenSource Software 2015

Presentation slides for the course CFD with OpenSource Software 2015 Presentation slides for the course CFD with OpenSource Software 2015 Sebastian Kohlstädt Applied Mechanics/Fluid Dynamics, Chalmers University of Technology, Gothenburg, Sweden 2015-12-08 Sebastian Kohlstädt

More information

ixcube 4-10 Brief introduction for membrane and cable systems.

ixcube 4-10 Brief introduction for membrane and cable systems. ixcube 4-10 Brief introduction for membrane and cable systems. ixcube is the evolution of 20 years of R&D in the field of membrane structures so it takes a while to understand the basic features. You must

More information

Pitz-Daily Turbulence Case. Jonathan Russell

Pitz-Daily Turbulence Case. Jonathan Russell Pitz-Daily Turbulence Case Jonathan Russell Content Pitz-Daily Problem 1) Description of the Case 2) Hypothesis 3) Physics of the problem 4) Preprocessing a. Mesh Generation b. Initial/Boundary Conditions

More information

midas NFX 2017R1 Release Note

midas NFX 2017R1 Release Note Total Solution for True Analysis-driven Design midas NFX 2017R1 Release Note 1 midas NFX R E L E A S E N O T E 2 0 1 7 R 1 Major Improvements Midas NFX is an integrated finite element analysis program

More information

Set No. 1 IV B.Tech. I Semester Regular Examinations, November 2010 FINITE ELEMENT METHODS (Mechanical Engineering) Time: 3 Hours Max Marks: 80 Answer any FIVE Questions All Questions carry equal marks

More information

Module 1.5: Moment Loading of a 2D Cantilever Beam

Module 1.5: Moment Loading of a 2D Cantilever Beam Module 1.5: Moment Loading of a D Cantilever Beam Table of Contents Page Number Problem Description Theory Geometry 4 Preprocessor 7 Element Type 7 Real Constants and Material Properties 8 Meshing 9 Loads

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

CHAPTER 4. Numerical Models. descriptions of the boundary conditions, element types, validation, and the force

CHAPTER 4. Numerical Models. descriptions of the boundary conditions, element types, validation, and the force CHAPTER 4 Numerical Models This chapter presents the development of numerical models for sandwich beams/plates subjected to four-point bending and the hydromat test system. Detailed descriptions of the

More information

Solid and shell elements

Solid and shell elements Solid and shell elements Theodore Sussman, Ph.D. ADINA R&D, Inc, 2016 1 Overview 2D and 3D solid elements Types of elements Effects of element distortions Incompatible modes elements u/p elements for incompressible

More information

More tutorials. Håkan Nilsson, Chalmers/ Applied Mechanics/ Fluid Dynamics 67

More tutorials. Håkan Nilsson, Chalmers/ Applied Mechanics/ Fluid Dynamics 67 More tutorials Wewillnowlearnhowtousea(small)numberofusefulutilitiesandlibraries. Some of them are described in the UserGuide and ProgrammersGuide, and some ofthemhavebeendiscussedintheforum. Inyourhomeassignmentyouwillbeaskedtogothroughallthewrittentutorials

More information

Wall thickness= Inlet: Prescribed mass flux. All lengths in meters kg/m, E Pa, 0.3,

Wall thickness= Inlet: Prescribed mass flux. All lengths in meters kg/m, E Pa, 0.3, Problem description Problem 30: Analysis of fluid-structure interaction within a pipe constriction It is desired to analyze the flow and structural response within the following pipe constriction: 1 1

More information

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

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

More information

OpenFOAM case: Mixing

OpenFOAM case: Mixing OpenFOAM case: Mixing nelson.marques@fsdynamics.pt; bruno.santos@fsdynamics.pt 30 th September 1 st October 2017 optim ises you rtec hnology 2 1 1. Case Description Overview Solver selection 2. Meshing

More information

Offshore Platform Fluid Structure Interaction (FSI) Simulation

Offshore Platform Fluid Structure Interaction (FSI) Simulation Offshore Platform Fluid Structure Interaction (FSI) Simulation Ali Marzaban, CD-adapco Murthy Lakshmiraju, CD-adapco Nigel Richardson, CD-adapco Mike Henneke, CD-adapco Guangyu Wu, Chevron Pedro M. Vargas,

More information

Tutorial Four Discretization Part 1

Tutorial Four Discretization Part 1 Discretization Part 1 4 th edition, Jan. 2018 This offering is not approved or endorsed by ESI Group, ESI-OpenCFD or the OpenFOAM Foundation, the producer of the OpenFOAM software and owner of the OpenFOAM

More information

Linear and Nonlinear Analysis of a Cantilever Beam

Linear and Nonlinear Analysis of a Cantilever Beam LESSON 1 Linear and Nonlinear Analysis of a Cantilever Beam P L Objectives: Create a beam database to be used for the specified subsequent exercises. Compare small vs. large displacement analysis. Linear

More information

A FSI tutorial on the axialturbine tutorial case

A FSI tutorial on the axialturbine tutorial case CFD with OpenSource software A course at Chalmers University of Technology Taught by Håkan Nilsson Project work: A FSI tutorial on the axialturbine tutorial case Developed for FOAM-3.1-ext Case files:

More information

Tutorial Ten Residence Time Distribution

Tutorial Ten Residence Time Distribution Residence Time Distribution 4 th edition, Jan. 2018 This offering is not approved or endorsed by ESI Group, ESI-OpenCFD or the OpenFOAM Foundation, the producer of the OpenFOAM software and owner of the

More information

Buckling Analysis of a Thin Plate

Buckling Analysis of a Thin Plate Buckling Analysis of a Thin Plate Outline 1 Description 2 Modeling approach 3 Finite Element Model 3.1 Units 3.2 Geometry definition 3.3 Properties 3.4 Boundary conditions 3.5 Loads 3.6 Meshing 4 Structural

More information

Partitioned strongly coupled Fluid-Structure Interaction

Partitioned strongly coupled Fluid-Structure Interaction Partitioned strongly coupled Fluid-Structure Interaction 7 th OpenFOAM Workshop Darmstadt, Germany Manuel Kosel * 1 and Ulrich Heck 2 1 Center for Computational Engineering Science, RWTH Aachen University,

More information

Coupled Analysis of FSI

Coupled Analysis of FSI Coupled Analysis of FSI Qin Yin Fan Oct. 11, 2008 Important Key Words Fluid Structure Interface = FSI Computational Fluid Dynamics = CFD Pressure Displacement Analysis = PDA Thermal Stress Analysis = TSA

More information

Revision of the SolidWorks Variable Pressure Simulation Tutorial J.E. Akin, Rice University, Mechanical Engineering. Introduction

Revision of the SolidWorks Variable Pressure Simulation Tutorial J.E. Akin, Rice University, Mechanical Engineering. Introduction Revision of the SolidWorks Variable Pressure Simulation Tutorial J.E. Akin, Rice University, Mechanical Engineering Introduction A SolidWorks simulation tutorial is just intended to illustrate where to

More information

Numerical Simulations of Fluid-Structure Interaction Problems using MpCCI

Numerical Simulations of Fluid-Structure Interaction Problems using MpCCI Numerical Simulations of Fluid-Structure Interaction Problems using MpCCI François Thirifay and Philippe Geuzaine CENAERO, Avenue Jean Mermoz 30, B-6041 Gosselies, Belgium Abstract. This paper reports

More information

ANSYS Workbench Guide

ANSYS Workbench Guide ANSYS Workbench Guide Introduction This document serves as a step-by-step guide for conducting a Finite Element Analysis (FEA) using ANSYS Workbench. It will cover the use of the simulation package through

More information

Module 1.6: Distributed Loading of a 2D Cantilever Beam

Module 1.6: Distributed Loading of a 2D Cantilever Beam Module 1.6: Distributed Loading of a 2D Cantilever Beam Table of Contents Page Number Problem Description 2 Theory 2 Geometry 4 Preprocessor 7 Element Type 7 Real Constants and Material Properties 8 Meshing

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

Auto Injector Syringe. A Fluent Dynamic Mesh 1DOF Tutorial

Auto Injector Syringe. A Fluent Dynamic Mesh 1DOF Tutorial Auto Injector Syringe A Fluent Dynamic Mesh 1DOF Tutorial 1 2015 ANSYS, Inc. June 26, 2015 Prerequisites This tutorial is written with the assumption that You have attended the Introduction to ANSYS Fluent

More information

CHAPTER 6 EXPERIMENTAL AND FINITE ELEMENT SIMULATION STUDIES OF SUPERPLASTIC BOX FORMING

CHAPTER 6 EXPERIMENTAL AND FINITE ELEMENT SIMULATION STUDIES OF SUPERPLASTIC BOX FORMING 113 CHAPTER 6 EXPERIMENTAL AND FINITE ELEMENT SIMULATION STUDIES OF SUPERPLASTIC BOX FORMING 6.1 INTRODUCTION Superplastic properties are exhibited only under a narrow range of strain rates. Hence, it

More information

Finite Element Analysis Using NEi Nastran

Finite Element Analysis Using NEi Nastran Appendix B Finite Element Analysis Using NEi Nastran B.1 INTRODUCTION NEi Nastran is engineering analysis and simulation software developed by Noran Engineering, Inc. NEi Nastran is a general purpose finite

More information

CE366/ME380 Finite Elements in Applied Mechanics I Fall 2007

CE366/ME380 Finite Elements in Applied Mechanics I Fall 2007 CE366/ME380 Finite Elements in Applied Mechanics I Fall 2007 FE Project 1: 2D Plane Stress Analysis of acantilever Beam (Due date =TBD) Figure 1 shows a cantilever beam that is subjected to a concentrated

More information

Aero-Vibro Acoustics For Wind Noise Application. David Roche and Ashok Khondge ANSYS, Inc.

Aero-Vibro Acoustics For Wind Noise Application. David Roche and Ashok Khondge ANSYS, Inc. Aero-Vibro Acoustics For Wind Noise Application David Roche and Ashok Khondge ANSYS, Inc. Outline 1. Wind Noise 2. Problem Description 3. Simulation Methodology 4. Results 5. Summary Thursday, October

More information

Project work for the PhD course in OpenFOAM

Project work for the PhD course in OpenFOAM Project work for the PhD course in OpenFOAM A tutorial on how to use Dynamic Mesh solver IcoDyMFOAM Performed by: Pirooz Moradnia Contact: pirooz.moradnia@forbrf.lth.se Spring 2008, Göteborg-Sweden Introduction:

More information

Multi-Step Analysis of a Cantilever Beam

Multi-Step Analysis of a Cantilever Beam LESSON 4 Multi-Step Analysis of a Cantilever Beam LEGEND 75000. 50000. 25000. 0. -25000. -50000. -75000. 0. 3.50 7.00 10.5 14.0 17.5 21.0 Objectives: Demonstrate multi-step analysis set up in MSC/Advanced_FEA.

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

ANSYS 5.6 Tutorials Lecture # 2 - Static Structural Analysis

ANSYS 5.6 Tutorials Lecture # 2 - Static Structural Analysis R50 ANSYS 5.6 Tutorials Lecture # 2 - Static Structural Analysis Example 1 Static Analysis of a Bracket 1. Problem Description: The objective of the problem is to demonstrate the basic ANSYS procedures

More information

Post-processing utilities in Elmer

Post-processing utilities in Elmer Post-processing utilities in Elmer Peter Råback ElmerTeam CSC IT Center for Science PATC course on parallel workflows Stockholm, 4-6.12.2013 Alternative postprocessors for Elmer Open source ElmerPost Postprocessor

More information

2008 International ANSYS Conference

2008 International ANSYS Conference 2008 International ANSYS Conference Simulation of Added Mass Effect on Disc Vibrating in Fluid Using Fluid-Structure Interaction Coupling of ANSYS/CFX QIAN LIKE ANSYS Japan K.K. 2008 ANSYS, Inc. All rights

More information

CHAPTER-10 DYNAMIC SIMULATION USING LS-DYNA

CHAPTER-10 DYNAMIC SIMULATION USING LS-DYNA DYNAMIC SIMULATION USING LS-DYNA CHAPTER-10 10.1 Introduction In the past few decades, the Finite Element Method (FEM) has been developed into a key indispensable technology in the modeling and simulation

More information

FINITE ELEMENT ANALYSIS OF A COMPOSITE CATAMARAN

FINITE ELEMENT ANALYSIS OF A COMPOSITE CATAMARAN NAFEMS WORLD CONGRESS 2013, SALZBURG, AUSTRIA FINITE ELEMENT ANALYSIS OF A COMPOSITE CATAMARAN Dr. C. Lequesne, Dr. M. Bruyneel (LMS Samtech, Belgium); Ir. R. Van Vlodorp (Aerofleet, Belgium). Dr. C. Lequesne,

More information

PATCH TEST OF HEXAHEDRAL ELEMENT

PATCH TEST OF HEXAHEDRAL ELEMENT Annual Report of ADVENTURE Project ADV-99- (999) PATCH TEST OF HEXAHEDRAL ELEMENT Yoshikazu ISHIHARA * and Hirohisa NOGUCHI * * Mitsubishi Research Institute, Inc. e-mail: y-ishi@mri.co.jp * Department

More information

Smooth finite elements

Smooth finite elements Smooth finite elements seamless handling of incompressibility, distorted and polygonal meshes; links with equilibrium methods Stéphane Bordas * Nguyen-Xuan Hung ** Nguyen-Dang Hung *** * University of

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

ME 475 FEA of a Composite Panel

ME 475 FEA of a Composite Panel ME 475 FEA of a Composite Panel Objectives: To determine the deflection and stress state of a composite panel subjected to asymmetric loading. Introduction: Composite laminates are composed of thin layers

More information

VOLCANIC DEFORMATION MODELLING: NUMERICAL BENCHMARKING WITH COMSOL

VOLCANIC DEFORMATION MODELLING: NUMERICAL BENCHMARKING WITH COMSOL VOLCANIC DEFORMATION MODELLING: NUMERICAL BENCHMARKING WITH COMSOL The following is a description of the model setups and input/output parameters for benchmarking analytical volcanic deformation models

More information

Performance of Implicit Solver Strategies on GPUs

Performance of Implicit Solver Strategies on GPUs 9. LS-DYNA Forum, Bamberg 2010 IT / Performance Performance of Implicit Solver Strategies on GPUs Prof. Dr. Uli Göhner DYNAmore GmbH Stuttgart, Germany Abstract: The increasing power of GPUs can be used

More information

CEE 618 Scientific Parallel Computing (Lecture 10)

CEE 618 Scientific Parallel Computing (Lecture 10) 1 / 20 CEE 618 Scientific Parallel Computing (Lecture 10) Computational Fluid Mechanics using OpenFOAM: Cavity (2) Albert S. Kim Department of Civil and Environmental Engineering University of Hawai i

More information

MASSACHUSETTS INSTITUTE OF TECHNOLOGY. Analyzing wind flow around the square plate using ADINA Project. Ankur Bajoria

MASSACHUSETTS INSTITUTE OF TECHNOLOGY. Analyzing wind flow around the square plate using ADINA Project. Ankur Bajoria MASSACHUSETTS INSTITUTE OF TECHNOLOGY Analyzing wind flow around the square plate using ADINA 2.094 - Project Ankur Bajoria May 1, 2008 Acknowledgement I would like to thank ADINA R & D, Inc for the full

More information

AM119: Yet another OpenFoam tutorial

AM119: Yet another OpenFoam tutorial AM119: Yet another OpenFoam tutorial Prof. Trask April 11, 2016 1 Todays project Today we re going to implement a projection method for the Navier-Stokes, learn how to build a mesh, and explore the difference

More information

Linear Bifurcation Buckling Analysis of Thin Plate

Linear Bifurcation Buckling Analysis of Thin Plate LESSON 13a Linear Bifurcation Buckling Analysis of Thin Plate Objectives: Construct a quarter model of a simply supported plate. Place an edge load on the plate. Run an Advanced FEA bifurcation buckling

More information

Introduction to 2 nd -order Lagrangian Element in LS-DYNA

Introduction to 2 nd -order Lagrangian Element in LS-DYNA Introduction to 2 nd -order Lagrangian Element in LS-DYNA Hailong Teng Livermore Software Technology Corporation Nov, 2017 Motivation Users are requesting higher order elements for implicit. Replace shells.

More information

EXACT BUCKLING SOLUTION OF COMPOSITE WEB/FLANGE ASSEMBLY

EXACT BUCKLING SOLUTION OF COMPOSITE WEB/FLANGE ASSEMBLY EXACT BUCKLING SOLUTION OF COMPOSITE WEB/FLANGE ASSEMBLY J. Sauvé 1*, M. Dubé 1, F. Dervault 2, G. Corriveau 2 1 Ecole de technologie superieure, Montreal, Canada 2 Airframe stress, Advanced Structures,

More information

Exercise 1. 3-Point Bending Using the GUI and the Bottom-up-Method

Exercise 1. 3-Point Bending Using the GUI and the Bottom-up-Method Exercise 1 3-Point Bending Using the GUI and the Bottom-up-Method Contents Learn how to... 1 Given... 2 Questions... 2 Taking advantage of symmetries... 2 A. Preprocessor (Setting up the Model)... 3 A.1

More information

Acceleration of partitioned fluid-structure interaction simulations by means of space mapping

Acceleration of partitioned fluid-structure interaction simulations by means of space mapping Master of Science Thesis Acceleration of partitioned fluid-structure interaction simulations by means of space mapping An analysis of suitable approaches March 28, 2012 Ad Acceleration of partitioned

More information

Tutorial Fourteen Sampling

Tutorial Fourteen Sampling Sampling 4 th edition, Jan. 2018 This offering is not approved or endorsed by ESI Group, ESI-OpenCFD or the OpenFOAM Foundation, the producer of the OpenFOAM software and owner of the OpenFOAM trademark.

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

Elfini Solver Verification

Elfini Solver Verification Page 1 Elfini Solver Verification Preface Using this Guide Where to Find More Information Conventions What's new User Tasks Static Analysis Cylindrical Roof Under its Own Weight Morley's Problem Twisted

More information

Contributions to the Turbomachinery Working Group: Case Study: Single-Channel Pump & Function Object: turboperformance

Contributions to the Turbomachinery Working Group: Case Study: Single-Channel Pump & Function Object: turboperformance Contributions to the Turbomachinery Working Group: : & Function Object: M. Auvinen 1, N. Pedersen 2, K. Dahl 2, H. Nilsson 3 1 Department of Applied Mechanics, Fluid Mechanics Aalto University 2 Structural

More information

Mutltiphysics for Ironcad Demonstration Models (Rev. 1.1)

Mutltiphysics for Ironcad Demonstration Models (Rev. 1.1) Centrifuge Model The centrifuge model demonstrates how to perform a rotational spinning centrifugal load analysis. It also demonstrates how to group different parts with/without the intended initial bonding

More information

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Vol. 12, Issue 1/2016, 63-68 DOI: 10.1515/cee-2016-0009 MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Juraj MUŽÍK 1,* 1 Department of Geotechnics, Faculty of Civil Engineering, University

More information

Revised Sheet Metal Simulation, J.E. Akin, Rice University

Revised Sheet Metal Simulation, J.E. Akin, Rice University Revised Sheet Metal Simulation, J.E. Akin, Rice University A SolidWorks simulation tutorial is just intended to illustrate where to find various icons that you would need in a real engineering analysis.

More information

CHAPTER 4 CFD AND FEA ANALYSIS OF DEEP DRAWING PROCESS

CHAPTER 4 CFD AND FEA ANALYSIS OF DEEP DRAWING PROCESS 54 CHAPTER 4 CFD AND FEA ANALYSIS OF DEEP DRAWING PROCESS 4.1 INTRODUCTION In Fluid assisted deep drawing process the punch moves in the fluid chamber, the pressure is generated in the fluid. This fluid

More information

Recent Advances on Higher Order 27-node Hexahedral Element in LS-DYNA

Recent Advances on Higher Order 27-node Hexahedral Element in LS-DYNA 14 th International LS-DYNA Users Conference Session: Simulation Recent Advances on Higher Order 27-node Hexahedral Element in LS-DYNA Hailong Teng Livermore Software Technology Corp. Abstract This paper

More information

Simulating Sinkage & Trim for Planing Boat Hulls. A Fluent Dynamic Mesh 6DOF Tutorial

Simulating Sinkage & Trim for Planing Boat Hulls. A Fluent Dynamic Mesh 6DOF Tutorial Simulating Sinkage & Trim for Planing Boat Hulls A Fluent Dynamic Mesh 6DOF Tutorial 1 Introduction Workshop Description This workshop describes how to perform a transient 2DOF simulation of a planing

More information

3D Finite Element Software for Cracks. Version 3.2. Benchmarks and Validation

3D Finite Element Software for Cracks. Version 3.2. Benchmarks and Validation 3D Finite Element Software for Cracks Version 3.2 Benchmarks and Validation October 217 1965 57 th Court North, Suite 1 Boulder, CO 831 Main: (33) 415-1475 www.questintegrity.com http://www.questintegrity.com/software-products/feacrack

More information

Tutorial Turbulent Flow and Minor Loss through a Pipe Elbow, Page 1 Pointwise to OpenFOAM Tutorial Minor Losses through a Pipe Elbow

Tutorial Turbulent Flow and Minor Loss through a Pipe Elbow, Page 1 Pointwise to OpenFOAM Tutorial Minor Losses through a Pipe Elbow Tutorial Turbulent Flow and Minor Loss through a Pipe Elbow, Page 1 Pointwise to OpenFOAM Tutorial Minor Losses through a Pipe Elbow Introduction This tutorial provides instructions for meshing an internal

More information

Dynamic Modeling of Mooring Lines Using a FSI Solver Based on OpenFOAM

Dynamic Modeling of Mooring Lines Using a FSI Solver Based on OpenFOAM Dynamic Modeling of Mooring Lines Using a FSI Solver Based on OpenFOAM 3RD Northern Germany OpenFOAM User Meeting 2015 Author: E-mail Co-Authors: H. G. Matthies, C. Borri 3 Northern Germany OpenFOAM User

More information

Using the Workbench LS-DYNA Extension

Using the Workbench LS-DYNA Extension Using the Workbench LS-DYNA Extension ANSYS, Inc. Southpointe 2600 ANSYS Drive Canonsburg, PA 15317 ansysinfo@ansys.com http://www.ansys.com (T) 724-746-3304 (F) 724-514-9494 Release 18.1 April 2017 ANSYS,

More information

The Durham gmsh Tutorial

The Durham gmsh Tutorial Introduction The Durham This provides a short step by step guide to meshing an aerofoil using the gmsh package. The aim being to introduce you the important features of the program in the shortest possible

More information

Mesh generation using blockmesh. blockmesh

Mesh generation using blockmesh. blockmesh Mesh generation using blockmesh blockmesh blockmesh is a multi-block mesh generator. For simple geometries, the mesh generation utility blockmesh can be used. The mesh is generated from a dictionary file

More information

Conjugate Simulations and Fluid-Structure Interaction In OpenFOAM

Conjugate Simulations and Fluid-Structure Interaction In OpenFOAM Conjugate Simulations and Fluid-Structure Interaction In OpenFOAM Hrvoje Jasak h.jasak@wikki.co.uk Wikki Ltd, United Kingdom and FSB, University of Zagreb, Croatia 7-9th June 2007 Conjugate Simulations

More information

Sliding Split Tube Telescope

Sliding Split Tube Telescope LESSON 15 Sliding Split Tube Telescope Objectives: Shell-to-shell contact -accounting for shell thickness. Creating boundary conditions and loads by way of rigid surfaces. Simulate large displacements,

More information

Flow and Heat Transfer in a Mixing Elbow

Flow and Heat Transfer in a Mixing Elbow Flow and Heat Transfer in a Mixing Elbow Objectives The main objectives of the project are to learn (i) how to set up and perform flow simulations with heat transfer and mixing, (ii) post-processing and

More information

A family of triangular and tetrahedral elements with rotational degrees of freedom

A family of triangular and tetrahedral elements with rotational degrees of freedom Acta Mech 229, 901 910 2018) https://doi.org/10.1007/s00707-017-2045-7 ORIGINAL PAPER Christian Bucher A family of triangular and tetrahedral elements with rotational degrees of freedom This paper is dedicated

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

Use 6DOF solver to calculate motion of the moving body. Create TIFF files for graphic visualization of the solution.

Use 6DOF solver to calculate motion of the moving body. Create TIFF files for graphic visualization of the solution. Introduction The purpose of this tutorial is to provide guidelines and recommendations for setting up and solving a moving deforming mesh (MDM) case along with the six degree of freedom (6DOF) solver and

More information

Module 1: Introduction to Finite Element Analysis. Lecture 4: Steps in Finite Element Analysis

Module 1: Introduction to Finite Element Analysis. Lecture 4: Steps in Finite Element Analysis 25 Module 1: Introduction to Finite Element Analysis Lecture 4: Steps in Finite Element Analysis 1.4.1 Loading Conditions There are multiple loading conditions which may be applied to a system. The load

More information

A MODELING METHOD OF CURING DEFORMATION FOR CFRP COMPOSITE STIFFENED PANEL WANG Yang 1, GAO Jubin 1 BO Ma 1 LIU Chuanjun 1

A MODELING METHOD OF CURING DEFORMATION FOR CFRP COMPOSITE STIFFENED PANEL WANG Yang 1, GAO Jubin 1 BO Ma 1 LIU Chuanjun 1 21 st International Conference on Composite Materials Xi an, 20-25 th August 2017 A MODELING METHOD OF CURING DEFORMATION FOR CFRP COMPOSITE STIFFENED PANEL WANG Yang 1, GAO Jubin 1 BO Ma 1 LIU Chuanjun

More information

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

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

More information

Contribution to numerical modeling of fluidstructure interaction in hydrodynamics applications

Contribution to numerical modeling of fluidstructure interaction in hydrodynamics applications Contribution to numerical modeling of fluidstructure interaction in hydrodynamics applications by Herry Lesmana A thesis submitted in partial fulfilment of the requirements for the degree of Master of

More information

Open Source Software Course: Assignment 1

Open Source Software Course: Assignment 1 Open Source Software Course: Assignment 1 Mengmeng Zhang Aeronautical and Vehicle Engineering, Royal Insistute of Technology (KTH), Stockholm, Sweden 2012-09-09 Mengmeng Zhang Open Source Software Course

More information

Crashbox Tutorial. In this tutorial the focus is on modeling a Formula Student Racecar Crashbox with HyperCrash 12.0

Crashbox Tutorial. In this tutorial the focus is on modeling a Formula Student Racecar Crashbox with HyperCrash 12.0 Crashbox Tutorial In this tutorial the focus is on modeling a Formula Student Racecar Crashbox with HyperCrash 12.0 (Written by Moritz Guenther, student at Altair Engineering GmbH) 1 HyperMesh* 1. Start

More information

Aufgabe 1: Dreipunktbiegung mit ANSYS Workbench

Aufgabe 1: Dreipunktbiegung mit ANSYS Workbench Aufgabe 1: Dreipunktbiegung mit ANSYS Workbench Contents Beam under 3-Pt Bending [Balken unter 3-Pkt-Biegung]... 2 Taking advantage of symmetries... 3 Starting and Configuring ANSYS Workbench... 4 A. Pre-Processing:

More information

About the Author. Acknowledgements

About the Author. Acknowledgements About the Author Dr. Paul Kurowski obtained his M.Sc. and Ph.D. in Applied Mechanics from Warsaw Technical University. He completed postdoctoral work at Kyoto University. Dr. Kurowski is an Assistant Professor

More information

STAR-CCM+: Wind loading on buildings SPRING 2018

STAR-CCM+: Wind loading on buildings SPRING 2018 STAR-CCM+: Wind loading on buildings SPRING 2018 1. Notes on the software 2. Assigned exercise (submission via Blackboard; deadline: Thursday Week 3, 11 pm) 1. NOTES ON THE SOFTWARE STAR-CCM+ generates

More information

Scuola Politecnica DIME

Scuola Politecnica DIME Scuola Politecnica DIME Ingegneria Meccanica - Energia e Aeronautica Anno scolastico 2017-2018 Fluidodinamica Avanzata Aircraft S-shaped duct geometry optimization Professor Jan Pralits Supervisor Joel

More information

Design Optimization of a Weather Radar Antenna using Finite Element Analysis (FEA) and Computational Fluid Dynamics (CFD)

Design Optimization of a Weather Radar Antenna using Finite Element Analysis (FEA) and Computational Fluid Dynamics (CFD) Design Optimization of a Weather Radar Antenna using Finite Element Analysis (FEA) and Computational Fluid Dynamics (CFD) Fernando Prevedello Regis Ataídes Nícolas Spogis Wagner Ortega Guedes Fabiano Armellini

More information

OpenFOAM Library for Fluid Structure Interaction

OpenFOAM Library for Fluid Structure Interaction OpenFOAM Library for Fluid Structure Interaction 9th OpenFOAM Workshop - Zagreb, Croatia Željko Tuković, P. Cardiff, A. Karač, H. Jasak, A. Ivanković University of Zagreb Faculty of Mechanical Engineering

More information

icofsifoam and interfsifoam

icofsifoam and interfsifoam icofsifoam and interfsifoam Constructing solvers for weakly coupled problems using OpenFOAM-1.5-dev Håkan Nilsson, Chalmers / Applied Mechanics / Fluid Dynamics 1 Fluid structure interaction Fluid structure

More information

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

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

More information

The ERCOFTAC centrifugal pump OpenFOAM case study

The ERCOFTAC centrifugal pump OpenFOAM case study The ERCOFTAC centrifugal pump OpenFOAM case study Olivier Petit and Håkan Nilsson Chalmers University of Technology, SVC Maryse Page and Martin Beaudoin Hydro Québec, Research Institute 4 th OpenFOAM workshop

More information

Introduction to Abaqus. About this Course

Introduction to Abaqus. About this Course Introduction to Abaqus R 6.12 About this Course Course objectives Upon completion of this course you will be able to: Use Abaqus/CAE to create complete finite element models. Use Abaqus/CAE to submit and

More information

Figure E3-1 A plane struss structure under applied loading. Start MARC Designer. From the main menu, select STATIC STRESS ANALYSIS.

Figure E3-1 A plane struss structure under applied loading. Start MARC Designer. From the main menu, select STATIC STRESS ANALYSIS. Example 3 Static Stress Analysis on a Plane Truss Structure Problem Statement: In this exercise, you will use MARC Designer software to carry out a static stress analysis on a simple plane truss structure,

More information

Engineering Analysis

Engineering Analysis Engineering Analysis with SOLIDWORKS Simulation 2018 Paul M. Kurowski SDC PUBLICATIONS Better Textbooks. Lower Prices. www.sdcpublications.com Powered by TCPDF (www.tcpdf.org) Visit the following websites

More information