Algorithms of Scientific Computing II

Size: px
Start display at page:

Download "Algorithms of Scientific Computing II"

Transcription

1 Technische Universität München WS 01/013 Institut für Informatik Prof. Dr. Hans-Joachim Bungartz Alexander Heinecke, M.Sc., M.Sc.w.H. Algorithms of Scientific Computing II Exercise 3 - Discretization, Short-Range Potentials 1) Time Discretization The movement of the molecules is being described by the following ordinary differential equation: F i = m i r i. In the lecture different methods for the discretization of that ODE have been introduced. In this exercise we will deal with those methods in more detail. a) Use the Taylor-Series to derive the position equation of the Explicit- Eulermethod Taylor-Series: r(t + t) = r(t) + t r(t) + 1 t r(t) + ti i! truncate after first derivative: r (i) (t) +... r(t + t) = r(t) + t r(t) = r(t) + t v(t) v(t + t) = v(t) + t a(t) b) The Störmer Verlet -method is given by the following formulas: r(t + t) = r(t) r(t t) + t a(t) (1) v(t) = r(t + t) r(t t) t () Use the Taylor-Series to derive the position equation of the Störmer-Verletmethod

2 Develop the Taylor-Series for t + t and t t: r(t + t) = r(t) + t r(t) + t r(t) + t r (t) + O( t 4 ) r(t t) = r(t) t r(t) + t r(t) t r (t) + O( t 4 ) Only the signs in front of terms with odd derivatives are different. Adding the two formulas yields: r(t + t) + r(t t) = r(t) + t r(t) + O( t 4 ) This gives us the formula for the position: r(t + t) = r(t) r(t t) + t r(t) + O( t 4 ) c) What are the drawbacks of the Störmer-Verlet-method? At the beginning of the simulation, the position of the particles is known. But the Störmer-Verlet-method requires the position to be known at two different timesteps. You always have to store the position for the two latest timesteps. The velocity is not being calculated. d) In exact arithmetics, the Störmer Verlet- and the Velocity-Störmer-Verletmethod are equivalent. Prove the equivalence of the two schemes by starting from the Störmer Verlet-method and derive the Velocity-Störmer-Verletmethod: From () we get: r(t + t) = r(t) + t v(t) + t a(t) (3) v(t + t) = v(t) + t (a(t) + a(t + t)) (4) r(t t) = r(t + t) t v(t) (5) substituting (5) into (1) and further transformations lead to the formula for the position: r(t + t) = r(t) r(t + t) + t v + t a(t) r(t + t) = r(t) + t v + t a(t)

3 r(t + t) = r(t) + t v + t a(t) (6) To get a formula for the velocity, we substitute (1) into (): v(t) = r(t) t r(t t) t + t construct the same formula for the next time step: a(t) (7) add (7) and (8) v(t + t) = r(t + t) t r(t) t + t a(t + t) (8) v(t) + v(t + t) = r(t + t) r(t t) t + ( a(t + t) + a(t)) t v(t + t) = v(t) + ( a(t + t) + a(t)) t Eq. 6 and eq. 9 are the desired Velocity Störmer Verlet method. (9) e) The Euler discretisation scheme is not time reversible. Analyse the Velocity- Störmer-Verlet-method to find out whether it is time reversible. To find out wheter the method is time reversible, one calculates backwards, so starting from the calculated positions and velocites at time (t + t), one calculates those at time t by using t = t from the previous formula as a time step. We call the resulting values at time (t + t + t) = t r and ṽ, as we don t know yet wheter they are really equal to r and v. So be replacing t by t and t by t + t in eq. (3) and (4) we get: r(t + t + t) = r(t + t) + t v(t + t) + t a(t + t) (10) ṽ(t + t + t) = v(t + t) + t (a(t + t) + ã(t + t + t)) (11) Replacing t by t in 10: r(t) = r(t + t) t v(t + t) + t a(t + t) (1)

4 Substituting (3) and (4) into (1): r(t) = (r(t) + t v(t) + t a(t)) (13) t (v(t) + t t (a(t) + a(t + t))) + a(t + t) (14) = r(t) (15) Concerning the calculation of the positions, the Velocity Störmer Verlet method is time reversible. This also means that ã(t) equals a(t) Now we will have a look at the velocities. Replacing t by t in 11: Substituting (4) into (17): ṽ(t) = v(t + t) t = v(t + t) t (a(t + t) + ã(t)) (16) (a(t + t) + a(t)) (17) ṽ(t) = v(t) + t t (a(t) + a(t + t)) (a(t + t) + a(t)) (18) = v(t) (19) So also the velocity calculation and therefore the whole Velocity Störmer Verlet method is time reversible. f) For the derivation of the Euler method, which is a first order method, all terms of second or higher order were neglected. In the derivetion of the Störmer Verlet method, all terms of fourth or higher order were neglected. Yet, the Störmer Verlet method is not a third order, but only a second order method. Show why this is the case. The Störmer-Verlet method is given by r(t + t) = r(t) r(t t) + t a(t) + O( t 4 ). Assume, that r(t) and r(t t) are known exactly. Then the error for r(t+ t) is Error( r(t + t)) = O( t 4 ). Neglecting errors in a(t + t), we apply the scheme several times and determine the errror:

5 At time t + t: r(t + t) = r(t + t) r(t) + t a(t + t) + O( t 4 ) Error( r(t + t)) = Error( r(t + t))+? + O( t 4 ) = 3 O( t 4 ) At time t + 3 t: r(t + 3 t) = r(t + t) r(t + t) + t a(t + t) + O( t 4 ) Error( r(t + 3 t)) = Error( r(t + t)) Error( r(t + t))+? + O( t 4 ) = 3 At time t + n t: By induction, one can show: = 6 O( t 4 ) O( t 4 )+? + O( t 4 ) = 6 O( t 4 ) Error( r(t + n t)) = n (n 1) O( t 4 ) So at time T = n t we get Error( r(t + n t)) = ( n + n ) O( t4 ) T = ( t + T t ) O( t4 ) = O( t ) n= T t ) Short-range Potentials a) Assume we simulate a molecular dynamics scenario with N molecules. If we explicitely compute the forces between all pairs of molecules, O(N ) operations are necessary. For short-range potentials, we neglect interactions between particles that have a mutual distance bigger than a certain cut-off radius. This reduces the number of required operations to O(N). Someone tries to convince you that this is not true: Assume that a simululation with N molecules requires C operations for the force calculations. Double the number of molecules in the domain. Then we of course have to compute forces for twice as many molecules. But, in addition, the number of molecules within the cut-off radius of a certain molecule doubles, too. Such,

6 we need 4C operations, which means that the number of operations behaves like O(N ). Why is that argumentation faulty? The fault is that with doubling the number of molecules in a domain the scenario changes completely, as we now deal with matter of double the density. Thus doubling the problem size doesn t correspond to simply doubling the number of molecules, but rather to doubling the size of the domain, with constant density. In that case the algorithm really needs only twice the number of calculations. b) For short-range potentials it is sufficient to consider only neighbouring particles for the force calculation. That means that all particles which are farther away as the cutoff-radius are neglected. But this is only allowed when the integral over the cut-away potential (from r c to inf is finite. In the lecture you have seen for D potentials of the form U(r) = c r p this is the case for p > Now consider a 3D potential of the same form (U(r) = c r p ). For which values of p is this potential short-range in 3D? In order to be a short-range potential, the integral over the cut-off area has to be finite. In the following we consider the integrals in 1d, d and 3d 1D: U( r)d r r >rc As we only want to analyze if the integral is finite, it is sufficient to consider positive distances: [ ] r U(r)dr = c r p 1 p ( ) 1 p = c = c 1 p 1 p rc1 p 1 p r>rc r>rc Thus, for p 1 the integral approaches infinity. For p > 1 the 1dpotential is short-range. D: The calculation of the two-dimensional integral over the cutoff-area is simpler to perform in polar coordinates. Therefore we perform a transformation of the coordinates before. The transformation function Ψ(r, α) reads: ( ) ( ) x1 r cos α = Ψ(r, α) = r sin α x rc

7 With that function the integral can be written as U( r)d r = π r >rc 0 rc U(r)det(J(Ψ(r, α)))drdα (0) First we determine the determinant of the Jacobian matrix: det(j(ψ(r, α))) = r 1(r, α) r (r, α) α 1(r, α) α (r, α) = cos α sin α r sin α r cos α = r cos α + r sin α = r That result put into (0) gives us: r >rc U( r)d r = π 0 rc U(r) r drdα Now we replace the potential with the one given: r >rc U( r)d r = = π π = πc 0 rc c r p r drdα = [ r c r 1 p p dr = πc rc p ( ) p p 0 p p π 0 rc ] 0 c r 1 p drdα As we can see, the integral is finite for p >, thus the potential is short-range in that case. 3D: We want fo find out for wich potentials U(r) the integral r >r c U( r )d r is finite. First, we have to do a coordinate transformation to polar coordinates: x 1 x x 3 = Ψ(r, α, β) = r cos α cos β r sin α cos β r sin β r >r c U( r )d r = pi pi π 0 r c U( r ) det(j(ψ(r, α, β)))drdαdβ (1)

8 Calcuate the determinant of the Jacobi-matrix det(j(ψ(r, α, β))) = = Ψ r 1(r, α, β) Ψ r (r, α, β) Ψ r 3(r, α, β) Ψ α 1(r, α, β) Ψ α (r, α, β) Ψ α 3(r, α, β) Ψ β 1(r, α, β) Ψ β (r, α, β) Ψ β 3(r, α, β) cos α cos β sin α cos β sin β r sin α cos β r cos α cos β 0 r cos α sin β r sin α sin β r cos β = r cos α cos 3 βr sin α sin β cos β + r cos α sin β cos βr sin α c = r (cos 3 β(cos α + sin α) + sin β cos β(sin α + cos α)) = r (cos 3 β + sin β cos β) = r cos β and the norm of r: r = r (cos α cos β + sin α cos β + sin β) = r (cos β(cos α + sin α) + sin β) = r Using this with (1): r >r c U( r )d r = = π = π π π 0 r c π π π 0 r c π π r c π U( r ) det(j(ψ(r, α, β)))drdαdβ c r p r cos βdrdαdβ c r p cos βdrdβ ] [ r 3 p = πc cos βdβ π 3 p r c [ ] r 3 p = πc [sin β] π 3 p π rc ( 3 p = πc 3 p r3 p c 3 p { 4πc = r3 p c if p > 3 3 p if p 3 ) ( sin( π ) sin( π ) )

9 3) Linked Cells a) The linked cell datastructure is used to access neighbouring molecules. In the most simple case, the cells are cubic and the side length of a cell equals the cutoff radius. In 3D, apart from the cell itself, 6 additional cells have to be examined (8 cells in D). By reducing the size of the cells, more cells have to be used, but the volume covered by these cells is smaller. As the covered volume corresponds to the number of distance calculations, smaller cell sizes can increase the performance. Calculate the covered volume for l = rc, l = rc, l = rc and l 0 in D and 3D. 4 D (% unnecessary) 3D (% unnecessary) l = rc l = rc l = rc 4... L 0 i) l = rc: In this case, we have to consider only the directly neighbouring cells: D: 9 cells 3D: 7 cells A cells 9rc 7rc 3 A in cutoff πrc 4 3 πrc3 π A in cutoff / A cells 4π 9 81 unneccessary: 65% 84% ii) l = rc : In this case, we have to consider two neighbouring cells in each direction, thus five cells per dimension: D: 5 cells 3D: 15 cells A cells 5( rc ) = 5 15 rc 4 8 rc3 A in cutoff πrc 4 3 πrc3 4π A in cutoff / A cells 50% 3π 7% unneccessary: 50% 73% iii) l = rc : Here we have to take 9 cells in each dimension into consideration. 4 But now we can get rid of some cells. In d, e.g. the smallest distance possible between a particle in the middle cell to a particle in a corner cell is ( 3 4 rc) = 1.06rc. Thus we don t have to search the corner cells for particles within the cutoff-radius. In 3d, searching all cells along the edges is unneccessary. Moreover we can save 4 more cells per surface of the cube.

