Session 1 : Fundamental concepts

Size: px
Start display at page:

Download "Session 1 : Fundamental concepts"

Transcription

1 BRUFACE Vibrations and Acoustics MA1 Academic year Cédric Dumoulin Arnaud Deraemaeker Exercise 1 Session 1 : Fundamental concepts Consider the following one-degree-of-freedom (1 DOF) system Write the equation of motion in the time domain. mẍ + cẋ + kx = f Give the expression of ω n and of ξ ω n = k/m ξ = c mk For this system a) Give the expression of the impulse response and represent it using the following numerical values: m = 1 kg, k = 16 N/m, c =.1 Ns/m) with ω d = ω n 1 ξ h(t) = 1 mω d e ξωnt sin ω d t t=linspace(,1,1); k=16; m=1; c=.1; wn=sqrt(k/m); xi=c/(*sqrt(k*m)); wd=wn*sqrt(1-xiˆ); h=1/(m*wd)*exp(-xi*wn*t).*sin(wd*t); figure; set(gca, Fontsize,15); plot(t,h); xlabel( time ); ylabel( Impulse response h(t) )

2 b) Give the expression of the harmonic forced response and represent it using the Bode diagram H(ω) = X F = 1 m (ω n ω + jξωω n ) w=linspace(,,1); H=1./(m*(wnˆ-w.ˆ+*j*xi*w*wn)); figure; set(gca, Fontsize,15); subplot(,1,1); plot(w,*log1(abs(h))); xlabel( \omega );ylabel( Mag(dB) ) subplot(,1,); plot(w,angle(h)*18/pi); xlabel( \omega );ylabel( Phase(deg) ) c) Plot the Nyquist diagram and indicate the resonant frequency as well as some intermediary frequencies on the diagram. Comment. RE=real(H); IM=imag(H); figure; set(gca, Fontsize,15); plot(re(:),im(:)); xlabel( Re(H) ); ylabel( Im(H) ) ind=[ ]; for i=ind text(re(i),im(i),[ \omega= numstr(w(i))]) The Nyquist plot looks like a circle, we clearly see that most values on the circle correspond to a frequency range in the close vicinity of the resonant frequency of the system. d) Repeats points a),b) and c) with the following successive values of damping: c =.1 Ns/m, c =.5 Ns/m, c = 1 Ns/m. What are the corresponding values of ξ? Plot the respective responses on the same plot t=linspace(,1,1); k=16; m=1; c=.1; wn=sqrt(k/m); ci=[.1.5 1]; color= rgb ; figure; set(gca, Fontsize,15) for i=1:length(ci) c=ci(i); xi=c/(*sqrt(k*m)); wd=wn*sqrt(1-xiˆ); h=1/(m*wd)*exp(-xi*wn*t).*sin(wd*t); plot(t,h,color(i)); hold on; figure; set(gca, Fontsize,15) for i=1:length(ci) c=ci(i); xi=c/(*sqrt(k*m)); wd=wn*sqrt(1-xiˆ); H=1./(m*(wnˆ-w.ˆ+*j*xi*w*wn)); subplot(,1,1); plot(w,*log1(abs(h)),color(i)); hold on xlabel( \omega );ylabel( Mag(dB) )

3 subplot(,1,); plot(w,angle(h)*18/pi,color(i)); hold on xlabel( \omega );ylabel( Phase(deg) ) figure; set(gca, Fontsize,15) for i=1:length(ci) c=ci(i); xi=c/(*sqrt(k*m)); wd=wn*sqrt(1-xiˆ); H=1./(m*(wnˆ-w.ˆ+*j*xi*w*wn)); RE=real(H); IM=imag(H); plot(re(:),im(:),color(i)); hold on xlabel( Re(H) ); ylabel( Im(H) ) c =.1 ξ =.15 c =.5 ξ =.65 c = 1 ξ = 1.5 e) Write the relationship between the impulse response and the forced harmonic response. Verify numerically that it is valid. H(ω) = h(τ)e jωτ dτ t=linspace(,15,1); dt=t()-t(1); k=16; m=1; c=.1; wn=sqrt(k/m); xi=c/(*sqrt(k*m)); wd=wn*sqrt(1-xiˆ); h=1/(m*wd)*exp(-xi*wn*t).*sin(wd*t); a=fft(h)*dt; % see note below w=linspace(,1/dt**pi,length(a)); H=1./(m*(wnˆ-w.ˆ+*j*xi*w*wn)); figure; plot(w,*log1(abs(a))); hold on; plot(w,*log1(abs(h(:))), g ); set(gca, Xim,[ ]) leg( FT of h(t), H ); Note : the discrete Fourier transform (DFT) is defined as : c n = 1 T T u(t) e inω t dt When the signal u(t) is sampled at m regular time intervals with time spacing t, for a small value of t we have m m c n T t u(j t) e inωj t = t u(j t) e inωj t = ( t)fft(u) j= where fft(u) is the discrete Fourier transform of a sampled signal as computed in Matlab using the Fast Fourier Transform algorithm (FFT). For the limit of T, c n T is the continuous Fourier transform. Therefore a good approximation of the continuous Fourier transform can be obtained by taking a long period T, a short time spacing t, and performing the discrete fourier transform f f t(u) in Matlab, then multiplying by t. j=

