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

Size: px
Start display at page:

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

Transcription

1 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

2 Introduction to Dynamic Analysis Introduction Swiss Federal Institute of Technology Page 3 The very basics - Newton s nd law of motion: The Introduction very basics ti to Dynamic Analysis k Unstretched position Newtons nd law of motion: kδ mx = w k( Δ+ x) Δ Introduction m m Stretched position w= mg mx The w + very k( Δ+ basics x) = 0 k Unstretched (static equilibrium) position Newtons nd law of motion: kδ x xx, mx = w k( x) Δ m m mx kδ+ k( Δ+ x) = mx + kx = 0 Stretched position k w= mg x+ mx x = w x+ + k( ωδ+ n x= x) 0= 0 (static equilibrium) π m ωτ n = π τ = = π m ωn k x xx, 1 1 k fn = = mx k k x mx kx τ π m 0 0 x(t) x= Asin k ω cos t nt+ B ωnt x= x sinωnt+ xcosω t x = + Asinω x= x+ n t ω + n x= Bcosω 0 n t x(t) = ẋ0 sinω π n mt + x 0 cosω n t ωτ n = π ωτ = = π m n ωn k 1 1 k fn = = where ω n = π k τ π m T = m 0 0 x= Asinω t+ Bcosω t t x= x sinω t+ xcosω t thod of Finite Elements II n n n n Method of Finite Elements II Institute of Structural Engineering Method of Finite Elements II

3 Introduction to Dynamic Analysis We have previously considered the equilibrium equations governing the linear dynamic response of a system of finite elements: MÜ + C U + KU = R F I (t) + F D (t) + F E (t) = R(t) where: M : Mass Matrix K : Stiffness Matrix U : Displacements U : Velocities Ü : Accelerations where: F I (t) = MÜ F D (t) = C U F E (t) = KU Inertial Force Damping Force Internal Force Institute of Structural Engineering Method of Finite Elements II 3

4 Introduction to Dynamic Analysis When is Dynamic Analysis required? Whether a dynamic analysis is needed or not is generally up to engineering judgment requires understanding of the interaction between loading and structural response! In general if the loading varies over time with frequencies higher than the Eigen-frequencies of the structure dynamic analysis will be required Institute of Structural Engineering Method of Finite Elements II 4

5 Introduction to Dynamic Analysis Objective Solve the dynamic Equation of motion (numerically) MÜ + C U + KU = R In principle the equilibrium equations may be solved by any standard numerical integration scheme BUT! Efficiency numerical efforts must be considered and it is worthwhile to look at special techniques of integration which are especially suited for the analysis of finite element assemblies. *The section on Direct Integration Methods is based on Prof. M. Faber s notes of the FEM II course - Fall 009 Institute of Structural Engineering Method of Finite Elements II 5

6 Direct Integration Methods These methods rely in discretizing the continuous problem. The original problem formulation is essentially the dynamic equation of motion which is for structural problems is a second order Ordinary Differential Equation (ODE). This involves, after the solution is defined at time zero, the attempt to satisfy dynamic equilibrium at discrete points in time. Most methods use equal time intervals at t, t, 3 t...n t. However this is not mandatory; in some cases a variable time step might be employed. This is most commonly the case for special classes of problems such as Impact Problems. Institute of Structural Engineering Method of Finite Elements II 6

7 Direct Integration Methods Direct means: The equations are solved in their original form Two ideas are utilized 1. The equilibrium equations are satisfied only at time steps, i.e. at discrete times with intervals t. A particular variation of displacements, velocities and accelerations within each time interval is assumed The accuracy depends on these assumptions as well as the choice of time intervals! Institute of Structural Engineering Method of Finite Elements II 7

8 Direct Integration Methods Assumptions The displacements, velocities and accelerations U 0 : U 0 : Ü 0 : Displacement vector at time t Velocity vector at time t Acceleration vector at time t are assumed to be known and we aim to establish the solution of the equilibrium equations for the period 0 - T. For this purpose we sub-divide T into n intervals of length t = T/n and establish solutions for the times t, t, 3 t,..., T Institute of Structural Engineering Method of Finite Elements II 8

9 Direct Integration Methods We distinguish principally between Implicit and Explicit methods Explicit methods: Solution is based on the equilibrium equations at time t 1st order Example: The Forward Euler Method Assuming we want to approximate the solution of the initial value problem ẏ = f(t, y(t)), y(t 0 ) = y 0 by using the first two terms of the Taylor expansion of y, which represents the linear approximation around the point (t 0, y(t 0 )) we obtain the forward Euler integration rule: y n+1 = y n + hf(t n, y n ) Institute of Structural Engineering Method of Finite Elements II 9

10 Direct Integration Methods Implicit methods: Solution is based on the equilibrium equations at time t + t 1st order Example: The Backward Euler Method Assuming we want to approximate the solution of the same initial value problem the backward Euler integration rule is obtained as: y n+1 = y n + hf(t n+1, y n+1 ) Since f(t, y) is, in general, a non-linear function of y, iteration is required to solve this last equation for y n+1. Institute of Structural Engineering Method of Finite Elements II 10

11 Direct Integration Methods Explicit methods calculate the state of a system at a later time from the state of the system at the current time, while implicit methods find a solution by solving an equation involving both the current state of the system and the later one. Note that: Implicit integration is not necessarily more accurate than explicit. It can be less accurate! The major benefit of implicit integration is stability. Many of these methods are able to run with any arbitrarily large time step for any input unless we are lying at the limits of floating point math (unconditionally stable). Obviously a large time step implies throwing away accuracy. For most real structures, which contain stiff elements, a very small time step is required in order to obtain a stable solution. Therefore, all explicit methods are conditionally stable. The condition is the size of the selected time step. Institute of Structural Engineering Method of Finite Elements II 11