10 D: 77 cells 3D: 613 cells A cells 77( rc 4 ) = rc rc3 A in cutoff πrc 4 3 πrc3 16π A in cutoff / A cells 56π unneccessary: 35% 56% Here is an overview of all the results: l = rc l = rc l = rc... L 0 4 D (% unneccessary) 65% 50% 35% 0% 3D (% unneccessary) 84% 73% 56% 0% b) As investigated in part a), the computational time to evaluate the force on one particle depends on the size of the cells of the linked-cells datastructure. Try to determine further factors which influence the computational time and construct a formula! The time for dealing with one cell consists of the time to access the cell plus the time to access the cell s particle and calculating the distances of the particles. If the particles are equally distributed, the number of molecules in a cell is proportional to the density ρ: t Cell = c Cell + c distance ρ V Cell The number of force calculations is independent of the size of the cells, as only the forces between those molecules are calculated which ly within the cutoff radius, but it depends on the density: t force = (c force ρ 4 3 π rc3 ) ρ V domain Thus, the total time is t total = N cells t cell + t force

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

Ph 22.1 Return of the ODEs: higher-order methods

Ph 22.1 Return of the ODEs: higher-order methods Ph 22.1 Return of the ODEs: higher-order methods -v20130111- Introduction This week we are going to build on the experience that you gathered in the Ph20, and program more advanced (and accurate!) solvers

More information

Physics 342 Lecture 23. Radial Separation. Lecture 23. Physics 342 Quantum Mechanics I

Physics 342 Lecture 23. Radial Separation. Lecture 23. Physics 342 Quantum Mechanics I Physics 342 Lecture 23 Radial Separation Lecture 23 Physics 342 Quantum Mechanics I Friday, March 26th, 2010 We begin our spherical solutions with the simplest possible case zero potential. Aside from

More information

Fundamental Algorithms 11

Fundamental Algorithms 11 Technische Universität München WS 2013/14 Institut für Informatik Worksheet Scientific Computing in Computer Science 20.01.2014 Fundamental Algorithms 11 Exercise 1 Hypergraphs A hypergraph extends the

More information

PDEs in Spherical and Circular Coordinates

PDEs in Spherical and Circular Coordinates Introduction to Partial Differential Equations part of EM, Scalar and Vector Fields module (PHY2064) This lecture Laplacian in spherical & circular polar coordinates Laplace s PDE in electrostatics Schrödinger

More information

Computational Techniques Prof. Dr. Niket Kaisare Department of Chemical Engineering Indian Institute of Technology, Madras

Computational Techniques Prof. Dr. Niket Kaisare Department of Chemical Engineering Indian Institute of Technology, Madras Computational Techniques Prof. Dr. Niket Kaisare Department of Chemical Engineering Indian Institute of Technology, Madras Module No. # 07 Lecture No. # 04 Ordinary Differential Equations (Initial Value

More information

3 rd class Mech. Eng. Dept. hamdiahmed.weebly.com Fourier Series

3 rd class Mech. Eng. Dept. hamdiahmed.weebly.com Fourier Series Definition 1 Fourier Series A function f is said to be piecewise continuous on [a, b] if there exists finitely many points a = x 1 < x 2

More information

Review of Power Series

Review of Power Series Review of Power Series MATH 365 Ordinary Differential Equations J. Robert Buchanan Department of Mathematics Fall 2018 Introduction In addition to the techniques we have studied so far, we may use power

More information

AIMS Exercise Set # 1

AIMS Exercise Set # 1 AIMS Exercise Set #. Determine the form of the single precision floating point arithmetic used in the computers at AIMS. What is the largest number that can be accurately represented? What is the smallest

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

Practical Course Scientific Computing and Visualization

Practical Course Scientific Computing and Visualization Technische Universität München WT 007/00 Institut für Informatik Dr. Miriam Mehl Tobias Weinzierl Csaba Vigh Practical Course Scientific Computing and Visualization Worksheet distributed: 07..007 due to:

More information

Condensed Matter Physics Prof. G. Rangarajan Department of Physics Indian Institute of Technology, Madras

Condensed Matter Physics Prof. G. Rangarajan Department of Physics Indian Institute of Technology, Madras Condensed Matter Physics Prof. G. Rangarajan Department of Physics Indian Institute of Technology, Madras Lecture - 03 Symmetry in Perfect Solids Worked Examples Stated without prove to be in the lecture.

More information

Worksheet 8 Sample Solutions

Worksheet 8 Sample Solutions Technische Universität München WS 2016/17 Lehrstuhl für Informatik V Scientific Computing Univ.-Prof. Dr. M. Bader 19.12.2016/21.12.2016 M.Sc. S. Seckler, M.Sc. D. Jarema Worksheet 8 Sample Solutions Ordinary

More information

Introduction to the Numerical Solution of IVP for ODE

Introduction to the Numerical Solution of IVP for ODE Introduction to the Numerical Solution of IVP for ODE 45 Introduction to the Numerical Solution of IVP for ODE Consider the IVP: DE x = f(t, x), IC x(a) = x a. For simplicity, we will assume here that

