Computer lab: Density functional perturbation theory. theory for lattice dynamics

Size: px
Start display at page:

Download "Computer lab: Density functional perturbation theory. theory for lattice dynamics"

Transcription

1 Computer lab: density functional perturbation theory for lattice dynamics SISSA and DEMOCRITOS Trieste (Italy)

2 Outline 1 The dynamical matrix

3 Dynamical matrix We want to write a small computer program that calculates the dynamical matrix of a solid: D sαs β(q) = + Ω Ω d 3 2 V loc (r) r u sα(q) u s β(q) ρ(r) I 1 ( ) ( ) d 3 V loc (r) ρ(r) r I 2 u sα (q) u s β(q) + D Ewald sαs β (q) I 3. We need three routines: dynmat0, drhodv and d2ionq to calculate I 1, I 2 and I 3 respectively.

4 dynmat0 I 1 can be calculated using the charge density only. It is calculated in reciprocal space. Writing: V loc (r) = µ,s = vloc s (k)eik r e ik Rµ e ik ds e ik uµ,s, µ,s k where vloc s (k) = 1 V d 3 r vloc s (r)e ik r is the Fourier transform of (r), we have that: v s loc v s loc (r R µ d s u µ,s ) 2 V loc (r) u sα(q) u s β(q) = δ s,s ṽloc s (G)e ig ds G α G β e ig r, where ṽloc s (G) = 1 Ω d 3 r vloc s (r)e ig r. G