12 Direct Integration Methods Most Commonly used Direct Integration Methods (for the case of the Dynamic Equation of Motion) 1 The Central Difference Method (CDF) The Houbolt method 3 The Newmark method 4 The Wilson θ method 5 Coupling of integration operators The difference in items 1-4 lies in the way we choose a discretized equivalent of the derivatives. The overall setup of the solution is very much similar for all methods. Additionally depending on the resulting equations some schemes are explicit (CDF) and others implicit (Houbolt, Newmark, Wilson θ) Institute of Structural Engineering Method of Finite Elements II 1

13 Direct Integration Methods Most Commonly used Direct Integration Methods Velocity Central Difference Method Acceleration U(t) t - Δt t t + Δt U(t) t - Δt t t + Δt t - Δt t t + Δt Reminder: The difference lies in the way we choose a discretized equivalent of the derivatives. Institute of Structural Engineering Method of Finite Elements II 13

14 Direct Integration Methods Most Commonly used Direct Integration Methods Displacement The Houbolt Method Velocity U(t) Acceleration t - Δt t - Δt t t + Δt These approximations are derived via the displacement approximation. Houbolt s method uses a third-order interpolation of displacements extending two steps back in time. Reminder: The difference lies in the way we choose a discretized equivalent of the derivatives. Institute of Structural Engineering Method of Finite Elements II 14

15 Direct Integration Methods Most Commonly used Direct Integration Methods The Newmark Method Displacement Velocity The Newmark method uses a second order Taylor expansion for approximating Velocities and U! t+δt = U! t + Δt U!! V Accelerations: U t+δt = U t + Δt U!! V + Δt U!!, where U!! V, U!! D are approximations of the Acceleration D if if t t + Δt t t + Δt Reminder: The difference lies in the way we choose a discretized equivalent of the derivatives. Institute of Structural Engineering Method of Finite Elements II 15

16 The Central Difference Method Approximate the velocity (first derivative) as: t U = 1 t (t+ t U t- t U) (1) Approximate the acceleration (second derivative) as: tü = 1 t (t+ t U t U + t- t U) () Substitute Eqns (1),() into MÜ + C U + KU = R: ( 1 t M + 1 ) ( t C t+ t U = t R K ) ( t M t 1 U t M 1 ) t C t- t U (a 0 M + a 1 C) t+ t U = t R (K a M) t U (a 0 M a 1 C) t- t U Institute of Structural Engineering Method of Finite Elements II 16

17 The Central Difference Method We see that we do not need to factorize the stiffness matrix, i.e, we only rely on info from the current step t to go to the next one t + t (explicit method) We also see that in order to calculate the displacements at time t we need to know the displacements at time 0 and t In general, 0 U, 0 U, 0 Ü are known and we can use Eqns (1),() to obtain t U: - t U = 0 U t 0 U + t 0Ü Institute of Structural Engineering Method of Finite Elements II 17

18 The Central Difference Method Solution Procedure A. Initial Calculations Institute of Structural Engineering Method of Finite Elements II 18

19 The Direct Central Integration Difference ti Methods Method Solution Procedure The Central difference method: Solution procedure: B. B: For For each each time time step step 1) Calculate effective loads at time t: ( ) ( ) ˆ Δ R = R K a M U a M a C U t t t t t 0 1 ) Solve for the displacements U at time t + Δt LDL Tt +Δ t U = t Rˆ 3) If required, solve for the corresponding velocities and accelerations U ( Δ U U+ +Δ = a U) 0 t t t t t t U Δ +Δ = a 1 ( U+ U ) t t t t t thod of Finite Elements II Institute of Structural Engineering Method of Finite Elements II 19

20 Direct Integration ti Methods The Central Difference Method The effectiveness Central difference of the central methoddifference method depends on the efficiency of the time step solution since generally a small discretization The effectiveness is required. of the central difference method depends on the efficiency of the time step solution because we need a lot of For them this reason the method is usually only applied when a lumped (diagonal) For this reason massthe matrix method can is beusually assumed only and applied when the when velocity a lumped dependent mass matrix damping can be (C) assumed can beand neglected, when the i.e.: velocity dependent damping can be neglected, i.e.: 1 t+δt t M U= Rˆ Δt t+δt t ˆ Δt 1 U i = Ri ( ), mii > 0 t t t t ΔΔ t RˆR = R K M U M U m ii Δt Δt () () KU t = K i t U= t F i t () ˆ t t i 1 t Δ t t i i R = R F M ( U U ) Δt ethod of Finite Elements II i Institute of Structural Engineering Method of Finite Elements II 0

21 The Central Difference Method Direct Integration ti Methods Example - DOF system k 1 = 4 U, U, U m = R = 0 1 k = 1 0 m = 1 R = 10 0 U 6 1 U1 0 + = 0 1 U 4 U 10 U, U, U k 3 = Method of Finite Elements II For this system the natural periods are T 1 = 4.45, T =.8 Institute of Structural Engineering Method of Finite Elements II 1

22 The Central Difference Method Example - DOF system Institute of Structural Engineering Method of Finite Elements II

23 Direct Integration Methods The Central Difference Method Example - DOF system The Central difference method: Example: a = 0, a 1, a a0, a3 Δ t = Δ t = = a 1 1 a0 = = 1.8, a 1 = = 1.79, (0.8) 0.8 For Δt = a = = 5.5, a 3 = = (0.8) 5.5 Δt Ui = = ˆ M = = t ˆ t t Δt R = U U 0 U U Method of Finite Elements II Institute of Structural Engineering Method of Finite Elements II 3

