ME751 Advanced Computational Multibody Dynamics

Size: px
Start display at page:

Download "ME751 Advanced Computational Multibody Dynamics"

Transcription

1 ME751 Advanced Computational Multibody Dynamics November 9, 2016 Antonio Recuero University of Wisconsin-Madison

2 Quote of the Day I intend to live forever, or die trying. -Groucho Marx 2

3 Before we get started On Monday, we learned: Define constraints with ANCF finite elements and rigid bodies ANCF cable element kinematics ANCF cable element strains ANCF cable element inertia forces This lecture Wrap up implementation of ANCF cable element in Chrono Plates and shells Introduce Chrono s bilinear ANCF shell element Kinematics of ANCF shell element Curvilinear initial configuration Inertia forces Internal forces 3

4 ANCF Cable: Virtual Work of Elastic Forces The virtual of the elastic forces for the gradient-deficient beam element may be defined as where W EA EId x e x x L 1 2 rr T x x x rx r 1 and = r xx 3 x are the axial Green-Lagrange strain and bending curvature Calculation of strain variations for virtual work 1 T T rx x rr x x 1 e rx e e2 e For bending curvature: f rx rxx, f r r, g r 3 g r x x xx x 1 f g e g f 2 e e g e e T r r f r r r r T e e rxrxx rxrxx e e r r r r g 3 1 T 2 T 2 T rx rr x x 3rr x x rx e e e x xx x xx x xx T 3 x xx x xx 4