4 Exercise Consider a bridge crane consisting of a simply supported beam to which the lifting system is attached, as shown in Figure 1(a). The system can be modeled as a simply supported beam to which a mass m (equal to the total mass of the lifting system and the weight) is attached, as shown in Figure (a). (a) Bridge crane (b) 1DOF model. Figure 1: Bridge crane and equivalent SDOF system EI;úS m (a) Model of the bridge crane EI;úS m W (b) Model of the bridge crane with an additional mass W Figure : Bridge crane model with and without additional mass The beam is a steel IPE 75x196 (see tables) of length = 1m (E = 1GP a, ρ = 78kg/m 3 ), and the mass m is 5 Tons. Assuming that the mass of the beam is small with respect to the mass m, which is located at position x = /: 1. Determine the stiffness k, and the mass M of the equivalent 1 DOF system represented in Figure 1(b) (use the tables provided). Use the energy method in order to determine

5 the part of the equivalent mass due to the mass of the beam. Give the expression of the eigenfrequency of the equivalent 1 DOF system. For the stiffness, from the tables, we find : k = 48EI 3 = = 4kN/m For the equivalent mass, the kinetic energy is computed on a half beam. The static displacement profile under a load P is given by y(x) = P ( ) 3 x 1EI 4 x3 < x < / and the velocity profile is therefore assumed to be ( ) v(x) = 3 x 4 4 x3 x 3 1 so that the velocity of the center point where the mass m is attached is v(/) = x 1 The kinetic energy of the half beam is given by [ E k = 1 which requires to compute the following integral = [ 3 4 x 3 = 16 ρ 16 ( ) 3 x dx] 6 4 x3 ( ) 3 x 4 x3 dx ( 9 4 x + x 6 3 ) 16 x 4 dx + x7 7 3 ] 1 x 5 = = m a1 = 16ρ = 17 7 ρ m a = ρ = m beam The additional mass due to a half-beam is therefore m a1 = 16ρ = 17 7 ρ x 1

6 And for the full beam, taking into account the numerical values, we have m a = ρ = m beam = = 951kg The natural frequency of the system is therefore: f n = π = 1.15 (Hz) Hint for the equivalent mass due to the mass of the beam: Assume that the displacement profile of the beam is proportional to the static displacement of the beam due to a point force in the middle of the beam compute the associated kinetic energy and identify the equivalent mass by comparing with the kinetic energy of the 1 DOF system. Plot the shape of the frequency response function of the equivalent 1 DOF system assuming a damping value of ξ =.1. What is the amplification factor with respect to the static response? How many eigenfrequencies are present? How many eigenfrequencies would be present if you were to plot the frequency response function of the real system? k=.4*1e7; m = 5951 ; xi=.1; b=*xi*sqrt(k*m); w=linspace(,**pi,1); figure; plot(w/(*pi), *log1(abs(1./(k-w.ˆ*m+j*w*b)))) xlabel( Frequency (Hz) ); ylabel ( Disp center of beam (db) ) The static displacement under unit force is The amplification factor is X = 1/k = m 1 ξ = 5 so that for a dynamic force of 1kN, the amplitude of the displacement at the center of the beam will be X =.64mm. For the real system, there is an infinite number of eigenfrequencies due to the fact that the beam is a continuous system. 3. Assume that an additional weight of mass W = 1kg is attached to the lifting system (Figure (b)). At time t =, The rope attaching this additional mass is cut. Plot the shape of the evolution of the displacement in the vertical direction at position x = / as a function of time (assume a damping value of ξ =.1 and use the equivalent 1 DOF representation). Indicate the value of the period of oscillation. How many oscillations are needed to reduce the amplitude of vibration by approximately one half? Use the logarithmic decrement method to determine the damping coefficient. If we consider that the system is at equilibrium before we add the mass W, we take the displacement of the center of the beam as the reference zero displacement. Adding the mass of 1 kg results in an initial displacement of: x = F/k = / =.45mm

7 and an initial zero velocity. The general form of the solution is: ( x(t) = e ξωnt x cos ω d t + x ) + ω n ξx sin ω d t ω d and for a zero initial velocity : ( x(t) = e ξωnt x cos ω d t + ω ) nξx sin ω d t ω d t=linspace(,5,1); k=.4*1e7; m = 5951 ; xi=.1; b=*xi*sqrt(k*m); x=4.5e-4; wn=sqrt(k/m); wd=wn*sqrt(1-xiˆ); x=exp(-xi*wn*t).*(x*cos(wd*t)+wn/wd*xi*x*sin(wd*t)); figure; plot(t,x); xlabel( time(s) ); ylabel( Amplitude (m) ) The period of oscillation is given by T = 1 f = π ω d =.985s And using the logarithmic decrement method : x=x; n=; for i=1:n [ind(i)]=find(x==max(x)); x=x(ind(i):); j=find(x<); x=x(j:); max=x(ind) xi=1/(*pi*(n-1))*log(max(1)/max()); we can check that the value is very close to ξ =.1.

Session 2: MDOF systems

Session 2: MDOF systems BRUFACE Vibrations and Acoustics MA Academic year 7-8 Cédric Dumoulin (cedumoul@ulb.ac.be) Arnaud Deraemaeker (aderaema@ulb.ac.be) Session : MDOF systems Exercise : Multiple DOFs System Consider the following

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 Outline of the chapter *One degree of freedom systems in real life Hypothesis Examples *Response

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

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