More information

1 Ordinary differential equations

1 Ordinary differential equations Numerical Analysis Seminar Frühjahrssemester 08 Lecturers: Prof. M. Torrilhon, Prof. D. Kressner The Störmer-Verlet method F. Crivelli (flcrivel@student.ethz.ch May 8, 2008 Introduction During this talk

More information

Algorithms: Lecture 2

Algorithms: Lecture 2 1 Algorithms: Lecture 2 Basic Structures: Sets, Functions, Sequences, and Sums Jinwoo Kim jwkim@jjay.cuny.edu 2.1 Sets 2 1 2.1 Sets 3 2.1 Sets 4 2 2.1 Sets 5 2.1 Sets 6 3 2.1 Sets 7 2.2 Set Operations

More information

Scientific Computing II

Scientific Computing II Technische Universität München ST 008 Institut für Informatik Dr. Miriam Mehl Scientific Computing II Final Exam, July, 008 Iterative Solvers (3 pts + 4 extra pts, 60 min) a) Steepest Descent and Conjugate

More information

Report on Numerical Approximations of FDE s with Method of Steps

Report on Numerical Approximations of FDE s with Method of Steps Report on Numerical Approximations of FDE s with Method of Steps Simon Lacoste-Julien May 30, 2001 Abstract This is a summary of a meeting I had with Hans Vangheluwe on Thursday May 24 about numerical

More information

Last Update: March 1 2, 201 0

Last Update: March 1 2, 201 0 M ath 2 0 1 E S 1 W inter 2 0 1 0 Last Update: March 1 2, 201 0 S eries S olutions of Differential Equations Disclaimer: This lecture note tries to provide an alternative approach to the material in Sections

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

AM205: Assignment 3 (due 5 PM, October 20)

AM205: Assignment 3 (due 5 PM, October 20) AM25: Assignment 3 (due 5 PM, October 2) For this assignment, first complete problems 1, 2, 3, and 4, and then complete either problem 5 (on theory) or problem 6 (on an application). If you submit answers

More information

Sums of Squares (FNS 195-S) Fall 2014

Sums of Squares (FNS 195-S) Fall 2014 Sums of Squares (FNS 195-S) Fall 014 Record of What We Did Drew Armstrong Vectors When we tried to apply Cartesian coordinates in 3 dimensions we ran into some difficulty tryiing to describe lines and

More information

PHIL 422 Advanced Logic Inductive Proof

PHIL 422 Advanced Logic Inductive Proof PHIL 422 Advanced Logic Inductive Proof 1. Preamble: One of the most powerful tools in your meta-logical toolkit will be proof by induction. Just about every significant meta-logical result relies upon

More information

CS 124 Math Review Section January 29, 2018

CS 124 Math Review Section January 29, 2018 CS 124 Math Review Section CS 124 is more math intensive than most of the introductory courses in the department. You re going to need to be able to do two things: 1. Perform some clever calculations to

More information

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by 1. QUESTION (a) Given a nth degree Taylor polynomial P n (x) of a function f(x), expanded about x = x 0, write down the Lagrange formula for the truncation error, carefully defining all its elements. How

More information

Chapter 3: Polynomial and Rational Functions

Chapter 3: Polynomial and Rational Functions .1 Power and Polynomial Functions 155 Chapter : Polynomial and Rational Functions Section.1 Power Functions & Polynomial Functions... 155 Section. Quadratic Functions... 16 Section. Graphs of Polynomial

More information

Learn how to use Desmos

Learn how to use Desmos Learn how to use Desmos Maclaurin and Taylor series 1 Go to www.desmos.com. Create an account (click on bottom near top right of screen) Change the grid settings (click on the spanner) to 1 x 3, 1 y 12

More information

No Solution Equations Let s look at the following equation: 2 +3=2 +7

No Solution Equations Let s look at the following equation: 2 +3=2 +7 5.4 Solving Equations with Infinite or No Solutions So far we have looked at equations where there is exactly one solution. It is possible to have more than solution in other types of equations that are

More information

Sum and difference formulae for sine and cosine. Elementary Functions. Consider angles α and β with α > β. These angles identify points on the

Sum and difference formulae for sine and cosine. Elementary Functions. Consider angles α and β with α > β. These angles identify points on the Consider angles α and β with α > β. These angles identify points on the unit circle, P (cos α, sin α) and Q(cos β, sin β). Part 5, Trigonometry Lecture 5.1a, Sum and Difference Formulas Dr. Ken W. Smith

More information

Physics 342 Lecture 22. The Hydrogen Atom. Lecture 22. Physics 342 Quantum Mechanics I

Physics 342 Lecture 22. The Hydrogen Atom. Lecture 22. Physics 342 Quantum Mechanics I Physics 342 Lecture 22 The Hydrogen Atom Lecture 22 Physics 342 Quantum Mechanics I Friday, March 28th, 2008 We now begin our discussion of the Hydrogen atom. Operationally, this is just another choice

More information

Mathematics for Intelligent Systems Lecture 5 Homework Solutions

Mathematics for Intelligent Systems Lecture 5 Homework Solutions Mathematics for Intelligent Systems Lecture 5 Homework Solutions Advanced Calculus I: Derivatives and local geometry) Nathan Ratliff Nov 25, 204 Problem : Gradient and Hessian Calculations We ve seen that

More information

Mathematics for Chemists 2 Lecture 14: Fourier analysis. Fourier series, Fourier transform, DFT/FFT

Mathematics for Chemists 2 Lecture 14: Fourier analysis. Fourier series, Fourier transform, DFT/FFT Mathematics for Chemists 2 Lecture 14: Fourier analysis Fourier series, Fourier transform, DFT/FFT Johannes Kepler University Summer semester 2012 Lecturer: David Sevilla Fourier analysis 1/25 Remembering

