Solution of Vibration and Transient Problems

Size: px
Start display at page:

Download "Solution of Vibration and Transient Problems"

Transcription

1 . 9 Solution of Vibration and Transient Problems 9

2 Chapter 9: SOLUTION OF VIBRATION AND TRANSIENT PROBLEMS 9 9. MODAL APPROACH TO TRANSIENT ANALYSIS Consider the following large-order finite element model equations of motion for linear structures: Mü(t) + D u(t) + Ku(t) = f(t), D = (αm + βk), (α, β) are constant. (9.) where the size of the displacement vector, n, ranges from several thousands to several millions. Now suppose we would like to obtain the displacement response, u(t), for expected applied force, f(t). There are two approaches: direct time integration and modal superposition. We will differ direct time integration techniques for transient response analysis to the latter part of the course, and concentrate on modal superposition techniques. To this end, we first decompose the displacement vector, u(t), in terms of its modal components by u(t) = Ψq(t) (9.) where Ψ is the mode shapes of the free-vibration modes, and q(t) is the generalized modal displacement. The mode shape matrix Ψ has the property of simultaneously diagonalizing both the mass and stiffness matrices. That is, it is obtained from the following eigenvalue problem: K Ψ = M ΨΛ Λ = diag(ω,...,ω N ) (9.3) where ω j is the j-th undamped frequency component of (9.). In structural dynamics, one often employs the following special form of mode shapes (eigenvector): Ψ T K Ψ = λ, Ψ T M Ψ = I = diag(,,...,) (9.4) Substituting (9.) into (9.) and pre-multiplying the resulting equation by Ψ T results in the following uncoupled modal equation: q i (t) + (α + βωi ) q i(t) + ωi q i (t) = p i (t), p i (t) = Ψ(i, :) T f(t) The above equation can be cast into a canonical form i =,, 3,...,n. (9.5) ẋ i (t) = A i x i (t) + b p i (t), x i = [ q i (t) q i (t) ] T [ ] [ ] A i = ωi (α + βωi ), b = (9.6) whose solution is given by x i (t) = e A i t x i () + t e A i (t τ) b p i (τ) dτ (9.7) It should be noted that the above solution provides only for one of the n-vector generalized modal coordinates, q(t) (n ). Carrying out for the entire n-modal vector, the physical displacement, u(t) (n ), can be obtained from (9.) by u(t) = Ψ( :n, :n) q(t) (:n, ), q = [ q (t), q (t),..., q n (t) ] T (9.8) 9

3 SOLUTION BY DIRECT INTEGRATION METHODS While the solution method described in (9.) - (9.8) appears to be straightfowrad, its practical implementation needs to overcome several computational challenges, which include: (a) When the size of discrete finite element model increases, the task for obtaining a large number of modes (m), if not all, m << n, becomes computationally expensive. In practice, it is customary to truncate only part of the modes and obtain an approximate solution of the form u(t) Ψ( :n, :m) q(t)(:m, ), q = [ q (t), q (t),..., q m (t) ] T, m << n (9.9) It is not uncommon to have m/n <(/ /). (b) A typical vehicle consists of many substructures whose structural characteristics are distinctly different from one to another. For example, a fuselage has different structural characteristics from wing structures. Likewise, engine blocks are considerably stiffer than the car frame structure. The impact of stiffness differences on the computed modes and mode shapes can lead to accuracy loss, and frequently to an unacceptable level. (c) In modern manufacturing arrangements, rarely an aerospace company or automobile company designs, manufactures, assembles and tests the entire vehicle system. This means, except for the final performance evaluation, each substructure can be modeled, analyzed and tested before it can be assembled, as a separate and independent structure. An alternative approach is to numerically integrate the equations of motion (9.). We will discuss computational procedures of two direction algorithms in the next section. Their algorithmic properties will be examined later in the course. 9. SOLUTION BY DIRECT INTEGRATION METHODS There are two distinct direct time integration methods: explicit and implicit integration formulas. summarize their computational sequences below. We 9.. Central Difference Method for Undamped Case (D = ) First, we express the acceleration vector ü from(9.) as ü(t) = M (f Ku(t)) (9.) Hence, it is clear that if the mass matrix is diagonal, the computation for obtaining the acceleration vector would be greatly simplified. We now describe direction time integration by the central difference method: Initial step: Given the initial conditions, { u(), u(), f(t)}, obtain the velocity at the half step {t = h, h = t} by Subsequent steps ü() = M (f() Ku()) u( h) = u() + h ü() (9.) u(h) = u() + h u( h) 9 3