Introduction to Vibration. Professor Mike Brennan

Introduction to Vibration. Professor Mike Brennan Introduction to Vibration Professor Mie Brennan Introduction to Vibration Nature of vibration of mechanical systems Free and forced vibrations Frequency response functions Fundamentals For free vibration

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

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

Dynamics of Structures: Theory and Analysis

Dynamics of Structures: Theory and Analysis 1. Free vibrations 2. Forced vibrations 3. Transient response 4. Damping mechanisms Dynamics of Structures: Theory and Analysis Steen Krenk Technical University of Denmark 5. Modal analysis I: Basic idea

More information

STRUCTURAL DYNAMICS BASICS:

STRUCTURAL DYNAMICS BASICS: BASICS: STRUCTURAL DYNAMICS Real-life structures are subjected to loads which vary with time Except self weight of the structure, all other loads vary with time In many cases, this variation of the load

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

Introduction to Vibration. Mike Brennan UNESP, Ilha Solteira São Paulo Brazil

Introduction to Vibration. Mike Brennan UNESP, Ilha Solteira São Paulo Brazil Introduction to Vibration Mike Brennan UNESP, Ilha Solteira São Paulo Brazil Vibration Most vibrations are undesirable, but there are many instances where vibrations are useful Ultrasonic (very high

More information

Math Assignment 5

Math Assignment 5 Math 2280 - Assignment 5 Dylan Zwick Fall 2013 Section 3.4-1, 5, 18, 21 Section 3.5-1, 11, 23, 28, 35, 47, 56 Section 3.6-1, 2, 9, 17, 24 1 Section 3.4 - Mechanical Vibrations 3.4.1 - Determine the period

More information

Introduction to structural dynamics

Introduction to structural dynamics Introduction to structural dynamics p n m n u n p n-1 p 3... m n-1 m 3... u n-1 u 3 k 1 c 1 u 1 u 2 k 2 m p 1 1 c 2 m2 p 2 k n c n m n u n p n m 2 p 2 u 2 m 1 p 1 u 1 Static vs dynamic analysis Static

More information

Solutions - Homework # 3

Solutions - Homework # 3 ECE-34: Signals and Systems Summer 23 PROBLEM One period of the DTFS coefficients is given by: X[] = (/3) 2, 8. Solutions - Homewor # 3 a) What is the fundamental period 'N' of the time-domain signal x[n]?

More information

Chapter 5 Design. D. J. Inman 1/51 Mechanical Engineering at Virginia Tech

Chapter 5 Design. D. J. Inman 1/51 Mechanical Engineering at Virginia Tech Chapter 5 Design Acceptable vibration levels (ISO) Vibration isolation Vibration absorbers Effects of damping in absorbers Optimization Viscoelastic damping treatments Critical Speeds Design for vibration

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

2. Determine whether the following pair of functions are linearly dependent, or linearly independent:

2. Determine whether the following pair of functions are linearly dependent, or linearly independent: Topics to be covered on the exam include: Recognizing, and verifying solutions to homogeneous second-order linear differential equations, and their corresponding Initial Value Problems Recognizing and

More information

Solutions for homework 5

Solutions for homework 5 1 Section 4.3 Solutions for homework 5 17. The following equation has repeated, real, characteristic roots. Find the general solution. y 4y + 4y = 0. The characteristic equation is λ 4λ + 4 = 0 which has

More information

Structural Dynamics Lecture 2. Outline of Lecture 2. Single-Degree-of-Freedom Systems (cont.)

Structural Dynamics Lecture 2. Outline of Lecture 2. Single-Degree-of-Freedom Systems (cont.) Outline of Single-Degree-of-Freedom Systems (cont.) Linear Viscous Damped Eigenvibrations. Logarithmic decrement. Response to Harmonic and Periodic Loads. 1 Single-Degreee-of-Freedom Systems (cont.). Linear

More information

Chapter 14 Oscillations. Copyright 2009 Pearson Education, Inc.

Chapter 14 Oscillations. Copyright 2009 Pearson Education, Inc. Chapter 14 Oscillations 14-1 Oscillations of a Spring If an object vibrates or oscillates back and forth over the same path, each cycle taking the same amount of time, the motion is called periodic. The

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

Chapter 14 Oscillations

Chapter 14 Oscillations Chapter 14 Oscillations If an object vibrates or oscillates back and forth over the same path, each cycle taking the same amount of time, the motion is called periodic. The mass and spring system is a

More information

MATH 2250 Final Exam Solutions

MATH 2250 Final Exam Solutions MATH 225 Final Exam Solutions Tuesday, April 29, 28, 6: 8:PM Write your name and ID number at the top of this page. Show all your work. You may refer to one double-sided sheet of notes during the exam

More information

2.003 Engineering Dynamics Problem Set 10 with answer to the concept questions

2.003 Engineering Dynamics Problem Set 10 with answer to the concept questions .003 Engineering Dynamics Problem Set 10 with answer to the concept questions Problem 1 Figure 1. Cart with a slender rod A slender rod of length l (m) and mass m (0.5kg)is attached by a frictionless pivot

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

CE 6701 Structural Dynamics and Earthquake Engineering Dr. P. Venkateswara Rao

CE 6701 Structural Dynamics and Earthquake Engineering Dr. P. Venkateswara Rao CE 6701 Structural Dynamics and Earthquake Engineering Dr. P. Venkateswara Rao Associate Professor Dept. of Civil Engineering SVCE, Sriperumbudur Difference between static loading and dynamic loading Degree

More information

Tuning TMDs to Fix Floors in MDOF Shear Buildings

Tuning TMDs to Fix Floors in MDOF Shear Buildings Tuning TMDs to Fix Floors in MDOF Shear Buildings This is a paper I wrote in my first year of graduate school at Duke University. It applied the TMD tuning methodology I developed in my undergraduate research

More information

2C9 Design for seismic and climate changes. Jiří Máca

2C9 Design for seismic and climate changes. Jiří Máca 2C9 Design for seismic and climate changes Jiří Máca List of lectures 1. Elements of seismology and seismicity I 2. Elements of seismology and seismicity II 3. Dynamic analysis of single-degree-of-freedom

More information

Figure 1: System of three coupled harmonic oscillators with fixed boundary conditions. 2 (u i+1 u i ) 2. i=0

Figure 1: System of three coupled harmonic oscillators with fixed boundary conditions. 2 (u i+1 u i ) 2. i=0 Department of Applied Physics, Chalmers, Göteborg Martin Gren, Göran Wahnström 014-11-03 E1 Coupled harmonic oscillators Oscillatory motion is common in physics. Here we will consider coupled harmonic

More information

ME 563 HOMEWORK # 7 SOLUTIONS Fall 2010

ME 563 HOMEWORK # 7 SOLUTIONS Fall 2010 ME 563 HOMEWORK # 7 SOLUTIONS Fall 2010 PROBLEM 1: Given the mass matrix and two undamped natural frequencies for a general two degree-of-freedom system with a symmetric stiffness matrix, find the stiffness

More information

Physics 2101 S c e t c i cti n o 3 n 3 March 31st Announcements: Quiz today about Ch. 14 Class Website:

Physics 2101 S c e t c i cti n o 3 n 3 March 31st Announcements: Quiz today about Ch. 14 Class Website: Physics 2101 Section 3 March 31 st Announcements: Quiz today about Ch. 14 Class Website: http://www.phys.lsu.edu/classes/spring2010/phys2101 3/ http://www.phys.lsu.edu/~jzhang/teaching.html Simple Harmonic

More information

DYNAMICS OF MACHINES 41614

DYNAMICS OF MACHINES 41614 DYNAMICS OF MACHINES 464 PART I INTRODUCTION TO THE BASIC TOOLS OF MODELLING, SIMULATION, ANALYSIS & EXPERIMENTAL VALIDATION 6 x 4 Angular Velocity: rpm Mode: Nat. Freq.: 4.788 Hz 4 4 3 x 4 Signal (a)

More information

State Space Representation

State Space Representation ME Homework #6 State Space Representation Last Updated September 6 6. From the homework problems on the following pages 5. 5. 5.6 5.7. 5.6 Chapter 5 Homework Problems 5.6. Simulation of Linear and Nonlinear

More information

MAE106 Laboratory Exercises Lab # 6 - Vibrating systems

MAE106 Laboratory Exercises Lab # 6 - Vibrating systems MAE106 Laboratory Exercises Lab # 6 - Vibrating systems Goals Understand how the oscillations in a mechanical system affect its behavior. Parts & equipment Qty Part/Equipment 1 Seeeduino board 1 Motor

More information

Dynamics of structures

Dynamics of structures Dynamics of structures 1.2 Viscous damping Luc St-Pierre October 30, 2017 1 / 22 Summary so far We analysed the spring-mass system and found that its motion is governed by: mẍ(t) + kx(t) = 0 k y m x x

More information

Chapter 14 Oscillations. Copyright 2009 Pearson Education, Inc.

Chapter 14 Oscillations. Copyright 2009 Pearson Education, Inc. Chapter 14 Oscillations Oscillations of a Spring Simple Harmonic Motion Energy in the Simple Harmonic Oscillator Simple Harmonic Motion Related to Uniform Circular Motion The Simple Pendulum The Physical

More information

Nonlinear Dynamic Systems Homework 1

Nonlinear Dynamic Systems Homework 1 Nonlinear Dynamic Systems Homework 1 1. A particle of mass m is constrained to travel along the path shown in Figure 1, which is described by the following function yx = 5x + 1x 4, 1 where x is defined

More information

Laboratory handout 5 Mode shapes and resonance

Laboratory handout 5 Mode shapes and resonance laboratory handouts, me 34 82 Laboratory handout 5 Mode shapes and resonance In this handout, material and assignments marked as optional can be skipped when preparing for the lab, but may provide a useful

More information

THE subject of the analysis is system composed by

THE subject of the analysis is system composed by MECHANICAL VIBRATION ASSIGNEMENT 1 On 3 DOF system identification Diego Zenari, 182160, M.Sc Mechatronics engineering Abstract The present investigation carries out several analyses on a 3-DOF system.

More information

Chapter 12. Recall that when a spring is stretched a distance x, it will pull back with a force given by: F = -kx

Chapter 12. Recall that when a spring is stretched a distance x, it will pull back with a force given by: F = -kx Chapter 1 Lecture Notes Chapter 1 Oscillatory Motion Recall that when a spring is stretched a distance x, it will pull back with a force given by: F = -kx When the mass is released, the spring will pull

More information

MODELLING A MASS / SPRING SYSTEM Free oscillations, Damping, Force oscillations (impulsive and sinusoidal)

MODELLING A MASS / SPRING SYSTEM Free oscillations, Damping, Force oscillations (impulsive and sinusoidal) DOING PHYSICS WITH MATLAB MODELLING A MASS / SPRING SYSTEM Free oscillations, Damping, Force oscillations (impulsive and sinusoidal) Download Directory: Matlab mscripts osc_harmonic01.m The script uses

More information

Dynamic Loads CE 543. Examples. Harmonic Loads

Dynamic Loads CE 543. Examples. Harmonic Loads CE 543 Structural Dynamics Introduction Dynamic Loads Dynamic loads are time-varying loads. (But time-varying loads may not require dynamic analysis.) Dynamics loads can be grouped in one of the following

More information

Introduction to Dynamical Systems. Tuesday, September 9, 14

Introduction to Dynamical Systems. Tuesday, September 9, 14 Introduction to Dynamical Systems 1 Dynamical Systems A dynamical system is a set of related phenomena that change over time in a deterministic way. The future states of the system can be predicted from

More information

Differential Equations

Differential Equations Differential Equations A differential equation (DE) is an equation which involves an unknown function f (x) as well as some of its derivatives. To solve a differential equation means to find the unknown

More information

C.-H. Lamarque. University of Lyon/ENTPE/LGCB & LTDS UMR CNRS 5513

C.-H. Lamarque. University of Lyon/ENTPE/LGCB & LTDS UMR CNRS 5513 Nonlinear Dynamics of Smooth and Non-Smooth Systems with Application to Passive Controls 3rd Sperlonga Summer School on Mechanics and Engineering Sciences on Dynamics, Stability and Control of Flexible

More information

1-DOF Forced Harmonic Vibration. MCE371: Vibrations. Prof. Richter. Department of Mechanical Engineering. Handout 8 Fall 2011

1-DOF Forced Harmonic Vibration. MCE371: Vibrations. Prof. Richter. Department of Mechanical Engineering. Handout 8 Fall 2011 MCE371: Vibrations Prof. Richter Department of Mechanical Engineering Handout 8 Fall 2011 Harmonic Forcing Functions Transient vs. Steady Vibration Follow Palm, Sect. 4.1, 4.9 and 4.10 Harmonic forcing

More information

Physics 41 HW Set 1 Chapter 15 Serway 8 th ( 7 th )

Physics 41 HW Set 1 Chapter 15 Serway 8 th ( 7 th ) Conceptual Q: 4 (7), 7 (), 8 (6) Physics 4 HW Set Chapter 5 Serway 8 th ( 7 th ) Q4(7) Answer (c). The equilibrium position is 5 cm below the starting point. The motion is symmetric about the equilibrium

More information

Name: Fall 2014 CLOSED BOOK

Name: Fall 2014 CLOSED BOOK Name: Fall 2014 1. Rod AB with weight W = 40 lb is pinned at A to a vertical axle which rotates with constant angular velocity ω =15 rad/s. The rod position is maintained by a horizontal wire BC. Determine

More information

Linear second-order differential equations with constant coefficients and nonzero right-hand side

Linear second-order differential equations with constant coefficients and nonzero right-hand side Linear second-order differential equations with constant coefficients and nonzero right-hand side We return to the damped, driven simple harmonic oscillator d 2 y dy + 2b dt2 dt + ω2 0y = F sin ωt We note

More information

Harmonic Oscillator. Mass-Spring Oscillator Resonance The Pendulum. Physics 109 Experiment Number 12

Harmonic Oscillator. Mass-Spring Oscillator Resonance The Pendulum. Physics 109 Experiment Number 12 Harmonic Oscillator Mass-Spring Oscillator Resonance The Pendulum Physics 109 Experiment Number 12 Outline Simple harmonic motion The vertical mass-spring system Driven oscillations and resonance The pendulum

More information

Laboratory handouts, ME 340

Laboratory handouts, ME 340 Laboratory handouts, ME 34 This document contains summary theory, solved exercises, prelab assignments, lab instructions, and report assignments for Lab 6. 214-216 Harry Dankowicz, unless otherwise noted

More information

The... of a particle is defined as its change in position in some time interval.

The... of a particle is defined as its change in position in some time interval. Distance is the. of a path followed by a particle. Distance is a quantity. The... of a particle is defined as its change in position in some time interval. Displacement is a.. quantity. The... of a particle

More information

Introduction to Signal Analysis Parts I and II

Introduction to Signal Analysis Parts I and II 41614 Dynamics of Machinery 23/03/2005 IFS Introduction to Signal Analysis Parts I and II Contents 1 Topics of the Lecture 11/03/2005 (Part I) 2 2 Fourier Analysis Fourier Series, Integral and Complex

More information

18.12 FORCED-DAMPED VIBRATIONS

18.12 FORCED-DAMPED VIBRATIONS 8. ORCED-DAMPED VIBRATIONS Vibrations A mass m is attached to a helical spring and is suspended from a fixed support as before. Damping is also provided in the system ith a dashpot (ig. 8.). Before the

More information

Introduction to Geotechnical Earthquake Engineering

Introduction to Geotechnical Earthquake Engineering Module 1 Introduction to Geotechnical Earthquake Engineering by Dr. Deepankar Choudhury Professor Department of Civil Engineering IIT Bombay, Powai, Mumbai 400 076, India. Email: dc@civil.iitb.ac.in URL:

More information

DFT and Matlab with some examples.

DFT and Matlab with some examples. DFT and Matlab with some examples 1 www.icrf.nl Fourier transform Fourier transform is defined as: X + jωt = x( t e dt ( ω ) ) with ω= 2 π f Rad/s And x(t) a signal in the time domain. www.icrf.nl 2 Fourier

More information

In-Structure Response Spectra Development Using Complex Frequency Analysis Method

In-Structure Response Spectra Development Using Complex Frequency Analysis Method Transactions, SMiRT-22 In-Structure Response Spectra Development Using Complex Frequency Analysis Method Hadi Razavi 1,2, Ram Srinivasan 1 1 AREVA, Inc., Civil and Layout Department, Mountain View, CA

More information

Lecture Notes on. BST004: Structural Dynamics. M. Tech Structural Engineering

Lecture Notes on. BST004: Structural Dynamics. M. Tech Structural Engineering Lecture Notes on BST004: Structural Dynamics M. Tech Structural Engineering Department of Civil Engineering INSTITUTE OF AERONAUTICAL ENGINEERING Dundigal, Hyderabad Disclaimer This document does not claim

More information

Chapter 5 Oscillatory Motion

Chapter 5 Oscillatory Motion Chapter 5 Oscillatory Motion Simple Harmonic Motion An object moves with simple harmonic motion whenever its acceleration is proportional to its displacement from some equilibrium position and is oppositely

More information

Explosion Protection of Buildings

Explosion Protection of Buildings Explosion Protection of Buildings Author: Miroslav Mynarz Explosion Protection of Buildings Introduction to the Problems of Determination of Building Structure's Response 3 Classification of actions According

More information

Modeling and Experimentation: Mass-Spring-Damper System Dynamics

Modeling and Experimentation: Mass-Spring-Damper System Dynamics Modeling and Experimentation: Mass-Spring-Damper System Dynamics Prof. R.G. Longoria Department of Mechanical Engineering The University of Texas at Austin July 20, 2014 Overview 1 This lab is meant to

More information

MATH 23 Exam 2 Review Solutions

MATH 23 Exam 2 Review Solutions MATH 23 Exam 2 Review Solutions Problem 1. Use the method of reduction of order to find a second solution of the given differential equation x 2 y (x 0.1875)y = 0, x > 0, y 1 (x) = x 1/4 e 2 x Solution

More information

Equations. A body executing simple harmonic motion has maximum acceleration ) At the mean positions ) At the two extreme position 3) At any position 4) he question is irrelevant. A particle moves on the

