N-body simulations. Phys 750 Lecture 10

Size: px
Start display at page:

Download "N-body simulations. Phys 750 Lecture 10"

Transcription

1 N-body simulations Phys 750 Lecture 10

2 N-body simulations Forward integration in time of strongly coupled classical particles or (rigid-body composite objects) dissipation Brownian motion Very general class of second-order ODE: r = r apple r apple r 5 + ë (2) (r, r )+ <, ë Referred to as N-body simulation or molecular dynamics in various scientific communities arbitrary forces (3) (r, r, r )+5

3 Broad applicability Useful in many contexts and over vastly different scales galaxy formation virus classical water

4 N-body simulations Classical systems of many particles, dissipationless and interacting via central forces, have a Hamiltonian of the form = < ( ) Momentum variables are conjugate to the position variables ( 2DN dimensional phase space) r i p i = m i v i Interactions determined by the pair potential U(r)

5 N-body simulations The set of second-order differential equations maps to a set of coupled first-order equations: Ür i = )H )p i = p i m i = v i Üp i = )H )r i = jëi )U(r ij ) )r i = jëi U (r ij )Çr ij net force exerted by the other N 1 particles

6 N-body simulations Special considerations: For long-range forces all particle pairs interact strongly with one another at best, N(N 1) 2 scaling Repulsive interactions require a container (via walls or periodic boundary conditions) Time step must be adjusted such that the length scale v t can resolve the spatial structure of U(r)

7 Finite simulation cell Typical setup: finite L L L periodic cell serves as a representative sample of space How to judge distance for the L purpose of computing long range forces? L L

8 Finite simulation cell Periodicity is equivalent to tiling all space with copies of the same cell Forces arise from interactions with each of an infinite number of image particles

9 Finite simulation cell Approximating the infinite summation in 1D: F e (r) = 1X n= 1 F (r + nl) = + F (r L)+F (r)+f(r + L)+ F (min{ r,l r }) closest-image distance intra-cell separation L<r<L r

10 Finite simulation cell Summation has an F e (r) exact form for EMlike and gravity-like interactions F (r) = 1 r 2 F (min{ r,l r }) F (r) F e (r) =F (chord(r)) r sin( r/l) /L chord length

11 Finite simulation cell F (chord(r)) closest-image F e (r) approximation increasingly good as interactions become short-ranged; e.g., F (min{ r,l r }) F (r) F (r) = 1 r 7

12 Finite simulation cell r i =(x i,y i,z i ) Example distance measure r j =(x j,y j,z j ) in a 3D orthogonal cell d i, j = min{ Dx,L Dx } 2 +min{ Dy,L Dy } 2 j L +min{ Dz,L Dz } 2 1/2 i Dx = x i Dy = y i x j y j L L Dz = z i z j

13 Lennard-Jones Potential U(r) Model of Van der Waal s r 0 =2 1/6 attraction between neutral atoms plus an inner core repulsion U(r) =4 r 12 6 r Equilibrium point U (r 0 )=0 separates the attractive and repulsive regions

14 Choice of Time Step U(r) 1 two particles at rest at separation distance

15 Choice of Time Step U(r) artificial energy gain particle penetrated well beyond the classical turning point!

16 Adaptive Time Step t/3 t/3 Allow time step to vary dynamically within the simulation t/3 t Check convergence by comparing evolution of two otherwise identical copies of the system

17 Range Truncation If interactions are finite-range, there are only a small number of forces acting on each particle (unless the particles have coalesced) Algorithm now scales as 1 2 N i=1 N (i) nearby N(N 1) 2 Can we impose a cutoff?

18 Range Truncation E.g., Lennard-Jones tail is very weak beyond r c U(r) U (r)

19 Range Truncation Care must be taken not to introduce unphysical forces 10 8 U(r)θ(r c r) U (r)θ(r c r) + U(r)δ(r c r) discontinuous, impulsive force

20 Range Truncation Ũ(r) U(r) U(r c )+(r r c )U (r c ) (r c r) F (r) = Ũ (r) = U (r)+u (r c) (r c r) 10 8 ~ U(r) ~ U (r)

21 Ewald summation Naive truncation is not possible in the case of truly longranged interactions Ewald summation is a useful Fourier space trick E.g., consider non-self electrostatic interactions between particles in all image cells: U Coulomb = 1 2 X i,j X X q i q j (1 ri rj,nl) r i r j + nl n2z 3 0 q i q j 1 2 i,j,n r i,j,n

22 Ewald summation Exact rewriting in terms of a background constant, a direct space sum, and a dual space sum: U 0 = U 1 = X p i q 2 i 0 X erfc(r i,j,n / 0 ) 0q i q j i,j,n U 2 = 1 2 L 3 X i,j q i q j r i,j,n X m2z 3 m6=0 exponentially real lattice decaying envelope exp ( m ) 2 +2 im (r i r j ) m 2 reciprocal lattice