4 Chapter 9: SOLUTION OF VIBRATION AND TRANSIENT PROBLEMS 9 4 T total = hn max for n = :n max ü(n) = M (f(n) Ku(n)) u(n + ) = u(n ) + h ü(n) (9.) u(n + ) = u(n) + h u(n + ) end 9.. The Trapezoidal Rule for Undamped Case (D = ) This method is also referred to Newmark s implicit rule with its free parameter chosen to be (α =,β = /4). Among several ways of implementing the trapezoidal integration rule, we will employ a summed form or half-interval rule given as follows. u(n + ) = u(n) + h ü(n + ) u(n + ) = u(n) + h u(n + ) (9.3) u(n + ) = u(n + ) u(n) u(n + ) = u(n + ) u(n) In using the preceding formula, one multiply the first of (9.3) by M to yield M u(n + ) = M u(n) + h M ü(n + ) (9.4) The term M ü(n + ) in the above equation is obtained from (9.) as Mü(n + ) = f(n + ) D u(n + ) Ku(n + ) (9.5) which, when substituted into (9.4), results in M u(n + ) = M u(n) + h {f(n + ) D u(n + ) Ku(n + )} (9.6) [M + hd] u(n + ) = M u(n) + h {f(n + ) Ku(n + )} Now multiply the second of (9.3) by [M + hd] to obtain [M + hd] u(n + ) = [M + hd] u(n) + h [M + hd] u(n + ) (9.7) third, substitute the second term in the righthand side of (9.7) by (9.6), one obtains [M + hd] u(n + ) = [M + hd] u(n) + h {M u(n) + h {f(n + ) Ku(n + )} (9.8) [M + hd + ( h) K] u(n + ) = M {u(n) + h u(n)}+ h Du(n) + ( h) f(n + ) 9 4

5 ILLUSTRATIVE PROBLEMS Implicit integration steps Assemble: A = [M + hd + ( h) K] Factor: A = LU for n = :n max b(n) = M {u(n) + h u(n)}+ h Du(n) + ( h) f(n + ) u(n + ) = A b(n), where A = U L u(n + ) ={u(n + ) u(n)}/( h) u(n + ) = u(n + ) u(n) u(n + ) = u(n + ) u(n) end (9.9) 9.3 DISCRETE APPROXIMATION OF MODAL SOLUTION The modal-form solution of the equations of motion for linear structures given by (9.7) and (9.8) involves the convolution integral of the applied force. For general applied forces an exact evaluation of the convolution integral can involve a considerable effort. To this end, an approximate solution is utilized in practice. To this end, (9.7) is expressed in discrete form at time t = nh: x i (nh) = e A i nh x i () + nh e A i (nh τ) b p i (τ) dτ (9.) Likewise, at time t = nh + h, x i (nh + h) is given by x i (nh + h) = e A i nh+h x i () + = e A i h [e A i nh x i () + + nh+h nh nh+h nh e A i (nh+h τ) b p i (τ) dτ e A i (nh+h τ) b p i (τ) dτ e A i (nh τ) b p i (τ) dτ] (9.) The bracketed term in the above equation is x i (nh) in view of (9.) and the second term is approximated as nh+h e A nh+h i (nh+h τ) b p i (τ) dτ [ e A i (nh+h τ) dτ] b p i (nh) nh nh (9.) A i (e A i h I) b p i (nh) Substiutting this together the bracketed term by x i (nh) into (9.), x i (nh + h) is approximated as x i (nh + h) = e A i h x i (nh) + A i (e A i h I) b p i (nh), x i = [ q i (nh + h), q i (nh + h) ] T (9.3) Once x i (nh + h) is computed, the physical displacement u(nh + h) is obtained via the modal summation expression (9.8). 9 5

6 Chapter 9: SOLUTION OF VIBRATION AND TRANSIENT PROBLEMS ILLUSTRATIVE PROBLEMS Consider a beam with boundary constraints as shown in Figure 9.. For illustrative purposes, two beams will be considered: a fixed-simply supported beam and a beam with boundary constraints with the following specific boundary conditions: Fixed and simply supported ends: w(, t) = w(, t) x =, w(l, t) = (9.4) Beam with boundary springs: w(, t) = w(l, t) =, k θ = (.e + 5) EI L, k θ = EI L (9.5) z w Beam with boundary constraints kθ EI, m(x) k θ x k w k w L Fig. 9. Beam with boundary constraints It should be noted that the end condition, (w(, t) = w(l, t) = ), is equivalent to (k w, k w ). However, in computer implementation it is impractical to use (k w, k w ) due to limited floating point precision. The applied force chosen are Step load: f (L/, t) =., t Sinusoidal load: f (L/, t) = sin(π f f t) (9.6) where the forcing frequency is set to f f model problems. =.5(ω //π), with ω being the fundamental frequency of the Figures and 3 illustrate time responses of a beam with boundary springs subject to unit mid-span step load. The responses by solid red lines are those obtained by using the central difference method, the ones with + are by the trapezoidal rule, and the blue lines by the canonical formula(9.3). The step increments used for the three methods are {.898E 7, for the central difference method h =.586E 5, for the canonical formula e 5, for the trapezoidal rule (9.7) It should be noted that the stepsie for the central difference method is dictated by the computational stability whereas taht of the canonical formula and teh trapezoidal rule by accurcy considerations. We hope to revisit this issue later in the course. 9 6

7 ILLUSTRATIVE PROBLEMS 7 x -6 Beam under midspan step load with 4 beam elements 6 Vertical displacement at the beam center time (sec.) x -3 Fig. 9. Beam Midspan Vertical Time Response.5 x -5 Beam under midspan step load with 4 beam elements Rotational displacement at the beam center time (sec.) x -3 Fig. 9.3 Beam Midspan Rotational Time Response 9 7

Transient Response Analysis of Structural Systems

Transient Response Analysis of Structural Systems . 21 Transient Response Analysis of Structural Systems 21 1 Chapter 21: TRANSIENT RESPONSE ANALYSIS OF STRUCTURAL SYSTEMS 21 2 21.1 MODAL APPROACH TO TRANSIENT ANALYSIS Consider the following large-order

More information

Identification Methods for Structural Systems. Prof. Dr. Eleni Chatzi Lecture March, 2016

Identification Methods for Structural Systems. Prof. Dr. Eleni Chatzi Lecture March, 2016 Prof. Dr. Eleni Chatzi Lecture 4-09. March, 2016 Fundamentals Overview Multiple DOF Systems State-space Formulation Eigenvalue Analysis The Mode Superposition Method The effect of Damping on Structural

More information

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems: Non-Linear Dynamics Part I

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems: Non-Linear Dynamics Part I The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems: Non-Linear Dynamics Part I Prof. Dr. Eleni Chatzi Dr. Giuseppe Abbiati, Dr. Konstantinos Agathos Lecture 5/Part A - 23 November,

More information

Dynamics of Structures

Dynamics of Structures Dynamics of Structures Elements of structural dynamics Roberto Tomasi 11.05.2017 Roberto Tomasi Dynamics of Structures 11.05.2017 1 / 22 Overview 1 SDOF system SDOF system Equation of motion Response spectrum

More information

Exact Solution of Time History Response for Dynamic Systems with Coupled Damping using Complex Mode Superposition

Exact Solution of Time History Response for Dynamic Systems with Coupled Damping using Complex Mode Superposition Clemson University TigerPrints All Theses Theses 8-2007 Exact Solution of Time History Response for Dynamic Systems with Coupled Damping using Complex Mode Superposition Manoj kumar Chinnakonda Clemson

More information

AA242B: MECHANICAL VIBRATIONS

AA242B: MECHANICAL VIBRATIONS AA242B: MECHANICAL VIBRATIONS 1 / 50 AA242B: MECHANICAL VIBRATIONS Undamped Vibrations of n-dof Systems These slides are based on the recommended textbook: M. Géradin and D. Rixen, Mechanical Vibrations:

More information

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems. Prof. Dr. Eleni Chatzi Lecture 6-5 November, 2015

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems. Prof. Dr. Eleni Chatzi Lecture 6-5 November, 2015 The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems Prof. Dr. Eleni Chatzi Lecture 6-5 November, 015 Institute of Structural Engineering Method of Finite Elements II 1 Introduction

More information

ANALYSIS OF HIGHRISE BUILDING STRUCTURE WITH SETBACK SUBJECT TO EARTHQUAKE GROUND MOTIONS

ANALYSIS OF HIGHRISE BUILDING STRUCTURE WITH SETBACK SUBJECT TO EARTHQUAKE GROUND MOTIONS ANALYSIS OF HIGHRISE BUILDING SRUCURE WIH SEBACK SUBJEC O EARHQUAKE GROUND MOIONS 157 Xiaojun ZHANG 1 And John L MEEK SUMMARY he earthquake response behaviour of unframed highrise buildings with setbacks

More information

NATURAL MODES OF VIBRATION OF BUILDING STRUCTURES CE 131 Matrix Structural Analysis Henri Gavin Fall, 2006

NATURAL MODES OF VIBRATION OF BUILDING STRUCTURES CE 131 Matrix Structural Analysis Henri Gavin Fall, 2006 NATURAL MODES OF VIBRATION OF BUILDING STRUCTURES CE 131 Matrix Structural Analysis Henri Gavin Fall, 006 1 Mass and Stiffness Matrices Consider a building frame modeled by a set of rigid, massive flos

More information

Multi Degrees of Freedom Systems

Multi Degrees of Freedom Systems Multi Degrees of Freedom Systems MDOF s http://intranet.dica.polimi.it/people/boffi-giacomo Dipartimento di Ingegneria Civile Ambientale e Territoriale Politecnico di Milano March 9, 07 Outline, a System

More information

Lecture 27: Structural Dynamics - Beams.

Lecture 27: Structural Dynamics - Beams. Chapter #16: Structural Dynamics and Time Dependent Heat Transfer. Lectures #1-6 have discussed only steady systems. There has been no time dependence in any problems. We will investigate beam dynamics

More information

Vibrations Qualifying Exam Study Material

Vibrations Qualifying Exam Study Material Vibrations Qualifying Exam Study Material The candidate is expected to have a thorough understanding of engineering vibrations topics. These topics are listed below for clarification. Not all instructors

More information

SHOCK RESPONSE OF MULTI-DEGREE-OF-FREEDOM SYSTEMS Revision F By Tom Irvine May 24, 2010

SHOCK RESPONSE OF MULTI-DEGREE-OF-FREEDOM SYSTEMS Revision F By Tom Irvine   May 24, 2010 SHOCK RESPONSE OF MULTI-DEGREE-OF-FREEDOM SYSTEMS Revision F By Tom Irvine Email: tomirvine@aol.com May 4, 010 Introduction The primary purpose of this tutorial is to present the Modal Transient method

More information

Matrix Iteration. Giacomo Boffi.

Matrix Iteration. Giacomo Boffi. http://intranet.dica.polimi.it/people/boffi-giacomo Dipartimento di Ingegneria Civile Ambientale e Territoriale Politecnico di Milano April 12, 2016 Outline Second -Ritz Method Dynamic analysis of MDOF

More information

Abstract. 1. Introduction

Abstract. 1. Introduction Dynamic effects for structures caused by moving vehicles J. Gyorgyi Department of Structural Mechanics, Technical University of Budapest, H-1521 Budapest, Hungary Email: gyorgy@botond.me.bme.hu Abstract

More information

Dynamic Response of Structures With Frequency Dependent Damping

Dynamic Response of Structures With Frequency Dependent Damping Dynamic Response of Structures With Frequency Dependent Damping Blanca Pascual & S Adhikari School of Engineering, Swansea University, Swansea, UK Email: S.Adhikari@swansea.ac.uk URL: http://engweb.swan.ac.uk/

More information

FREE VIBRATION RESPONSE OF UNDAMPED SYSTEMS

FREE VIBRATION RESPONSE OF UNDAMPED SYSTEMS Lecture Notes: STRUCTURAL DYNAMICS / FALL 2011 / Page: 1 FREE VIBRATION RESPONSE OF UNDAMPED SYSTEMS : : 0, 0 As demonstrated previously, the above Equation of Motion (free-vibration equation) has a solution

More information

Reduction in number of dofs

Reduction in number of dofs Reduction in number of dofs Reduction in the number of dof to represent a structure reduces the size of matrices and, hence, computational cost. Because a subset of the original dof represent the whole

More information

AA 242B / ME 242B: Mechanical Vibrations (Spring 2016)

AA 242B / ME 242B: Mechanical Vibrations (Spring 2016) AA 242B / ME 242B: Mechanical Vibrations (Spring 206) Solution of Homework #3 Control Tab Figure : Schematic for the control tab. Inadequacy of a static-test A static-test for measuring θ would ideally

More information

Substructuring using Impulse Response Functions for Impact Analysis

Substructuring using Impulse Response Functions for Impact Analysis Proceedings of the IMAC-XXVIII February 1 4, 21, Jacksonville, Florida USA 21 Society for Experimental Mechanics Inc. Substructuring using Impulse Response Functions for Impact Analysis Daniel J. Rixen

More information

ANNEX A: ANALYSIS METHODOLOGIES

ANNEX A: ANALYSIS METHODOLOGIES ANNEX A: ANALYSIS METHODOLOGIES A.1 Introduction Before discussing supplemental damping devices, this annex provides a brief review of the seismic analysis methods used in the optimization algorithms considered

More information

The Finite Element Method

The Finite Element Method Page he Finite Element Method for the Analysis of Non-Linear and Dynamic Systems Prof. o. Dr. Michael Havbro bo Faber Dr. Nebojsa Mojsilovic Swiss Federal Institute of EH Zurich, Switzerland Contents of

More information

Identification of Damping Using Proper Orthogonal Decomposition

Identification of Damping Using Proper Orthogonal Decomposition Identification of Damping Using Proper Orthogonal Decomposition M Khalil, S Adhikari and A Sarkar Department of Aerospace Engineering, University of Bristol, Bristol, U.K. Email: S.Adhikari@bristol.ac.uk

More information

Dr. Ian R. Manchester

Dr. Ian R. Manchester Dr Ian R. Manchester Week Content Notes 1 Introduction 2 Frequency Domain Modelling 3 Transient Performance and the s-plane 4 Block Diagrams 5 Feedback System Characteristics Assign 1 Due 6 Root Locus

More information

Outline. Structural Matrices. Giacomo Boffi. Introductory Remarks. Structural Matrices. Evaluation of Structural Matrices

Outline. Structural Matrices. Giacomo Boffi. Introductory Remarks. Structural Matrices. Evaluation of Structural Matrices Outline in MDOF Systems Dipartimento di Ingegneria Civile e Ambientale, Politecnico di Milano May 8, 014 Additional Today we will study the properties of structural matrices, that is the operators that

More information

PARALLEL COMPUTATION OF 3D WAVE PROPAGATION BY SPECTRAL STOCHASTIC FINITE ELEMENT METHOD

PARALLEL COMPUTATION OF 3D WAVE PROPAGATION BY SPECTRAL STOCHASTIC FINITE ELEMENT METHOD 13 th World Conference on Earthquake Engineering Vancouver, B.C., Canada August 1-6, 24 Paper No. 569 PARALLEL COMPUTATION OF 3D WAVE PROPAGATION BY SPECTRAL STOCHASTIC FINITE ELEMENT METHOD Riki Honda

More information

This appendix gives you a working knowledge of the theory used to implement flexible bodies in ADAMS. The topics covered include

This appendix gives you a working knowledge of the theory used to implement flexible bodies in ADAMS. The topics covered include Appendix D Theoretical Background This appendix gives you a working knowledge of the theory used to implement flexible bodies in ADAMS. The topics covered include modal superposition component mode synthesis,

More information

CIVL 8/7117 Chapter 12 - Structural Dynamics 1/75. To discuss the dynamics of a single-degree-of freedom springmass

CIVL 8/7117 Chapter 12 - Structural Dynamics 1/75. To discuss the dynamics of a single-degree-of freedom springmass CIV 8/77 Chapter - /75 Introduction To discuss the dynamics of a single-degree-of freedom springmass system. To derive the finite element equations for the time-dependent stress analysis of the one-dimensional

More information

Structural Dynamics. Spring mass system. The spring force is given by and F(t) is the driving force. Start by applying Newton s second law (F=ma).

Structural Dynamics. Spring mass system. The spring force is given by and F(t) is the driving force. Start by applying Newton s second law (F=ma). Structural Dynamics Spring mass system. The spring force is given by and F(t) is the driving force. Start by applying Newton s second law (F=ma). We will now look at free vibrations. Considering the free

More information

THE STATIC SUBSTRUCTURE METHOD FOR DYNAMIC ANALYSIS OF STRUCTURES. Lou Menglin* SUMMARY

THE STATIC SUBSTRUCTURE METHOD FOR DYNAMIC ANALYSIS OF STRUCTURES. Lou Menglin* SUMMARY 264 THE STATIC SUBSTRUCTURE METHOD FOR DYNAMIC ANALYSIS OF STRUCTURES Lou Mengl* SUMMARY In this paper, the static substructure method based on the Ritz vector direct superposition method is suggested

More information

Due Monday, November 16 th, 12:00 midnight

Due Monday, November 16 th, 12:00 midnight Due Monday, November 16 th, 12:00 midnight This homework is considering the finite element analysis of transient and dynamic FEM analysis. You are asked to include transient and/dynamic effects to MatLab

More information

More Examples Of Generalized Coordinates

More Examples Of Generalized Coordinates Slides of ecture 8 Today s Class: Review Of Homework From ecture 7 Hamilton s Principle More Examples Of Generalized Coordinates Calculating Generalized Forces Via Virtual Work /3/98 /home/djsegal/unm/vibcourse/slides/ecture8.frm

More information

Time integration and the Trefftz Method, Part II Second-order and hyperbolic problems

Time integration and the Trefftz Method, Part II Second-order and hyperbolic problems ime integration and the refftz Method, Part II Second-order and hyperbolic problems JA eixeira de Freitas Departamento de Engenharia Civil e Arquitectura, Instituto Superior écnico echnical University

More information

Structural Matrices in MDOF Systems

Structural Matrices in MDOF Systems in MDOF Systems http://intranet.dica.polimi.it/people/boffi-giacomo Dipartimento di Ingegneria Civile Ambientale e Territoriale Politecnico di Milano April 9, 2016 Outline Additional Static Condensation

More information

ON THE INTEGRATION OF EQUATIONS OF MOTION: FEM AND MOLECULAR DYNAMICS PROBLEMS

ON THE INTEGRATION OF EQUATIONS OF MOTION: FEM AND MOLECULAR DYNAMICS PROBLEMS 8th International Congress on Computational Mechanics, Volos, 1-15 July 015 ON THE INTEGRATION OF EQUATIONS OF MOTION: FEM AND MOLECULAR DYNAMICS PROBLEMS E.G. Kakouris, V.K. Koumousis Institute of Structural

More information

APPROXIMATE DYNAMIC MODEL SENSITIVITY ANALYSIS FOR LARGE, COMPLEX SPACE STRUCTURES. Timothy S. West, Senior Engineer

APPROXIMATE DYNAMIC MODEL SENSITIVITY ANALYSIS FOR LARGE, COMPLEX SPACE STRUCTURES. Timothy S. West, Senior Engineer APPROXIMATE DYNAMIC MODEL SENSITIVITY ANALYSIS FOR LARGE, COMPLEX SPACE STRUCTURES Timothy S. West, Senior Engineer McDonnell Douglas Aerospace Space Station Division, Houston, Texas ABSTRACT During the

More information

TWO-STAGE ISOLATION FOR HARMONIC BASE EXCITATION Revision A. By Tom Irvine February 25, 2008

TWO-STAGE ISOLATION FOR HARMONIC BASE EXCITATION Revision A. By Tom Irvine   February 25, 2008 TWO-STAGE ISOLATION FOR HARMONIC BASE EXCITATION Revision A By Tom Irvine Email: tomirvine@aol.com February 5, 008 Introduction Consider a base plate mass m and an avionics mass m modeled as two-degree-of-freedom.

More information

Modeling and Analysis Techniques. for Suspension Rubber Bushings

Modeling and Analysis Techniques. for Suspension Rubber Bushings Modeling and Analysis Techniques for Suspension Rubber Bushings Satoshi Ito*, Taro Koishikura*, and Daichi Suzuki** *Toyota Motor Corporation **Toyota Technical Development Corporation Abstract: Suspension

More information

Matrix Assembly in FEA

Matrix Assembly in FEA Matrix Assembly in FEA 1 In Chapter 2, we spoke about how the global matrix equations are assembled in the finite element method. We now want to revisit that discussion and add some details. For example,

More information

1. Multiple Degree-of-Freedom (MDOF) Systems: Introduction

1. Multiple Degree-of-Freedom (MDOF) Systems: Introduction 1. Multiple Degree-of-Freedom (MDOF) Systems: Introduction Lesson Objectives: 1) List examples of MDOF structural systems and state assumptions of the idealizations. 2) Formulate the equation of motion