More information

An Estimation of Error-Free Frequency Response Function from Impact Hammer Testing

An Estimation of Error-Free Frequency Response Function from Impact Hammer Testing 85 An Estimation of Error-Free Frequency Response Function from Impact Hammer Testing Se Jin AHN, Weui Bong JEONG and Wan Suk YOO The spectrum of impulse response signal from the impact hammer testing

More information

Structural Dynamics Lecture 4. Outline of Lecture 4. Multi-Degree-of-Freedom Systems. Formulation of Equations of Motions. Undamped Eigenvibrations.

Structural Dynamics Lecture 4. Outline of Lecture 4. Multi-Degree-of-Freedom Systems. Formulation of Equations of Motions. Undamped Eigenvibrations. Outline of Multi-Degree-of-Freedom Systems Formulation of Equations of Motions. Newton s 2 nd Law Applied to Free Masses. D Alembert s Principle. Basic Equations of Motion for Forced Vibrations of Linear

More information

SEISMIC WAVE PROPAGATION. Lecture 2: Fourier Analysis

SEISMIC WAVE PROPAGATION. Lecture 2: Fourier Analysis SEISMIC WAVE PROPAGATION Lecture 2: Fourier Analysis Fourier Series & Fourier Transforms Fourier Series Review of trigonometric identities Analysing the square wave Fourier Transform Transforms of some