More information

LECTURE 10: REVIEW OF POWER SERIES. 1. Motivation

LECTURE 10: REVIEW OF POWER SERIES. 1. Motivation LECTURE 10: REVIEW OF POWER SERIES By definition, a power series centered at x 0 is a series of the form where a 0, a 1,... and x 0 are constants. For convenience, we shall mostly be concerned with the

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

FINITE DIFFERENCES. Lecture 1: (a) Operators (b) Forward Differences and their calculations. (c) Backward Differences and their calculations.

FINITE DIFFERENCES. Lecture 1: (a) Operators (b) Forward Differences and their calculations. (c) Backward Differences and their calculations. FINITE DIFFERENCES Lecture 1: (a) Operators (b) Forward Differences and their calculations. (c) Backward Differences and their calculations. 1. Introduction When a function is known explicitly, it is easy

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

30.4. Matrix Norms. Introduction. Prerequisites. Learning Outcomes

30.4. Matrix Norms. Introduction. Prerequisites. Learning Outcomes Matrix Norms 304 Introduction A matrix norm is a number defined in terms of the entries of the matrix The norm is a useful quantity which can give important information about a matrix Prerequisites Before

More information

A sequence { a n } converges if a n = finite number. Otherwise, { a n }

A sequence { a n } converges if a n = finite number. Otherwise, { a n } 9.1 Infinite Sequences Ex 1: Write the first four terms and determine if the sequence { a n } converges or diverges given a n =(2n) 1 /2n A sequence { a n } converges if a n = finite number. Otherwise,

More information

Physics 115/242 The leapfrog method and other symplectic algorithms for integrating Newton s laws of motion

Physics 115/242 The leapfrog method and other symplectic algorithms for integrating Newton s laws of motion Physics 115/242 The leapfrog method and other symplectic algorithms for integrating Newton s laws of motion Peter Young (Dated: April 14, 2009) I. INTRODUCTION One frequently obtains detailed dynamical

More information

2tdt 1 y = t2 + C y = which implies C = 1 and the solution is y = 1

2tdt 1 y = t2 + C y = which implies C = 1 and the solution is y = 1 Lectures - Week 11 General First Order ODEs & Numerical Methods for IVPs In general, nonlinear problems are much more difficult to solve than linear ones. Unfortunately many phenomena exhibit nonlinear

More information

Math 300: Foundations of Higher Mathematics Northwestern University, Lecture Notes

Math 300: Foundations of Higher Mathematics Northwestern University, Lecture Notes Math 300: Foundations of Higher Mathematics Northwestern University, Lecture Notes Written by Santiago Cañez These are notes which provide a basic summary of each lecture for Math 300, Foundations of Higher

More information

Backward error analysis

Backward error analysis Backward error analysis Brynjulf Owren July 28, 2015 Introduction. The main source for these notes is the monograph by Hairer, Lubich and Wanner [2]. Consider ODEs in R d of the form ẏ = f(y), y(0) = y

More information

Condensed Matter Physics Prof. G. Rangarajan Department of Physics Indian Institute of Technology, Madras

Condensed Matter Physics Prof. G. Rangarajan Department of Physics Indian Institute of Technology, Madras (Refer Slide Time: 00:11) Condensed Matter Physics Prof. G. Rangarajan Department of Physics Indian Institute of Technology, Madras Lecture - 09 The Free Electron Theory of Metals-Worked Examples Now,

More information

Math 31 Lesson Plan. Day 2: Sets; Binary Operations. Elizabeth Gillaspy. September 23, 2011

Math 31 Lesson Plan. Day 2: Sets; Binary Operations. Elizabeth Gillaspy. September 23, 2011 Math 31 Lesson Plan Day 2: Sets; Binary Operations Elizabeth Gillaspy September 23, 2011 Supplies needed: 30 worksheets. Scratch paper? Sign in sheet Goals for myself: Tell them what you re going to tell

More information

EECS 117 Lecture 18: Magnetic Energy and Inductance

EECS 117 Lecture 18: Magnetic Energy and Inductance University of California, Berkeley EECS 117 Lecture 18 p. 1/2 EECS 117 Lecture 18: Magnetic Energy and Inductance Prof. Niknejad University of California, Berkeley University of California, Berkeley EECS

More information

Interpolation. P. Sam Johnson. January 30, P. Sam Johnson (NITK) Interpolation January 30, / 75

Interpolation. P. Sam Johnson. January 30, P. Sam Johnson (NITK) Interpolation January 30, / 75 Interpolation P. Sam Johnson January 30, 2015 P. Sam Johnson (NITK) Interpolation January 30, 2015 1 / 75 Overview One of the basic ideas in Mathematics is that of a function and most useful tool of numerical

More information

Waves, the Wave Equation, and Phase Velocity. We ll start with optics. The one-dimensional wave equation. What is a wave? Optional optics texts: f(x)

Waves, the Wave Equation, and Phase Velocity. We ll start with optics. The one-dimensional wave equation. What is a wave? Optional optics texts: f(x) We ll start with optics Optional optics texts: Waves, the Wave Equation, and Phase Velocity What is a wave? f(x) f(x-) f(x-) f(x-3) Eugene Hecht, Optics, 4th ed. J.F. James, A Student's Guide to Fourier

More information

Computational Fluid Dynamics Prof. Dr. SumanChakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur

Computational Fluid Dynamics Prof. Dr. SumanChakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Computational Fluid Dynamics Prof. Dr. SumanChakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Lecture No. #11 Fundamentals of Discretization: Finite Difference

More information

Theoretische Physik 2: Elektrodynamik (Prof. A-S. Smith) Home assignment 11