More information

Structural System, Machines and Load Cases

Structural System, Machines and Load Cases Machine-Induced Vibrations Machine-Induced Vibrations In the following example the dynamic excitation of two rotating machines is analyzed. A time history analysis in the add-on module RF-DYNAM Pro - Forced

More information

Using Simulink to analyze 2 degrees of freedom system

Using Simulink to analyze 2 degrees of freedom system Using Simulink to analyze 2 degrees of freedom system Nasser M. Abbasi Spring 29 page compiled on June 29, 25 at 4:2pm Abstract A two degrees of freedom system consisting of two masses connected by springs

More information

LECTURE 14: DEVELOPING THE EQUATIONS OF MOTION FOR TWO-MASS VIBRATION EXAMPLES

LECTURE 14: DEVELOPING THE EQUATIONS OF MOTION FOR TWO-MASS VIBRATION EXAMPLES LECTURE 14: DEVELOPING THE EQUATIONS OF MOTION FOR TWO-MASS VIBRATION EXAMPLES Figure 3.47 a. Two-mass, linear vibration system with spring connections. b. Free-body diagrams. c. Alternative free-body

More information

Structural Dynamics A Graduate Course in Aerospace Engineering

Structural Dynamics A Graduate Course in Aerospace Engineering Structural Dynamics A Graduate Course in Aerospace Engineering By: H. Ahmadian ahmadian@iust.ac.ir The Science and Art of Structural Dynamics What do all the followings have in common? > A sport-utility