More information

Assignment 4 Solutions Continuous-Time Fourier Transform

Assignment 4 Solutions Continuous-Time Fourier Transform Assignment 4 Solutions Continuous-Time Fourier Transform ECE 3 Signals and Systems II Version 1.01 Spring 006 1. Properties of complex numbers. Let c 1 α 1 + jβ 1 and c α + jβ be two complex numbers. a.

More information

Physics 121, April 3, Equilibrium and Simple Harmonic Motion. Physics 121. April 3, Physics 121. April 3, Course Information

Physics 121, April 3, Equilibrium and Simple Harmonic Motion. Physics 121. April 3, Physics 121. April 3, Course Information Physics 121, April 3, 2008. Equilibrium and Simple Harmonic Motion. Physics 121. April 3, 2008. Course Information Topics to be discussed today: Requirements for Equilibrium (a brief review) Stress and

More information

Chapter a. Spring constant, k : The change in the force per unit length change of the spring. b. Coefficient of subgrade reaction, k:

Chapter a. Spring constant, k : The change in the force per unit length change of the spring. b. Coefficient of subgrade reaction, k: Principles of Soil Dynamics 3rd Edition Das SOLUTIONS MANUAL Full clear download (no formatting errors) at: https://testbankreal.com/download/principles-soil-dynamics-3rd-editiondas-solutions-manual/ Chapter