23 Ewald summation Safe to truncate the sum in U 1 at separations above 0 Order sum over particle indices in can be N 2 evaluated as two order U 2 = 1 2 L 3 X m6=0 N exp sums: U 2 ( m ) 2 m 2 S(m) 2 S(m) = X j q j exp(2 im r j ) structure factor

24 Barnes-Hut tree dynamic data structure: recursive subdivision of space into quads containing at most one particle The centre-of-mass position is calculated at each tree level and passed up the linked-list hierarchy

25 Barnes-Hut tree Assume that a particle cluster sufficiently far away can be represented by a single representative particle at the centreof-mass (neglects tidal forces) d l Distance judged by the size of the opening angle l/d < c Scales as N log N

26 Parallel Computation Simulate on many CPUs simultaneously Each machine updates the particles in a sub-region of the full space 8 3 Position information passed as messages passed around the ring

27 Parallel Computation Because of message-passing overhead, the algorithm scales somewhat worse than N(N : Each CPU is numbered cyclically n =0, 1,...,N CPU 1 Loop for each time step: Node n computes forces exerted by its own particles Repeat n 1 times: 1)/2N CPU Node n sends positions to node n + 1 and receives positions from node n 1 Uses received positions to compute forces on its own particles Each node updates its own positions and velocities

28 Neutral territory methods R R R R traditional half-shell neutral territory message passing overhead 1 2 R2 +2R 2R

Neighbor Tables Long-Range Potentials

Neighbor Tables Long-Range Potentials Neighbor Tables Long-Range Potentials Today we learn how we can handle long range potentials. Neighbor tables Long-range potential Ewald sums MSE485/PHY466/CSE485 1 Periodic distances Minimum Image Convention:

More information

Coarse-Grained Models!

Coarse-Grained Models! Coarse-Grained Models! Large and complex molecules (e.g. long polymers) can not be simulated on the all-atom level! Requires coarse-graining of the model! Coarse-grained models are usually also particles

More information

Advanced Molecular Molecular Dynamics