More information

3. Mathematical Properties of MDOF Systems

3. Mathematical Properties of MDOF Systems 3. Mathematical Properties of MDOF Systems 3.1 The Generalized Eigenvalue Problem Recall that the natural frequencies ω and modes a are found from [ - ω 2 M + K ] a = 0 or K a = ω 2 M a Where M and K are

More information

DYNAMICS OF MACHINERY 41514

DYNAMICS OF MACHINERY 41514 DYNAMICS OF MACHINERY 454 PROJECT : Theoretical and Experimental Modal Analysis and Validation of Mathematical Models in Multibody Dynamics Holistic Overview of the Project Steps & Their Conceptual Links

More information

Structural Analysis III Compatibility of Displacements & Principle of Superposition

Structural Analysis III Compatibility of Displacements & Principle of Superposition Structural Analysis III Compatibility of Displacements & Principle of Superposition 2007/8 Dr. Colin Caprani, Chartered Engineer 1 1. Introduction 1.1 Background In the case of 2-dimensional structures

More information

Truncation Errors Numerical Integration Multiple Support Excitation

Truncation Errors Numerical Integration Multiple Support Excitation Errors Numerical Integration Multiple Support Excitation http://intranet.dica.polimi.it/people/boffi-giacomo Dipartimento di Ingegneria Civile Ambientale e Territoriale Politecnico di Milano April 10,