More information

CE6701 STRUCTURAL DYNAMICS AND EARTHQUAKE ENGINEERING QUESTION BANK UNIT I THEORY OF VIBRATIONS PART A

CE6701 STRUCTURAL DYNAMICS AND EARTHQUAKE ENGINEERING QUESTION BANK UNIT I THEORY OF VIBRATIONS PART A CE6701 STRUCTURAL DYNAMICS AND EARTHQUAKE ENGINEERING QUESTION BANK UNIT I THEORY OF VIBRATIONS PART A 1. What is mean by Frequency? 2. Write a short note on Amplitude. 3. What are the effects of vibration?

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

spring magnet Fig. 7.1 One end of the magnet hangs inside a coil of wire. The coil is connected in series with a resistor R.

spring magnet Fig. 7.1 One end of the magnet hangs inside a coil of wire. The coil is connected in series with a resistor R. 1 A magnet is suspended vertically from a fixed point by means of a spring, as shown in Fig. 7.1. spring magnet coil R Fig. 7.1 One end of the magnet hangs inside a coil of wire. The coil is connected

More information

Direct Fatigue Damage Spectrum Calculation for a Shock Response Spectrum

Direct Fatigue Damage Spectrum Calculation for a Shock Response Spectrum Direct Fatigue Damage Spectrum Calculation for a Shock Response Spectrum By Tom Irvine Email: tom@vibrationdata.com June 25, 2014 Introduction A fatigue damage spectrum (FDS) was calculated for a number