5 b. Generalized internal forces Axial class MyForcesAxial : public ChIntegrable1D<ChMatrixNM<double, 12, 1> > { public: ChElementCableANCF* element; ChMatrixNM<double, 4, 3>* d; // this is an external matrix, use pointer ChMatrixNM<double, 12, 1>* d_dt; // this is an external matrix, use pointer ChMatrixNM<double, 3, 12> Sd; ChMatrixNM<double, 1, 4> N; ChMatrixNM<double, 1, 4> Nd; ChMatrixNM<double, 1, 12> straind; Declarations needed ChMatrixNM<double, 1, 1> strain; ChMatrixNM<double, 1, 3> Nd_d; ChMatrixNM<double, 12, 12> temp; /// Evaluate (straind'*strain) at point x virtual void Evaluate(ChMatrixNM<double, 12, 1>& result, const double x) { element >ShapeFunctionsDerivatives(Nd, x); Evaluate shape function derivatives at // Sd=[Nd1*eye(3) Nd2*eye(3) Nd3*eye(3) Nd4*eye(3)] ChMatrix33<> Sdi; Sdi.FillDiag(Nd(0)); Sd.PasteMatrix(&Sdi, 0, 0); Sdi.FillDiag(Nd(1)); Sd.PasteMatrix(&Sdi, 0, 3); Sdi.FillDiag(Nd(2)); Sd.PasteMatrix(&Sdi, 0, 6); Sdi.FillDiag(Nd(3)); Sd.PasteMatrix(&Sdi, 0, 9); Nd_d = Nd * (*d); straind = Nd_d * Sd; r x xx e 5

6 b. Generalized internal forces Axial strain.matrmultiplyt(nd_d, Nd_d); strain(0, 0) += 1; strain(0, 0) *= 0.5; Calculation of strain Optional addition of damping // Add damping forces if selected if (element >m_use_damping) strain(0, 0) += (element >m_alpha) * (straind * (*d_dt))(0, 0); result.matrtmultiply(straind, strain); // result: straind'*strain } }; MyForcesAxial myformulaax; myformulaax.d = &d; myformulaax.d_dt = &vel_vector; myformulaax.element = this; Result dependent on space parameter ChMatrixNM<double, 12, 1> Faxial; ChQuadrature::Integrate1D<ChMatrixNM<double, 12, 1> >(Faxial, // result of integration will go there myformulaax, // formula to integrate 0, // start of x Integration and addition to generalized force vector 1, // end of x 5 // order of integration ); Faxial *= E * Area * length; 6 Fi = Faxial;

7 c. Generalized internal forces. Bending strain /// Integrate (k_e'*k_e) class MyForcesCurv : public ChIntegrable1D<ChMatrixNM<double, 12, 1> > { public: ChElementCableANCF* element; ChMatrixNM<double, 4, 3>* d; // this is an external matrix, use pointer ChMatrixNM<double, 12, 1>* d_dt; // this is an external matrix, use pointer ChMatrixNM<double, 3, 12> Sd; ChMatrixNM<double, 3, 12> Sdd; ChMatrixNM<double, 1, 4> Nd; ChMatrixNM<double, 1, 4> Ndd; ChMatrixNM<double, 1, 3> r_x; ChMatrixNM<double, 1, 3> r_xx; ChMatrixNM<double, 1, 12> g_e; ChMatrixNM<double, 1, 12> f_e; ChMatrixNM<double, 1, 12> k_e; ChMatrixNM<double, 3, 12> fe1; Declarations f rx rxx, f r r, r 3 g rx 1 f g e g f 2 e e g e e 3 x xx g x First and second shape functions needed /// Evaluate at point x virtual void Evaluate(ChMatrixNM<double, 12, 1>& result, const double x) { element >ShapeFunctionsDerivatives(Nd, x); element >ShapeFunctionsDerivatives2(Ndd, x); 7

8 c. Generalized internal forces. Bending strain // Sd=[Nd1*eye(3) Nd2*eye(3) Nd3*eye(3) Nd4*eye(3)] // Sdd=[Ndd1*eye(3) Ndd2*eye(3) Ndd3*eye(3) Ndd4*eye(3)] ChMatrix33<> Sdi; Sdi.FillDiag(Nd(0)); Sd.PasteMatrix(&Sdi, 0, 0); Sdi.FillDiag(Nd(1)); Sd.PasteMatrix(&Sdi, 0, 3); Sdi.FillDiag(Nd(2)); Sd.PasteMatrix(&Sdi, 0, 6); Sdi.FillDiag(Nd(3)); Sd.PasteMatrix(&Sdi, 0, 9); Sdi.FillDiag(Ndd(0)); Sdd.PasteMatrix(&Sdi, 0, 0); Sdi.FillDiag(Ndd(1)); Sdd.PasteMatrix(&Sdi, 0, 3); Sdi.FillDiag(Ndd(2)); Sdd.PasteMatrix(&Sdi, 0, 6); Sdi.FillDiag(Ndd(3)); Sdd.PasteMatrix(&Sdi, 0, 9); Shape function matrices: First and second derivative r_x.matrmultiply(nd, (*d)); // r_x=d'*nd'; (transposed) r_xx.matrmultiply(ndd, (*d)); // r_xx=d'*ndd'; (transposed) r x, r xx 8

9 c. Generalized internal forces. Bending strain r_xx.matrmultiply(ndd, (*d)); // r_xx=d'*ndd'; (transposed) // if (r_xx.length()==0) // {r_xx(0)=0; r_xx(1)=1; r_xx(2)=0;} ChVector<> vr_x(r_x(0), r_x(1), r_x(2)); ChVector<> vr_xx(r_xx(0), r_xx(1), r_xx(2)); ChVector<> vf1 = Vcross(vr_x, vr_xx); double f = vf1.length(); double g1 = vr_x.length(); double g = pow(g1, 3); double k = f / g; g_e = (Nd * (*d)) * Sd; g_e *= (3 * g1); // do: fe1=cross(sd,r_xxrep)+cross(r_xrep,sdd); for (int col = 0; col < 12; ++col) { ChVector<> Sd_i = Sd.ClipVector(0, col); fe1.pastevector(vcross(sd_i, vr_xx), 0, col); ChVector<> Sdd_i = Sdd.ClipVector(0, col); fe1.pastesumvector(vcross(vr_x, Sdd_i), 0, col); } ChMatrixNM<double, 3, 1> f1; f1.pastevector(vf1, 0, 0); Building the bending strain formula and its variation to obtain generalized bending force f rx rxx, f r r, g r 3 g rx 1 f g e g f 2 e e g e e x xx x 3 if (f == 0) f_e.matrtmultiply(f1, fe1); else { f_e.matrtmultiply(f1, fe1); f_e *= (1 / f); } 9

10 c. Generalized internal forces. k_e = (f_e * g g_e * f) * (1 / (pow(g, 2))); // result: k_e'*k result.copyfrommatrixt(k_e); // Add damping if selected by user: curvature rate if (element >m_use_damping) k += (element >m_alpha) * (k_e * (*d_dt))(0, 0); Bending strain }; } result *= k; MyForcesCurv myformulacurv; myformulacurv.d = &d; myformulacurv.d_dt = &vel_vector; myformulacurv.element = this; f rx rxx, f r r, g r 3 g r x x xx x 1 f g e g f 2 e e g e e 3 ChMatrixNM<double, 12, 1> Fcurv; ChQuadrature::Integrate1D<ChMatrixNM<double, 12, 1> >(Fcurv, // result of integration will myformulacurv, // formula to integrate 0, // start of x 1, // end of x 3 // order of integration ); Fcurv *= E * I * length; // note Iyy should be the same value (circular section assumption) Fi += Fcurv; Integrate formula with order 3. Account for initial configuration. Multiply by material constants. } // Substract contribution of initial configuration Fi = this >m_genforcevec0; 10

11 1. Shells and Plates 11

12 1. Shells 12

13 1. Shells 13

14 1. Shells 14

15 2. ANCF Shell Elements 15

16 2. ANCF Shell Elements. Types 16

17 2. ANCF Shell Elements. Types 17

18 3. Chrono s ANCF Shell Element 18

19 3. Chrono s ANCF Shell Element 19

20 3. Chrono s ANCF Shell Element Element i Membrane strains 20

21 3. Chrono s ANCF Shell Element More on this later! 21

22 4. Shell strains: Orthotropic and curvilinear reference 22

23 4. Shell strains: Orthotropic and curvilinear reference 23

24 4. Shell strains: Orthotropic and curvilinear reference Current deformed reference 24

25 4. Shell strains: Orthotropic and curvilinear reference 25

26 4. Shell strains: Orthotropic and curvilinear reference 26

27 4. Shell strains: Orthotropic and curvilinear reference Final expression! These strains are related to constitutive equations 27

28 4. Shell strains: Orthotropic and curvilinear reference 28

29 5. Generalized forces Full and reduced 29

30 5. Generalized forces Beta matrices need manipulations to accommodate strain vector 30

31 6. Jacobian of internal forces Integrand of elastic energy 31

32 7. Mass matrix Internal parameters 32

33 8. Generalized external forces: Point load 33

34 8. Generalized external forces: Pressure Normal definition: dependent on element s kinematics 34

35 8. Generalized external forces: Gravity load 35

36 9. Locking issues: Convergence 36

ME751 Advanced Computational Multibody Dynamics

ME751 Advanced Computational Multibody Dynamics ME751 Advanced Computational Multibody Dynamics November 23, 2016 Antonio Recuero University of Wisconsin-Madison Before we get started Last time, we learned: Plates and shells Introduce Chrono s bilinear

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

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

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

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

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

More information

Olivier Brüls. Department of Aerospace and Mechanical Engineering University of Liège

Olivier Brüls. Department of Aerospace and Mechanical Engineering University of Liège Fully coupled simulation of mechatronic and flexible multibody systems: An extended finite element approach Olivier Brüls Department of Aerospace and Mechanical Engineering University of Liège o.bruls@ulg.ac.be

More information

Recent developments in simulation, optimization and control of flexible multibody systems

Recent developments in simulation, optimization and control of flexible multibody systems Recent developments in simulation, optimization and control of flexible multibody systems Olivier Brüls Department of Aerospace and Mechanical Engineering University of Liège o.bruls@ulg.ac.be Katholieke

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

Reduction of Finite Element Models for Explicit Car Crash Simulations

Reduction of Finite Element Models for Explicit Car Crash Simulations Reduction of Finite Element Models for Explicit Car Crash Simulations K. Flídrová a,b), D. Lenoir a), N. Vasseur b), L. Jézéquel a) a) Laboratory of Tribology and System Dynamics UMR-CNRS 5513, Centrale

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

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