More information

Mechanical and Structural Vibration: Theory and Applications

Mechanical and Structural Vibration: Theory and Applications Mechanical and Structural Vibration: Theory and Applications Jerry H. Ginsberg Errata to the First Printing: 17 August 2001 Pg. 15, second line:...and L 2 + x 2 x 1, respectively,... Pg. 15, 2nd eq. and

More information

D && 9.0 DYNAMIC ANALYSIS

D && 9.0 DYNAMIC ANALYSIS 9.0 DYNAMIC ANALYSIS Introduction When a structure has a loading which varies with time, it is reasonable to assume its response will also vary with time. In such cases, a dynamic analysis may have to

More information

Chapter 4 Analysis of a cantilever

Chapter 4 Analysis of a cantilever Chapter 4 Analysis of a cantilever Before a complex structure is studied performing a seismic analysis, the behaviour of simpler ones should be fully understood. To achieve this knowledge we will start

More information

Aalto University School of Engineering

Aalto University School of Engineering Aalto University School of Engineering Kul-24.4120 Ship Structural Design (P) Lecture 8 - Local and Global Vibratory Response Kul-24.4120 Ship Structures Response Lecture 5: Tertiary Response: Bending

More information

Design of Earthquake-Resistant Structures

Design of Earthquake-Resistant Structures NATIONAL TECHNICAL UNIVERSITY OF ATHENS LABORATORY OF EARTHQUAKE ENGINEERING Design of Earthquake-Resistant Structures Basic principles Ioannis N. Psycharis Basic considerations Design earthquake: small