24 The Central Difference Method Swiss Federal Institute of Technology Page 18 Direct Integration ti Methods Example - DOF system U The Central difference method: Example: The equation which must be solved for each time step is: 0 U 6 1 U = 4 U 10 The equation which must be solved for each time step is: t+δt U1 t ˆ = t+δ t R U t t Δt t ˆ U U 1 R = t t t U Δ U Method of Finite Elements II Institute of Structural Engineering Method of Finite Elements II 4

25 The Central Difference Method Example - DOF system The results are: CentralDifference_U1 CentralDifference_U Institute of Structural Engineering Method of Finite Elements II 5

26 The Houbolt Method Swiss Federal Institute of Technology Page 0 Houbolt Direct Integration Method tiderivative Methods Approximation MU + CU + KU = R c t+δ t U 1 ( t+δt 5 t 4 t Δt t Δt = U U+ U U ) Δtt 1 ( U = U U+ U U ) 6Δt t+δ t t+δt t t Δt t Δt a b a and b inserted in c 1 t+δt + + = Δt M 6Δt C K U t+δt R 5 3 t 4 3 t Δt 1 1 t Δt Δt M Δt C U Δt M Δt C U Δt M 3Δt C U ethod of Finite Elements II Institute of Structural Engineering Method of Finite Elements II 6

27 The Houbolt Method We will not consider the Houbolt in more detail however it is noted that it is necessary to factorize the stiffness matrix (implicit method) Furthermore, if the mass and damping terms are neglected, the Houbolt method results in the static analysis equations: K t+ t U = t+ t R Notice how this is not true for the CDM! Institute of Structural Engineering Method of Finite Elements II 7

28 The Direct Newmark Integration Method ti Methods In 1959 Newmark presented a family of single-step integration The Newmark method methods for the solution of structural dynamic problems for both blast and seismic loading. This method may be seen as an extension of the Wilson θ method U = U + (1 δ) U + δ U Δt t+δ t t t t+δt 1 U= U+ U Δ t+ ( α) U + α U Δt t +Δ t t t t t +Δ t δ and α are parameters which may be adjusted to achieve accuracy and stability The terms essentially result from the use of a Taylor series expansion: δ =0.5, α = 1/6 corresponds to the linear acceleration method which also correspond t U = t- t U to + the t t- t Wilson U + t θ method t- tü t 3 + with θ =... t- t 1 Newmark originally proposed δ =0.5, 05 α = 1/4 which results in an t unconditionally U = t- t stable U + tscheme t- t Ü + t (the trapetzoidal rule) thod of Finite Elements II!! t- t... U ! U +... Institute of Structural Engineering Method of Finite Elements II 8

29 The Newmark Method Notes: δ and a are parameters, effectively acting as weights for calculating the approximation of the acceleration, and may be adjusted to achieve accuracy and stability δ = 0.5, a = 1/6 is known as the linear acceleration method, which also correspond to the Wilson θ method with θ = 1 Newmark originally proposed δ=0.5, a = 1/4, which results in an unconditionally stable scheme (the trapezoidal rule) Institute of Structural Engineering Method of Finite Elements II 9

30 The Newmark Method We now solve for the displacements, velocities and accelerations by inserting the above into the dynamic equilibrium equation: where Institute of Structural Engineering Method of Finite Elements II 30

31 The Newmark Method Solution Procedure A. For each time step Institute of Structural Engineering Method of Finite Elements II 31

32 The Direct Newmark Integration ti Method Methods Solution Procedure The Newmark method : Solution procedure: B. For each time step B: For each time step 1) Calculate effective loads at time t: t +Δ t ˆ t +Δ t t t ( t R = R+ M a 0 U+ a U+ a3 U ) t t t + C( a U+ a U + a U ) ) Solve for the displacements U at time t + Δt Tt t t t LDL +Δ U = +Δ Rˆ 3) Solve for the corresponding velocities and accelerations t+δ t t+δt t t t U = a0( U U) a U a3 U t+δ t t t+δ t t U= U+ a U+ a U thod of Finite Elements II 7 6 Institute of Structural Engineering Method of Finite Elements II 3

33 The Newmark Method Stability of the Newmark Method For zero damping the Newmark method is conditionally stable if δ 1, α 1 and t 1 ω max δ α where ω max is the maximum natural frequency. The Newmark method is unconditionally stable if α δ 1 Institute of Structural Engineering Method of Finite Elements II 33

34 The Newmark Method Stability of the Newmark Method However, if δ 1, errors are introduced. These errors are associated with numerical damping and period elongation, i.e. a seemingly larger damping and period of oscillation than in reality. Because of the unconditional stability of the average acceleration method, it is the most robust method to be used for the step-by-step dynamic analysis of large complex structural systems in which a large number of high frequencies, short periods, are present. The only problem with the method is that the short periods, which are smaller than the time step, oscillate indefinitely after they are excited. The higher mode oscillation can however be reduced by the addition of stiffness proportional (artificial) damping. source: csiberkeley.com Institute of Structural Engineering Method of Finite Elements II 34

35 The Newmark Method dof system example t = 0.8s Discrete Time Step, Δt=1 sec 1st Floor CMD nd Floor CMD 1st Floor NM nd Floor NM 1st Floor true nd Floor true Displacement time Institute of Structural Engineering Method of Finite Elements II 35

36 The Newmark Method dof system example t = 1s Displacement Discrete Time Step, Δt=1 sec 1st Floor CMD nd Floor CMD 1st Floor NM nd Floor NM 1st Floor true nd Floor true time Institute of Structural Engineering Method of Finite Elements II 36