General modeling guidelines

General modeling guidelines General modeling guidelines Some quotes from industry FEA experts: Finite element analysis is a very powerful tool with which to design products of superior quality. Like all tools, it can be used properly,

More information

Predicting Tumour Location by Modelling the Deformation of the Breast using Nonlinear Elasticity

Predicting Tumour Location by Modelling the Deformation of the Breast using Nonlinear Elasticity Predicting Tumour Location by Modelling the Deformation of the Breast using Nonlinear Elasticity November 8th, 2006 Outline Motivation Motivation Motivation for Modelling Breast Deformation Mesh Generation

More information

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

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

More information

Introduction to FEM Modeling

Introduction to FEM Modeling Total Analysis Solution for Multi-disciplinary Optimum Design Apoorv Sharma midas NFX CAE Consultant 1 1. Introduction 2. Element Types 3. Sample Exercise: 1D Modeling 4. Meshing Tools 5. Loads and Boundary

More information

Applications. Human and animal motion Robotics control Hair Plants Molecular motion

Applications. Human and animal motion Robotics control Hair Plants Molecular motion Multibody dynamics Applications Human and animal motion Robotics control Hair Plants Molecular motion Generalized coordinates Virtual work and generalized forces Lagrangian dynamics for mass points

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

Chrono::FEA is a C++ module that enables flexible parts in Chrono

Chrono::FEA is a C++ module that enables flexible parts in Chrono Chrono::FEA API 1 Chrono::FEA Chrono::FEA is a C++ module that enables flexible parts in Chrono Chrono::FEA contains classes for modeling finite elements of various types: Beams Shells Tetrahedrons, hexahedrons

More information

Technical Report Example (1) Chartered (CEng) Membership

Technical Report Example (1) Chartered (CEng) Membership Technical Report Example (1) Chartered (CEng) Membership A TECHNICAL REPORT IN SUPPORT OF APPLICATION FOR CHARTERED MEMBERSHIP OF IGEM DESIGN OF 600 (103 BAR) 820MM SELF SEALING REPAIR CLAMP AND VERIFICATION

More information

Module: 2 Finite Element Formulation Techniques Lecture 3: Finite Element Method: Displacement Approach

Module: 2 Finite Element Formulation Techniques Lecture 3: Finite Element Method: Displacement Approach 11 Module: 2 Finite Element Formulation Techniques Lecture 3: Finite Element Method: Displacement Approach 2.3.1 Choice of Displacement Function Displacement function is the beginning point for the structural

More information

Chapter 5 Modeling and Simulation of Mechanism

Chapter 5 Modeling and Simulation of Mechanism Chapter 5 Modeling and Simulation of Mechanism In the present study, KED analysis of four bar planar mechanism using MATLAB program and ANSYS software has been carried out. The analysis has also been carried

More information

Strain-Based Finite Element Analysis of Stiffened Cylindrical Shell Roof

Strain-Based Finite Element Analysis of Stiffened Cylindrical Shell Roof American Journal of Civil Engineering 2017; 5(4): 225-230 http://www.sciencepublishinggroup.com/j/ajce doi: 10.11648/j.ajce.20170504.15 ISSN: 2330-8729 (Print); ISSN: 2330-8737 (Online) Strain-Based Finite

More information

Finite Element Buckling Analysis Of Stiffened Plates

Finite Element Buckling Analysis Of Stiffened Plates International Journal of Engineering Research and Development e-issn: 2278-067X, p-issn: 2278-800X, www.ijerd.com Volume 10, Issue 2 (February 2014), PP.79-83 Finite Element Buckling Analysis Of Stiffened

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