More information

DEFLECTION CALCULATIONS (from Nilson and Nawy)

DEFLECTION CALCULATIONS (from Nilson and Nawy) DEFLECTION CALCULATIONS (from Nilson and Nawy) The deflection of a uniformly loaded flat plate, flat slab, or two-way slab supported by beams on column lines can be calculated by an equivalent method that

More information

Sampling considerations for modal analysis with damping

Sampling considerations for modal analysis with damping Sampling considerations for modal analysis with damping Jae Young Park, a Michael B Wakin, b and Anna C Gilbert c a University of Michigan, 3 Beal Ave, Ann Arbor, MI 489 USA b Colorado School of Mines,

More information

on the figure. Someone has suggested that, in terms of the degrees of freedom x1 and M. Note that if you think the given 1.2

on the figure. Someone has suggested that, in terms of the degrees of freedom x1 and M. Note that if you think the given 1.2 1) A two-story building frame is shown below. The mass of the frame is assumed to be lumped at the floor levels and the floor slabs are considered rigid. The floor masses and the story stiffnesses are

More information

Finite element analysis of rotating structures

Finite element analysis of rotating structures Finite element analysis of rotating structures Dr. Louis Komzsik Chief Numerical Analyst Siemens PLM Software Why do rotor dynamics with FEM? Very complex structures with millions of degrees of freedom

More information

1.6: 16, 20, 24, 27, 28

1.6: 16, 20, 24, 27, 28 .6: 6, 2, 24, 27, 28 6) If A is positive definite, then A is positive definite. The proof of the above statement can easily be shown for the following 2 2 matrix, a b A = b c If that matrix is positive

More information

Dr.Vinod Hosur, Professor, Civil Engg.Dept., Gogte Institute of Technology, Belgaum

Dr.Vinod Hosur, Professor, Civil Engg.Dept., Gogte Institute of Technology, Belgaum STRUCTURAL DYNAMICS Dr.Vinod Hosur, Professor, Civil Engg.Dept., Gogte Institute of Technology, Belgaum Overview of Structural Dynamics Structure Members, joints, strength, stiffness, ductility Structure

More information

Resonance characteristics of two-span continuous beam under moving high speed trains

Resonance characteristics of two-span continuous beam under moving high speed trains 7(200) 85 99 Resonance characteristics of two-span continuous beam under moving high speed trains Abstract The resonance characteristics of a two-span continuous beam traversed by moving high speed trains

More information

Multiple Degree of Freedom Systems. The Millennium bridge required many degrees of freedom to model and design with.

Multiple Degree of Freedom Systems. The Millennium bridge required many degrees of freedom to model and design with. Multiple Degree of Freedom Systems The Millennium bridge required many degrees of freedom to model and design with. The first step in analyzing multiple degrees of freedom (DOF) is to look at DOF DOF:

More information

Effects of Damping Ratio of Restoring force Device on Response of a Structure Resting on Sliding Supports with Restoring Force Device

Effects of Damping Ratio of Restoring force Device on Response of a Structure Resting on Sliding Supports with Restoring Force Device Effects of Damping Ratio of Restoring force Device on Response of a Structure Resting on Sliding Supports with Restoring Force Device A. Krishnamoorthy Professor, Department of Civil Engineering Manipal

More information

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems: Thermomechanics

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems: Thermomechanics The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems: Thermomechanics Prof. Dr. Eleni Chatzi Dr. Giuseppe Abbiati, Dr. Konstantinos Agathos Lecture 13-14 December, 2017 1 / 30 Forewords

More information

Dynamics of Ocean Structures Prof. Dr. Srinivasan Chandrasekaran Department of Ocean Engineering Indian Institute of Technology, Madras

Dynamics of Ocean Structures Prof. Dr. Srinivasan Chandrasekaran Department of Ocean Engineering Indian Institute of Technology, Madras Dynamics of Ocean Structures Prof. Dr. Srinivasan Chandrasekaran Department of Ocean Engineering Indian Institute of Technology, Madras Lecture 25 Continuous System In the last class, in this, we will

More information

Preliminary Examination - Dynamics

Preliminary Examination - Dynamics Name: University of California, Berkeley Fall Semester, 2018 Problem 1 (30% weight) Preliminary Examination - Dynamics An undamped SDOF system with mass m and stiffness k is initially at rest and is then

More information

Stochastic structural dynamic analysis with random damping parameters

Stochastic structural dynamic analysis with random damping parameters Stochastic structural dynamic analysis with random damping parameters K. Sepahvand 1, F. Saati Khosroshahi, C. A. Geweth and S. Marburg Chair of Vibroacoustics of Vehicles and Machines Department of Mechanical

More information

Modal Analysis: What it is and is not Gerrit Visser

Modal Analysis: What it is and is not Gerrit Visser Modal Analysis: What it is and is not Gerrit Visser What is a Modal Analysis? What answers do we get out of it? How is it useful? What does it not tell us? In this article, we ll discuss where a modal

More information

Control Systems I. Lecture 5: Transfer Functions. Readings: Emilio Frazzoli. Institute for Dynamic Systems and Control D-MAVT ETH Zürich

Control Systems I. Lecture 5: Transfer Functions. Readings: Emilio Frazzoli. Institute for Dynamic Systems and Control D-MAVT ETH Zürich Control Systems I Lecture 5: Transfer Functions Readings: Emilio Frazzoli Institute for Dynamic Systems and Control D-MAVT ETH Zürich October 20, 2017 E. Frazzoli (ETH) Lecture 5: Control Systems I 20/10/2017