5 dynmat0 - I Writing the charge density in Fourier series: ρ(r) = G ρ(g)e ig r, I 1 is: I 1 = δ s,s Ω G ρ(g)ṽ s loc (G) e ig ds G α G β. dynmat0 calculates this sum using the fact that ṽloc s (G) is real and this integral is also real. So I 1 = δ s,s Ω ] ṽloc s (G)G αg β [Rρ(G)cos(G d s ) Iρ(G)sin(G d s ). G

6 dynmat0 - II Note that we will calculate the phonon frequencies of Si using the Appelbaum and Hamann pseudo-potential so: Ωṽ s loc where k 2 (k) = e 4α { 4πZ ve 2 k 2 + ( π α Z v = 4 v 1 = Ha v 2 = Ha α = /(a.u.) 2 ) 3 [ 2 v 1 + v ( )]} 2 3 α 2 k 2 4α

7 To calculate I 2 we need the periodic part of the bare perturbation V loc (r) u sα(q). We have: V loc (r) u sα (q) = µ e iq Rµ V loc(r) u µsα = i G ṽ s loc (q + G)(q + G) αe i(q+g) ds e i(q+g) r. Therefore the periodic part has Fourier components: V loc (q + G) = iṽloc s u sα (q) (q + G)(q + G) αe i(q+g) ds. This expression is calculated by the routine compute_dvloc.

8 Charge density response Then we need the lattice-periodic part of the induced charge density which is: ρ(r) u s β(q) = 2 kv u kv (r)pk+q c u kv (r) u s β(q). The routine incdrhoscf calculates this expression after the calculation of Pc k+q u kv (r) u s β (q). Note that if each band is occupied by 2 electrons, in the nonmagnetic case, we need another factor of 2 for spin degeneracy. The sum over k is done as in the calculation of the charge density.

9 P k+q c u kv (r) u s β (q) is the solution of the linear system: [H k+q + Q ɛ kv ] P k+q c u kv (r) u s β(q) = Pk+q c V KS (r) u s β(q) u kv(r). This linear system is solved by an iterative conjugate gradient algorithm that requires a routine that applies the left hand side to an arbitrary function and a routine that computes the right hand side. The left hand side is applied by the routine ch_psi_all, while the right hand side is calculated from the induced Kohn and Sham potential.

10 ch_psi_all - II The operator Q = v α u k+qv u k+qv vanishes when applied to Pc k+q so it will not change the solution. If α > max(ɛ kv ɛ k+qv ) it makes the operator H k+q + Q ɛ kv nonsingular and the linear system well defined. We take α = 2(max(ɛ kv ) min(ɛ kv )) and the same α is used for all k points.

11 is given by: V KS (r) u s β(q) = V loc (r) u s β(q) + d 3 r 1 r) ρ(r ) r r eiq(r u s β(q) + V xc(r) ρ(r) ρ u s β(q). The first term is calculated by compute_dvloc, while the other two terms are calculated by dv_of_drho.

12 dv_of_drho The induced exchange and correlation potential is calculated in real space. Vxc(r) ρ is calculated at the beginning of the run by phq_init and dmxc by numerical differentiation: [ ] V xc (r) = V xc (r, ρ + ) V xc (r, ρ ) /2, ρ and the induced exchange and correlation potential is calculated in real space: V xc (r) ρ ρ(r) u s β(q).

13 dv_of_drho - II The induced Hartree potential is calculated in reciprocal space, and a Fourier transform is later used to calculate it in real space. We have: d 3 r 1 r) ρ(r ) r r eiq(r u s β(q) = e iq r ρ(q + G) d 3 r 1 ei(q+g) r u s G β(q) r r = e ig r ρ(q + G) u s G β(q) 4π 1 q + G 2, ρ(q+g) where u s β (q) is calculated by a Fourier transform of ρ(r) u s β (q).

14 Putting all together: solve_linter We need a driver to solve the self-consistent linear system. The driver is solve_linter. This routine allocates space for the V loc (r) input and output induced potential, apply u s β (q) (using dvqpsi) and the input induced potential to u kv (r), and apply the projector Pc k+q to prepare the right hand side of the linear system. Then it calls cgsolve_all to solve the linear system and incdrhoscf to calculate the contribution of the k point to the induced charge density. These steps are repeated for all k points and then dv_of_drho is used to calculate the output induced potential. Finally a mixing routine checks if self-consistency has been achieved. If not the mixing routine provides the input induced potential for the next iteration.

15 drhodv After the self-consistent solution of the linear system we obtain ρ(r) the self-consistent induced charge density u s β (q). After a V Fourier transform of loc (q+g) V u sα(q) we get loc (r) u and sα(q) I 2 = ( ) ( ) Ω V loc (r i ) ρ(r i ), N 1 N 2 N 3 u sα (q) u s β(q) i where the sum is over all the points of the real space mesh and N 1, N 2 and N 3 are the dimensions of the mesh.

16 d2ionq Rev. Mod. Phys. 73, 515 (2001).

17 dyndia Finally we need a driver for the diagonalization of the dynamical matrix. The driver is dyndia. It divides the dynamical matrix by the masses, it forces it to be exactly Hermitian, it calls the routine cdiagh to diagonalize it and writes on output the frequencies. Imaginary frequencies are written with a minus sign.

18 Bibliography 1 S. Baroni, P. Giannozzi, and A. Testa, Phys. Rev. Lett. 58, 1861 (1987); P. Giannozzi, S. de Gironcoli, P. Pavone, and S. Baroni, Phys. Rev. B 43, 7231 (1991). 2 S. Baroni, S. de Gironcoli, A. Dal Corso, and P. Giannozzi, Rev. Mod. Phys. 73, 515 (2001). 3 A. Dal Corso, Phys. Rev. B 64, (2001). 4 A. Dal Corso, Phys. Rev. B 76, (2007). 5 A. Dal Corso, Phys. Rev. B 81, (2010).

= N 2 = 3π2 n = k 3 F. The kinetic energy of the uniform system is given by: 4πk 2 dk h2 k 2 2m. (2π) 3 0

= N 2 = 3π2 n = k 3 F. The kinetic energy of the uniform system is given by: 4πk 2 dk h2 k 2 2m. (2π) 3 0 Chapter 1 Thomas-Fermi Theory The Thomas-Fermi theory provides a functional form for the kinetic energy of a non-interacting electron gas in some known external potential V (r) (usually due to impurities)

More information

First Step : Identifying Pseudopotentials

First Step : Identifying Pseudopotentials Quantum Espresso Quick Start Introduction Quantum Espresso (http://www.quantum-espresso.org/) is a sophisticated collection of tools for electronic structure calculations via DFT using plane waves and

More information

The Application of Density Functional Theory in Materials Science

The Application of Density Functional Theory in Materials Science The Application of Density Functional Theory in Materials Science Slide 1 Outline Atomistic Modelling Group at MUL Density Functional Theory Numerical Details HPC Cluster at the MU Leoben Applications

More information

0.1 Phase Estimation Technique

0.1 Phase Estimation Technique Phase Estimation In this lecture we will describe Kitaev s phase estimation algorithm, and use it to obtain an alternate derivation of a quantum factoring algorithm We will also use this technique to design

More information

Lecture 3: Linear methods for classification

Lecture 3: Linear methods for classification Lecture 3: Linear methods for classification Rafael A. Irizarry and Hector Corrada Bravo February, 2010 Today we describe four specific algorithms useful for classification problems: linear regression,

More information

The Quantum ESPRESSO Software Distribution

The Quantum ESPRESSO Software Distribution The Quantum ESPRESSO Software Distribution The DEMOCRITOS center of Italian INFM is dedicated to atomistic simulations of materials, with a strong emphasis on the development of high-quality scientific

More information

Review of Statistical Mechanics

Review of Statistical Mechanics Review of Statistical Mechanics 3. Microcanonical, Canonical, Grand Canonical Ensembles In statistical mechanics, we deal with a situation in which even the quantum state of the system is unknown. The

More information

THE NUMBER OF GRAPHS AND A RANDOM GRAPH WITH A GIVEN DEGREE SEQUENCE. Alexander Barvinok

THE NUMBER OF GRAPHS AND A RANDOM GRAPH WITH A GIVEN DEGREE SEQUENCE. Alexander Barvinok THE NUMBER OF GRAPHS AND A RANDOM GRAPH WITH A GIVEN DEGREE SEQUENCE Alexer Barvinok Papers are available at http://www.math.lsa.umich.edu/ barvinok/papers.html This is a joint work with J.A. Hartigan

More information

Exact Inference for Gaussian Process Regression in case of Big Data with the Cartesian Product Structure

Exact Inference for Gaussian Process Regression in case of Big Data with the Cartesian Product Structure Exact Inference for Gaussian Process Regression in case of Big Data with the Cartesian Product Structure Belyaev Mikhail 1,2,3, Burnaev Evgeny 1,2,3, Kapushev Yermek 1,2 1 Institute for Information Transmission

More information

Electrostatic Fields: Coulomb s Law & the Electric Field Intensity

Electrostatic Fields: Coulomb s Law & the Electric Field Intensity Electrostatic Fields: Coulomb s Law & the Electric Field Intensity EE 141 Lecture Notes Topic 1 Professor K. E. Oughstun School of Engineering College of Engineering & Mathematical Sciences University

More information

Basic Concepts in Nuclear Physics

Basic Concepts in Nuclear Physics Basic Concepts in Nuclear Physics Paolo Finelli Corso di Teoria delle Forze Nucleari 2011 Literature/Bibliography Some useful texts are available at the Library: Wong, Nuclear Physics Krane, Introductory

More information

A DISCRETE TIME MARKOV CHAIN MODEL IN SUPERMARKETS FOR A PERIODIC INVENTORY SYSTEM WITH ONE WAY SUBSTITUTION

A DISCRETE TIME MARKOV CHAIN MODEL IN SUPERMARKETS FOR A PERIODIC INVENTORY SYSTEM WITH ONE WAY SUBSTITUTION A DISCRETE TIME MARKOV CHAIN MODEL IN SUPERMARKETS FOR A PERIODIC INVENTORY SYSTEM WITH ONE WAY SUBSTITUTION A Class Project for MATH 768: Applied Stochastic Processes Fall 2014 By Chudamani Poudyal &

More information

An Introduction to Hartree-Fock Molecular Orbital Theory

An Introduction to Hartree-Fock Molecular Orbital Theory An Introduction to Hartree-Fock Molecular Orbital Theory C. David Sherrill School of Chemistry and Biochemistry Georgia Institute of Technology June 2000 1 Introduction Hartree-Fock theory is fundamental

More information

Portfolio Distribution Modelling and Computation. Harry Zheng Department of Mathematics Imperial College h.zheng@imperial.ac.uk

Portfolio Distribution Modelling and Computation. Harry Zheng Department of Mathematics Imperial College h.zheng@imperial.ac.uk Portfolio Distribution Modelling and Computation Harry Zheng Department of Mathematics Imperial College h.zheng@imperial.ac.uk Workshop on Fast Financial Algorithms Tanaka Business School Imperial College

More information

State of Stress at Point

State of Stress at Point State of Stress at Point Einstein Notation The basic idea of Einstein notation is that a covector and a vector can form a scalar: This is typically written as an explicit sum: According to this convention,

More information

Dimensional Analysis

Dimensional Analysis Dimensional Analysis Mathematical Modelling Week 2 Kurt Bryan How does the escape velocity from a planet s surface depend on the planet s mass and radius? This sounds like a physics problem, but you can

More information

Teoretisk Fysik KTH. Advanced QM (SI2380), test questions 1

Teoretisk Fysik KTH. Advanced QM (SI2380), test questions 1 Teoretisk Fysik KTH Advanced QM (SI238), test questions NOTE THAT I TYPED THIS IN A HURRY AND TYPOS ARE POSSIBLE: PLEASE LET ME KNOW BY EMAIL IF YOU FIND ANY (I will try to correct typos asap - if you

More information

Scientific Software Development at Democritos

Scientific Software Development at Democritos Scientific Software Development at Democritos Paolo Giannozzi Democritos National Simulation Center & Scuola Normale Superiore di Pisa July 12, 2005 Typeset by FoilTEX What is Democritos? Democritos (Democritos

More information

POLYNOMIAL HISTOPOLATION, SUPERCONVERGENT DEGREES OF FREEDOM, AND PSEUDOSPECTRAL DISCRETE HODGE OPERATORS

POLYNOMIAL HISTOPOLATION, SUPERCONVERGENT DEGREES OF FREEDOM, AND PSEUDOSPECTRAL DISCRETE HODGE OPERATORS POLYNOMIAL HISTOPOLATION, SUPERCONVERGENT DEGREES OF FREEDOM, AND PSEUDOSPECTRAL DISCRETE HODGE OPERATORS N. ROBIDOUX Abstract. We show that, given a histogram with n bins possibly non-contiguous or consisting

More information

Web-based Supplementary Materials for Bayesian Effect Estimation. Accounting for Adjustment Uncertainty by Chi Wang, Giovanni

Web-based Supplementary Materials for Bayesian Effect Estimation. Accounting for Adjustment Uncertainty by Chi Wang, Giovanni 1 Web-based Supplementary Materials for Bayesian Effect Estimation Accounting for Adjustment Uncertainty by Chi Wang, Giovanni Parmigiani, and Francesca Dominici In Web Appendix A, we provide detailed

More information

Probing the Vacuum Induced Coherence in a Λ-system

Probing the Vacuum Induced Coherence in a Λ-system Probing the Vacuum Induced Coherence in a Λ-system Sunish Menon and G. S. Agarwal Physical Research Laboratory, Navrangpura, Ahmedabad 380 009, India. (February 8, 1999) We propose a simple test to demonstrate

More information

Proper Definition of Spin Current in Spin-Orbit Coupled Systems

Proper Definition of Spin Current in Spin-Orbit Coupled Systems Proper Definition of Spin Current in Spin-Orbit Coupled Systems Junren Shi ddd Institute of Physics Chinese Academy of Sciences March 25, 2006, Sanya Collaborators: Ping Zhang (dd) Di Xiao, Qian Niu(UT-Austin

More information

Section 3: Crystal Binding

Section 3: Crystal Binding Physics 97 Interatomic forces Section 3: rystal Binding Solids are stable structures, and therefore there exist interactions holding atoms in a crystal together. For example a crystal of sodium chloride

More information

Analysis, post-processing and visualization tools

Analysis, post-processing and visualization tools Analysis, post-processing and visualization tools Javier Junquera Andrei Postnikov Summary of different tools for post-processing and visualization DENCHAR PLRHO DOS, PDOS DOS and PDOS total Fe, d MACROAVE

More information

Examination paper for TMA4205 Numerical Linear Algebra

Examination paper for TMA4205 Numerical Linear Algebra Department of Mathematical Sciences Examination paper for TMA4205 Numerical Linear Algebra Academic contact during examination: Markus Grasmair Phone: 97580435 Examination date: December 16, 2015 Examination

More information

Lecture 9: Introduction to Pattern Analysis

Lecture 9: Introduction to Pattern Analysis Lecture 9: Introduction to Pattern Analysis g Features, patterns and classifiers g Components of a PR system g An example g Probability definitions g Bayes Theorem g Gaussian densities Features, patterns

More information

POLYNOMIAL HISTOPOLATION, SUPERCONVERGENT DEGREES OF FREEDOM, AND PSEUDOSPECTRAL DISCRETE HODGE OPERATORS

POLYNOMIAL HISTOPOLATION, SUPERCONVERGENT DEGREES OF FREEDOM, AND PSEUDOSPECTRAL DISCRETE HODGE OPERATORS POLYNOMIAL HISTOPOLATION, SUPERCONVERGENT DEGREES OF FREEDOM, AND PSEUDOSPECTRAL DISCRETE HODGE OPERATORS N. ROBIDOUX Abstract. We show that, given a histogram with n bins possibly non-contiguous or consisting

More information

Lecture 3 Fluid Dynamics and Balance Equa6ons for Reac6ng Flows

Lecture 3 Fluid Dynamics and Balance Equa6ons for Reac6ng Flows Lecture 3 Fluid Dynamics and Balance Equa6ons for Reac6ng Flows 3.- 1 Basics: equations of continuum mechanics - balance equations for mass and momentum - balance equations for the energy and the chemical

More information

Current Density Impedance Imaging with Complete Electrode Model

Current Density Impedance Imaging with Complete Electrode Model Current Density Impedance Imaging with Complete Electrode Model Alexandru Tamasan jointly with A. Nachman & J. Veras University of Central Florida Work supported by NSF BIRS Workshop on Hybrid Methods

More information

Analysis of Bayesian Dynamic Linear Models

Analysis of Bayesian Dynamic Linear Models Analysis of Bayesian Dynamic Linear Models Emily M. Casleton December 17, 2010 1 Introduction The main purpose of this project is to explore the Bayesian analysis of Dynamic Linear Models (DLMs). The main

More information

Accuracy of the coherent potential approximation for a onedimensional array with a Gaussian distribution of fluctuations in the on-site potential

Accuracy of the coherent potential approximation for a onedimensional array with a Gaussian distribution of fluctuations in the on-site potential Accuracy of the coherent potential approximation for a onedimensional array with a Gaussian distribution of fluctuations in the on-site potential I. Avgin Department of Electrical and Electronics Engineering,

More information

α α λ α = = λ λ α ψ = = α α α λ λ ψ α = + β = > θ θ β > β β θ θ θ β θ β γ θ β = γ θ > β > γ θ β γ = θ β = θ β = θ β = β θ = β β θ = = = β β θ = + α α α α α = = λ λ λ λ λ λ λ = λ λ α α α α λ ψ + α =

More information

Performance Improvement of Application on the K computer

Performance Improvement of Application on the K computer Performance Improvement of Application on the K computer November 13, 2011 Kazuo Minami Team Leader, Application Development Team Research and Development Group Next-Generation Supercomputer R & D Center

More information

Supporting Material to Crowding of molecular motors determines microtubule depolymerization

Supporting Material to Crowding of molecular motors determines microtubule depolymerization Supporting Material to Crowding of molecular motors determines microtubule depolymerization Louis Reese Anna Melbinger Erwin Frey Arnold Sommerfeld Center for Theoretical Physics and Center for NanoScience,

More information

NMR - Basic principles

NMR - Basic principles NMR - Basic principles Subatomic particles like electrons, protons and neutrons are associated with spin - a fundamental property like charge or mass. In the case of nuclei with even number of protons

More information

Influences in low-degree polynomials

Influences in low-degree polynomials Influences in low-degree polynomials Artūrs Bačkurs December 12, 2012 1 Introduction In 3] it is conjectured that every bounded real polynomial has a highly influential variable The conjecture is known

More information

Simulation of infrared and Raman spectra

Simulation of infrared and Raman spectra Simulation of infrared and Raman spectra, 1 Bernard Kirtman, 2 Michel Rérat, 3 Simone Salustro, 1 Marco De La Pierre, 1 Roberto Orlando, 1 Roberto Dovesi 1 1) Dipartimento di Chimica, Università di Torino

More information

5. Orthogonal matrices

5. Orthogonal matrices L Vandenberghe EE133A (Spring 2016) 5 Orthogonal matrices matrices with orthonormal columns orthogonal matrices tall matrices with orthonormal columns complex matrices with orthonormal columns 5-1 Orthonormal

More information

Variance Reduction. Pricing American Options. Monte Carlo Option Pricing. Delta and Common Random Numbers

Variance Reduction. Pricing American Options. Monte Carlo Option Pricing. Delta and Common Random Numbers Variance Reduction The statistical efficiency of Monte Carlo simulation can be measured by the variance of its output If this variance can be lowered without changing the expected value, fewer replications

More information

1 Variational calculation of a 1D bound state

1 Variational calculation of a 1D bound state TEORETISK FYSIK, KTH TENTAMEN I KVANTMEKANIK FÖRDJUPNINGSKURS EXAMINATION IN ADVANCED QUANTUM MECHAN- ICS Kvantmekanik fördjupningskurs SI38 för F4 Thursday December, 7, 8. 13. Write on each page: Name,

More information

Frustrated magnetism on Hollandite lattice

Frustrated magnetism on Hollandite lattice Frustrated magnetism on Hollandite lattice Saptarshi Mandal (ICTP, Trieste, Italy) Acknowledgment: A. Andreanov(MPIKS, Dresden) Y. Crespo and N. Seriani(ICTP, Italy) Workshop on Current Trends in Frustrated

More information

Computations of Magnetic Resonance Parameters for Crystalline Systems: Principles

Computations of Magnetic Resonance Parameters for Crystalline Systems: Principles Computations of Magnetic Resonance arameters for Crystalline Systems: rinciples 2 OVERVIEW OF THE LANEWAVE-SEUDOOTENTIAL AROACH There are numerous first-principles methods applicable to either molecules

More information

Final Year Project Progress Report. Frequency-Domain Adaptive Filtering. Myles Friel. Supervisor: Dr.Edward Jones

Final Year Project Progress Report. Frequency-Domain Adaptive Filtering. Myles Friel. Supervisor: Dr.Edward Jones Final Year Project Progress Report Frequency-Domain Adaptive Filtering Myles Friel 01510401 Supervisor: Dr.Edward Jones Abstract The Final Year Project is an important part of the final year of the Electronic

More information

Statistical Machine Learning from Data

Statistical Machine Learning from Data Samy Bengio Statistical Machine Learning from Data 1 Statistical Machine Learning from Data Gaussian Mixture Models Samy Bengio IDIAP Research Institute, Martigny, Switzerland, and Ecole Polytechnique

More information

DFT in practice : Part I. Ersen Mete

DFT in practice : Part I. Ersen Mete plane wave expansion & the Brillouin zone integration Department of Physics Balıkesir University, Balıkesir - Turkey August 13, 2009 - NanoDFT 09, İzmir Institute of Technology, İzmir Outline Plane wave

More information

Group Theory and Chemistry

Group Theory and Chemistry Group Theory and Chemistry Outline: Raman and infra-red spectroscopy Symmetry operations Point Groups and Schoenflies symbols Function space and matrix representation Reducible and irreducible representation

More information

Supporting Information

Supporting Information S1 Supporting Information GFT NMR, a New Approach to Rapidly Obtain Precise High Dimensional NMR Spectral Information Seho Kim and Thomas Szyperski * Department of Chemistry, University at Buffalo, The

More information

Sucesses and limitations of dynamical mean field theory. A.-M. Tremblay G. Sordi, D. Sénéchal, K. Haule, S. Okamoto, B. Kyung, M.

Sucesses and limitations of dynamical mean field theory. A.-M. Tremblay G. Sordi, D. Sénéchal, K. Haule, S. Okamoto, B. Kyung, M. Sucesses and limitations of dynamical mean field theory A.-M. Tremblay G. Sordi, D. Sénéchal, K. Haule, S. Okamoto, B. Kyung, M. Civelli MIT, 20 October, 2011 How to make a metal Courtesy, S. Julian r

More information

Numerical Analysis Lecture Notes

Numerical Analysis Lecture Notes Numerical Analysis Lecture Notes Peter J. Olver 6. Eigenvalues and Singular Values In this section, we collect together the basic facts about eigenvalues and eigenvectors. From a geometrical viewpoint,

More information

A Beginner s Guide to Materials Studio and DFT Calculations with Castep. P. Hasnip (pjh503@york.ac.uk)

A Beginner s Guide to Materials Studio and DFT Calculations with Castep. P. Hasnip (pjh503@york.ac.uk) A Beginner s Guide to Materials Studio and DFT Calculations with Castep P. Hasnip (pjh503@york.ac.uk) September 18, 2007 Materials Studio collects all of its files into Projects. We ll start by creating

More information

Quantum Time: Formalism and Applications

Quantum Time: Formalism and Applications Quantum Time: Formalism and Applications Submitted in partial fulfillment of honors requirements for the Department of Physics and Astronomy, Franklin and Marshall College, by Yuan Gao Professor Calvin

More information

Some probability and statistics

Some probability and statistics Appendix A Some probability and statistics A Probabilities, random variables and their distribution We summarize a few of the basic concepts of random variables, usually denoted by capital letters, X,Y,

More information

F en = mω 0 2 x. We should regard this as a model of the response of an atom, rather than a classical model of the atom itself.

F en = mω 0 2 x. We should regard this as a model of the response of an atom, rather than a classical model of the atom itself. The Electron Oscillator/Lorentz Atom Consider a simple model of a classical atom, in which the electron is harmonically bound to the nucleus n x e F en = mω 0 2 x origin resonance frequency Note: We should

More information

Computer Physics Communications

Computer Physics Communications Computer Physics Communications 180 (2009) 1041 1053 Contents lists available at ScienceDirect Computer Physics Communications www.elsevier.com/locate/cpc Linear-scaling density-functional theory with

More information

CITY UNIVERSITY LONDON. BEng Degree in Computer Systems Engineering Part II BSc Degree in Computer Systems Engineering Part III PART 2 EXAMINATION

CITY UNIVERSITY LONDON. BEng Degree in Computer Systems Engineering Part II BSc Degree in Computer Systems Engineering Part III PART 2 EXAMINATION No: CITY UNIVERSITY LONDON BEng Degree in Computer Systems Engineering Part II BSc Degree in Computer Systems Engineering Part III PART 2 EXAMINATION ENGINEERING MATHEMATICS 2 (resit) EX2005 Date: August

More information

Introduction to General and Generalized Linear Models

Introduction to General and Generalized Linear Models Introduction to General and Generalized Linear Models General Linear Models - part I Henrik Madsen Poul Thyregod Informatics and Mathematical Modelling Technical University of Denmark DK-2800 Kgs. Lyngby

More information

5.61 Physical Chemistry 25 Helium Atom page 1 HELIUM ATOM

5.61 Physical Chemistry 25 Helium Atom page 1 HELIUM ATOM 5.6 Physical Chemistry 5 Helium Atom page HELIUM ATOM Now that we have treated the Hydrogen like atoms in some detail, we now proceed to discuss the next simplest system: the Helium atom. In this situation,

More information

Section 5.0 : Horn Physics. By Martin J. King, 6/29/08 Copyright 2008 by Martin J. King. All Rights Reserved.

Section 5.0 : Horn Physics. By Martin J. King, 6/29/08 Copyright 2008 by Martin J. King. All Rights Reserved. Section 5. : Horn Physics Section 5. : Horn Physics By Martin J. King, 6/29/8 Copyright 28 by Martin J. King. All Rights Reserved. Before discussing the design of a horn loaded loudspeaker system, it is

More information

Statistical Machine Learning

Statistical Machine Learning Statistical Machine Learning UoC Stats 37700, Winter quarter Lecture 4: classical linear and quadratic discriminants. 1 / 25 Linear separation For two classes in R d : simple idea: separate the classes

More information

Credit Risk Models: An Overview

Credit Risk Models: An Overview Credit Risk Models: An Overview Paul Embrechts, Rüdiger Frey, Alexander McNeil ETH Zürich c 2003 (Embrechts, Frey, McNeil) A. Multivariate Models for Portfolio Credit Risk 1. Modelling Dependent Defaults:

More information

arxiv:hep-lat/9210041v1 30 Oct 1992

arxiv:hep-lat/9210041v1 30 Oct 1992 1 The Interface Tension in Quenched QCD at the Critical Temperature B. Grossmann a, M.. aursen a, T. Trappenberg a b and U. J. Wiese c a HRZ, c/o Kfa Juelich, P.O. Box 1913, D-5170 Jülich, Germany arxiv:hep-lat/9210041v1

More information

CHAPTER 24 GAUSS S LAW

CHAPTER 24 GAUSS S LAW CHAPTER 4 GAUSS S LAW 4. The net charge shown in Fig. 4-40 is Q. Identify each of the charges A, B, C shown. A B C FIGURE 4-40 4. From the direction of the lines of force (away from positive and toward

More information

14. Nonlinear least-squares

14. Nonlinear least-squares 14 Nonlinear least-squares EE103 (Fall 2011-12) definition Newton s method Gauss-Newton method 14-1 Nonlinear least-squares minimize r i (x) 2 = r(x) 2 r i is a nonlinear function of the n-vector of variables

More information

Isotropic Entanglement

Isotropic Entanglement Isotropic Entanglement (Density of States of Quantum Spin Systems) Ramis Movassagh 1 and Alan Edelman 2 1 Department of Mathematics, Northeastern University 2 Department of Mathematics, M.I.T. Fields Institute,

More information

Topologically Massive Gravity with a Cosmological Constant

Topologically Massive Gravity with a Cosmological Constant Topologically Massive Gravity with a Cosmological Constant Derek K. Wise Joint work with S. Carlip, S. Deser, A. Waldron Details and references at arxiv:0803.3998 [hep-th] (or for the short story, 0807.0486,

More information

Pearson's Correlation Tests

Pearson's Correlation Tests Chapter 800 Pearson's Correlation Tests Introduction The correlation coefficient, ρ (rho), is a popular statistic for describing the strength of the relationship between two variables. The correlation

More information

Quantum Computing with NMR

Quantum Computing with NMR Quantum Computing with NMR Sabine Keiber, Martin Krauÿ June 3, 2009 Sabine Keiber, Martin Krauÿ Quantum Computing with NMR June 3, 2009 1 / 46 1 A Short Introduction to NMR 2 Di Vincenzo's Requirements

More information

Post-Quantum Cryptography #2

Post-Quantum Cryptography #2 Post-Quantum Cryptography #2 Prof. Claude Crépeau McGill University 49 Post-Quantum Cryptography Finite Fields based cryptography Codes Multi-variate Polynomials Integers based cryptography Approximate

More information

Sample Size Calculation for Longitudinal Studies

Sample Size Calculation for Longitudinal Studies Sample Size Calculation for Longitudinal Studies Phil Schumm Department of Health Studies University of Chicago August 23, 2004 (Supported by National Institute on Aging grant P01 AG18911-01A1) Introduction

More information

Linear Algebra: Determinants, Inverses, Rank

Linear Algebra: Determinants, Inverses, Rank D Linear Algebra: Determinants, Inverses, Rank D 1 Appendix D: LINEAR ALGEBRA: DETERMINANTS, INVERSES, RANK TABLE OF CONTENTS Page D.1. Introduction D 3 D.2. Determinants D 3 D.2.1. Some Properties of

More information

Time domain modeling

Time domain modeling Time domain modeling Equationof motion of a WEC Frequency domain: Ok if all effects/forces are linear M+ A ω X && % ω = F% ω K + K X% ω B ω + B X% & ω ( ) H PTO PTO + others Time domain: Must be linear

More information

CONCEPT OF DETERMINISTIC ION IMPLANTATION AT THE NANOSCALE

CONCEPT OF DETERMINISTIC ION IMPLANTATION AT THE NANOSCALE CONCEPT OF DETERMINISTIC ION IMPLANTATION AT THE NANOSCALE Daniel Spemann Jan Meijer 1, Jürgen W. Gerlach, Paul Räcke 1, Susann Liedtke, Stephan Rauschenbach 2, Bernd Rauschenbach 1 University of Leipzig,

More information

Logistic Regression. Jia Li. Department of Statistics The Pennsylvania State University. Logistic Regression

Logistic Regression. Jia Li. Department of Statistics The Pennsylvania State University. Logistic Regression Logistic Regression Department of Statistics The Pennsylvania State University Email: jiali@stat.psu.edu Logistic Regression Preserve linear classification boundaries. By the Bayes rule: Ĝ(x) = arg max

More information

FIELD THEORY OF ISING PERCOLATING CLUSTERS

FIELD THEORY OF ISING PERCOLATING CLUSTERS UK Meeting on Integrable Models and Conformal Field heory University of Kent, Canterbury 16-17 April 21 FIELD HEORY OF ISING PERCOLAING CLUSERS Gesualdo Delfino SISSA-rieste Based on : GD, Nucl.Phys.B

More information

Point Biserial Correlation Tests

Point Biserial Correlation Tests Chapter 807 Point Biserial Correlation Tests Introduction The point biserial correlation coefficient (ρ in this chapter) is the product-moment correlation calculated between a continuous random variable

More information

MAN-BITES-DOG BUSINESS CYCLES ONLINE APPENDIX

MAN-BITES-DOG BUSINESS CYCLES ONLINE APPENDIX MAN-BITES-DOG BUSINESS CYCLES ONLINE APPENDIX KRISTOFFER P. NIMARK The next section derives the equilibrium expressions for the beauty contest model from Section 3 of the main paper. This is followed by

More information

arxiv:hep-th/0507236v1 25 Jul 2005

arxiv:hep-th/0507236v1 25 Jul 2005 Non perturbative series for the calculation of one loop integrals at finite temperature Paolo Amore arxiv:hep-th/050736v 5 Jul 005 Facultad de Ciencias, Universidad de Colima, Bernal Diaz del Castillo

More information

PHY4604 Introduction to Quantum Mechanics Fall 2004 Practice Test 3 November 22, 2004

PHY4604 Introduction to Quantum Mechanics Fall 2004 Practice Test 3 November 22, 2004 PHY464 Introduction to Quantum Mechanics Fall 4 Practice Test 3 November, 4 These problems are similar but not identical to the actual test. One or two parts will actually show up.. Short answer. (a) Recall

More information

Basic Concepts in Nuclear Physics. Paolo Finelli

Basic Concepts in Nuclear Physics. Paolo Finelli Basic Concepts in Nuclear Physics Paolo Finelli Literature/Bibliography Some useful texts are available at the Library: Wong, Nuclear Physics Krane, Introductory Nuclear Physics Basdevant, Rich and Spiro,

More information

6.2 Permutations continued

6.2 Permutations continued 6.2 Permutations continued Theorem A permutation on a finite set A is either a cycle or can be expressed as a product (composition of disjoint cycles. Proof is by (strong induction on the number, r, of

More information

Analysis of Multi-Spacecraft Magnetic Field Data

Analysis of Multi-Spacecraft Magnetic Field Data COSPAR Capacity Building Beijing, 5 May 2004 Joachim Vogt Analysis of Multi-Spacecraft Magnetic Field Data 1 Introduction, single-spacecraft vs. multi-spacecraft 2 Single-spacecraft data, minimum variance

More information

Mutual Inductance and Transformers F3 3. r L = ω o

Mutual Inductance and Transformers F3 3. r L = ω o utual Inductance and Transformers F3 1 utual Inductance & Transformers If a current, i 1, flows in a coil or circuit then it produces a magnetic field. Some of the magnetic flux may link a second coil

More information

Plate waves in phononic crystals slabs

Plate waves in phononic crystals slabs Acoustics 8 Paris Plate waves in phononic crystals slabs J.-J. Chen and B. Bonello CNRS and Paris VI University, INSP - 14 rue de Lourmel, 7515 Paris, France chen99nju@gmail.com 41 Acoustics 8 Paris We

More information

Conservative Systems 6 1

Conservative Systems 6 1 6 Conservative Systems 6 1 Chapter 6: CONSERVATIVE SYSTEMS TABLE OF CONTENTS Page 6.1 Introduction..................... 6 3 6.2 Work and Work Functions................ 6 3 6.2.1 Mechanical Work Concept.............

More information

Lecture 8 February 4

Lecture 8 February 4 ICS273A: Machine Learning Winter 2008 Lecture 8 February 4 Scribe: Carlos Agell (Student) Lecturer: Deva Ramanan 8.1 Neural Nets 8.1.1 Logistic Regression Recall the logistic function: g(x) = 1 1 + e θt

More information

ASEN 3112 - Structures. MDOF Dynamic Systems. ASEN 3112 Lecture 1 Slide 1

ASEN 3112 - Structures. MDOF Dynamic Systems. ASEN 3112 Lecture 1 Slide 1 19 MDOF Dynamic Systems ASEN 3112 Lecture 1 Slide 1 A Two-DOF Mass-Spring-Dashpot Dynamic System Consider the lumped-parameter, mass-spring-dashpot dynamic system shown in the Figure. It has two point

More information

Free Electron Fermi Gas (Kittel Ch. 6)

Free Electron Fermi Gas (Kittel Ch. 6) Free Electron Fermi Gas (Kittel Ch. 6) Role of Electrons in Solids Electrons are responsible for binding of crystals -- they are the glue that hold the nuclei together Types of binding (see next slide)

More information

Solid State Detectors = Semi-Conductor based Detectors

Solid State Detectors = Semi-Conductor based Detectors Solid State Detectors = Semi-Conductor based Detectors Materials and their properties Energy bands and electronic structure Charge transport and conductivity Boundaries: the p-n junction Charge collection

More information

1 Introduction to Matrices

1 Introduction to Matrices 1 Introduction to Matrices In this section, important definitions and results from matrix algebra that are useful in regression analysis are introduced. While all statements below regarding the columns

More information

N 1. (q k+1 q k ) 2 + α 3. k=0

N 1. (q k+1 q k ) 2 + α 3. k=0 Teoretisk Fysik Hand-in problem B, SI1142, Spring 2010 In 1955 Fermi, Pasta and Ulam 1 numerically studied a simple model for a one dimensional chain of non-linear oscillators to see how the energy distribution

More information

Outline. Topic 4 - Analysis of Variance Approach to Regression. Partitioning Sums of Squares. Total Sum of Squares. Partitioning sums of squares

Outline. Topic 4 - Analysis of Variance Approach to Regression. Partitioning Sums of Squares. Total Sum of Squares. Partitioning sums of squares Topic 4 - Analysis of Variance Approach to Regression Outline Partitioning sums of squares Degrees of freedom Expected mean squares General linear test - Fall 2013 R 2 and the coefficient of correlation

More information

Linear Threshold Units

Linear Threshold Units Linear Threshold Units w x hx (... w n x n w We assume that each feature x j and each weight w j is a real number (we will relax this later) We will study three different algorithms for learning linear

More information

Nonlinear Algebraic Equations Example

Nonlinear Algebraic Equations Example Nonlinear Algebraic Equations Example Continuous Stirred Tank Reactor (CSTR). Look for steady state concentrations & temperature. s r (in) p,i (in) i In: N spieces with concentrations c, heat capacities

More information

19 LINEAR QUADRATIC REGULATOR

19 LINEAR QUADRATIC REGULATOR 19 LINEAR QUADRATIC REGULATOR 19.1 Introduction The simple form of loopshaping in scalar systems does not extend directly to multivariable (MIMO) plants, which are characterized by transfer matrices instead

More information

Introduction to SME and Scattering Theory. Don Colladay. New College of Florida Sarasota, FL, 34243, U.S.A.

Introduction to SME and Scattering Theory. Don Colladay. New College of Florida Sarasota, FL, 34243, U.S.A. June 2012 Introduction to SME and Scattering Theory Don Colladay New College of Florida Sarasota, FL, 34243, U.S.A. This lecture was given at the IUCSS summer school during June of 2012. It contains a

More information

Fundamentals of Plasma Physics Waves in plasmas

Fundamentals of Plasma Physics Waves in plasmas Fundamentals of Plasma Physics Waves in plasmas APPLAuSE Instituto Superior Técnico Instituto de Plasmas e Fusão Nuclear Vasco Guerra 1 Waves in plasmas What can we study with the complete description

More information

SOME EXAMPLES OF INTEGRAL DEFINITE QUATERNARY QUADRATIC FORMS WITH PRIME DISCRIMINANT KI-ICHIRO HASHIMOTO

SOME EXAMPLES OF INTEGRAL DEFINITE QUATERNARY QUADRATIC FORMS WITH PRIME DISCRIMINANT KI-ICHIRO HASHIMOTO K. Hashimoto Nagoya Math. J. Vol. 77 (1980), 167-175 SOME EXAMPLES OF INTEGRAL DEFINITE QUATERNARY QUADRATIC FORMS WITH PRIME DISCRIMINANT KI-ICHIRO HASHIMOTO Introduction In the theory of integral quadratic

More information

Well-Separated Pair Decomposition for the Unit-disk Graph Metric and its Applications

Well-Separated Pair Decomposition for the Unit-disk Graph Metric and its Applications Well-Separated Pair Decomposition for the Unit-disk Graph Metric and its Applications Jie Gao Department of Computer Science Stanford University Joint work with Li Zhang Systems Research Center Hewlett-Packard

More information