37 The Wilson θ Method APPENDIX The Wilson θ Method In 1973, the general Newmark method was made unconditionally stable by the introduction of a θ factor. The introduction of this factor is motivated by the observation that an unstable solution tends to oscillate about the true solution. Therefore, if the numerical solution is evaluated within the time increment the spurious oscillations are minimized. This can be accomplished by a simple modification to the Newmark method by using a time step defined by: t = θ t, θ 1.0 source: csiberkeley.com Reminder: For θ = 1 the Wilson θ method is equivalent to the Newmark linear acceleration method with δ = 0.5, a = 1/6. Institute of Structural Engineering Method of Finite Elements II 37

38 Direct Integration ti Methods The Wilson θ Method The Wilson θ method In this method the acceleration is assumed to vary linearly from time t to t + Δt τ U = U + U U θδt θ ( ) t + τ t t + Δ t t By integration we obtain τ U = U + U τ + U U θδt θ ( ) t+ τ t t t+ Δt t U 1 1 = U + U τ + τ + τ U θ U U 6θΔt θ ( ) t+ τ t t t 3 t+ Δt t thod of Finite Elements II Institute of Structural Engineering Method of Finite Elements II 38

39 The Wilson θ Method The Wilson θ method Setting τ = θ Δt we get θδt U = U + U + U θ ( ) t+δ θ t t t+δt t 1 U= U+ U θδ t+ Δ U + U 6 θ ( θ t) ( ) t +Δ θ t t t t +Δ t t from which we can solve Swiss Federal Institute of Technology Page 4 t+δ θ t 6 t+δt t 6 t t Direct U = Integration U U U U ti Methods θδt θ ( ) ( ) θδt t+δ θ t 3 t+δ θ t t t θδt t U = ( U U ) U U The Wilson θδt θ method Method of Finite Elements II 6 6 U = U U U U θδt +Δ θ t t t+δt t t t ( ) ( θ ) θδt 3 θδ t U = ( U U) U U θδt We now solve for the displacements, velocities and accelerations by inserting into the dynamic equilibrium equation t+δ θ t t+ θδ t t+ θδ t t+ θδt M U + C U + K U= R R = R + θ ( R R ) t + θδ t t t +Δ t t Institute of Structural Engineering Method of Finite Elements II 39

40 The Wilson θ Method Solution Procedure A. Initial Calculations Implicit Procedure! Institute of Structural Engineering Method of Finite Elements II 40

41 The Direct Wilson Integration θ Method ti Methods Solution Procedure The Wilson θ method : Solution procedure: B. For each time step B: For each time step 1) Calculate effective loads at time t+ t: t +Δ θ t ˆ t t +Δ θ t t t t t R = R+ θ ( R R) + M( a 0 U+ a U+ U ) t t t + C( a1 U+ U + a3 U ) ) Solve for the displacements U at time t + Δt Tt θ t t θ t LDL +Δ U = +Δ Rˆ 3) Solve for the corresponding velocities and accelerations t+δ t t+ θδt t t t U = a4( U U) + a5 U + a6 U t+δ t t t+δt t U = U+ a ( U + U ) t+δ t 7 U= t U+ Δ t t U + a ( t+δt t ) 8 U + U thod of Finite Elements II Institute of Structural Engineering Method of Finite Elements II 41

42 Direct Integration Methods Coupling of integration operators For some problems it may be an advantage to combine the different types of integration schemes e.g. if a structure is subjected to dynamic load effect from hydrodynamic loading then the analysis of the hydrodynamic forces may be assessed using an explicit scheme and the structural response by using an implicit scheme. The best choice of strategy will depend on the problem at hand in regard with stability and accuracy! Institute of Structural Engineering Method of Finite Elements II 4

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

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

Ordinary differential equations. Phys 420/580 Lecture 8

Ordinary differential equations. Phys 420/580 Lecture 8 Ordinary differential equations Phys 420/580 Lecture 8 Most physical laws are expressed as differential equations These come in three flavours: initial-value problems boundary-value problems eigenvalue

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

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

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

ECE 422/522 Power System Operations & Planning/Power Systems Analysis II : 7 - Transient Stability

ECE 422/522 Power System Operations & Planning/Power Systems Analysis II : 7 - Transient Stability ECE 4/5 Power System Operations & Planning/Power Systems Analysis II : 7 - Transient Stability Spring 014 Instructor: Kai Sun 1 Transient Stability The ability of the power system to maintain synchronism

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

Ordinary Differential Equations II

Ordinary Differential Equations II Ordinary Differential Equations II CS 205A: Mathematical Methods for Robotics, Vision, and Graphics Justin Solomon CS 205A: Mathematical Methods Ordinary Differential Equations II 1 / 33 Almost Done! Last

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

A Harmonic Balance Approach for Large-Scale Problems in Nonlinear Structural Dynamics

A Harmonic Balance Approach for Large-Scale Problems in Nonlinear Structural Dynamics A Harmonic Balance Approach for Large-Scale Problems in Nonlinear Structural Dynamics Allen R, PhD Candidate Peter J Attar, Assistant Professor University of Oklahoma Aerospace and Mechanical Engineering

More information

Chapter 2 Finite Element Formulations

Chapter 2 Finite Element Formulations Chapter 2 Finite Element Formulations The governing equations for problems solved by the finite element method are typically formulated by partial differential equations in their original form. These are

More information

11. Some applications of second order differential

11. Some applications of second order differential October 3, 2011 11-1 11. Some applications of second order differential equations The first application we consider is the motion of a mass on a spring. Consider an object of mass m on a spring suspended

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

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

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

Lecture IV: Time Discretization

Lecture IV: Time Discretization Lecture IV: Time Discretization Motivation Kinematics: continuous motion in continuous time Computer simulation: Discrete time steps t Discrete Space (mesh particles) Updating Position Force induces acceleration.