More information

Numerical Solution of Equation of Motion

Numerical Solution of Equation of Motion Class Notes: Earthquake Engineering, Ahmed Elgamal, September 25, 2001 (DRAFT) Numerical Solution of Equation of Motion Average Acceleration Method (Trapezoidal method) m a + c v + k d = f (t) In the above

More information

Modal Decomposition and the Time-Domain Response of Linear Systems 1

Modal Decomposition and the Time-Domain Response of Linear Systems 1 MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING.151 Advanced System Dynamics and Control Modal Decomposition and the Time-Domain Response of Linear Systems 1 In a previous handout

More information

JUST THE MATHS UNIT NUMBER 9.9. MATRICES 9 (Modal & spectral matrices) A.J.Hobson

JUST THE MATHS UNIT NUMBER 9.9. MATRICES 9 (Modal & spectral matrices) A.J.Hobson JUST THE MATHS UNIT NUMBER 9.9 MATRICES 9 (Modal & spectral matrices) by A.J.Hobson 9.9. Assumptions and definitions 9.9.2 Diagonalisation of a matrix 9.9.3 Exercises 9.9.4 Answers to exercises UNIT 9.9

More information

Parallel Methods for ODEs

Parallel Methods for ODEs Parallel Methods for ODEs Levels of parallelism There are a number of levels of parallelism that are possible within a program to numerically solve ODEs. An obvious place to start is with manual code restructuring

More information

Modeling of Resonators

Modeling of Resonators . 23 Modeling of Resonators 23 1 Chapter 23: MODELING OF RESONATORS 23 2 23.1 A GENERIC RESONATOR A second example where simplified discrete modeling has been found valuable is in the assessment of the

More information

Application of a novel method to identify multi-axis joint properties

Application of a novel method to identify multi-axis joint properties Application of a novel method to identify multi-axis joint properties Scott Noll, Jason Dreyer, and Rajendra Singh The Ohio State University, 219 W. 19 th Avenue, Columbus, Ohio 4321 USA ABSTRACT This

More information

New implicit method for analysis of problems in nonlinear structural dynamics

New implicit method for analysis of problems in nonlinear structural dynamics Applied and Computational Mechanics 5 (2011) 15 20 New implicit method for analysis of problems in nonlinear structural dynamics A. A. Gholampour a,, M. Ghassemieh a a School of Civil Engineering, University

More information

Chapter 23: Principles of Passive Vibration Control: Design of absorber

Chapter 23: Principles of Passive Vibration Control: Design of absorber Chapter 23: Principles of Passive Vibration Control: Design of absorber INTRODUCTION The term 'vibration absorber' is used for passive devices attached to the vibrating structure. Such devices are made

More information

Undamped Free Vibrations (Simple Harmonic Motion; SHM also called Simple Harmonic Oscillator)

Undamped Free Vibrations (Simple Harmonic Motion; SHM also called Simple Harmonic Oscillator) Section 3. 7 Mass-Spring Systems (no damping) Key Terms/ Ideas: Hooke s Law of Springs Undamped Free Vibrations (Simple Harmonic Motion; SHM also called Simple Harmonic Oscillator) Amplitude Natural Frequency

More information

Some Aspects of Structural Dynamics

Some Aspects of Structural Dynamics Appendix B Some Aspects of Structural Dynamics This Appendix deals with some aspects of the dynamic behavior of SDOF and MDOF. It starts with the formulation of the equation of motion of SDOF systems.

More information

Dynamics of structures

Dynamics of structures Dynamics of structures 2.Vibrations: single degree of freedom system Arnaud Deraemaeker (aderaema@ulb.ac.be) 1 One degree of freedom systems in real life 2 1 Reduction of a system to a one dof system Example

More information

A consistent dynamic finite element formulation for a pipe using Euler parameters

A consistent dynamic finite element formulation for a pipe using Euler parameters 111 A consistent dynamic finite element formulation for a pipe using Euler parameters Ara Arabyan and Yaqun Jiang Department of Aerospace and Mechanical Engineering, University of Arizona, Tucson, AZ 85721,

More information

Software Verification

Software Verification SAP000 EXAMPLE 6-00 LINK LINEAR LINK WITH RAMP LOADING PROBLEM DESCRIPTION In this example a ramp load is applied to an undamped single degree of freedom structure. The ramp loading has a finite rise time

More information

A NEW METHOD FOR VIBRATION MODE ANALYSIS

A NEW METHOD FOR VIBRATION MODE ANALYSIS Proceedings of IDETC/CIE 25 25 ASME 25 International Design Engineering Technical Conferences & Computers and Information in Engineering Conference Long Beach, California, USA, September 24-28, 25 DETC25-85138

More information

ME 475 Modal Analysis of a Tapered Beam

ME 475 Modal Analysis of a Tapered Beam ME 475 Modal Analysis of a Tapered Beam Objectives: 1. To find the natural frequencies and mode shapes of a tapered beam using FEA.. To compare the FE solution to analytical solutions of the vibratory

More information

PROJECT 1 DYNAMICS OF MACHINES 41514

PROJECT 1 DYNAMICS OF MACHINES 41514 PROJECT DYNAMICS OF MACHINES 454 Theoretical and Experimental Modal Analysis and Validation of Mathematical Models in Multibody Dynamics Ilmar Ferreira Santos, Professor Dr.-Ing., Dr.Techn., Livre-Docente

More information

Effect of Mass Matrix Formulation Schemes on Dynamics of Structures

Effect of Mass Matrix Formulation Schemes on Dynamics of Structures Effect of Mass Matrix Formulation Schemes on Dynamics of Structures Swapan Kumar Nandi Tata Consultancy Services GEDC, 185 LR, Chennai 600086, India Sudeep Bosu Tata Consultancy Services GEDC, 185 LR,

More information

Collocated versus non-collocated control [H04Q7]

Collocated versus non-collocated control [H04Q7] Collocated versus non-collocated control [H04Q7] Jan Swevers September 2008 0-0 Contents Some concepts of structural dynamics Collocated versus non-collocated control Summary This lecture is based on parts