Advanced Molecular Molecular Dynamics Advanced Molecular Molecular Dynamics Technical details May 12, 2014 Integration of harmonic oscillator r m period = 2 k k and the temperature T determine the sampling of x (here T is related with v 0

More information

Computer simulation methods (2) Dr. Vania Calandrini

Computer simulation methods (2) Dr. Vania Calandrini Computer simulation methods (2) Dr. Vania Calandrini in the previous lecture: time average versus ensemble average MC versus MD simulations equipartition theorem (=> computing T) virial theorem (=> computing

More information

Notes on Ewald summation techniques

Notes on Ewald summation techniques February 3, 011 Notes on Ewald summation techniques Adapted from similar presentation in PHY 71 he total electrostatic potential energy of interaction between point charges {q i } at the positions {r i

More information

Non-bonded interactions

Non-bonded interactions speeding up the number-crunching continued Marcus Elstner and Tomáš Kubař December 3, 2013 why care? number of individual pair-wise interactions bonded interactions proportional to N: O(N) non-bonded interactions

More information

Simulations of bulk phases. Periodic boundaries. Cubic boxes

Simulations of bulk phases. Periodic boundaries. Cubic boxes Simulations of bulk phases ChE210D Today's lecture: considerations for setting up and running simulations of bulk, isotropic phases (e.g., liquids and gases) Periodic boundaries Cubic boxes In simulations

More information

Physics 212: Statistical mechanics II Lecture IV

Physics 212: Statistical mechanics II Lecture IV Physics 22: Statistical mechanics II Lecture IV Our program for kinetic theory in the last lecture and this lecture can be expressed in the following series of steps, from most exact and general to most

More information

Introduction to molecular dynamics

Introduction to molecular dynamics 1 Introduction to molecular dynamics Yves Lansac Université François Rabelais, Tours, France Visiting MSE, GIST for the summer Molecular Simulation 2 Molecular simulation is a computational experiment.

More information

Scientific Computing II

Scientific Computing II Scientific Computing II Molecular Dynamics Simulation Michael Bader SCCS Summer Term 2015 Molecular Dynamics Simulation, Summer Term 2015 1 Continuum Mechanics for Fluid Mechanics? Molecular Dynamics the

More information

An introduction to Molecular Dynamics. EMBO, June 2016

An introduction to Molecular Dynamics. EMBO, June 2016 An introduction to Molecular Dynamics EMBO, June 2016 What is MD? everything that living things do can be understood in terms of the jiggling and wiggling of atoms. The Feynman Lectures in Physics vol.

More information

Tutorial on the smooth particle-mesh Ewald algorithm

Tutorial on the smooth particle-mesh Ewald algorithm Tutorial on the smooth particle-mesh Ewald algorithm These notes explain the smooth particle-mesh Ewald algorithm (SPME) in detail. The accompanying library libpme6 is a fully-featured implementation of

More information

Intermolecular Forces and Monte-Carlo Integration 열역학특수연구

Intermolecular Forces and Monte-Carlo Integration 열역학특수연구 Intermolecular Forces and Monte-Carlo Integration 열역학특수연구 2003.3.28 Source of the lecture note. J.M.Prausnitz and others, Molecular Thermodynamics of Fluid Phase Equiliria Atkins, Physical Chemistry Lecture

More information

Supplemental Material Controlled Self-Assembly of Periodic and Aperiodic Cluster Crystals

Supplemental Material Controlled Self-Assembly of Periodic and Aperiodic Cluster Crystals Supplemental Material Controlled Self-Assembly of Periodic and Aperiodic Cluster Crystals Kobi Barkan, 1 Michael Engel, 2 and Ron Lifshitz 1, 3 1 Raymond and Beverly Sackler School of Physics and Astronomy,

More information

Optimizing GROMACS for parallel performance

Optimizing GROMACS for parallel performance Optimizing GROMACS for parallel performance Outline 1. Why optimize? Performance status quo 2. GROMACS as a black box. (PME) 3. How does GROMACS spend its time? (MPE) 4. What you can do What I want to

More information

Molecular Dynamics Simulations

Molecular Dynamics Simulations Molecular Dynamics Simulations Dr. Kasra Momeni www.knanosys.com Outline Long-range Interactions Ewald Sum Fast Multipole Method Spherically Truncated Coulombic Potential Speeding up Calculations SPaSM

More information

Supplemental Material Controlled Self-Assembly of Periodic and Aperiodic Cluster Crystals

Supplemental Material Controlled Self-Assembly of Periodic and Aperiodic Cluster Crystals Supplemental Material Controlled Self-Assembly of Periodic and Aperiodic Cluster Crystals Kobi Barkan, 1 Michael Engel, 2 and Ron Lifshitz 1, 3 1 Raymond and Beverly Sackler School of Physics and Astronomy,

More information

lim = F F = F x x + F y y + F z

lim = F F = F x x + F y y + F z Physics 361 Summary of Results from Lecture Physics 361 Derivatives of Scalar and Vector Fields The gradient of a scalar field f( r) is given by g = f. coordinates f g = ê x x + ê f y y + ê f z z Expressed

More information

Multiphase Flow and Heat Transfer

Multiphase Flow and Heat Transfer Multiphase Flow and Heat Transfer Liquid-Vapor Interface Sudheer Siddapuredddy sudheer@iitp.ac.in Department of Mechanical Engineering Indian Institution of Technology Patna Multiphase Flow and Heat Transfer

More information

Non-bonded interactions

Non-bonded interactions speeding up the number-crunching Marcus Elstner and Tomáš Kubař May 8, 2015 why care? key to understand biomolecular structure and function binding of a ligand efficiency of a reaction color of a chromophore

More information

Molecular Dynamics 9/6/16

Molecular Dynamics 9/6/16 Molecular Dynamics What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: Lesar Chpt 6, F&S Chpt 4 1 The Molecular Dynamics (MD) method for classical

More information

Introduction to Molecular Dynamics

Introduction to Molecular Dynamics Introduction to Molecular Dynamics Dr. Kasra Momeni www.knanosys.com Overview of the MD Classical Dynamics Outline Basics and Terminology Pairwise interacting objects Interatomic potentials (short-range

More information

Molecular Dynamics. What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: F&S Chapter 4

Molecular Dynamics. What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: F&S Chapter 4 Molecular Dynamics What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: F&S Chapter 4 MSE485/PHY466/CSE485 1 The Molecular Dynamics (MD) method

More information

Lecture Models for heavy-ion collisions (Part III): transport models. SS2016: Dynamical models for relativistic heavy-ion collisions

Lecture Models for heavy-ion collisions (Part III): transport models. SS2016: Dynamical models for relativistic heavy-ion collisions Lecture Models for heavy-ion collisions (Part III: transport models SS06: Dynamical models for relativistic heavy-ion collisions Quantum mechanical description of the many-body system Dynamics of heavy-ion

More information

Chapter 2 Experimental sources of intermolecular potentials

Chapter 2 Experimental sources of intermolecular potentials Chapter 2 Experimental sources of intermolecular potentials 2.1 Overview thermodynamical properties: heat of vaporization (Trouton s rule) crystal structures ionic crystals rare gas solids physico-chemical

More information

Molecular Dynamics Simulation of Argon

Molecular Dynamics Simulation of Argon Molecular Dynamics Simulation of Argon The fundamental work on this problem was done by A. Rahman, Phys. Rev. 136, A405 (1964). It was extended in many important ways by L. Verlet, Phys. Rev. 159, 98 (1967),

More information

The Second Virial Coefficient & van der Waals Equation

The Second Virial Coefficient & van der Waals Equation V.C The Second Virial Coefficient & van der Waals Equation Let us study the second virial coefficient B, for a typical gas using eq.v.33). As discussed before, the two-body potential is characterized by

More information

General theory of diffraction

General theory of diffraction General theory of diffraction X-rays scatter off the charge density (r), neutrons scatter off the spin density. Coherent scattering (diffraction) creates the Fourier transform of (r) from real to reciprocal

More information

Exploring the energy landscape

Exploring the energy landscape Exploring the energy landscape ChE210D Today's lecture: what are general features of the potential energy surface and how can we locate and characterize minima on it Derivatives of the potential energy

More information

General Physical Chemistry II

General Physical Chemistry II General Physical Chemistry II Lecture 13 Aleksey Kocherzhenko October 16, 2014" Last time " The Hückel method" Ø Used to study π systems of conjugated molecules" Ø π orbitals are treated separately from

More information

Introduction to Simulation - Lectures 17, 18. Molecular Dynamics. Nicolas Hadjiconstantinou

Introduction to Simulation - Lectures 17, 18. Molecular Dynamics. Nicolas Hadjiconstantinou Introduction to Simulation - Lectures 17, 18 Molecular Dynamics Nicolas Hadjiconstantinou Molecular Dynamics Molecular dynamics is a technique for computing the equilibrium and non-equilibrium properties

More information

Material Surfaces, Grain Boundaries and Interfaces: Structure-Property Relationship Predictions

Material Surfaces, Grain Boundaries and Interfaces: Structure-Property Relationship Predictions Material Surfaces, Grain Boundaries and Interfaces: Structure-Property Relationship Predictions Susan B. Sinnott Department of Materials Science and Engineering Penn State University September 16, 2016

More information

PROBING CRYSTAL STRUCTURE

PROBING CRYSTAL STRUCTURE PROBING CRYSTAL STRUCTURE Andrew Baczewski PHY 491, October 10th, 2011 OVERVIEW First - we ll briefly discuss Friday s quiz. Today, we will answer the following questions: How do we experimentally probe

More information

Forces, Energy and Equations of Motion

Forces, Energy and Equations of Motion Forces, Energy and Equations of Motion Chapter 1 P. J. Grandinetti Chem. 4300 Jan. 8, 2019 P. J. Grandinetti (Chem. 4300) Forces, Energy and Equations of Motion Jan. 8, 2019 1 / 50 Galileo taught us how

More information

Chapter 21 Chapter 23 Gauss Law. Copyright 2014 John Wiley & Sons, Inc. All rights reserved.

Chapter 21 Chapter 23 Gauss Law. Copyright 2014 John Wiley & Sons, Inc. All rights reserved. Chapter 21 Chapter 23 Gauss Law Copyright 23-1 What is Physics? Gauss law relates the electric fields at points on a (closed) Gaussian surface to the net charge enclosed by that surface. Gauss law considers

More information

Lecture 5: Logistic Regression. Neural Networks

Lecture 5: Logistic Regression. Neural Networks Lecture 5: Logistic Regression. Neural Networks Logistic regression Comparison with generative models Feed-forward neural networks Backpropagation Tricks for training neural networks COMP-652, Lecture

More information

CE 530 Molecular Simulation

CE 530 Molecular Simulation 1 CE 530 Molecular Simulation Lecture 14 Molecular Models David A. Kofke Department of Chemical Engineering SUNY Buffalo kofke@eng.buffalo.edu 2 Review Monte Carlo ensemble averaging, no dynamics easy

More information

Ideal Gas Behavior. NC State University

Ideal Gas Behavior. NC State University Chemistry 331 Lecture 6 Ideal Gas Behavior NC State University Macroscopic variables P, T Pressure is a force per unit area (P= F/A) The force arises from the change in momentum as particles hit an object

More information

Lecture 11: Long-wavelength expansion in the Neel state Energetic terms

Lecture 11: Long-wavelength expansion in the Neel state Energetic terms Lecture 11: Long-wavelength expansion in the Neel state Energetic terms In the last class we derived the low energy effective Hamiltonian for a Mott insulator. This derivation is an example of the kind

More information

8.1 Concentration inequality for Gaussian random matrix (cont d)

8.1 Concentration inequality for Gaussian random matrix (cont d) MGMT 69: Topics in High-dimensional Data Analysis Falll 26 Lecture 8: Spectral clustering and Laplacian matrices Lecturer: Jiaming Xu Scribe: Hyun-Ju Oh and Taotao He, October 4, 26 Outline Concentration

More information

Lecture #3 a) Nuclear structure - nuclear shell model b) Nuclear structure -quasiparticle random phase approximation c) Exactly solvable model d)

Lecture #3 a) Nuclear structure - nuclear shell model b) Nuclear structure -quasiparticle random phase approximation c) Exactly solvable model d) Lecture #3 a) Nuclear structure - nuclear shell model b) Nuclear structure -quasiparticle random phase approximation c) Exactly solvable model d) Dependence on the distance between neutrons (or protons)

More information

PHYS102 - Gauss s Law.

PHYS102 - Gauss s Law. PHYS102 - Gauss s Law. Dr. Suess February 2, 2007 PRS Questions 2 Question #1.............................................................................. 2 Answer to Question #1......................................................................

More information

CE 530 Molecular Simulation

CE 530 Molecular Simulation 1 CE 530 Molecular Simulation Lecture 16 Dielectrics and Reaction Field Method David A. Kofke Department of Chemical Engineering SUNY Buffalo kofke@eng.buffalo.edu 2 Review Molecular models intramolecular

More information

Lifting Airfoils in Incompressible Irrotational Flow. AA210b Lecture 3 January 13, AA210b - Fundamentals of Compressible Flow II 1

Lifting Airfoils in Incompressible Irrotational Flow. AA210b Lecture 3 January 13, AA210b - Fundamentals of Compressible Flow II 1 Lifting Airfoils in Incompressible Irrotational Flow AA21b Lecture 3 January 13, 28 AA21b - Fundamentals of Compressible Flow II 1 Governing Equations For an incompressible fluid, the continuity equation

More information

V.C The Second Virial Coefficient & van der Waals Equation

V.C The Second Virial Coefficient & van der Waals Equation V.C The Second Virial Coefficient & van der Waals Equation Let us study the second virial coefficient B, for a typical gas using eq.(v.33). As discussed before, the two-body potential is characterized

More information

Coulomb s Law. Phys102 Lecture 2. Key Points. Coulomb s Law The electric field (E is a vector!) References

Coulomb s Law. Phys102 Lecture 2. Key Points. Coulomb s Law The electric field (E is a vector!) References Phys102 Lecture 2 Phys102 Lecture 2-1 Coulomb s Law Key Points Coulomb s Law The electric field (E is a vector!) References SFU Ed: 21-5,6,7,8,9,10. 6 th Ed: 16-6,7,8,9,+. Phys102 Lecture 2 Phys102 Lecture

More information

8/24/2018. Charge Polarization. Charge Polarization. Charge Polarization

8/24/2018. Charge Polarization. Charge Polarization. Charge Polarization Charge Polarization The figure shows how a charged rod held close to an electroscope causes the leaves to repel each other. How do charged objects of either sign exert an attractive force on a neutral

More information

Imperfect Gases. NC State University

Imperfect Gases. NC State University Chemistry 431 Lecture 3 Imperfect Gases NC State University The Compression Factor One way to represent the relationship between ideal and real gases is to plot the deviation from ideality as the gas is

More information

Review of Forces and Conservation of Momentum

Review of Forces and Conservation of Momentum Physics 7B-1 (A/B) Professor Cebra Winter 2010 Lecture 6 Review of Forces and Conservation of Momentum Slide 1 of 22 Vector Addition and Subtraction Vectors are added head to tail Note: a+b = b+a Vectors

More information

Summary of electrostatics

Summary of electrostatics Summary of electrostatics 1 In electrostatics we deal with the electric effects of charges at rest. Electric charge can be defined as is the intrinsic characteristic that is associated with fundamental

More information

A Crash Course on Fast Multipole Method (FMM)

A Crash Course on Fast Multipole Method (FMM) A Crash Course on Fast Multipole Method (FMM) Hanliang Guo Kanso Biodynamical System Lab, 2018 April What is FMM? A fast algorithm to study N body interactions (Gravitational, Coulombic interactions )

More information

Basis sets for electron correlation

Basis sets for electron correlation Basis sets for electron correlation Trygve Helgaker Centre for Theoretical and Computational Chemistry Department of Chemistry, University of Oslo, Norway The 12th Sostrup Summer School Quantum Chemistry

More information

Dynamics of Galaxies: Basics. Frontiers in Numerical Gravitational Astrophysics July 3, 2008

Dynamics of Galaxies: Basics. Frontiers in Numerical Gravitational Astrophysics July 3, 2008 Dynamics of Galaxies: Basics Frontiers in Numerical Gravitational Astrophysics July 3, 2008 c = G = 1 h = 0 Outline (a) Galaxies as physical systems. (b) The Collisionless Boltzmann Equation. (c) N-body

More information

Molecular Dynamics. The Molecular Dynamics (MD) method for classical systems (not H or He)

Molecular Dynamics. The Molecular Dynamics (MD) method for classical systems (not H or He) Molecular Dynamics What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: F&S Chapter 4 1 The Molecular Dynamics (MD) method for classical systems

More information

Review of Exponential Change Model and Forces

Review of Exponential Change Model and Forces Physics 7B-1 (A/B) Professor Cebra Winter 2010 Lecture 5 Review of Exponential Change Model and Forces Slide 1 of 37 Exponential Growth Slide 2 of 37 Slide 3 of 37 Exponential decay Slide 4 of 37 The half

More information

ψ s a ˆn a s b ˆn b ψ Hint: Because the state is spherically symmetric the answer can depend only on the angle between the two directions.

ψ s a ˆn a s b ˆn b ψ Hint: Because the state is spherically symmetric the answer can depend only on the angle between the two directions. 1. Quantum Mechanics (Fall 2004) Two spin-half particles are in a state with total spin zero. Let ˆn a and ˆn b be unit vectors in two arbitrary directions. Calculate the expectation value of the product

More information

General Physics II. Electric Charge, Forces & Fields

General Physics II. Electric Charge, Forces & Fields General Physics II Electric Charge, Forces & Fields Electric Charge Recall that fundamental particles carry something called electric charge protons have exactly one unit of positive charge +1.602 x 10-19

More information

PHY 396 K. Solutions for problems 1 and 2 of set #5.

PHY 396 K. Solutions for problems 1 and 2 of set #5. PHY 396 K. Solutions for problems 1 and of set #5. Problem 1a: The conjugacy relations  k,  k,, Ê k, Ê k, follow from hermiticity of the Âx and Êx quantum fields and from the third eq. 6 for the polarization

More information

Machine Learning. Kernels. Fall (Kernels, Kernelized Perceptron and SVM) Professor Liang Huang. (Chap. 12 of CIML)

Machine Learning. Kernels. Fall (Kernels, Kernelized Perceptron and SVM) Professor Liang Huang. (Chap. 12 of CIML) Machine Learning Fall 2017 Kernels (Kernels, Kernelized Perceptron and SVM) Professor Liang Huang (Chap. 12 of CIML) Nonlinear Features x4: -1 x1: +1 x3: +1 x2: -1 Concatenated (combined) features XOR:

More information

+ V = 0, j = 1,..., 3N (7.1) i =1, 3 m = 1, N, X mi, V X mi. i = 0 in the equilibrium. X mi X nj

+ V = 0, j = 1,..., 3N (7.1) i =1, 3 m = 1, N, X mi, V X mi. i = 0 in the equilibrium. X mi X nj 7. Lattice dynamics 7.1 Basic consideratons In this section we ll follow a number of well-known textbooks, and only try to keep the notations consistent. Suppose we have a system of N atoms, m=1,...,n,

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

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

Chemistry 365: Normal Mode Analysis David Ronis McGill University

Chemistry 365: Normal Mode Analysis David Ronis McGill University Chemistry 365: Normal Mode Analysis David Ronis McGill University 1. Quantum Mechanical Treatment Our starting point is the Schrodinger wave equation: Σ h 2 2 2m i N i=1 r 2 i + U( r 1,..., r N ) Ψ( r

More information

Section B. Electromagnetism

Section B. Electromagnetism Prelims EM Spring 2014 1 Section B. Electromagnetism Problem 0, Page 1. An infinite cylinder of radius R oriented parallel to the z-axis has uniform magnetization parallel to the x-axis, M = m 0ˆx. Calculate

More information

STA 4273H: Statistical Machine Learning

STA 4273H: Statistical Machine Learning STA 4273H: Statistical Machine Learning Russ Salakhutdinov Department of Statistics! rsalakhu@utstat.toronto.edu! http://www.utstat.utoronto.ca/~rsalakhu/ Sidney Smith Hall, Room 6002 Lecture 11 Project

More information

Problem Set 2: Solutions

Problem Set 2: Solutions University of Alabama Department of Physics and Astronomy PH 102 / LeClair Summer II 2012 Problem Set 2: Solutions 1. Two volley balls, mass 0.3 kg, tethered by nylon strings and charged with an electrostatic

More information

Computer Simulation of Shock Waves in Condensed Matter. Matthew R. Farrow 2 November 2007

Computer Simulation of Shock Waves in Condensed Matter. Matthew R. Farrow 2 November 2007 Computer Simulation of Shock Waves in Condensed Matter Matthew R. Farrow 2 November 2007 Outline of talk Shock wave theory Results Conclusion Computer simulation of shock waves Shock Wave Theory Shock

More information

Nucleon Pair Approximation to the nuclear Shell Model

Nucleon Pair Approximation to the nuclear Shell Model Nucleon Pair Approximation to the nuclear Shell Model Yu-Min Zhao (Speaker: Yi-Yuan Cheng) 2 nd International Workshop & 12 th RIBF Discussion on Neutron-Proton Correlations, Hong Kong July 6-9, 2015 Outline

More information

Signals and systems Lecture (S3) Square Wave Example, Signal Power and Properties of Fourier Series March 18, 2008

Signals and systems Lecture (S3) Square Wave Example, Signal Power and Properties of Fourier Series March 18, 2008 Signals and systems Lecture (S3) Square Wave Example, Signal Power and Properties of Fourier Series March 18, 2008 Today s Topics 1. Derivation of a Fourier series representation of a square wave signal

More information

Lecture C2 Microscopic to Macroscopic, Part 2: Intermolecular Interactions. Let's get together.

Lecture C2 Microscopic to Macroscopic, Part 2: Intermolecular Interactions. Let's get together. Lecture C2 Microscopic to Macroscopic, Part 2: Intermolecular Interactions Let's get together. Most gases are NOT ideal except at very low pressures: Z=1 for ideal gases Intermolecular interactions come

More information

Short Sample Solutions to the Sample Exam for (3rd Year Course 6) Hilary Term 2011

Short Sample Solutions to the Sample Exam for (3rd Year Course 6) Hilary Term 2011 Short Sample Solutions to the Sample Exam for (3rd Year Course 6) Hilary Term 0. [4] A Lattice is an infinite set of points in space where the environment of any given point is identical to the enivironment

More information

175-IJN Article No SPIN IN CARBON NANOTUBE-BASED OSCILLATORS

175-IJN Article No SPIN IN CARBON NANOTUBE-BASED OSCILLATORS 175-IJN Article No. 49 FA International Journal of Nanoscience Vol. 5, No. 1 (26) 47 55 World Scientific Publishing Company SPIN IN CARBON NANOTUBE-BASED OSCILLATORS SHAOPING XIAO Department of Mechanical

More information

Outline for Fundamentals of Statistical Physics Leo P. Kadanoff

Outline for Fundamentals of Statistical Physics Leo P. Kadanoff Outline for Fundamentals of Statistical Physics Leo P. Kadanoff text: Statistical Physics, Statics, Dynamics, Renormalization Leo Kadanoff I also referred often to Wikipedia and found it accurate and helpful.

More information

Lecture 4; January Electrons in Atoms: Magnetism; Term Symbols, Z eff, and Other Properties

Lecture 4; January Electrons in Atoms: Magnetism; Term Symbols, Z eff, and Other Properties Lecture 4; January 2017 Electrons in Atoms: Magnetism; Term Symbols, Z eff, and Other Properties Three prototypical kinds of Magnetic Behavior Paramagnetism: atoms, molecules, and solids with unpaired

More information

Statistical Machine Learning Lecture 8: Markov Chain Monte Carlo Sampling

Statistical Machine Learning Lecture 8: Markov Chain Monte Carlo Sampling 1 / 27 Statistical Machine Learning Lecture 8: Markov Chain Monte Carlo Sampling Melih Kandemir Özyeğin University, İstanbul, Turkey 2 / 27 Monte Carlo Integration The big question : Evaluate E p(z) [f(z)]

More information

Chapter 3. The (L)APW+lo Method. 3.1 Choosing A Basis Set

Chapter 3. The (L)APW+lo Method. 3.1 Choosing A Basis Set Chapter 3 The (L)APW+lo Method 3.1 Choosing A Basis Set The Kohn-Sham equations (Eq. (2.17)) provide a formulation of how to practically find a solution to the Hohenberg-Kohn functional (Eq. (2.15)). Nevertheless

More information

Linear Algebra and Dirac Notation, Pt. 1

Linear Algebra and Dirac Notation, Pt. 1 Linear Algebra and Dirac Notation, Pt. 1 PHYS 500 - Southern Illinois University February 1, 2017 PHYS 500 - Southern Illinois University Linear Algebra and Dirac Notation, Pt. 1 February 1, 2017 1 / 13

More information

Physics 127c: Statistical Mechanics. Weakly Interacting Fermi Gas. The Electron Gas

Physics 127c: Statistical Mechanics. Weakly Interacting Fermi Gas. The Electron Gas Physics 7c: Statistical Mechanics Wealy Interacting Fermi Gas Unlie the Boson case, there is usually no ualitative change in behavior going from the noninteracting to the wealy interacting Fermi gas for

More information

PHYS 2426 Brooks INTRODUCTION. Physics for Scientists and Engineers, with Modern Physics, 4 th edition Giancoli

PHYS 2426 Brooks INTRODUCTION.  Physics for Scientists and Engineers, with Modern Physics, 4 th edition Giancoli PHYS 2426 Brooks INTRODUCTION http://iws.ccccd.edu/mbrooks Physics for Scientists and Engineers, with Modern Physics, 4 th edition Giancoli Chapter 21 Electric Charge and Electric Field Static Electricity;

More information

Part III: The Nuclear Many-Body Problem

Part III: The Nuclear Many-Body Problem Part III: The Nuclear Many-Body Problem To understand the properties of complex nuclei from first principles Microscopic Valence- Space Interactions Model spaces Many-body perturbation theory (MBPT) Calculating

More information

The broad topic of physical metallurgy provides a basis that links the structure of materials with their properties, focusing primarily on metals.

The broad topic of physical metallurgy provides a basis that links the structure of materials with their properties, focusing primarily on metals. Physical Metallurgy The broad topic of physical metallurgy provides a basis that links the structure of materials with their properties, focusing primarily on metals. Crystal Binding In our discussions

More information

CHEM-UA 652: Thermodynamics and Kinetics

CHEM-UA 652: Thermodynamics and Kinetics 1 CHEM-UA 652: Thermodynamics and Kinetics Notes for Lecture 4 I. THE ISOTHERMAL-ISOBARIC ENSEMBLE The isothermal-isobaric ensemble is the closest mimic to the conditions under which most experiments are

More information

Theoretical comparative study on hydrogen storage of BC 3 and carbon nanotubes

Theoretical comparative study on hydrogen storage of BC 3 and carbon nanotubes J. At. Mol. Sci. doi: 10.4208/jams.121011.011412a Vol. 3, No. 4, pp. 367-374 November 2012 Theoretical comparative study on hydrogen storage of BC 3 and carbon nanotubes Xiu-Ying Liu a,, Li-Ying Zhang

More information

Molecular Dynamics Simulations. Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia

Molecular Dynamics Simulations. Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia Molecular Dynamics Simulations Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia 1 An Introduction to Molecular Dynamics Simulations Macroscopic properties

More information

221B Lecture Notes Spontaneous Symmetry Breaking

221B Lecture Notes Spontaneous Symmetry Breaking B Lecture Notes Spontaneous Symmetry Breaking Spontaneous Symmetry Breaking Spontaneous Symmetry Breaking is an ubiquitous concept in modern physics, especially in condensed matter and particle physics.

More information

Statistical Physics. Solutions Sheet 11.

Statistical Physics. Solutions Sheet 11. Statistical Physics. Solutions Sheet. Exercise. HS 0 Prof. Manfred Sigrist Condensation and crystallization in the lattice gas model. The lattice gas model is obtained by dividing the volume V into microscopic

More information

The Fast Multipole Method in molecular dynamics

The Fast Multipole Method in molecular dynamics The Fast Multipole Method in molecular dynamics Berk Hess KTH Royal Institute of Technology, Stockholm, Sweden ADAC6 workshop Zurich, 20-06-2018 Slide BioExcel Slide Molecular Dynamics of biomolecules

More information

Lecture 21 Gravitational and Central Forces

Lecture 21 Gravitational and Central Forces Lecture 21 Gravitational and Central Forces 21.1 Newton s Law of Universal Gravitation According to Newton s Law of Universal Graviation, the force on a particle i of mass m i exerted by a particle j of

More information

Electrons in periodic potential

Electrons in periodic potential Chapter 9 Electrons in periodic potential The computation of electronic states in a solid is a nontrivial problem. A great simplification can be achieved if the solid is a crystal, i.e. if it can be described

More information

1 4 r q. (9.172) G(r, q) =

1 4 r q. (9.172) G(r, q) = FOURIER ANALYSIS: LECTURE 5 9 Green s functions 9. Response to an impulse We have spent some time so far in applying Fourier methods to solution of di erential equations such as the damped oscillator.

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

Complex functions in the theory of 2D flow

Complex functions in the theory of 2D flow Complex functions in the theory of D flow Martin Scholtz Institute of Theoretical Physics Charles University in Prague scholtz@utf.mff.cuni.cz Faculty of Transportation Sciences Czech Technical University

More information

Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar.

Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar. Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar. 25, 2002 Molecular Dynamics: Introduction At physiological conditions, the

More information

Quantum Mechanics II

Quantum Mechanics II Quantum Mechanics II Prof. Boris Altshuler April, 20 Lecture 2. Scattering Theory Reviewed Remember what we have covered so far for scattering theory. We separated the Hamiltonian similar to the way in

More information

Electric Flux. If we know the electric field on a Gaussian surface, we can find the net charge enclosed by the surface.

Electric Flux. If we know the electric field on a Gaussian surface, we can find the net charge enclosed by the surface. Chapter 23 Gauss' Law Instead of considering the electric fields of charge elements in a given charge distribution, Gauss' law considers a hypothetical closed surface enclosing the charge distribution.

More information

Gases and the Virial Expansion

Gases and the Virial Expansion Gases and the irial Expansion February 7, 3 First task is to examine what ensemble theory tells us about simple systems via the thermodynamic connection Calculate thermodynamic quantities: average energy,

More information

Quantization of the Spins

Quantization of the Spins Chapter 5 Quantization of the Spins As pointed out already in chapter 3, the external degrees of freedom, position and momentum, of an ensemble of identical atoms is described by the Scödinger field operator.

More information

( nonlinear constraints)

( nonlinear constraints) Wavelet Design & Applications Basic requirements: Admissibility (single constraint) Orthogonality ( nonlinear constraints) Sparse Representation Smooth functions well approx. by Fourier High-frequency

More information

Project: Vibration of Diatomic Molecules

Project: Vibration of Diatomic Molecules Project: Vibration of Diatomic Molecules Objective: Find the vibration energies and the corresponding vibrational wavefunctions of diatomic molecules H 2 and I 2 using the Morse potential. equired Numerical

More information

The Kernel Trick, Gram Matrices, and Feature Extraction. CS6787 Lecture 4 Fall 2017

The Kernel Trick, Gram Matrices, and Feature Extraction. CS6787 Lecture 4 Fall 2017 The Kernel Trick, Gram Matrices, and Feature Extraction CS6787 Lecture 4 Fall 2017 Momentum for Principle Component Analysis CS6787 Lecture 3.1 Fall 2017 Principle Component Analysis Setting: find the

More information