Introduction to the Finite Element Method (3)

Introduction to the Finite Element Method (3) Introduction to the Finite Element Method (3) Petr Kabele Czech Technical University in Prague Faculty of Civil Engineering Czech Republic petr.kabele@fsv.cvut.cz people.fsv.cvut.cz/~pkabele 1 Outline

More information

The Mechanics of Composites Collection Material Minds Software A Product of Materials Sciences Corporation

The Mechanics of Composites Collection Material Minds Software A Product of Materials Sciences Corporation The Mechanics of Composites Collection Material Minds Software A Product of Materials Sciences Corporation aterial inds Software The Materials Minds Philosophy Engineers are smart people that want the

More information

SAMCEF for ROTORS. Chapter 3.2: Rotor modeling. This document is the property of SAMTECH S.A. MEF A, Page 1

SAMCEF for ROTORS. Chapter 3.2: Rotor modeling. This document is the property of SAMTECH S.A. MEF A, Page 1 SAMCEF for ROTORS Chapter 3.2: Rotor modeling This document is the property of SAMTECH S.A. MEF 101-03-2-A, Page 1 Table of contents Introduction Introduction 1D Model 2D Model 3D Model 1D Models: Beam-Spring-

More information

MULTIPHYSICS SIMULATION USING GPU

MULTIPHYSICS SIMULATION USING GPU MULTIPHYSICS SIMULATION USING GPU Arman Pazouki Simulation-Based Engineering Laboratory Department of Mechanical Engineering University of Wisconsin - Madison Acknowledgements Prof. Dan Negrut Dr. Radu

More information

A simple example. Assume we want to find the change in the rotation angles to get the end effector to G. Effect of changing s

A simple example. Assume we want to find the change in the rotation angles to get the end effector to G. Effect of changing s CENG 732 Computer Animation This week Inverse Kinematics (continued) Rigid Body Simulation Bodies in free fall Bodies in contact Spring 2006-2007 Week 5 Inverse Kinematics Physically Based Rigid Body Simulation

More information

The Application of. Interface Elements to Dissimilar Meshes in. Global/Local Analysis

The Application of. Interface Elements to Dissimilar Meshes in. Global/Local Analysis The Application of Interface Elements to Dissimilar Meshes in Global/Local Analysis John E Schiermeier Senior Development Engineer The MacNeal Schwendler Corporation Los Angeles, California Jerrold M Housner

More information

Support for Multi physics in Chrono

Support for Multi physics in Chrono Support for Multi physics in Chrono The Story Ahead Overview of multi physics strategy in Chrono Summary of handling rigid/flexible body dynamics using Lagrangian approach Summary of handling fluid, and

More information

TABLE OF CONTENTS SECTION 2 BACKGROUND AND LITERATURE REVIEW... 3 SECTION 3 WAVE REFLECTION AND TRANSMISSION IN RODS Introduction...

TABLE OF CONTENTS SECTION 2 BACKGROUND AND LITERATURE REVIEW... 3 SECTION 3 WAVE REFLECTION AND TRANSMISSION IN RODS Introduction... TABLE OF CONTENTS SECTION 1 INTRODUCTION... 1 1.1 Introduction... 1 1.2 Objectives... 1 1.3 Report organization... 2 SECTION 2 BACKGROUND AND LITERATURE REVIEW... 3 2.1 Introduction... 3 2.2 Wave propagation

More information

Simulation of Overhead Crane Wire Ropes Utilizing LS-DYNA

Simulation of Overhead Crane Wire Ropes Utilizing LS-DYNA Simulation of Overhead Crane Wire Ropes Utilizing LS-DYNA Andrew Smyth, P.E. LPI, Inc., New York, NY, USA Abstract Overhead crane wire ropes utilized within manufacturing plants are subject to extensive

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

ME Optimization of a Frame

ME Optimization of a Frame ME 475 - Optimization of a Frame Analysis Problem Statement: The following problem will be analyzed using Abaqus. 4 7 7 5,000 N 5,000 N 0,000 N 6 6 4 3 5 5 4 4 3 3 Figure. Full frame geometry and loading

More information

Challenge Problem 5 - The Solution Dynamic Characteristics of a Truss Structure

Challenge Problem 5 - The Solution Dynamic Characteristics of a Truss Structure Challenge Problem 5 - The Solution Dynamic Characteristics of a Truss Structure In the final year of his engineering degree course a student was introduced to finite element analysis and conducted an assessment

More information

Scientific Manual FEM-Design 17.0

Scientific Manual FEM-Design 17.0 Scientific Manual FEM-Design 17. 1.4.6 Calculations considering diaphragms All of the available calculation in FEM-Design can be performed with diaphragms or without diaphragms if the diaphragms were defined

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

Lecture #9 Matrix methods

Lecture #9 Matrix methods Lecture #9 Matrix methods METHODS TO SOLVE INDETERMINATE PROBLEM Small degree of statical indeterminacy Force method Displacement methods Displacement method in matrix formulation Large degree of statical

More information

Simulation of 3D Polyarticulated Mechanisms Through Object- Oriented Approach