More information

Structural Damage Detection Using Time Windowing Technique from Measured Acceleration during Earthquake

Structural Damage Detection Using Time Windowing Technique from Measured Acceleration during Earthquake Structural Damage Detection Using Time Windowing Technique from Measured Acceleration during Earthquake Seung Keun Park and Hae Sung Lee ABSTRACT This paper presents a system identification (SI) scheme

More information

Static & Dynamic. Analysis of Structures. Edward L.Wilson. University of California, Berkeley. Fourth Edition. Professor Emeritus of Civil Engineering

Static & Dynamic. Analysis of Structures. Edward L.Wilson. University of California, Berkeley. Fourth Edition. Professor Emeritus of Civil Engineering Static & Dynamic Analysis of Structures A Physical Approach With Emphasis on Earthquake Engineering Edward LWilson Professor Emeritus of Civil Engineering University of California, Berkeley Fourth Edition

More information

2.314/1.56/2.084/13.14 Fall Problem Set IX Solution

2.314/1.56/2.084/13.14 Fall Problem Set IX Solution Solution: The pipe can be modeled as in Figure 1..314/1.56/.084/13.14 Fall 006 Problem Set IX Solution m Lumped mass P R m P Pipe eam with the same support Geometr and properties: L=3m, R=0.105m and t=0.007m

More information

EQUIVALENT SINGLE-DEGREE-OF-FREEDOM SYSTEM AND FREE VIBRATION

EQUIVALENT SINGLE-DEGREE-OF-FREEDOM SYSTEM AND FREE VIBRATION 1 EQUIVALENT SINGLE-DEGREE-OF-FREEDOM SYSTEM AND FREE VIBRATION The course on Mechanical Vibration is an important part of the Mechanical Engineering undergraduate curriculum. It is necessary for the development

More information

Codal Provisions IS 1893 (Part 1) 2002

Codal Provisions IS 1893 (Part 1) 2002 Abstract Codal Provisions IS 1893 (Part 1) 00 Paresh V. Patel Assistant Professor, Civil Engineering Department, Nirma Institute of Technology, Ahmedabad 38481 In this article codal provisions of IS 1893

More information

Review of Strain Energy Methods and Introduction to Stiffness Matrix Methods of Structural Analysis

Review of Strain Energy Methods and Introduction to Stiffness Matrix Methods of Structural Analysis uke University epartment of Civil and Environmental Engineering CEE 42L. Matrix Structural Analysis Henri P. Gavin Fall, 22 Review of Strain Energy Methods and Introduction to Stiffness Matrix Methods

More information

EVALUATING DYNAMIC STRESSES OF A PIPELINE

EVALUATING DYNAMIC STRESSES OF A PIPELINE EVALUATING DYNAMIC STRESSES OF A PIPELINE by K.T. TRUONG Member ASME Mechanical & Piping Division THE ULTRAGEN GROUP LTD 2255 Rue De La Province Longueuil (Quebec) J4G 1G3 This document is provided to

More information

ME scope Application Note 28

ME scope Application Note 28 App Note 8 www.vibetech.com 3/7/17 ME scope Application Note 8 Mathematics of a Mass-Spring-Damper System INTRODUCTION In this note, the capabilities of ME scope will be used to build a model of the mass-spring-damper

More information

Appendix A Equations of Motion in the Configuration and State Spaces

Appendix A Equations of Motion in the Configuration and State Spaces Appendix A Equations of Motion in the Configuration and State Spaces A.1 Discrete Linear Systems A.1.1 Configuration Space Consider a system with a single degree of freedom and assume that the equation

More information

Software Verification

Software Verification EXAMPLE 6-003 LINK GAP ELEMENT PROBLEM DESCRIPTION This example uses a single-bay, single-story rigid frame to test the gap link element. This link element carries compression loads only; it has zero stiffness

More information

IDENTIFICATION OF SEMI-RIGID JOINTS IN FRAME STRUCTURES

IDENTIFICATION OF SEMI-RIGID JOINTS IN FRAME STRUCTURES 6th ECCOMAS Conference on Smart Structures and Materials SMART213 Politecnico di Torino, 24-26 June 213 E. Carrera, F. Miglioretti and M. Petrolo (Editors) www.smart213.com IDENTIFICATION OF SEMI-RIGID

More information

DYNAMIC CHARACTERISTICS OF ELASTICALLY SUPPORTED BEAM SUBJECTED TO A COMPRESSIVE AXIAL FORCE AND A MOVING LOAD

DYNAMIC CHARACTERISTICS OF ELASTICALLY SUPPORTED BEAM SUBJECTED TO A COMPRESSIVE AXIAL FORCE AND A MOVING LOAD Vietnam Journal of Mechanics, VAST, Vol. 33, No. (), pp. 3 3 DYNAMIC CHARACTERISTICS OF ELASTICALLY SUPPORTED BEAM SUBJECTED TO A COMPRESSIVE AXIAL FORCE AND A MOVING LOAD Nguyen Dinh Kien, Le Thi Ha Institute

More information

EFFECTIVE MODAL MASS & MODAL PARTICIPATION FACTORS Revision F

EFFECTIVE MODAL MASS & MODAL PARTICIPATION FACTORS Revision F EFFECTIVE MODA MASS & MODA PARTICIPATION FACTORS Revision F By Tom Irvine Email: tomirvine@aol.com March 9, 1 Introduction The effective modal mass provides a method for judging the significance of a vibration

More information

Efficient Reduced Order Modeling of Low- to Mid-Frequency Vibration and Power Flow in Complex Structures

Efficient Reduced Order Modeling of Low- to Mid-Frequency Vibration and Power Flow in Complex Structures Efficient Reduced Order Modeling of Low- to Mid-Frequency Vibration and Power Flow in Complex Structures Yung-Chang Tan Graduate Student Research Assistant Matthew P. Castanier Assistant Research Scientist

More information