More information

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

Ordinary Differential Equations II

Ordinary Differential Equations II Ordinary Differential Equations II CS 205A: Mathematical Methods for Robotics, Vision, and Graphics Justin Solomon CS 205A: Mathematical Methods Ordinary Differential Equations II 1 / 29 Almost Done! No

More information

Solution of Vibration and Transient Problems

Solution of Vibration and Transient Problems . 9 Solution of Vibration and Transient Problems 9 Chapter 9: SOLUTION OF VIBRATION AND TRANSIENT PROBLEMS 9 9. MODAL APPROACH TO TRANSIENT ANALYSIS Consider the following large-order finite element model

More information

MATH 251 Week 6 Not collected, however you are encouraged to approach all problems to prepare for exam

MATH 251 Week 6 Not collected, however you are encouraged to approach all problems to prepare for exam MATH 51 Week 6 Not collected, however you are encouraged to approach all problems to prepare for exam A collection of previous exams could be found at the coordinator s web: http://www.math.psu.edu/tseng/class/m51samples.html

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

Problem 1: Find the Equation of Motion from the static equilibrium position for the following systems: 1) Assumptions

Problem 1: Find the Equation of Motion from the static equilibrium position for the following systems: 1) Assumptions Problem 1: Find the Equation of Motion from the static equilibrium position for the following systems: 1) Assumptions k 2 Wheels roll without friction k 1 Motion will not cause block to hit the supports

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

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 9 Initial Value Problems for Ordinary Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign

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

Second Order Systems

Second Order Systems Second Order Systems independent energy storage elements => Resonance: inertance & capacitance trade energy, kinetic to potential Example: Automobile Suspension x z vertical motions suspension spring shock

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

Lecture 11. Scott Pauls 1 4/20/07. Dartmouth College. Math 23, Spring Scott Pauls. Last class. Today s material. Next class

Lecture 11. Scott Pauls 1 4/20/07. Dartmouth College. Math 23, Spring Scott Pauls. Last class. Today s material. Next class Lecture 11 1 1 Department of Mathematics Dartmouth College 4/20/07 Outline Material from last class Inhomogeneous equations Method of undetermined coefficients Variation of parameters Mass spring Consider

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

Review: control, feedback, etc. Today s topic: state-space models of systems; linearization

Review: control, feedback, etc. Today s topic: state-space models of systems; linearization Plan of the Lecture Review: control, feedback, etc Today s topic: state-space models of systems; linearization Goal: a general framework that encompasses all examples of interest Once we have mastered

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

Runga-Kutta Schemes. Exact evolution over a small time step: Expand both sides in a small time increment: d(δt) F (x(t + δt),t+ δt) Ft + FF x ( t)

Runga-Kutta Schemes. Exact evolution over a small time step: Expand both sides in a small time increment: d(δt) F (x(t + δt),t+ δt) Ft + FF x ( t) Runga-Kutta Schemes Exact evolution over a small time step: x(t + t) =x(t)+ t 0 d(δt) F (x(t + δt),t+ δt) Expand both sides in a small time increment: x(t + t) =x(t)+x (t) t + 1 2 x (t)( t) 2 + 1 6 x (t)+

More information

Numerical Methods for Initial Value Problems; Harmonic Oscillators

Numerical Methods for Initial Value Problems; Harmonic Oscillators Lab 1 Numerical Methods for Initial Value Problems; Harmonic Oscillators Lab Objective: Implement several basic numerical methods for initial value problems (IVPs), and use them to study harmonic oscillators.

More information

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

BRB and viscous damper hybrid vibration mitigation structural system: seismic performance analysis method and case studies

BRB and viscous damper hybrid vibration mitigation structural system: seismic performance analysis method and case studies BRB and viscous damper hybrid vibration mitigation structural system: seismic performance analysis method and case studies Xin Zhao Tongji Architectural Design (Group) Co., Ltd., Shanghai, China 2 Contents

More information

Differential Equations, Math 315 Midterm 2 Solutions

Differential Equations, Math 315 Midterm 2 Solutions Name: Section: Differential Equations, Math 35 Midterm 2 Solutions. A mass of 5 kg stretches a spring 0. m (meters). The mass is acted on by an external force of 0 sin(t/2)n (newtons) and moves in a medium

More information

Numerical Methods for Initial Value Problems; Harmonic Oscillators

Numerical Methods for Initial Value Problems; Harmonic Oscillators 1 Numerical Methods for Initial Value Problems; Harmonic Oscillators Lab Objective: Implement several basic numerical methods for initial value problems (IVPs), and use them to study harmonic oscillators.

More information

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 9

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 9 Lecture Notes to Accompany Scientific Computing An Introductory Survey Second Edition by Michael T. Heath Chapter 9 Initial Value Problems for Ordinary Differential Equations Copyright c 2001. Reproduction

More information

Assignment on iterative solution methods and preconditioning

Assignment on iterative solution methods and preconditioning Division of Scientific Computing, Department of Information Technology, Uppsala University Numerical Linear Algebra October-November, 2018 Assignment on iterative solution methods and preconditioning 1.

More information

Numerical Methods for the Solution of Differential Equations

Numerical Methods for the Solution of Differential Equations Numerical Methods for the Solution of Differential Equations Markus Grasmair Vienna, winter term 2011 2012 Analytical Solutions of Ordinary Differential Equations 1. Find the general solution of the differential

More information

Lecture 4: Numerical solution of ordinary differential equations

Lecture 4: Numerical solution of ordinary differential equations Lecture 4: Numerical solution of ordinary differential equations Department of Mathematics, ETH Zürich General explicit one-step method: Consistency; Stability; Convergence. High-order methods: Taylor