Simulation of 3D Polyarticulated Mechanisms Through Object- Oriented Approach Simulation of 3D Polyarticulated Mechanisms Through Object- Oriented Approach DUFOSSE Francois *, KROMER Valerie *, MIKOLAJCZAK Alain * and GUEURY Michel * * Equipe de Recherches en Interfaces Numeriques

More information

Project Chrono. Overview, structure, capabilities

Project Chrono. Overview, structure, capabilities Project Chrono Overview, structure, capabilities Project Chrono Growing ecosystem of software tools Multi physics simulation engine Open source, released under permissive BSD 3 license Provides support

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

ES 230 Strengths Intro to Finite Element Modeling & Analysis Homework Assignment 2

ES 230 Strengths Intro to Finite Element Modeling & Analysis Homework Assignment 2 ES 230 Strengths Intro to Finite Element Modeling & Analysis Homework Assignment 2 In this homework assignment you will use your rapidly developing ANSYS skill set to model and analyze three different

More information

Flexible multibody dynamics: From FE formulations to control and optimization

Flexible multibody dynamics: From FE formulations to control and optimization Flexible multibody dynamics: From FE formulations to control and optimization Olivier Brüls Multibody & Mechatronic Systems Laboratory Department of Aerospace and Mechanical Engineering University of Liège,

More information

A Numerical Form Finding Method for Minimal Surface of Membrane Structure

A Numerical Form Finding Method for Minimal Surface of Membrane Structure 10 th World Congress on Structural and Multidisciplinary Optimization May 19-24, 2013, Orlando, Florida, US Numerical Form Finding Method for Minimal Surface of Membrane Structure Koichi Yamane 1, Masatoshi

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

Analysis of mechanisms with flexible beam-like links, rotary joints and assembly errors

Analysis of mechanisms with flexible beam-like links, rotary joints and assembly errors Arch Appl Mech (2012) 82:283 295 DOI 10.1007/s00419-011-0556-6 ORIGINAL Krzysztof Augustynek Iwona Adamiec-Wójcik Analysis of mechanisms with flexible beam-like links, rotary joints and assembly errors

More information

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123 2.7 Cloth Animation 320491: Advanced Graphics - Chapter 2 123 Example: Cloth draping Image Michael Kass 320491: Advanced Graphics - Chapter 2 124 Cloth using mass-spring model Network of masses and springs

More information

The numerical simulation of complex PDE problems. A numerical simulation project The finite element method for solving a boundary-value problem in R 2

The numerical simulation of complex PDE problems. A numerical simulation project The finite element method for solving a boundary-value problem in R 2 Universidad de Chile The numerical simulation of complex PDE problems Facultad de Ciencias Físicas y Matemáticas P. Frey, M. De Buhan Year 2008 MA691 & CC60X A numerical simulation project The finite element

More information

Industrial Applications of Computational Mechanics Plates and Shells Mesh generation static SSI. Prof. Dr.-Ing. Casimir Katz SOFiSTiK AG

Industrial Applications of Computational Mechanics Plates and Shells Mesh generation static SSI. Prof. Dr.-Ing. Casimir Katz SOFiSTiK AG Industrial Applications of Plates and Shells Mesh generation static SSI Prof. Dr.-Ing. Casimir Katz SOFiSTiK AG FEM - Reminder A mathematical method The real (continuous) world is mapped on to a discrete

More information

Non-Rigid Image Registration III

Non-Rigid Image Registration III Non-Rigid Image Registration III CS6240 Multimedia Analysis Leow Wee Kheng Department of Computer Science School of Computing National University of Singapore Leow Wee Kheng (CS6240) Non-Rigid Image Registration

More information

Flexible multibody systems - Relative coordinates approach

Flexible multibody systems - Relative coordinates approach Computer-aided analysis of multibody dynamics (part 2) Flexible multibody systems - Relative coordinates approach Paul Fisette (paul.fisette@uclouvain.be) Introduction In terms of modeling, multibody scientists

More information

Learning Module 8 Shape Optimization

Learning Module 8 Shape Optimization Learning Module 8 Shape Optimization What is a Learning Module? Title Page Guide A Learning Module (LM) is a structured, concise, and self-sufficient learning resource. An LM provides the learner with

More information

Finite Element Analysis Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology Madras. Module - 01 Lecture - 15

Finite Element Analysis Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology Madras. Module - 01 Lecture - 15 Finite Element Analysis Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology Madras Module - 01 Lecture - 15 In the last class we were looking at this 3-D space frames; let me summarize

More information

NEW FINITE ELEMENT / MULTIBODY SYSTEM ALGORITHM FOR MODELING FLEXIBLE TRACKED VEHICLES

NEW FINITE ELEMENT / MULTIBODY SYSTEM ALGORITHM FOR MODELING FLEXIBLE TRACKED VEHICLES NEW FINITE ELEMENT / MULTIBODY SYSTEM ALGORITHM FOR MODELING FLEXIBLE TRACKED VEHICLES Paramsothy Jayakumar, Mike Letherwood US Army RDECOM TARDEC Ulysses Contreras, Ashraf M. Hamed, Abdel-Nasser A. Mohamed,

More information

Lecture «Robot Dynamics»: Kinematic Control

Lecture «Robot Dynamics»: Kinematic Control Lecture «Robot Dynamics»: Kinematic Control 151-0851-00 V lecture: CAB G11 Tuesday 10:15 12:00, every week exercise: HG E1.2 Wednesday 8:15 10:00, according to schedule (about every 2nd week) Marco Hutter,