Theoretische Physik 2: Elektrodynamik (Prof. A-S. Smith) Home assignment 11 WiSe 22..23 Prof. Dr. A-S. Smith Dipl.-Phys. Matthias Saba am Lehrstuhl für Theoretische Physik I Department für Physik Friedrich-Alexander-Universität Erlangen-Nürnberg Problem. Theoretische Physik 2:

More information

Applied Mathematics 205. Unit 0: Overview of Scientific Computing. Lecturer: Dr. David Knezevic

Applied Mathematics 205. Unit 0: Overview of Scientific Computing. Lecturer: Dr. David Knezevic Applied Mathematics 205 Unit 0: Overview of Scientific Computing Lecturer: Dr. David Knezevic Scientific Computing Computation is now recognized as the third pillar of science (along with theory and experiment)

More information

ODE Runge-Kutta methods

ODE Runge-Kutta methods ODE Runge-Kutta methods The theory (very short excerpts from lectures) First-order initial value problem We want to approximate the solution Y(x) of a system of first-order ordinary differential equations

More information

Implementation of test scenarios for incompressible flow using a divergence free finite element approach

Implementation of test scenarios for incompressible flow using a divergence free finite element approach Bachelor s Thesis Implementation of test scenarios for incompressible flow using a divergence free finite element approach Author: Benjamin Rüth Maistraße 54 8337 München Field of Studies: Informatics,

More information

QM and Angular Momentum

QM and Angular Momentum Chapter 5 QM and Angular Momentum 5. Angular Momentum Operators In your Introductory Quantum Mechanics (QM) course you learned about the basic properties of low spin systems. Here we want to review that

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

What is Classical Molecular Dynamics?

What is Classical Molecular Dynamics? What is Classical Molecular Dynamics? Simulation of explicit particles (atoms, ions,... ) Particles interact via relatively simple analytical potential functions Newton s equations of motion are integrated

More information

An Analysis of Five Numerical Methods for Approximating Certain Hypergeometric Functions in Domains within their Radii of Convergence

An Analysis of Five Numerical Methods for Approximating Certain Hypergeometric Functions in Domains within their Radii of Convergence An Analysis of Five Numerical Methods for Approximating Certain Hypergeometric Functions in Domains within their Radii of Convergence John Pearson MSc Special Topic Abstract Numerical approximations of

More information

(Refer Slide Time: 1:58 min)

(Refer Slide Time: 1:58 min) Applied Mechanics Prof. R. K. Mittal Department of Applied Mechanics Indian Institution of Technology, Delhi Lecture No. # 13 Moments and Products of Inertia (Contd.) Today s lecture is lecture thirteen

More information

Lecture 10: Multiple Integrals

Lecture 10: Multiple Integrals Lecture 10: Multiple Integrals 1. Key points Multiple integrals as Iterated Integrals Change of variables: Jacobian Maple int(f(x,y),[xa..b,yc..d]) VectorCalculus[Jacobian] LinearAlgebra[Determinant] 2.

More information

Spring 2010 Exam 2. You may not use your books, notes, or any calculator on this exam.

Spring 2010 Exam 2. You may not use your books, notes, or any calculator on this exam. MTH 282 final Spring 2010 Exam 2 Time Limit: 110 Minutes Name (Print): Instructor: Prof. Houhong Fan This exam contains 6 pages (including this cover page) and 5 problems. Check to see if any pages are

More information

r 2 dr h2 α = 8m2 q 4 Substituting we find that variational estimate for the energy is m e q 4 E G = 4

r 2 dr h2 α = 8m2 q 4 Substituting we find that variational estimate for the energy is m e q 4 E G = 4 Variational calculations for Hydrogen and Helium Recall the variational principle See Chapter 16 of the textbook The variational theorem states that for a Hermitian operator H with the smallest eigenvalue

More information

Intermediate Math Circles March 11, 2009 Sequences and Series

Intermediate Math Circles March 11, 2009 Sequences and Series 1 University of Waterloo Faculty of Mathematics Centre for Education in Mathematics and Computing Intermediate Math Circles March 11, 009 Sequences and Series Tower of Hanoi The Tower of Hanoi is a game

More information

Applied Math for Engineers

Applied Math for Engineers Applied Math for Engineers Ming Zhong Lecture 15 March 28, 2018 Ming Zhong (JHU) AMS Spring 2018 1 / 28 Recap Table of Contents 1 Recap 2 Numerical ODEs: Single Step Methods 3 Multistep Methods 4 Method

More information

NUMERICAL SOLUTION OF ODE IVPs. Overview

NUMERICAL SOLUTION OF ODE IVPs. Overview NUMERICAL SOLUTION OF ODE IVPs 1 Quick review of direction fields Overview 2 A reminder about and 3 Important test: Is the ODE initial value problem? 4 Fundamental concepts: Euler s Method 5 Fundamental

More information

Algorithms (II) Yu Yu. Shanghai Jiaotong University

Algorithms (II) Yu Yu. Shanghai Jiaotong University Algorithms (II) Yu Yu Shanghai Jiaotong University Chapter 1. Algorithms with Numbers Two seemingly similar problems Factoring: Given a number N, express it as a product of its prime factors. Primality:

More information

are the q-versions of n, n! and . The falling factorial is (x) k = x(x 1)(x 2)... (x k + 1).

are the q-versions of n, n! and . The falling factorial is (x) k = x(x 1)(x 2)... (x k + 1). Lecture A jacques@ucsd.edu Notation: N, R, Z, F, C naturals, reals, integers, a field, complex numbers. p(n), S n,, b(n), s n, partition numbers, Stirling of the second ind, Bell numbers, Stirling of the

More information

Functions of Two Variables

Functions of Two Variables Unit #17 - Functions of Two Variables Some problems and solutions selected or adapted from Hughes-Hallett Calculus. Functions of More Than One Variable 1. The balance, B, in dollars, in a bank account

More information