More information

CS 450 Numerical Analysis. Chapter 9: Initial Value Problems for Ordinary Differential Equations

CS 450 Numerical Analysis. Chapter 9: Initial Value Problems for Ordinary Differential Equations Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

MATH2351 Introduction to Ordinary Differential Equations, Fall Hints to Week 07 Worksheet: Mechanical Vibrations

MATH2351 Introduction to Ordinary Differential Equations, Fall Hints to Week 07 Worksheet: Mechanical Vibrations MATH351 Introduction to Ordinary Differential Equations, Fall 11-1 Hints to Week 7 Worksheet: Mechanical Vibrations 1. (Demonstration) ( 3.8, page 3, Q. 5) A mass weighing lb streches a spring by 6 in.

More information

Time stepping methods

Time stepping methods Time stepping methods ATHENS course: Introduction into Finite Elements Delft Institute of Applied Mathematics, TU Delft Matthias Möller (m.moller@tudelft.nl) 19 November 2014 M. Möller (DIAM@TUDelft) Time

More information

Lecture Notes for PHY 405 Classical Mechanics

Lecture Notes for PHY 405 Classical Mechanics Lecture Notes for PHY 405 Classical Mechanics From Thorton & Marion s Classical Mechanics Prepared by Dr. Joseph M. Hahn Saint Mary s University Department of Astronomy & Physics September 1, 2005 Chapter

More information

Analysis of a class of high-order local absorbing boundary conditions

Analysis of a class of high-order local absorbing boundary conditions Report No. UCB/SEMM-2011/07 Structural Engineering Mechanics and Materials Analysis of a class of high-order local absorbing boundary conditions By Koki Sagiyama and Sanjay Govindjee June 2011 Department

More information

ECE257 Numerical Methods and Scientific Computing. Ordinary Differential Equations

ECE257 Numerical Methods and Scientific Computing. Ordinary Differential Equations ECE257 Numerical Methods and Scientific Computing Ordinary Differential Equations Today s s class: Stiffness Multistep Methods Stiff Equations Stiffness occurs in a problem where two or more independent

More information

( ) Chapter 3: Free Vibration of the Breakwater. 3.1 Introduction

( ) Chapter 3: Free Vibration of the Breakwater. 3.1 Introduction Chapter : Free Vibration of the Breakwater. Introduction Before conducting forcing analyses on the breakwater, a free vibration study is necessary. This chapter will describe the analysis conducted to

More information

Ordinary Differential Equations I

Ordinary Differential Equations I Ordinary Differential Equations I CS 205A: Mathematical Methods for Robotics, Vision, and Graphics Justin Solomon CS 205A: Mathematical Methods Ordinary Differential Equations I 1 / 27 Theme of Last Three

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

Ordinary Differential Equations I

Ordinary Differential Equations I Ordinary Differential Equations I CS 205A: Mathematical Methods for Robotics, Vision, and Graphics Justin Solomon CS 205A: Mathematical Methods Ordinary Differential Equations I 1 / 32 Theme of Last Few

More information

Seismic Analysis of Structures by TK Dutta, Civil Department, IIT Delhi, New Delhi.

Seismic Analysis of Structures by TK Dutta, Civil Department, IIT Delhi, New Delhi. Seismic Analysis of Structures by Dutta, Civil Department, II Delhi, New Delhi. Module Response Analysis for Specified Ground Motion Exercise Problems:.. Find the effective mass and stiffness of the structure

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

Solving Ordinary Differential Equations

Solving Ordinary Differential Equations Solving Ordinary Differential Equations Sanzheng Qiao Department of Computing and Software McMaster University March, 2014 Outline 1 Initial Value Problem Euler s Method Runge-Kutta Methods Multistep Methods

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

Differential Equations

Differential Equations Differential Equations Overview of differential equation! Initial value problem! Explicit numeric methods! Implicit numeric methods! Modular implementation Physics-based simulation An algorithm that

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

Time scales. Notes. Mixed Implicit/Explicit. Newmark Methods [ ] [ ] "!t = O 1 %

Time scales. Notes. Mixed Implicit/Explicit. Newmark Methods [ ] [ ] !t = O 1 % Notes Time scales! For using Pixie (the renderer) make sure you type use pixie first! Assignment 1 questions?! [work out]! For position dependence, characteristic time interval is "!t = O 1 % $ ' # K &!

More information

NUMERICAL SIMULATION OF STEEL CATENARY RISER

NUMERICAL SIMULATION OF STEEL CATENARY RISER SIMMEC/EMMCOMP 214 XI Simpósio de Mecânica Computacional II Encontro Mineiro de Modelagem Computacional Juiz De Fora, MG, 28-3 de Maio De 214 NUMERICAL SIMULATION OF STEEL CATENARY RISER Marcus V. S. Casagrande

More information

A Guide to linear dynamic analysis with Damping

A Guide to linear dynamic analysis with Damping A Guide to linear dynamic analysis with Damping This guide starts from the applications of linear dynamic response and its role in FEA simulation. Fundamental concepts and principles will be introduced

More information

Consistency and Convergence

Consistency and Convergence Jim Lambers MAT 77 Fall Semester 010-11 Lecture 0 Notes These notes correspond to Sections 1.3, 1.4 and 1.5 in the text. Consistency and Convergence We have learned that the numerical solution obtained

More information

Part IB Numerical Analysis

Part IB Numerical Analysis Part IB Numerical Analysis Definitions Based on lectures by G. Moore Notes taken by Dexter Chua Lent 206 These notes are not endorsed by the lecturers, and I have modified them (often significantly) after

More information