More information

Introduction to Multi-body Dynamics

Introduction to Multi-body Dynamics division Graduate Course ME 244) Tentative Draft Syllabus 1. Basic concepts in 3-D rigid-body mechanics 1. Rigid body vs flexible body 2. Spatial kinematics (3-D rotation transformations) and Euler theorem

More information

FEA Applications I MET 415 Review Course Structure: 15 week course Weekly Schedule 50 minute lecture 2.5 hour laboratory 50 minute lecture

FEA Applications I MET 415 Review Course Structure: 15 week course Weekly Schedule 50 minute lecture 2.5 hour laboratory 50 minute lecture FEA Applications I MET 415 Review Course Structure: 15 week course Weekly Schedule 50 minute lecture 2.5 hour laboratory 50 minute lecture Goal: Obtain feedback from Industry Users on course presentation

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

FEM Convergence Requirements

FEM Convergence Requirements 19 FEM Convergence Requirements IFEM Ch 19 Slide 1 Convergence Requirements for Finite Element Discretization Convergence: discrete (FEM) solution approaches the analytical (math model) solution in some

More information

(Based on a paper presented at the 8th International Modal Analysis Conference, Kissimmee, EL 1990.)

(Based on a paper presented at the 8th International Modal Analysis Conference, Kissimmee, EL 1990.) Design Optimization of a Vibration Exciter Head Expander Robert S. Ballinger, Anatrol Corporation, Cincinnati, Ohio Edward L. Peterson, MB Dynamics, Inc., Cleveland, Ohio David L Brown, University of Cincinnati,

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

1. Two double lectures about deformable contours. 4. The transparencies define the exam requirements. 1. Matlab demonstration

1. Two double lectures about deformable contours. 4. The transparencies define the exam requirements. 1. Matlab demonstration Practical information INF 5300 Deformable contours, I An introduction 1. Two double lectures about deformable contours. 2. The lectures are based on articles, references will be given during the course.

More information

Simplified modelling of steel frame connections under cyclic loading

Simplified modelling of steel frame connections under cyclic loading Simplified modelling of steel frame connections under cyclic loading Saher El-Khoriby 1), *Mohammed A. Sakr 2), Tarek M. Khalifa 3) and Mohammed Eladly 4) 1), 2), 3), 4) Department of Structural Engineering,

More information

Development of Eight Node Isoparametric Quadrilateral (QUAD8) Elements in Java

Development of Eight Node Isoparametric Quadrilateral (QUAD8) Elements in Java 709 Development of Eight Node Isoparametric Quadrilateral (QUAD8) Elements in Java I.E Umeonyiagu 1, N.P Ogbonna 2 1 Department of Civil Engineering, Chukwuemeka Odumegwu Ojukwu University, Uli. Nigeria

More information

This week. CENG 732 Computer Animation. Warping an Object. Warping an Object. 2D Grid Deformation. Warping an Object.

This week. CENG 732 Computer Animation. Warping an Object. Warping an Object. 2D Grid Deformation. Warping an Object. CENG 732 Computer Animation Spring 2006-2007 Week 4 Shape Deformation Animating Articulated Structures: Forward Kinematics/Inverse Kinematics This week Shape Deformation FFD: Free Form Deformation Hierarchical

More information

Course in. FEM ANSYS Classic

Course in. FEM ANSYS Classic Course in Geometric modeling Modeling Programme for Lesson: Modeling considerations Element Type Real Constants Material Properties Sections Geometry/Modeling WorkPlane & Coordinate systems Keypoints Lines

More information

Example Lecture 12: The Stiffness Method Prismatic Beams. Consider again the two span beam previously discussed and determine

Example Lecture 12: The Stiffness Method Prismatic Beams. Consider again the two span beam previously discussed and determine Example 1.1 Consider again the two span beam previously discussed and determine The shearing force M1 at end B of member B. The bending moment M at end B of member B. The shearing force M3 at end B of

More information

CRANK ROUND SLIDER ENGINE MULTI-FLEXIBLE-BODY DYNAMICS SIMULATION

CRANK ROUND SLIDER ENGINE MULTI-FLEXIBLE-BODY DYNAMICS SIMULATION RANK ROUND SLIDER ENGINE MULTI-FLEXIBLE-BODY DYNAMIS SIMULATION 1 HONG-YUAN ZHANG, 2 XING-GUO MA 1 School of Automobile and Traffic, Shenyang Ligong University, Shenyang 110159, hina 2 School of Mechanical

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

Scientific Manual FEM-Design 16.0

Scientific Manual FEM-Design 16.0 1.4.6 Calculations considering diaphragms All of the available calculation in FEM-Design can be performed with diaphragms or without diaphragms if the diaphragms were defined in the model. B the different

More information

ANALYSIS OF PLANE FRAME STRUCTURE WITH MATLAB AND SAP2000 PROGRAMS

ANALYSIS OF PLANE FRAME STRUCTURE WITH MATLAB AND SAP2000 PROGRAMS ANALYSIS OF PLANE FRAME STRUCTURE WITH MATLAB AND SAP2000 PROGRAMS Abdul Ahad FAIZAN Master Student, Dept. of Civil Engineering, Sakarya University, Sakarya, Turkey ---------------------------------------------------------------------***---------------------------------------------------------------------