Math53: Ordinary Differential Equations Autumn 2004

Math53: Ordinary Differential Equations Autumn 2004 Math53: Ordinary Differential Equations Autumn 2004 Unit 2 Summary Second- and Higher-Order Ordinary Differential Equations Extremely Important: Euler s formula Very Important: finding solutions to linear

More information

output H = 2*H+P H=2*(H-P)

output H = 2*H+P H=2*(H-P) Ecient Algorithms for Multiplication on Elliptic Curves by Volker Muller TI-9/97 22. April 997 Institut fur theoretische Informatik Ecient Algorithms for Multiplication on Elliptic Curves Volker Muller

More information

Draft TAYLOR SERIES METHOD FOR SYSTEM OF PARTICLES INTERACTING VIA LENNARD-JONES POTENTIAL. Nikolai Shegunov, Ivan Hristov

Draft TAYLOR SERIES METHOD FOR SYSTEM OF PARTICLES INTERACTING VIA LENNARD-JONES POTENTIAL. Nikolai Shegunov, Ivan Hristov TAYLOR SERIES METHOD FOR SYSTEM OF PARTICLES INTERACTING VIA LENNARD-JONES POTENTIAL Nikolai Shegunov, Ivan Hristov March 9, Seminar in IMI,BAS,Soa 1/25 Mathematical model We consider the Hamiltonian :

More information

Numerical Methods and Computation Prof. S.R.K. Iyengar Department of Mathematics Indian Institute of Technology Delhi

Numerical Methods and Computation Prof. S.R.K. Iyengar Department of Mathematics Indian Institute of Technology Delhi Numerical Methods and Computation Prof. S.R.K. Iyengar Department of Mathematics Indian Institute of Technology Delhi Lecture No - 27 Interpolation and Approximation (Continued.) In our last lecture we

More information

Mathematics-I Prof. S.K. Ray Department of Mathematics and Statistics Indian Institute of Technology, Kanpur. Lecture 1 Real Numbers

Mathematics-I Prof. S.K. Ray Department of Mathematics and Statistics Indian Institute of Technology, Kanpur. Lecture 1 Real Numbers Mathematics-I Prof. S.K. Ray Department of Mathematics and Statistics Indian Institute of Technology, Kanpur Lecture 1 Real Numbers In these lectures, we are going to study a branch of mathematics called

More information

Reading and Writing. Mathematical Proofs. Slides by Arthur van Goetham

Reading and Writing. Mathematical Proofs. Slides by Arthur van Goetham Reading and Writing Mathematical Proofs Slides by Arthur van Goetham What is a proof? Why explanations are not proofs What is a proof? A method for establishing truth What establishes truth depends on

More information

Volume in n Dimensions