More information

Introduction to Continuous Systems. Continuous Systems. Strings, Torsional Rods and Beams.

Introduction to Continuous Systems. Continuous Systems. Strings, Torsional Rods and Beams. Outline of Continuous Systems. Introduction to Continuous Systems. Continuous Systems. Strings, Torsional Rods and Beams. Vibrations of Flexible Strings. Torsional Vibration of Rods. Bernoulli-Euler Beams.

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

a) Find the equation of motion of the system and write it in matrix form.

a) Find the equation of motion of the system and write it in matrix form. .003 Engineering Dynamics Problem Set Problem : Torsional Oscillator Two disks of radius r and r and mass m and m are mounted in series with steel shafts. The shaft between the base and m has length L

More information

Energy in a Simple Harmonic Oscillator. Class 30. Simple Harmonic Motion

Energy in a Simple Harmonic Oscillator. Class 30. Simple Harmonic Motion Simple Harmonic Motion Class 30 Here is a simulation of a mass hanging from a spring. This is a case of stable equilibrium in which there is a large extension in which the restoring force is linear in

More information

Chapter 3 Mathematical Methods

Chapter 3 Mathematical Methods Chapter 3 Mathematical Methods Slides to accompany lectures in Vibro-Acoustic Design in Mechanical Systems 0 by D. W. Herrin Department of Mechanical Engineering Lexington, KY 40506-0503 Tel: 859-8-0609

More information

Experimental Aerodynamics. Experimental Aerodynamics

Experimental Aerodynamics. Experimental Aerodynamics Lecture 3: Vortex shedding and buffeting G. Dimitriadis Buffeting! All structures exposed to a wind have the tendency to vibrate.! These vibrations are normally of small amplitude and have stochastic character!

More information

ME 328 Machine Design Vibration handout (vibrations is not covered in text)

ME 328 Machine Design Vibration handout (vibrations is not covered in text) ME 38 Machine Design Vibration handout (vibrations is not covered in text) The ollowing are two good textbooks or vibrations (any edition). There are numerous other texts o equal quality. M. L. James,

More information

Periodic functions: simple harmonic oscillator

Periodic functions: simple harmonic oscillator Periodic functions: simple harmonic oscillator Recall the simple harmonic oscillator (e.g. mass-spring system) d 2 y dt 2 + ω2 0y = 0 Solution can be written in various ways: y(t) = Ae iω 0t y(t) = A cos

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

Math 1302, Week 8: Oscillations

Math 1302, Week 8: Oscillations Math 302, Week 8: Oscillations T y eq Y y = y eq + Y mg Figure : Simple harmonic motion. At equilibrium the string is of total length y eq. During the motion we let Y be the extension beyond equilibrium,

More information

E2.5 Signals & Linear Systems. Tutorial Sheet 1 Introduction to Signals & Systems (Lectures 1 & 2)

E2.5 Signals & Linear Systems. Tutorial Sheet 1 Introduction to Signals & Systems (Lectures 1 & 2) E.5 Signals & Linear Systems Tutorial Sheet 1 Introduction to Signals & Systems (Lectures 1 & ) 1. Sketch each of the following continuous-time signals, specify if the signal is periodic/non-periodic,

More information

VTU-NPTEL-NMEICT Project

VTU-NPTEL-NMEICT Project MODULE-II --- SINGLE DOF FREE S VTU-NPTEL-NMEICT Project Progress Report The Project on Development of Remaining Three Quadrants to NPTEL Phase-I under grant in aid NMEICT, MHRD, New Delhi SME Name : Course

More information

Address for Correspondence

Address for Correspondence Research Article EXPERIMENT STUDY OF DYNAMIC RESPONSE OF SOFT STOREY BUILDING MODEL C. S. Sanghvi 1, H S Patil 2 and B J Shah 3 Address for Correspondence 1 Associate Professor, Applied Mechanics Department,

More information

Outline of parts 1 and 2