Ordinary differential equation II

Ordinary differential equation II Ordinary Differential Equations ISC-5315 1 Ordinary differential equation II 1 Some Basic Methods 1.1 Backward Euler method (implicit method) The algorithm looks like this: y n = y n 1 + hf n (1) In contrast

More information

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 28 PART II Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 29 BOUNDARY VALUE PROBLEMS (I) Solving a TWO

More information

Implementation of a user-defined time integration in FEAP: Wilson-Θ

Implementation of a user-defined time integration in FEAP: Wilson-Θ Report No. UCB/SEMM-2010/07 Structural Engineering Mechanics and Materials Implementation of a user-defined time integration in FEAP: Wilson-Θ By Karl Steeger Mentor: Sanjay Govindjee July 2010 Department

More information

Ordinary Differential Equations

Ordinary Differential Equations Chapter 13 Ordinary Differential Equations We motivated the problem of interpolation in Chapter 11 by transitioning from analzying to finding functions. That is, in problems like interpolation and regression,

More information

Free Vibration of Single-Degree-of-Freedom (SDOF) Systems

Free Vibration of Single-Degree-of-Freedom (SDOF) Systems Free Vibration of Single-Degree-of-Freedom (SDOF) Systems Procedure in solving structural dynamics problems 1. Abstraction/modeling Idealize the actual structure to a simplified version, depending on the

More information

sc Control Systems Design Q.1, Sem.1, Ac. Yr. 2010/11

sc Control Systems Design Q.1, Sem.1, Ac. Yr. 2010/11 sc46 - Control Systems Design Q Sem Ac Yr / Mock Exam originally given November 5 9 Notes: Please be reminded that only an A4 paper with formulas may be used during the exam no other material is to be

More information

Scientific Computing II

Scientific Computing II Scientific Computing II Molecular Dynamics Numerics Michael Bader SCCS Technical University of Munich Summer 018 Recall: Molecular Dynamics System of ODEs resulting force acting on a molecule: F i = j

More information

Introduction to numerical schemes

Introduction to numerical schemes 236861 Numerical Geometry of Images Tutorial 2 Introduction to numerical schemes Heat equation The simple parabolic PDE with the initial values u t = K 2 u 2 x u(0, x) = u 0 (x) and some boundary conditions

More information

Numerical solution of ODEs

Numerical solution of ODEs Numerical solution of ODEs Arne Morten Kvarving Department of Mathematical Sciences Norwegian University of Science and Technology November 5 2007 Problem and solution strategy We want to find an approximation

More information

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK KINGS COLLEGE OF ENGINEERING MA5-NUMERICAL METHODS DEPARTMENT OF MATHEMATICS ACADEMIC YEAR 00-0 / EVEN SEMESTER QUESTION BANK SUBJECT NAME: NUMERICAL METHODS YEAR/SEM: II / IV UNIT - I SOLUTION OF EQUATIONS

More information

Lecture 5: Single Step Methods

Lecture 5: Single Step Methods Lecture 5: Single Step Methods J.K. Ryan@tudelft.nl WI3097TU Delft Institute of Applied Mathematics Delft University of Technology 1 October 2012 () Single Step Methods 1 October 2012 1 / 44 Outline 1

More information

[ ] is a vector of size p.

[ ] is a vector of size p. Lecture 11 Copyright by Hongyun Wang, UCSC Recap: General form of explicit Runger-Kutta methods for solving y = F( y, t) k i = hfy n + i1 j =1 c ij k j, t n + d i h, i = 1,, p + p j =1 b j k j A Runge-Kutta

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

Time-dependent variational forms

Time-dependent variational forms Time-dependent variational forms Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Oct 30, 2015 PRELIMINARY VERSION

More information

Lecture V: The game-engine loop & Time Integration

Lecture V: The game-engine loop & Time Integration Lecture V: The game-engine loop & Time Integration The Basic Game-Engine Loop Previous state: " #, %(#) ( #, )(#) Forces -(#) Integrate velocities and positions Resolve Interpenetrations Per-body change

More information

Module 4: Numerical Methods for ODE. Michael Bader. Winter 2007/2008

Module 4: Numerical Methods for ODE. Michael Bader. Winter 2007/2008 Outlines Module 4: for ODE Part I: Basic Part II: Advanced Lehrstuhl Informatik V Winter 2007/2008 Part I: Basic 1 Direction Fields 2 Euler s Method Outlines Part I: Basic Part II: Advanced 3 Discretized

More information

18. FAST NONLINEAR ANALYSIS. The Dynamic Analysis of a Structure with a Small Number of Nonlinear Elements is Almost as Fast as a Linear Analysis

18. FAST NONLINEAR ANALYSIS. The Dynamic Analysis of a Structure with a Small Number of Nonlinear Elements is Almost as Fast as a Linear Analysis 18. FAS NONLINEAR ANALYSIS he Dynamic Analysis of a Structure with a Small Number of Nonlinear Elements is Almost as Fast as a Linear Analysis 18.1 INRODUCION he response of real structures when subjected

More information

Solutions 2: Simple Harmonic Oscillator and General Oscillations

Solutions 2: Simple Harmonic Oscillator and General Oscillations Massachusetts Institute of Technology MITES 2017 Physics III Solutions 2: Simple Harmonic Oscillator and General Oscillations Due Wednesday June 21, at 9AM under Rene García s door Preface: This problem

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

Cyber-Physical Systems Modeling and Simulation of Continuous Systems

Cyber-Physical Systems Modeling and Simulation of Continuous Systems Cyber-Physical Systems Modeling and Simulation of Continuous Systems Matthias Althoff TU München 29. May 2015 Matthias Althoff Modeling and Simulation of Cont. Systems 29. May 2015 1 / 38 Ordinary Differential