Volume in n Dimensions Volume in n Dimensions MA 305 Kurt Bryan Introduction You ve seen that if we have two vectors v and w in two dimensions then the area spanned by these vectors can be computed as v w = v 1 w 2 v 2 w 1 (where

More information

INTRODUCTION TO COMPUTER METHODS FOR O.D.E.

INTRODUCTION TO COMPUTER METHODS FOR O.D.E. INTRODUCTION TO COMPUTER METHODS FOR O.D.E. 0. Introduction. The goal of this handout is to introduce some of the ideas behind the basic computer algorithms to approximate solutions to differential equations.

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

Power Series. Part 1. J. Gonzalez-Zugasti, University of Massachusetts - Lowell

Power Series. Part 1. J. Gonzalez-Zugasti, University of Massachusetts - Lowell Power Series Part 1 1 Power Series Suppose x is a variable and c k & a are constants. A power series about x = 0 is c k x k A power series about x = a is c k x a k a = center of the power series c k =

More information

3.3 Accumulation Sequences

3.3 Accumulation Sequences 3.3. ACCUMULATION SEQUENCES 25 3.3 Accumulation Sequences Overview. One of the most important mathematical ideas in calculus is that of an accumulation of change for physical quantities. As we have been

More information

INFINITE SUMS. In this chapter, let s take that power to infinity! And it will be equally natural and straightforward.

INFINITE SUMS. In this chapter, let s take that power to infinity! And it will be equally natural and straightforward. EXPLODING DOTS CHAPTER 7 INFINITE SUMS In the previous chapter we played with the machine and saw the power of that machine to make advanced school algebra so natural and straightforward. In this chapter,

More information

II. Unit Speed Curves

II. Unit Speed Curves The Geometry of Curves, Part I Rob Donnelly From Murray State University s Calculus III, Fall 2001 note: This material supplements Sections 13.3 and 13.4 of the text Calculus with Early Transcendentals,

More information

Computational Techniques Prof. Dr. Niket Kaisare Department of Chemical Engineering Indian Institute of Technology, Madras

Computational Techniques Prof. Dr. Niket Kaisare Department of Chemical Engineering Indian Institute of Technology, Madras Computational Techniques Prof. Dr. Niket Kaisare Department of Chemical Engineering Indian Institute of Technology, Madras Module No. # 07 Lecture No. # 05 Ordinary Differential Equations (Refer Slide

More information

MITOCW watch?v=dztkqqy2jn4

MITOCW watch?v=dztkqqy2jn4 MITOCW watch?v=dztkqqy2jn4 The following content is provided under a Creative Commons license. Your support will help MIT OpenCourseWare continue to offer high quality educational resources for free. To

More information

Geometric Series and the Ratio and Root Test

Geometric Series and the Ratio and Root Test Geometric Series and the Ratio and Root Test James K. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University September 5, 2018 Outline 1 Geometric Series

More information

Lecture 4.2 Finite Difference Approximation

Lecture 4.2 Finite Difference Approximation Lecture 4. Finite Difference Approimation 1 Discretization As stated in Lecture 1.0, there are three steps in numerically solving the differential equations. They are: 1. Discretization of the domain by

More information

32. SOLVING LINEAR EQUATIONS IN ONE VARIABLE

32. SOLVING LINEAR EQUATIONS IN ONE VARIABLE get the complete book: /getfulltextfullbook.htm 32. SOLVING LINEAR EQUATIONS IN ONE VARIABLE classifying families of sentences In mathematics, it is common to group together sentences of the same type

More information

In Exercises 1 12, list the all of the elements of the given set. 2. The set of all positive integers whose square roots are less than or equal to 3

In Exercises 1 12, list the all of the elements of the given set. 2. The set of all positive integers whose square roots are less than or equal to 3 APPENDIX A EXERCISES In Exercises 1 12, list the all of the elements of the given set. 1. The set of all prime numbers less than 20 2. The set of all positive integers whose square roots are less than

More information

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II Advection / Hyperbolic PDEs Notes In addition to the slides and code examples, my notes on PDEs with the finite-volume method are up online: https://github.com/open-astrophysics-bookshelf/numerical_exercises

More information

Mathematics for chemical engineers. Numerical solution of ordinary differential equations

Mathematics for chemical engineers. Numerical solution of ordinary differential equations Mathematics for chemical engineers Drahoslava Janovská Numerical solution of ordinary differential equations Initial value problem Winter Semester 2015-2016 Outline 1 Introduction 2 One step methods Euler

More information

Announcements. Read Section 2.1 (Sets), 2.2 (Set Operations) and 5.1 (Mathematical Induction) Existence Proofs. Non-constructive

Announcements. Read Section 2.1 (Sets), 2.2 (Set Operations) and 5.1 (Mathematical Induction) Existence Proofs. Non-constructive Announcements Homework 2 Due Homework 3 Posted Due next Monday Quiz 2 on Wednesday Read Section 2.1 (Sets), 2.2 (Set Operations) and 5.1 (Mathematical Induction) Exam 1 in two weeks Monday, February 19

More information

In this lecture we calculate moments and products of inertia of some simple geometric figures. (Refer Slide Time: 0:22)

In this lecture we calculate moments and products of inertia of some simple geometric figures. (Refer Slide Time: 0:22) Engineering Mechanics Professor Manoj K Harbola Department of Physics Indian Institute of Technology Kanpur Module 4 Lecture No 37 Properties of plane surfaces VIII: second moment and product of an area,

More information

3.4 Introduction to power series

3.4 Introduction to power series 3.4 Introduction to power series Definition 3.4.. A polynomial in the variable x is an expression of the form n a i x i = a 0 + a x + a 2 x 2 + + a n x n + a n x n i=0 or a n x n + a n x n + + a 2 x 2

More information

Modeling Data with Linear Combinations of Basis Functions. Read Chapter 3 in the text by Bishop

Modeling Data with Linear Combinations of Basis Functions. Read Chapter 3 in the text by Bishop Modeling Data with Linear Combinations of Basis Functions Read Chapter 3 in the text by Bishop A Type of Supervised Learning Problem We want to model data (x 1, t 1 ),..., (x N, t N ), where x i is a vector

More information

Basic Quantum Mechanics Prof. Ajoy Ghatak Department of Physics Indian Institute of Technology, Delhi

Basic Quantum Mechanics Prof. Ajoy Ghatak Department of Physics Indian Institute of Technology, Delhi Basic Quantum Mechanics Prof. Ajoy Ghatak Department of Physics Indian Institute of Technology, Delhi Module No. # 05 The Angular Momentum I Lecture No. # 02 The Angular Momentum Problem (Contd.) In the

More information

Worksheet 1: Integrators

Worksheet 1: Integrators Simulation Methods in Physics I WS 2014/2015 Worksheet 1: Integrators Olaf Lenz Alexander Schlaich Stefan Kesselheim Florian Fahrenberger Peter Košovan October 22, 2014 Institute for Computational Physics,

More information

Quantum Mechanics in Three Dimensions

Quantum Mechanics in Three Dimensions Physics 342 Lecture 21 Quantum Mechanics in Three Dimensions Lecture 21 Physics 342 Quantum Mechanics I Monday, March 22nd, 21 We are used to the temporal separation that gives, for example, the timeindependent

More information

A Nobel Prize for Molecular Dynamics and QM/MM What is Classical Molecular Dynamics? Simulation of explicit particles (atoms, ions,... ) Particles interact via relatively simple analytical potential

More information

Mechanics, Heat, Oscillations and Waves Prof. V. Balakrishnan Department of Physics Indian Institute of Technology, Madras

Mechanics, Heat, Oscillations and Waves Prof. V. Balakrishnan Department of Physics Indian Institute of Technology, Madras Mechanics, Heat, Oscillations and Waves Prof. V. Balakrishnan Department of Physics Indian Institute of Technology, Madras Lecture - 21 Central Potential and Central Force Ready now to take up the idea

More information

Balancing Chemical Equations

Balancing Chemical Equations Unit: Chemical Reactions Skills: correctly balance a chemical equation Date: A chemical equation needs to describe the chemical formulas and relative number of molecules involved of each molecule that

More information

Series Solutions Near an Ordinary Point

Series Solutions Near an Ordinary Point Series Solutions Near an Ordinary Point MATH 365 Ordinary Differential Equations J. Robert Buchanan Department of Mathematics Spring 2018 Ordinary Points (1 of 2) Consider the second order linear homogeneous

More information

Courant and all that. Consistency, Convergence Stability Numerical Dispersion Computational grids and numerical anisotropy

Courant and all that. Consistency, Convergence Stability Numerical Dispersion Computational grids and numerical anisotropy Consistency, Convergence Stability Numerical Dispersion Computational grids and numerical anisotropy c dx ε 1 he goal of this lecture is to understand how to find suitable parameters (i.e., grid spacing

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