More information

Modelling of Torsion Beam Rear Suspension by Using Multibody Method

Modelling of Torsion Beam Rear Suspension by Using Multibody Method Multibody System Dynamics 12: 303 316, 2004. C 2004 Kluwer Academic Publishers. Printed in the Netherlands. 303 Modelling of Torsion Beam Rear Suspension by Using Multibody Method G. FICHERA, M. LACAGNINA

More information

Plane strain conditions, 20 mm thick. b a. Material properties: E aa= N/mm2 Interface properties: G IC=0.28 N/mm E =E 00 N/mm2.

Plane strain conditions, 20 mm thick. b a. Material properties: E aa= N/mm2 Interface properties: G IC=0.28 N/mm E =E 00 N/mm2. Problem description The figure shows a double cantilever beam (DCB) of a composite material, subjected to displacement loads at its ends. u All lengths in mm. Not drawn to scale. Plane strain conditions,

More information

Appendix-B. (WoodFrameSolver Analysis Results and Comparison with SAP 2000)

Appendix-B. (WoodFrameSolver Analysis Results and Comparison with SAP 2000) Appendix-B ( Analysis Results and Comparison with SAP 2000) This Appendix presents some example models used in testing and verification. All the results and figures are obtained from the verification manual

More information

Physically Based Simulation

Physically Based Simulation CSCI 480 Computer Graphics Lecture 21 Physically Based Simulation April 11, 2011 Jernej Barbic University of Southern California http://www-bcf.usc.edu/~jbarbic/cs480-s11/ Examples Particle Systems Numerical

More information

Building the Graphics Memory of. the Stiffness Matrix of the Beam

Building the Graphics Memory of. the Stiffness Matrix of the Beam Contemporary Engineering Sciences, Vol. 11, 2018, no. 92, 4593-4605 HIKARI td, www.m-hikari.com https://doi.org/10.12988/ces.2018.89502 Building the Graphics Memory of the Stiffness Matrix of the Beam

More information

FEA Model Updating Using SDM

FEA Model Updating Using SDM FEA l Updating Using SDM Brian Schwarz & Mark Richardson Vibrant Technology, Inc. Scotts Valley, California David L. Formenti Sage Technologies Santa Cruz, California ABSTRACT In recent years, a variety

More information

Locking-Free Smoothed Finite Element Method with Tetrahedral/Triangular Mesh Rezoning in Severely Large Deformation Problems

Locking-Free Smoothed Finite Element Method with Tetrahedral/Triangular Mesh Rezoning in Severely Large Deformation Problems Locking-Free Smoothed Finite Element Method with Tetrahedral/Triangular Mesh Rezoning in Severely Large Deformation Problems Yuki ONISHI, Kenji AMAYA Tokyo Institute of Technology (Japan) P. 1 P. 1 Motivation

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

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

Physically Based Simulation

Physically Based Simulation CSCI 420 Computer Graphics Lecture 21 Physically Based Simulation Examples Particle Systems Numerical Integration Cloth Simulation [Angel Ch. 9] Jernej Barbic University of Southern California 1 Physics

More information

Week 12 - Lecture Mechanical Event Simulation. ME Introduction to CAD/CAE Tools

Week 12 - Lecture Mechanical Event Simulation. ME Introduction to CAD/CAE Tools Week 12 - Lecture Mechanical Event Simulation Lecture Topics Mechanical Event Simulation Overview Additional Element Types Joint Component Description General Constraint Refresh Mesh Control Force Estimation

More information

Chrono::FEA Hands on Exercises. Modeling and simulation of colliding beams

Chrono::FEA Hands on Exercises. Modeling and simulation of colliding beams Chrono::FEA Hands on Exercises Modeling and simulation of colliding beams 1 Tutorial 1 Swinging cable with a weight at the end 2 The exercise FEA_cable_collide_1.cpp Use ChElementCableANCF to model a flexible

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

INFLUENCE OF MODELLING AND NUMERICAL PARAMETERS ON THE PERFORMANCE OF A FLEXIBLE MBS FORMULATION

INFLUENCE OF MODELLING AND NUMERICAL PARAMETERS ON THE PERFORMANCE OF A FLEXIBLE MBS FORMULATION INFLUENCE OF MODELLING AND NUMERICAL PARAMETERS ON THE PERFORMANCE OF A FLEXIBLE MBS FORMULATION J. CUADRADO, R. GUTIERREZ Escuela Politecnica Superior, Universidad de La Coruña, Ferrol, Spain SYNOPSIS

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

Advanced Robotic Manipulation

Advanced Robotic Manipulation Advanced Robotic Manipulation Handout CS327A (Spring 2017) Problem Set #4 Due Thurs, May 26 th Guidelines: This homework has both problem-solving and programming components. So please start early. In problems

More information

1314. Estimation of mode shapes expanded from incomplete measurements

1314. Estimation of mode shapes expanded from incomplete measurements 34. Estimation of mode shapes expanded from incomplete measurements Sang-Kyu Rim, Hee-Chang Eun, Eun-Taik Lee 3 Department of Architectural Engineering, Kangwon National University, Samcheok, Korea Corresponding

More information