More information

Math 660 Lecture 4: FDM for evolutionary equations: ODE solvers

Math 660 Lecture 4: FDM for evolutionary equations: ODE solvers Math 660 Lecture 4: FDM for evolutionary equations: ODE solvers Consider the ODE u (t) = f(t, u(t)), u(0) = u 0, where u could be a vector valued function. Any ODE can be reduced to a first order system,

More information

Imaginary. Axis. Real. Axis

Imaginary. Axis. Real. Axis Name ME6 Final. I certify that I upheld the Stanford Honor code during this exam Monday December 2, 25 3:3-6:3 p.m. ffl Print your name and sign the honor code statement ffl You may use your course notes,

More information

First Year Physics: Prelims CP1. Classical Mechanics: Prof. Neville Harnew. Problem Set III : Projectiles, rocket motion and motion in E & B fields

First Year Physics: Prelims CP1. Classical Mechanics: Prof. Neville Harnew. Problem Set III : Projectiles, rocket motion and motion in E & B fields HT017 First Year Physics: Prelims CP1 Classical Mechanics: Prof Neville Harnew Problem Set III : Projectiles, rocket motion and motion in E & B fields Questions 1-10 are standard examples Questions 11-1

More information

Methods for Computing Periodic Steady-State Jacob White

Methods for Computing Periodic Steady-State Jacob White Introduction to Simulation - Lecture 15 Methods for Computing Periodic Steady-State Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Outline Periodic Steady-state problems Application

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

Final Exam Sample Problems, Math 246, Spring 2018

Final Exam Sample Problems, Math 246, Spring 2018 Final Exam Sample Problems, Math 246, Spring 2018 1) Consider the differential equation dy dt = 9 y2 )y 2. a) Find all of its stationary points and classify their stability. b) Sketch its phase-line portrait

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

Lecture 1 Notes: 06 / 27. The first part of this class will primarily cover oscillating systems (harmonic oscillators and waves).

Lecture 1 Notes: 06 / 27. The first part of this class will primarily cover oscillating systems (harmonic oscillators and waves). Lecture 1 Notes: 06 / 27 The first part of this class will primarily cover oscillating systems (harmonic oscillators and waves). These systems are very common in nature - a system displaced from equilibrium

More information

Dynamical Systems. Mechanical Systems

Dynamical Systems. Mechanical Systems EE/ME/AE324: Dynamical Systems Chapter 2: Modeling Translational Mechanical Systems Common Variables Used Assumes 1 DoF per mass, i.e., all motion scalar Displacement: x ()[ t [m] Velocity: dx() t vt ()

More information

Math 221 Topics since the second exam

Math 221 Topics since the second exam Laplace Transforms. Math 1 Topics since the second exam There is a whole different set of techniques for solving n-th order linear equations, which are based on the Laplace transform of a function. For

More information

Ordinary differential equations - Initial value problems

Ordinary differential equations - Initial value problems Education has produced a vast population able to read but unable to distinguish what is worth reading. G.M. TREVELYAN Chapter 6 Ordinary differential equations - Initial value problems In this chapter

More information

DELFT UNIVERSITY OF TECHNOLOGY Faculty of Electrical Engineering, Mathematics and Computer Science

DELFT UNIVERSITY OF TECHNOLOGY Faculty of Electrical Engineering, Mathematics and Computer Science DELFT UNIVERSITY OF TECHNOLOGY Faculty of Electrical Engineering, Mathematics and Computer Science ANSWERS OF THE TEST NUMERICAL METHODS FOR DIFFERENTIAL EQUATIONS (WI097 TU) Thursday January 014, 18:0-1:0

More information

DELFT UNIVERSITY OF TECHNOLOGY Faculty of Electrical Engineering, Mathematics and Computer Science

DELFT UNIVERSITY OF TECHNOLOGY Faculty of Electrical Engineering, Mathematics and Computer Science DELFT UNIVERSITY OF TECHNOLOGY Faculty of Electrical Engineering, Matematics and Computer Science. ANSWERS OF THE TEST NUMERICAL METHODS FOR DIFFERENTIAL EQUATIONS (WI3097 TU) Tuesday January 9 008, 9:00-:00

More information

Simulating Two-Dimensional Stick-Slip Motion of a Rigid Body using a New Friction Model

Simulating Two-Dimensional Stick-Slip Motion of a Rigid Body using a New Friction Model Proceedings of the 2 nd World Congress on Mechanical, Chemical, and Material Engineering (MCM'16) Budapest, Hungary August 22 23, 2016 Paper No. ICMIE 116 DOI: 10.11159/icmie16.116 Simulating Two-Dimensional

More information

Numerical Methods for Differential Equations

Numerical Methods for Differential Equations Numerical Methods for Differential Equations Chapter 2: Runge Kutta and Linear Multistep methods Gustaf Söderlind and Carmen Arévalo Numerical Analysis, Lund University Textbooks: A First Course in the

More information

Theoretical physics. Deterministic chaos in classical physics. Martin Scholtz

Theoretical physics. Deterministic chaos in classical physics. Martin Scholtz Theoretical physics Deterministic chaos in classical physics Martin Scholtz scholtzzz@gmail.com Fundamental physical theories and role of classical mechanics. Intuitive characteristics of chaos. Newton

More information

Application of Second Order Linear ODEs: Mechanical Vibrations

Application of Second Order Linear ODEs: Mechanical Vibrations Application of Second Order Linear ODEs: October 23 27, 2017 Application of Second Order Linear ODEs Consider a vertical spring of original length l > 0 [m or ft] that exhibits a stiffness of κ > 0 [N/m

More information