1 Exercise: Heat equation in 2-D with FE

Size: px
Start display at page:

Download "1 Exercise: Heat equation in 2-D with FE"

Transcription

1 1 Exercise: Heat equation in 2-D with FE Reading Hughes (2000, sec Dabrowski et al. (2008, sec. 1-3, 4.1.1, 4.1.3, This FE exercise and most of the following ones are based on the MILAMIN package by Dabrowski et al. (2008 which provides a set of efficient, 2-D Matlab-based FE routines including a thermal and a Stokes fluid solver. Given that the code uses Matlab, MILAMIN is remarkably efficient and certainly a good choice for simple 2-D research problems that lend themselves to FE modeling. You may want to consider working on expanding the MILAMIN capabilities, e.g. by adding advection to the thermal solver and combining it with the Stokes solver for a convection code. Over the next sections, we will discuss all of the issues described in Dabrowski et al. (2008. This paper will be a good additional reference, and the original MILAMIN Matlab codes can be downloaded from (the latter will not be of help with the exercises. 1.1 Implementation of 2-D heat equation We spent the last three sections discussing the fundamentals of finite element analysis building up to the solution of the 2-D, stationary heat equation, which is given by ( κ T + ( κ T = H, (1 x x dz where κ is conductivity (not diffusivity, we use κ to distinguish from the stiffness matrix K, and H are heat sources. Both κ and H may vary in space, and, unlike for FD, the solution domain can now be irregular. The FE approach casts the boundary value problem (boundary conditions are assumed given in the weak (variational form, discretized on elements on which shape functions, N, approximate the solution of the PDE as T. The solution is given by nodal temperatures T = {T A } for all NNOD nodes of the mesh, which can be combined to T(x, z = NNOD A=1 N A (x, zt A. (2 Following, e.g., Hughes (2000, we use the Galerkin approach for which the resulting stiffness matrix components, on an element level, is K e ab = Ω e κe ( Na x USC GEOL557: Modeling Earth Systems 1 x + N a dω. (3

2 Here, a and b are node numbers local to element e, and integration Ω e is over the element area. If we express the spatial coordinates x = {x, z} in a node-local coordinate system ξ = {ξ, η} and use Gaussian quadrature with NINT points and weights W i for integration, we need to evaluate terms of the kind K e ab = K e ab = 1 1 dξ 1 1 dηκ ( Na + N a NINT ( Na N W i κ b i + N a i J 1 j (4 J 1 j (5 where J 1 is the inverse and j = det(j = J the determinant of the Jacobian matrix J = ( x x, (6 respectively. The load vector F has to be assembled on an element basis as Fa e = N ahdω K e ˆT Ω e ab b, (7 where the terms on the right hand side are due to heat sources, H, and a correction due to prescribed temperatures on the boundaries ˆT (zero flux BCs need no specific treatment, see Hughes, 2000, p. 69 and Dabrowski et al. (2008. The global K and F are assembled by looping through all elements and adding up thek e and F e contributions, while eliminating those rows that belong to nodes where essential boundary conditions ( ˆT are supplied. The solution is then obtained from solving Meshing KT = F. (8 Download generate_mesh.m. Start by reading through this Matlab code, it is a modification of the MILAMIN wrapper for triangle. Triangle is a 2-D triangular mesh generator by Shewchuk (2002. That work is freely available as C source code and a flexible, production quality Delaunay mesh generator. A Delaunay mesh is such that all nodes are connected by elements in a way that any circle which is drawn through the three nodes of an element has no other nodes within its circumference. Aside: The dual graph (sort of the graphic opposite of a Delaunay mesh are the Voronoi cells around each node. Those can be constructed based on the triangulation by connecting lines that are orthogonal to each of the triangles sides and centered half-way between nodes. Those two properties are important for computational geometry, inverse theory, and interpolation problems. USC GEOL557: Modeling Earth Systems 2

3 A Delaunay triangulation is the best possible mesh for a given number of nodes in the sense that the triangles are closest to equilateral. For FE analysis, we always strive for nicely shaped elements (i.e. not distorted from their ideal, local coordinate system form so that the J 1 does not go haywire, and j = det(j remains positive. Typically, meshers like triangle will allow you to refine the mesh (i.e. add more nodes for a given boundary structure and overall domain by enforcing minimum area and/or angle constraints. Those refinements may also be iteratively applied based on an initial solution of the PDE, e.g. to refine in local regions of large variations (adaptive mesh refinement, AMR. Exercise Download a test driver for the triangle wrapper, mesher_test.m. You will have to fill in the blanks after reading through generate_mesh.m, and make sure the triangle binary (program is installed on your machine in the directory you are executing your Matlab commands in. Note: For this exercise and those below, please first inspect graphs on the screen while playing with the code, and then only print out a few geometries. 1. Create a triangular grid using three node triangles for the domain 0 x 1, 0 z 1 using minimum area constraint 0.1 and minimum angle 20. Create a print out plot of this mesh highlighting nodes that are on the outer boundary. 2. Change the area constraint to 0.01, remesh, and replot. 3. Use second order triangles and an area constraint of and minimum angle of Using the same quality constraints, create and print out a mesh plot of an elliptical inclusion of radius 0.2, ellipticity 0.8, and 50 nodes on its perimeter. Color the elements of the inclusion differently from those of the exterior. Denote nodes on the boundary of the inclusion. 5. Create and plot a mesh with a circular hole and a circular inclusion of radius Thermal solver Downloadthermal2d_std.m; this is a simplified version of the MILAMIN thermal solver (thermal2d.m which should be easier to read than the version of Dabrowski et al. (2008; it also allows for heat production. Read through this Matlab code and identify the matrix assembly and solution method we discussed in sec Please make sure you take this step seriously. Also download and read through shp_deriv_triangle.m and ip_triangle.m which implement linear (three node and quadratic (six node, triangular shape functions and derivatives, and weights for Gauss quadratures, respectively. USC GEOL557: Modeling Earth Systems 3

4 Exercise 1. Download a rudimentary driver for the mesher and thermal solver, thermal2d_test.m. You will need to fill in the blanks. 2. Generate a regular mesh with area constraint and solve the heat equation with linear shape functions, without heat sources, given no flux on the sides, unity temperature at the bottom, and zero temperature at the top. Plot your results. Use constant conductivity. 3. Place an elliptical inclusion with radius 0.4, ellipticity 0.8, and ten times higher conductivity than the ambient material in the medium, and plot the resulting temperatures. Experiment with variable resolutions and second order triangles. Comment on the how the solution changes (visually only is OK. 4. Set the heat production of the inclusion to 10 and 100, and plot the solution. Compare with boundary conditions where zero temperatures are prescribed on all boundary conditions. 5. Compute the temperature as well as the geothermal gradient at a specific location. This exercise is so that you gain experience using shape functions and derivatives of shape functions and requires you to identify the N and N equivalents. USC GEOL557: Modeling Earth Systems 4

5 BIBLIOGRAPHY Bibliography Dabrowski, M., M. Krotkiewski, and D. W. Schmid (2008, MILAMIN: MATLAB-based finite element method solver for large problems, Geochem., Geophys., Geosys., 9(Q04030, doi: /2007gc Hughes, T. J. R. (2000, The finite element method, Dover Publications. Shewchuk, J. R. (2002, Delaunay refinement algorithms for triangular mesh generation, Comput. Geom.: Theor. Appl., 22, USC GEOL557: Modeling Earth Systems 5

1 Exercise: 1-D heat conduction with finite elements

1 Exercise: 1-D heat conduction with finite elements 1 Exercise: 1-D heat conduction with finite elements Reading This finite element example is based on Hughes (2000, sec. 1.1-1.15. 1.1 Implementation of the 1-D heat equation example In the previous two

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

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

AMS527: Numerical Analysis II

AMS527: Numerical Analysis II AMS527: Numerical Analysis II A Brief Overview of Finite Element Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao SUNY Stony Brook AMS527: Numerical Analysis II 1 / 25 Overview Basic concepts Mathematical

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

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

f xx + f yy = F (x, y)

f xx + f yy = F (x, y) Application of the 2D finite element method to Laplace (Poisson) equation; f xx + f yy = F (x, y) M. R. Hadizadeh Computer Club, Department of Physics and Astronomy, Ohio University 4 Nov. 2013 Domain

More information

A complete methodology for the implementation of XFEM models. Team: - Carlos Hernán Villanueva - Kai Yu

A complete methodology for the implementation of XFEM models. Team: - Carlos Hernán Villanueva - Kai Yu A complete methodology for the implementation of XFEM models Team: - Carlos Hernán Villanueva - Kai Yu Problem Statement QUAD4 DISCONTINUITY Problem Statement Traditional FEM Mesh generates discrete representation

More information

Lecture 3.2 Methods for Structured Mesh Generation

Lecture 3.2 Methods for Structured Mesh Generation Lecture 3.2 Methods for Structured Mesh Generation 1 There are several methods to develop the structured meshes: Algebraic methods, Interpolation methods, and methods based on solving partial differential

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

Investigation of a Robust Method for Connecting Dissimilar 3D Finite Element Models. David M. Trujillo 1. December 2005

Investigation of a Robust Method for Connecting Dissimilar 3D Finite Element Models. David M. Trujillo 1. December 2005 Investigation of a Robust Method for Connecting Dissimilar 3D Finite Element Models by David M. Trujillo 1 December 2005 1 Consultant, TRUCOMP, Fountain Valley, California trucomp@earthlink.net Abstract

More information

Computational Fluid Dynamics - Incompressible Flows

Computational Fluid Dynamics - Incompressible Flows Computational Fluid Dynamics - Incompressible Flows March 25, 2008 Incompressible Flows Basis Functions Discrete Equations CFD - Incompressible Flows CFD is a Huge field Numerical Techniques for solving

More information

E(FG) 2 : A NEW FIXED-GRID SHAPE OPTIMIZATION METHOD

E(FG) 2 : A NEW FIXED-GRID SHAPE OPTIMIZATION METHOD University of Nebraska - Lincoln DigitalCommons@University of Nebraska - Lincoln Faculty Publications from the Department of Engineering Mechanics Mechanical & Materials Engineering, Department of 1-1-2006

More information

2D & 3D Finite Element Method Packages of CEMTool for Engineering PDE Problems

2D & 3D Finite Element Method Packages of CEMTool for Engineering PDE Problems 2D & 3D Finite Element Method Packages of CEMTool for Engineering PDE Problems Choon Ki Ahn, Jung Hun Park, and Wook Hyun Kwon 1 Abstract CEMTool is a command style design and analyzing package for scientific

More information

Modeling Skills Thermal Analysis J.E. Akin, Rice University

Modeling Skills Thermal Analysis J.E. Akin, Rice University Introduction Modeling Skills Thermal Analysis J.E. Akin, Rice University Most finite element analysis tasks involve utilizing commercial software, for which you do not have the source code. Thus, you need

More information

SETTLEMENT OF A CIRCULAR FOOTING ON SAND

SETTLEMENT OF A CIRCULAR FOOTING ON SAND 1 SETTLEMENT OF A CIRCULAR FOOTING ON SAND In this chapter a first application is considered, namely the settlement of a circular foundation footing on sand. This is the first step in becoming familiar

More information

Metafor FE Software. 2. Operator split. 4. Rezoning methods 5. Contact with friction

Metafor FE Software. 2. Operator split. 4. Rezoning methods 5. Contact with friction ALE simulations ua sus using Metafor eao 1. Introduction 2. Operator split 3. Convection schemes 4. Rezoning methods 5. Contact with friction 1 Introduction EULERIAN FORMALISM Undistorted mesh Ideal for

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

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

Finite Volume Discretization on Irregular Voronoi Grids

Finite Volume Discretization on Irregular Voronoi Grids Finite Volume Discretization on Irregular Voronoi Grids C.Huettig 1, W. Moore 1 1 Hampton University / National Institute of Aerospace Folie 1 The earth and its terrestrial neighbors NASA Colin Rose, Dorling

More information

How TMG Uses Elements and Nodes

How TMG Uses Elements and Nodes Simulation: TMG Thermal Analysis User's Guide How TMG Uses Elements and Nodes Defining Boundary Conditions on Elements You create a TMG thermal model in exactly the same way that you create any finite

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

Microprocessor Thermal Analysis using the Finite Element Method

Microprocessor Thermal Analysis using the Finite Element Method Microprocessor Thermal Analysis using the Finite Element Method Bhavya Daya Massachusetts Institute of Technology Abstract The microelectronics industry is pursuing many options to sustain the performance

More information

An introduction to mesh generation Part IV : elliptic meshing

An introduction to mesh generation Part IV : elliptic meshing Elliptic An introduction to mesh generation Part IV : elliptic meshing Department of Civil Engineering, Université catholique de Louvain, Belgium Elliptic Curvilinear Meshes Basic concept A curvilinear

More information

Middle East Technical University Mechanical Engineering Department ME 413 Introduction to Finite Element Analysis Spring 2015 (Dr.

Middle East Technical University Mechanical Engineering Department ME 413 Introduction to Finite Element Analysis Spring 2015 (Dr. Middle East Technical University Mechanical Engineering Department ME 413 Introduction to Finite Element Analysis Spring 2015 (Dr. Sert) COMSOL 1 Tutorial 2 Problem Definition Hot combustion gases of a

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

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

3-D Wind Field Simulation over Complex Terrain

3-D Wind Field Simulation over Complex Terrain 3-D Wind Field Simulation over Complex Terrain University Institute for Intelligent Systems and Numerical Applications in Engineering Congreso de la RSME 2015 Soluciones Matemáticas e Innovación en la

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

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

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

More information

Journal of Engineering Research and Studies E-ISSN

Journal of Engineering Research and Studies E-ISSN Journal of Engineering Research and Studies E-ISS 0976-79 Research Article SPECTRAL SOLUTIO OF STEADY STATE CODUCTIO I ARBITRARY QUADRILATERAL DOMAIS Alavani Chitra R 1*, Joshi Pallavi A 1, S Pavitran

More information

Partial Differential Equations

Partial Differential Equations Simulation in Computer Graphics Partial Differential Equations Matthias Teschner Computer Science Department University of Freiburg Motivation various dynamic effects and physical processes are described

More information

Best Practices Workshop: Overset Meshing

Best Practices Workshop: Overset Meshing Best Practices Workshop: Overset Meshing Overview Introduction to Overset Meshes Range of Application Workflow Demonstrations and Best Practices What are Overset Meshes? Overset meshes are also known as

More information

Review of 7 th Grade Geometry

Review of 7 th Grade Geometry Review of 7 th Grade Geometry In the 7 th Grade Geometry we have covered: 1. Definition of geometry. Definition of a polygon. Definition of a regular polygon. Definition of a quadrilateral. Types of quadrilaterals

More information

PROPERTIES OF NATURAL ELEMENT COORDINATES ON ANY POLYHEDRON

PROPERTIES OF NATURAL ELEMENT COORDINATES ON ANY POLYHEDRON PROPRTIS OF NATURAL LMNT COORDINATS ON ANY POLYHDRON P. Milbradt and T. Fröbel Institute of Computer Science in Civil ngineering, Univercity of Hanover, 3067, Hanover, Germany; PH (+49) 5-76-5757; FAX

More information

LAB 4: Introduction to MATLAB PDE Toolbox and SolidWorks Simulation

LAB 4: Introduction to MATLAB PDE Toolbox and SolidWorks Simulation LAB 4: Introduction to MATLAB PDE Toolbox and SolidWorks Simulation Objective: The objective of this laboratory is to introduce how to use MATLAB PDE toolbox and SolidWorks Simulation to solve two-dimensional

More information

Mesh-Free Applications for Static and Dynamically Changing Node Configurations

Mesh-Free Applications for Static and Dynamically Changing Node Configurations Mesh-Free Applications for Static and Dynamically Changing Node Configurations Natasha Flyer Computational Information Systems Lab National Center for Atmospheric Research Boulder, CO Meshes vs. Mesh-free

More information

Möbius Transformations in Scientific Computing. David Eppstein

Möbius Transformations in Scientific Computing. David Eppstein Möbius Transformations in Scientific Computing David Eppstein Univ. of California, Irvine School of Information and Computer Science (including joint work with Marshall Bern from WADS 01 and SODA 03) Outline

More information

Journal of Theoretical and Applied Mechanics, Sofia, 2015, vol. 45, No. 2, pp

Journal of Theoretical and Applied Mechanics, Sofia, 2015, vol. 45, No. 2, pp Journal of Theoretical and Applied Mechanics, Sofia, 2015, vol. 45, No. 2, pp. 59 74 SOLID MECHANICS WAVE PROPAGATION DUE TO AN EMBEDDED SEISMIC SOURCE IN A GRADED HALF-PLANE WITH RELIEF PECULIARITIES.

More information

Practice to Informatics for Energy and Environment

Practice to Informatics for Energy and Environment Practice to Informatics for Energy and Environment Part 3: Finite Elemente Method Example 1: 2-D Domain with Heat Conduction Tutorial by Cornell University https://confluence.cornell.edu/display/simulation/ansys+-+2d+steady+conduction

More information

PorePy: A Python Simulation Tool for Fractured and Deformable Porous Media. Eirik Keilegavlen, Alessio Fumagalli, Runar Berge, Ivar Stefansson

PorePy: A Python Simulation Tool for Fractured and Deformable Porous Media. Eirik Keilegavlen, Alessio Fumagalli, Runar Berge, Ivar Stefansson PorePy: A Python Simulation Tool for Fractured and Deformable Porous Media Eirik Keilegavlen, Alessio Fumagalli, Runar Berge, Ivar Stefansson Summary Meshing and discretization of dynamics in fractured

More information

Jassim Katwan, Osama (2010) Discrete modelling of heat transfer. MSc(R) thesis, University of Glasgow.

Jassim Katwan, Osama (2010) Discrete modelling of heat transfer. MSc(R) thesis, University of Glasgow. Jassim Katwan, Osama (2010) Discrete modelling of heat transfer. MSc(R) thesis, University of Glasgow. http://theses.gla.ac.uk/1602/ Copyright and moral rights for this thesis are retained by the author

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

Surface Parameterization

Surface Parameterization Surface Parameterization A Tutorial and Survey Michael Floater and Kai Hormann Presented by Afra Zomorodian CS 468 10/19/5 1 Problem 1-1 mapping from domain to surface Original application: Texture mapping

More information

Overview of Unstructured Mesh Generation Methods

Overview of Unstructured Mesh Generation Methods Overview of Unstructured Mesh Generation Methods Structured Meshes local mesh points and cells do not depend on their position but are defined by a general rule. Lead to very efficient algorithms and storage.

More information

Introduction to Finite Element Analysis using ANSYS

Introduction to Finite Element Analysis using ANSYS Introduction to Finite Element Analysis using ANSYS Sasi Kumar Tippabhotla PhD Candidate Xtreme Photovoltaics (XPV) Lab EPD, SUTD Disclaimer: The material and simulations (using Ansys student version)

More information

Heat Transfer Analysis of a Pipe

Heat Transfer Analysis of a Pipe LESSON 25 Heat Transfer Analysis of a Pipe 3 Fluid 800 Ambient Temperture Temperture, C 800 500 2 Dia Fluid Ambient 10 20 30 40 Time, s Objectives: Transient Heat Transfer Analysis Model Convection, Conduction

More information

cuibm A GPU Accelerated Immersed Boundary Method

cuibm A GPU Accelerated Immersed Boundary Method cuibm A GPU Accelerated Immersed Boundary Method S. K. Layton, A. Krishnan and L. A. Barba Corresponding author: labarba@bu.edu Department of Mechanical Engineering, Boston University, Boston, MA, 225,

More information

Geostatistics 2D GMS 7.0 TUTORIALS. 1 Introduction. 1.1 Contents

Geostatistics 2D GMS 7.0 TUTORIALS. 1 Introduction. 1.1 Contents GMS 7.0 TUTORIALS 1 Introduction Two-dimensional geostatistics (interpolation) can be performed in GMS using the 2D Scatter Point module. The module is used to interpolate from sets of 2D scatter points

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

Compressible Flow in a Nozzle

Compressible Flow in a Nozzle SPC 407 Supersonic & Hypersonic Fluid Dynamics Ansys Fluent Tutorial 1 Compressible Flow in a Nozzle Ahmed M Nagib Elmekawy, PhD, P.E. Problem Specification Consider air flowing at high-speed through a

More information

METHOD IMPROVEMENTS IN THERMAL ANALYSIS OF MACH 10 LEADING EDGES

METHOD IMPROVEMENTS IN THERMAL ANALYSIS OF MACH 10 LEADING EDGES METHOD IMPROVEMENTS IN THERMAL ANALYSIS OF MACH 10 LEADING EDGES Ruth M. Amundsen National Aeronautics and Space Administration Langley Research Center Hampton VA 23681-2199 ABSTRACT Several improvements

More information

Free Convection Cookbook for StarCCM+

Free Convection Cookbook for StarCCM+ ME 448/548 February 28, 2012 Free Convection Cookbook for StarCCM+ Gerald Recktenwald gerry@me.pdx.edu 1 Overview Figure 1 depicts a two-dimensional fluid domain bounded by a cylinder of diameter D. Inside

More information

Isogeometric Collocation Method

Isogeometric Collocation Method Chair for Computational Analysis of Technical Systems Faculty of Mechanical Engineering, RWTH Aachen University Isogeometric Collocation Method Seminararbeit By Marko Blatzheim Supervisors: Dr. Stefanie

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

Basic Programming with Elmer Mikko Lyly Spring 2010

Basic Programming with Elmer Mikko Lyly Spring 2010 Basic Programming with Elmer Mikko Lyly Spring 2010 1 User defined functions 1.1 Calling convention User defined functions (udf) can be used to compute complicated material parameters, body forces, boundary

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

Index. C m (Ω), 141 L 2 (Ω) space, 143 p-th order, 17

Index. C m (Ω), 141 L 2 (Ω) space, 143 p-th order, 17 Bibliography [1] J. Adams, P. Swarztrauber, and R. Sweet. Fishpack: Efficient Fortran subprograms for the solution of separable elliptic partial differential equations. http://www.netlib.org/fishpack/.

More information

Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes

Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes Stefan Vater 1 Kaveh Rahnema 2 Jörn Behrens 1 Michael Bader 2 1 Universität Hamburg 2014 PDES Workshop 2 TU München Partial

More information

ACCURACY OF NUMERICAL SOLUTION OF HEAT DIFFUSION EQUATION

ACCURACY OF NUMERICAL SOLUTION OF HEAT DIFFUSION EQUATION Scientific Research of the Institute of Mathematics and Computer Science ACCURACY OF NUMERICAL SOLUTION OF HEAT DIFFUSION EQUATION Ewa Węgrzyn-Skrzypczak, Tomasz Skrzypczak Institute of Mathematics, Czestochowa

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

Similar Pulley Wheel Description J.E. Akin, Rice University

Similar Pulley Wheel Description J.E. Akin, Rice University Similar Pulley Wheel Description J.E. Akin, Rice University The SolidWorks simulation tutorial on the analysis of an assembly suggested noting another type of boundary condition that is not illustrated

More information

Tutorial 1. Introduction to Using FLUENT: Fluid Flow and Heat Transfer in a Mixing Elbow

Tutorial 1. Introduction to Using FLUENT: Fluid Flow and Heat Transfer in a Mixing Elbow Tutorial 1. Introduction to Using FLUENT: Fluid Flow and Heat Transfer in a Mixing Elbow Introduction This tutorial illustrates the setup and solution of the two-dimensional turbulent fluid flow and heat

More information

1 Stokes equations with FD on a staggered grid using the stream-function approach.

1 Stokes equations with FD on a staggered grid using the stream-function approach. Figure 1: Discretiation for the streamfunction approach. The boundary conditions are set through fictious boundary points. 1 Stokes equations with FD on a staggered grid using the stream-function approach.

More information

Finite Element Convergence for Time-Dependent PDEs with a Point Source in COMSOL 4.2

Finite Element Convergence for Time-Dependent PDEs with a Point Source in COMSOL 4.2 Finite Element Convergence for Time-Dependent PDEs with a Point Source in COMSOL 4.2 David W. Trott and Matthias K. Gobbert Department of Mathematics and Statistics, University of Maryland, Baltimore County,

More information

June 5, Institute of Structural Analysis Graz University of Technology Lessingstr. 25/II, 8010 Graz, Austria

June 5, Institute of Structural Analysis Graz University of Technology Lessingstr. 25/II, 8010 Graz, Austria Higher-order meshing of implicit geometries part I: Integration and interpolation in cut elements arxiv:706.00578v [cs.na] 2 Jun 207 T.P. Fries, S. Omerović, D. Schöllhammer, J. Steidl June 5, 207 Institute

More information

v Mesh Editing SMS 11.2 Tutorial Requirements Mesh Module Time minutes Prerequisites None Objectives

v Mesh Editing SMS 11.2 Tutorial Requirements Mesh Module Time minutes Prerequisites None Objectives v. 11.2 SMS 11.2 Tutorial Objectives This tutorial lesson teaches manual mesh generation and editing techniques that can be performed using SMS. It should be noted that manual methods are NOT recommended.

More information

Solving partial differential equations using the NAG Library

Solving partial differential equations using the NAG Library Solving partial differential equations using the NAG Library 1. Introduction Jeremy Walton The Numerical Algorithms Group, Ltd. Wilkinson House, Jordan Hill Road Oxford OX2 8DR, United Kingdom A partial

More information

COMSOL Model Report. 1. Table of Contents. 2. Model Properties. 3. Constants

COMSOL Model Report. 1. Table of Contents. 2. Model Properties. 3. Constants COMSOL Model Report 1. Table of Contents Title - COMSOL Model Report Table of Contents Model Properties Constants Global Expressions Geometry Geom1 Integration Coupling Variables Solver Settings Postprocessing

More information

Appendix S. ESATAN Thermal Modelling Suite Product Developments and Demonstration. Chris Kirtley Nicolas Bures (ITP Engines UK Ltd, United Kingdom)

Appendix S. ESATAN Thermal Modelling Suite Product Developments and Demonstration. Chris Kirtley Nicolas Bures (ITP Engines UK Ltd, United Kingdom) 249 Appendix S ESATAN Thermal Modelling Suite Product Developments and Demonstration Chris Kirtley Nicolas Bures (ITP Engines UK Ltd, United Kingdom) 250 ESATAN Thermal Modelling Suite Product Developments

More information

MATHEMATICAL ANALYSIS, MODELING AND OPTIMIZATION OF COMPLEX HEAT TRANSFER PROCESSES

MATHEMATICAL ANALYSIS, MODELING AND OPTIMIZATION OF COMPLEX HEAT TRANSFER PROCESSES MATHEMATICAL ANALYSIS, MODELING AND OPTIMIZATION OF COMPLEX HEAT TRANSFER PROCESSES Goals of research Dr. Uldis Raitums, Dr. Kārlis Birģelis To develop and investigate mathematical properties of algorithms

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

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

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

FLUID FLOW TOPOLOGY OPTIMIZATION USING POLYGINAL ELEMENTS: STABILITY AND COMPUTATIONAL IMPLEMENTATION IN PolyTop 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

More information

Package RTriangle. January 31, 2018

Package RTriangle. January 31, 2018 Package RTriangle January 31, 2018 Copyright 1993, 1995, 1997, 1998, 2002, 2005 Jonathan Richard Shewchuk; 2011-2018 License CC BY-NC-SA 4.0 Title Triangle - A 2D Quality Mesh Generator and Delaunay Triangulator

More information

SCILAB FINITE ELEMENT SOLVER

SCILAB FINITE ELEMENT SOLVER powered by SCILAB FINITE ELEMENT SOLVER FOR STATIONARY AND INCOMPRESSIBLE NAVIER-STOKES EQUATIONS Author: Massimiliano Margonari Keywords. Scilab; Open source software; Navier-Stokes equations Abstract:

More information

Lab 9: FLUENT: Transient Natural Convection Between Concentric Cylinders

Lab 9: FLUENT: Transient Natural Convection Between Concentric Cylinders Lab 9: FLUENT: Transient Natural Convection Between Concentric Cylinders Objective: The objective of this laboratory is to introduce how to use FLUENT to solve both transient and natural convection problems.

More information

Puffin User Manual. March 1, Johan Hoffman and Anders Logg.

Puffin User Manual. March 1, Johan Hoffman and Anders Logg. Puffin User Manual March 1, 2006 Johan Hoffman and Anders Logg www.fenics.org Visit http://www.fenics.org/ for the latest version of this manual. Send comments and suggestions to puffin-dev@fenics.org.

More information

SOLIDWORKS: Lesson III Patterns & Mirrors. UCF Engineering

SOLIDWORKS: Lesson III Patterns & Mirrors. UCF Engineering SOLIDWORKS: Lesson III Patterns & Mirrors UCF Engineering Solidworks Review Last lesson we discussed several more features that can be added to models in order to increase their complexity. We are now

More information

Masters Projects in Scientific Computing. By Jan Nordström

Masters Projects in Scientific Computing. By Jan Nordström Masters Projects in Scientific Computing By Jan Nordström PROJECT NO 1: OCEAN CIRKULATION CAUSED BY THE TIDE? Seamounts Trences Need efficient solver to compute the flow over a rough surface. We develop

More information

3D NURBS-ENHANCED FINITE ELEMENT METHOD

3D NURBS-ENHANCED FINITE ELEMENT METHOD 7th Workshop on Numerical Methods in Applied Science and Engineering (NMASE 8) Vall de Núria, 9 a 11 de enero de 28 c LaCàN, www.lacan-upc.es 3D NURBS-ENHANCED FINITE ELEMENT METHOD R. Sevilla, S. Fernández-Méndez

More information

Simple Mesh Examples to Illustrate Specific Finite Element Mesh Requirements

Simple Mesh Examples to Illustrate Specific Finite Element Mesh Requirements Simple Mesh Examples to Illustrate Specific Finite Element Mesh Requirements Peter Fleischmann, Robert Kosik, Bernhard Haindl, and Siegfried Selberherr Institute for Microelectronics, TU Vienna, Gu6hausstrafie

More information

ALF USER GUIDE. Date: September

ALF USER GUIDE. Date: September ALF USER GUIDE R. VERFÜRTH Contents 1. Introduction 1 2. User interface 2 3. Domain and initial grid 3 4. Differential equation 9 5. Discretization 12 6. Solver 12 7. Mesh refinement 14 8. Number of nodes

More information

Digital Geometry Processing Parameterization I

Digital Geometry Processing Parameterization I Problem Definition Given a surface (mesh) S in R 3 and a domain find a bective F: S Typical Domains Cutting to a Disk disk = genus zero + boundary sphere = closed genus zero Creates artificial boundary

More information

The General Purpose Parameter Based Two Dimensional Mesh Generator

The General Purpose Parameter Based Two Dimensional Mesh Generator The General Purpose Parameter Based Two Dimensional Mesh Generator Abstract Sivamayam Sivasuthan Department of Electrical and Computer Engineering Michigan State University East Lansing, MI 48824, USA

More information

CME 345: MODEL REDUCTION

CME 345: MODEL REDUCTION CME 345: MODEL REDUCTION Parameterized Partial Differential Equations Charbel Farhat Stanford University cfarhat@stanford.edu 1 / 19 Outline 1 Initial Boundary Value Problems 2 Typical Parameters of Interest

More information

Differential Geometry: Circle Patterns (Part 1) [Discrete Conformal Mappinngs via Circle Patterns. Kharevych, Springborn and Schröder]

Differential Geometry: Circle Patterns (Part 1) [Discrete Conformal Mappinngs via Circle Patterns. Kharevych, Springborn and Schröder] Differential Geometry: Circle Patterns (Part 1) [Discrete Conformal Mappinngs via Circle Patterns. Kharevych, Springborn and Schröder] Preliminaries Recall: Given a smooth function f:r R, the function

More information

Fast marching methods

Fast marching methods 1 Fast marching methods Lecture 3 Alexander & Michael Bronstein tosca.cs.technion.ac.il/book Numerical geometry of non-rigid shapes Stanford University, Winter 2009 Metric discretization 2 Approach I:

More information

A Comparison of the Computational Speed of 3DSIM versus ANSYS Finite Element Analyses for Simulation of Thermal History in Metal Laser Sintering

A Comparison of the Computational Speed of 3DSIM versus ANSYS Finite Element Analyses for Simulation of Thermal History in Metal Laser Sintering A Comparison of the Computational Speed of 3DSIM versus ANSYS Finite Element Analyses for Simulation of Thermal History in Metal Laser Sintering Kai Zeng a,b, Chong Teng a,b, Sally Xu b, Tim Sublette b,

More information

arxiv: v1 [cs.cg] 14 Nov 2017

arxiv: v1 [cs.cg] 14 Nov 2017 GENERATION OF UNSTRUCTURED MESHES IN 2-D, 3-D, AND SPHERICAL GEOMETRIES WITH EMBEDDED HIGH RESOLUTION SUB-REGIONS JORGE M. TARAMÓN, JASON P. MORGAN, CHAO SHI, AND JÖRG HASENCLEVER arxiv:1711.06333v1 [cs.cg]

More information

Adaptive numerical methods

Adaptive numerical methods METRO MEtallurgical TRaining On-line Adaptive numerical methods Arkadiusz Nagórka CzUT Education and Culture Introduction Common steps of finite element computations consists of preprocessing - definition

More information

Scilab Element Finite Cylinder

Scilab Element Finite Cylinder Scilab Element Finite Cylinder Free PDF ebook Download: Scilab Element Finite Cylinder Download or Read Online ebook scilab element finite cylinder in PDF Format From The Best User Guide Database Scilab

More information

NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011

NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011 NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011 First-Order Hyperbolic System Method If you have a CFD book for hyperbolic problems, you have a CFD book for all problems.

More information

Figure 1: execution of the program with the definition of the parameters.

Figure 1: execution of the program with the definition of the parameters. The Fortran90 code BEMdyn-incompressible is a general boundary element software suitable to solve problems of incompressible incremental non-linear elasticity with time-harmonic external loads of prescribed

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

Adaptive Isogeometric Analysis by Local h-refinement with T-splines

Adaptive Isogeometric Analysis by Local h-refinement with T-splines Adaptive Isogeometric Analysis by Local h-refinement with T-splines Michael Dörfel 1, Bert Jüttler 2, Bernd Simeon 1 1 TU Munich, Germany 2 JKU Linz, Austria SIMAI, Minisymposium M13 Outline Preliminaries:

More information

Introduction to Electrostatic FEA with BELA

Introduction to Electrostatic FEA with BELA Introduction to Electrostatic FEA with BELA David Meeker dmeeker@ieee.org Updated October 31, 2004 Introduction BELA ( Basic Electrostatic Analysis ) is a software package for the finite element analysis

More information

Finite element method, Matlab implementation

Finite element method, Matlab implementation TIES594 PDE-solvers Lecture 6, 2016 Olli Mali Finite element method, Matlab implementation Main program The main program is the actual finite element solver for the Poisson problem. In general, a finite

More information

Shape Modeling and Geometry Processing

Shape Modeling and Geometry Processing 252-0538-00L, Spring 2018 Shape Modeling and Geometry Processing Discrete Differential Geometry Differential Geometry Motivation Formalize geometric properties of shapes Roi Poranne # 2 Differential Geometry

More information

arxiv: v1 [math.na] 21 Feb 2019

arxiv: v1 [math.na] 21 Feb 2019 A Fully Lagrangian Meshfree Framework for PDEs on Evolving Surfaces Pratik Suchde a,, Jörg Kuhnert a a Fraunhofer ITWM, 67663 Kaiserslautern, Germany arxiv:1902.08107v1 [math.na] 21 Feb 2019 Abstract We

More information