midas Civil Advanced Webinar Date: February 9th, 2012 Topic: General Use of midas Civil Presenter: Abhishek Das Bridging Your Innovations to Realities

midas Civil Advanced Webinar Date: February 9th, 2012 Topic: General Use of midas Civil Presenter: Abhishek Das Bridging Your Innovations to Realities Advanced Webinar Date: February 9th, 2012 Topic: General Use of midas Civil Presenter: Abhishek Das Contents: Overview Modeling Boundary Conditions Loading Analysis Results Design and Misc. Introduction

More information

Executive Summary Sefea Basic Theory

Executive Summary Sefea Basic Theory Executive Summary Sefea is one of the newest generations of enriched finite element methods. Developed specifically for low-order 4-node tetrahedron and 3-node triangle in the CAE environment, Sefea achieves

More information

First Order Analysis for Automotive Body Structure Design Using Excel

First Order Analysis for Automotive Body Structure Design Using Excel Special Issue First Order Analysis 1 Research Report First Order Analysis for Automotive Body Structure Design Using Excel Hidekazu Nishigaki CAE numerically estimates the performance of automobiles and

More information

FINITE ELEMENT TECHNOLOGY FOR STEEL-ELASTOMER- SANDWICHES

FINITE ELEMENT TECHNOLOGY FOR STEEL-ELASTOMER- SANDWICHES 11th World Congress on Computational Mechanics (WCCM XI) 5th European Conference on Computational Mechanics (ECCM V) 6th European Conference on Computational Fluid Dynamics (ECFD VI) E. Oñate, J. Oliver

More information

1. INTRODUCTION. A shell may be defined as the solid material enclosed. between two closely spaced curved surfaces (1), the distance

1. INTRODUCTION. A shell may be defined as the solid material enclosed. between two closely spaced curved surfaces (1), the distance 1 1. INTRODUCTION 1.1. GENERAL A shell may be defined as the solid material enclosed between two closely spaced curved surfaces (1), the distance between these two surfaces being the thickness of the shell.

More information

Problem O. Isolated Building - Nonlinear Time History Analysis. Steel E =29000 ksi, Poissons Ratio = 0.3 Beams: W24X55; Columns: W14X90

Problem O. Isolated Building - Nonlinear Time History Analysis. Steel E =29000 ksi, Poissons Ratio = 0.3 Beams: W24X55; Columns: W14X90 Problem O Isolated Building - Nonlinear Time History Analysis Steel E =29000 ksi, Poissons Ratio = 0.3 Beams: W24X55; Columns: W14X90 Rubber Isolator Properties Vertical (axial) stiffness = 10,000 k/in

More information

Cloth Simulation. COMP 768 Presentation Zhen Wei

Cloth Simulation. COMP 768 Presentation Zhen Wei Cloth Simulation COMP 768 Presentation Zhen Wei Outline Motivation and Application Cloth Simulation Methods Physically-based Cloth Simulation Overview Development References 2 Motivation Movies Games VR

More information

DYNAMIC MODELING AND CONTROL OF THE OMEGA-3 PARALLEL MANIPULATOR

DYNAMIC MODELING AND CONTROL OF THE OMEGA-3 PARALLEL MANIPULATOR Proceedings of the 2009 IEEE International Conference on Systems, Man, and Cybernetics San Antonio, TX, USA - October 2009 DYNAMIC MODELING AND CONTROL OF THE OMEGA-3 PARALLEL MANIPULATOR Collins F. Adetu,

More information

DESIGN AND ANALYSIS OF MEMBRANE STRUCTURES IN FEM-BASED SOFTWARE MASTER THESIS

DESIGN AND ANALYSIS OF MEMBRANE STRUCTURES IN FEM-BASED SOFTWARE MASTER THESIS DESIGN AND ANALYSIS OF MEMBRANE STRUCTURES IN FEM-BASED SOFTWARE MASTER THESIS ARCHINEER INSTITUTES FOR MEMBRANE AND SHELL TECHNOLOGIES, BUILDING AND REAL ESTATE e.v. ANHALT UNIVERSITY OF APPLIED SCIENCES

More information

Proceedings of the ASME th Biennial Conference On Engineering Systems Design And Analysis ESDA2012 July 2-4, 2012, Nantes, France

Proceedings of the ASME th Biennial Conference On Engineering Systems Design And Analysis ESDA2012 July 2-4, 2012, Nantes, France Proceedings of the ASME 2012 11th Biennial Conference On Engineering Systems Design And Analysis ESDA2012 July 2-4 2012 Nantes France ESDA2012-82316 A MULTIBODY SYSTEM APPROACH TO DRILL STRING DYNAMICS

More information

[ Ω 1 ] Diagonal matrix of system 2 (updated) eigenvalues [ Φ 1 ] System 1 modal matrix [ Φ 2 ] System 2 (updated) modal matrix Φ fb

[ Ω 1 ] Diagonal matrix of system 2 (updated) eigenvalues [ Φ 1 ] System 1 modal matrix [ Φ 2 ] System 2 (updated) modal matrix Φ fb Proceedings of the IMAC-XXVIII February 1 4, 2010, Jacksonville, Florida USA 2010 Society for Experimental Mechanics Inc. Modal Test Data Adjustment For Interface Compliance Ryan E. Tuttle, Member of the

More information