Outline of parts 1 and 2 to Harmonic Loading http://intranet.dica.polimi.it/people/boffi-giacomo Dipartimento di Ingegneria Civile Ambientale e Territoriale Politecnico di Milano March, 6 Outline of parts and of an Oscillator

More information

Oscillations. Simple Harmonic Motion of a Mass on a Spring The equation of motion for a mass m is attached to a spring of constant k is

Oscillations. Simple Harmonic Motion of a Mass on a Spring The equation of motion for a mass m is attached to a spring of constant k is Dr. Alain Brizard College Physics I (PY 10) Oscillations Textbook Reference: Chapter 14 sections 1-8. Simple Harmonic Motion of a Mass on a Spring The equation of motion for a mass m is attached to a spring

More information

Laboratory notes. Torsional Vibration Absorber

Laboratory notes. Torsional Vibration Absorber Titurus, Marsico & Wagg Torsional Vibration Absorber UoB/1-11, v1. Laboratory notes Torsional Vibration Absorber Contents 1 Objectives... Apparatus... 3 Theory... 3 3.1 Background information... 3 3. Undamped

More information

Core Concepts Review. Orthogonality of Complex Sinusoids Consider two (possibly non-harmonic) complex sinusoids

Core Concepts Review. Orthogonality of Complex Sinusoids Consider two (possibly non-harmonic) complex sinusoids Overview of Continuous-Time Fourier Transform Topics Definition Compare & contrast with Laplace transform Conditions for existence Relationship to LTI systems Examples Ideal lowpass filters Relationship

More information

DEVELOPMENT OF A REAL-TIME HYBRID EXPERIMENTAL SYSTEM USING A SHAKING TABLE

DEVELOPMENT OF A REAL-TIME HYBRID EXPERIMENTAL SYSTEM USING A SHAKING TABLE DEVELOPMENT OF A REAL-TIME HYBRID EXPERIMENTAL SYSTEM USING A SHAKING TABLE Toshihiko HORIUCHI, Masahiko INOUE And Takao KONNO 3 SUMMARY A hybrid experimental method, in which an actuator-excited vibration

More information

The student will experimentally determine the parameters to represent the behavior of a damped oscillatory system of one degree of freedom.

The student will experimentally determine the parameters to represent the behavior of a damped oscillatory system of one degree of freedom. Practice 3 NAME STUDENT ID LAB GROUP PROFESSOR INSTRUCTOR Vibrations of systems of one degree of freedom with damping QUIZ 10% PARTICIPATION & PRESENTATION 5% INVESTIGATION 10% DESIGN PROBLEM 15% CALCULATIONS

More information

Trillingsdempende materialen basis & eigenschappen Berekenen en toepassen op trillingsisolatie van technische installaties.

Trillingsdempende materialen basis & eigenschappen Berekenen en toepassen op trillingsisolatie van technische installaties. Trillingsdempende materialen basis & eigenschappen Berekenen en toepassen op trillingsisolatie van technische installaties Patrick Carels KVIV Studiedag Ingenieurshuis - Antwerpen www.cdm.eu 23/9/206 Content

More information

TOPIC E: OSCILLATIONS SPRING 2019

TOPIC E: OSCILLATIONS SPRING 2019 TOPIC E: OSCILLATIONS SPRING 2019 1. Introduction 1.1 Overview 1.2 Degrees of freedom 1.3 Simple harmonic motion 2. Undamped free oscillation 2.1 Generalised mass-spring system: simple harmonic motion

More information

Homework 6 Solutions

Homework 6 Solutions 8-290 Signals and Systems Profs. Byron Yu and Pulkit Grover Fall 208 Homework 6 Solutions. Part One. (2 points) Consider an LTI system with impulse response h(t) e αt u(t), (a) Compute the frequency response

More information

Estimation of dynamic characteristics of a spring-mass-beam system

Estimation of dynamic characteristics of a spring-mass-beam system Shock and Vibration 14 (2007) 271 282 271 IOS Press Estimation of dynamic characteristics of a spring-mass-beam system Ding Zhou a,b, and Tianjian Ji b a College of Civil Engineering, Nanjing University

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

!Sketch f(t) over one period. Show that the Fourier Series for f(t) is as given below. What is θ 1?

!Sketch f(t) over one period. Show that the Fourier Series for f(t) is as given below. What is θ 1? Second Year Engineering Mathematics Laboratory Michaelmas Term 998 -M L G Oldfield 30 September, 999 Exercise : Fourier Series & Transforms Revision 4 Answer all parts of Section A and B which are marked

More information

Simplified Dynamic Analysis of Beams and Slabs with Tuned Mass Dampers

Simplified Dynamic Analysis of Beams and Slabs with Tuned Mass Dampers Simplified Dynamic Analysis of Beams and Slabs with Tuned Mass Dampers As structural material properties are enhanced and structures become lighter and considerably more flexible with lower structural

More information

FREE VIBRATIONS OF FRAMED STRUCTURES WITH INCLINED MEMBERS

FREE VIBRATIONS OF FRAMED STRUCTURES WITH INCLINED MEMBERS FREE VIBRATIONS OF FRAMED STRUCTURES WITH INCLINED MEMBERS A Thesis submitted in partial fulfillment of the requirements for the degree of Bachelor of Technology in Civil Engineering By JYOTI PRAKASH SAMAL

More information