Numerical Simulation of Spin Dynamics

Size: px
Start display at page:

Download "Numerical Simulation of Spin Dynamics"

Transcription

1 Numerical Simulation of Spin Dynamics Marie Kubinova MATH 789R: Advanced Numerical Linear Algebra Methods with Applications November 18, 2014

2 Introduction Discretization in time Computing the subpropagators Avoiding computation of subpropagators

3 Nuclear magnetic resonance spectroscopy Phenomenon of nuclear magnetic resonance Nuclei in a magnetic field absorb and re-emit electromagnetic radiation. This energy is at a specific resonance frequency which depends on the strength of the magnetic field and the magnetic properties of the isotope of the atoms. Quantum mechanics QM is know for being weird, counterintuitive, and difficult to understand. 4/38

4 QM recap The evolution of a closed system is given by the time-dependent Schrödinger equation i d ψ = H ψ, dt where H is the system Hamiltonian. The evolution of a closed system is unitary ψ(t) = U(t, 0) ψ(0). Equivalent Schrödinger equation for the time evolution operator (propagator) i du dt = HU. 5/38

5 Mixed states Pure state: can be described by state vector ψ or ψ ψ. Mixed state: statistical mixture of pure states ρ = N p j ψ j ψ j, j=1 where p j are real, 0 p j 1, j p j = 1. Liouville-von Neumann equation (equivalent of the Schrödinger equation for the density matrix) i dρ dt = [H, ρ]. Liouville-von Neumann equation is solved by use of propagators as ρ(t) = U(t, 0)ρ(0)U(t, 0). 6/38

6 Time-dependent Hamiltonian All previous equations hold also for H = H(t), in particular But However, du(t, 0) i = H(t)U(t, 0). dt U(t, 0) e ith e i t 0 H(t )dt. U(t, 0) = U(t, t )U(t, 0), t > t > 0. Therefore, for t t/n, For t small, U(t, 0) = U(t, (N 1) t) U(2 t, t)u( t, 0). U((k + 1) t, k t) e i th(k t). 7/38

7 Observable (Schrödinger picture) For a pure state, the expected value of an observable for a system in state ψ is given by O = ψ O ψ. For the density matrix ρ = j p j ψ j ψ j, O = N p j ψ j O ψ j = j=1 N p j Tr ( ψ j ψ j O) = Tr(ρO). j=1 identify dominating frequencies Fourier coefficients sampling s(t) O(t) s(t i ), i = 1,..., M DFT ([s(t i )] i=1,...,m ) 8/38

8 Our setting Given: To be computed: ρ(0), H(t), O, {t i } i=1,...,m. s(t i ) = Tr(U(t i, 0)ρ(0)U(t i, 0) O), where U((k + 1) t, k t) e i th(k t). (picture: Wikipedia) 9/38

9 Our setting (cont.) Required accuracy: 0.1% 1%. Important properties: N spins ±1/2 matrices 2 N 2 N ; ρ(0) is often sparse, but not necessarily; H(t) is real symmetric; H(t) is sparse with the same sparsity pattern t; H(t) is periodic; only small number of sampling times ( 4 10) within one period of Hamiltonian; O is sparse. 10/38

10 Example I H H nz = ρ FT (s) nz = /38

11 Example II 0 H without RF H without RF nz = H with RF H with RF nz = /38

12 Main tasks How to choose t? How to compute subpropagator e i th(k t)? How to avoid computation of subpropagators? 13/38

13 Choosing the time step t Aim: choose t s.t. H is almost constant in t [(k + 1) t, k t] { e i th(k t) U((k + 1) t, k t) Standard approach: refine until stagnation. e i th((k+1) t) Sensitivity of the matrix exponential A normal: e A+E e A e A E e E. Q: Is this bound tight? A: Quite. Q: Is this bound useful? A: Well, only locally... 15/38

14 Example rel. change Hams rel. change exps upper bound k rel. change Hams... H(k t) H((k + 1) t) / H(k t) rel. change exps... e i th(k t) e i th((k+1) t) / e i th(k t) upper bound... t H(k t) H((k + 1) t) e t H(k t) H((k+1) t) 16/38

15 Computing the subpropagators I Taylor expansion e A n k=0 1 k! Ak + requires only sparse-dense multiplications reasonable convergence only for th < 1 (ca. 7 terms) Scaling and squaring e A = (e A/n) n optimal: n = 2 k + scaling improves convergence of many methods requires dense-dense multiplications alternative: finer time discretization 18/38

16 Computing the subpropagators II Padé approximant such that m Rm,n(x) f k=0 = a kx k 1 + n l=1 b lx l, R(0) = f (0) R (0) = f (0). R (m+n) (0) = f (m+n) (0) usually m = n + explicit formulas for a k and b l denominator may be singular, stability issues useful only for th small 19/38

17 Computing the subpropagators III Chebyshev expansion e A = J 0 (i)i + 2 J k... Bessel functions i k J k ( i)t k (A), A 1 k=1 T k... Chebyshev polynomials of the first kind + T k (A) using three-term recurrence with only sparse-dense multiplications A 1 must hold Diagonalization A = V ΛV e A = V diag([e λ 1,..., e λn ])V depends on how efficiently we compute the spectral decomposition 20/38

18 Computing the subpropagators IV Diagonalization using updates use the spectral decomposition from previous time step A (k) = V (k) Λ (k) ( V (k)) for i = 1,..., n ( end µ (k+1) i λ (k+1) i v (k) i ) A (k+1) v (k) i compute the dominant eigenvector ṽ (k+1) i of (A (k+1) µ (k+1) i I ) 1 ( ) (k+1) ṽ i A (k+1)ṽ (k+1) (k+1) i, ṽ i v (k+1) i + power iteration generally converges very quickly poor convergence for λ i+1 λ i 1 21/38

19 Eigenvalues of a Hamiltonian λi i λi+1 / λi i 22/38

20 Computing the subpropagators V Sparse splitting methods in general Suzuki-Trotter formula: Sparse splitting: e t(a 1+A 2 ) = e ta 1 e ta 2 + O(t 2 ) A = A A k, s.t. e A i sparse e A e A 1 e A2 e A k + avoids dense-dense multiplication of the subpropagators error may be large for highly non-commutative matrices 23/38

21 Computing the subpropagators VI Checkerboard method A symmetric with zero diagonal, k = nnz(a) 2 : a i A i a i e A i = I.. cosh(a i ) sinh(a i ). I. sinh(a i ) cosh(a i ).. I For α = A < 1 and m = max i nnz(a(i, :)) e A e A 1 e A2 e A k 1 2 kmα2 e mα. + cheap multiplication by e A i error scales with nnz(a) + better splitting schemes: (mα) 2 e mα edge coloring 24/38

22 Computing the subpropagators: Summary Expansion methods often need scaling and squaring (or smaller time step) to achieve reasonable convergence. For Chebyshev expansion, proper scaling is absolutely inevitable. Diagonalization update is a difficult task if the eigenvalues are not well separated. Subpropagators are dense and must be multiplied to form the final propagator (dense-dense multiplication). Splitting methods may introduce large error. 25/38

23 Evolution of pure states Assume with k small. Compute ρ = k p j ψ j ψ j j=1 ψ j (t) = U(t, 0) ψ j (0) e i th(n t) e i th( t) e i th(0) ψ j (0), i.e., the action of the matrix exponential on a vector, and ρ(t) = k p j ψ j (t) ψ j (t). j=1 + only matrix-vector multiplication + Krylov subspace methods cannot employ the periodicity of H k is rarely small 27/38

24 Baker-Campbell-Hausdorff formula We know that e A+B e A e B. However, there always exists C, s.t. e C = e A e B [A, B] = 0 = C = A + B [A, B] central = C = A + B [A, B] [A, B] general = go to Wikipedia 28/38

25 Baker-Campbell-Hausdorff formula (cont.) + enables aggregation of subpropagators + allows employing the periodicity of H + computation of C only sparse-sparse multiplications C is generally not sparse often slow convergence nnz A B [A, B] [A, [A, B]] [B, [B, A]] [B, [A, [A, B]]] /38

26 Adjoint endomorphism (matrix Lie algebra) Compute directly the uniformly transformed density matrix using the following (Taylor-expansion type) formula e A Be A = B + [A, B] + 1 2! [A, [A, B]] + 1 [A, [A, [A, B]]] + 3! + fully avoids dense-dense no periodicity often slow convergence 30/38

27 Avoiding the computation of subpropagators: Summary Due to periodicity of H, propagators from the initial time to the sampling times can be reused, therefore avoiding computation of the subpropagators fully is counterproductive. To use (band) Krylov subspace methods, the initial state has to be a statistical mixture of a small number of pure states. Both commutators of two consecutive Hamiltonians and Hamiltonian and the density matrix decay relatively slowly. 31/38

28 References 32/38

29 References 33/38

30 References 34/38

31 References 35/38

32 References 36/38

33 References 37/38

34 Thank you for your attention.

35 Edge-coloring (pictures: Wikipedia) back

Numerical simulations of spin dynamics

Numerical simulations of spin dynamics Numerical simulations of spin dynamics Charles University in Prague Faculty of Science Institute of Computer Science Spin dynamics behavior of spins nuclear spin magnetic moment in magnetic field quantum

More information

Physics 550. Problem Set 6: Kinematics and Dynamics

Physics 550. Problem Set 6: Kinematics and Dynamics Physics 550 Problem Set 6: Kinematics and Dynamics Name: Instructions / Notes / Suggestions: Each problem is worth five points. In order to receive credit, you must show your work. Circle your final answer.

More information

Solution Set 3. Hand out : i d dt. Ψ(t) = Ĥ Ψ(t) + and

Solution Set 3. Hand out : i d dt. Ψ(t) = Ĥ Ψ(t) + and Physikalische Chemie IV Magnetische Resonanz HS Solution Set 3 Hand out : 5.. Repetition. The Schrödinger equation describes the time evolution of a closed quantum system: i d dt Ψt Ĥ Ψt Here the state

More information

Numerical Linear and Multilinear Algebra in Quantum Tensor Networks

Numerical Linear and Multilinear Algebra in Quantum Tensor Networks Numerical Linear and Multilinear Algebra in Quantum Tensor Networks Konrad Waldherr October 20, 2013 Joint work with Thomas Huckle QCCC 2013, Prien, October 20, 2013 1 Outline Numerical (Multi-) Linear

More information

S.K. Saikin May 22, Lecture 13

S.K. Saikin May 22, Lecture 13 S.K. Saikin May, 007 13 Decoherence I Lecture 13 A physical qubit is never isolated from its environment completely. As a trivial example, as in the case of a solid state qubit implementation, the physical

More information

Classical behavior of magnetic dipole vector. P. J. Grandinetti

Classical behavior of magnetic dipole vector. P. J. Grandinetti Classical behavior of magnetic dipole vector Z μ Y X Z μ Y X Quantum behavior of magnetic dipole vector Random sample of spin 1/2 nuclei measure μ z μ z = + γ h/2 group μ z = γ h/2 group Quantum behavior

More information

Chapter 2 The Group U(1) and its Representations

Chapter 2 The Group U(1) and its Representations Chapter 2 The Group U(1) and its Representations The simplest example of a Lie group is the group of rotations of the plane, with elements parametrized by a single number, the angle of rotation θ. It is

More information

The Hamiltonian and the Schrödinger equation Consider time evolution from t to t + ɛ. As before, we expand in powers of ɛ; we have. H(t) + O(ɛ 2 ).

The Hamiltonian and the Schrödinger equation Consider time evolution from t to t + ɛ. As before, we expand in powers of ɛ; we have. H(t) + O(ɛ 2 ). Lecture 12 Relevant sections in text: 2.1 The Hamiltonian and the Schrödinger equation Consider time evolution from t to t + ɛ. As before, we expand in powers of ɛ; we have U(t + ɛ, t) = I + ɛ ( īh ) H(t)

More information

Ensembles and incomplete information

Ensembles and incomplete information p. 1/32 Ensembles and incomplete information So far in this course, we have described quantum systems by states that are normalized vectors in a complex Hilbert space. This works so long as (a) the system

More information

Linear Algebra Review (Course Notes for Math 308H - Spring 2016)

Linear Algebra Review (Course Notes for Math 308H - Spring 2016) Linear Algebra Review (Course Notes for Math 308H - Spring 2016) Dr. Michael S. Pilant February 12, 2016 1 Background: We begin with one of the most fundamental notions in R 2, distance. Letting (x 1,

More information

Lie algebraic quantum control mechanism analysis

Lie algebraic quantum control mechanism analysis Lie algebraic quantum control mechanism analysis June 4, 2 Existing methods for quantum control mechanism identification do not exploit analytic features of control systems to delineate mechanism (or,

More information

Introduction to the GRAPE Algorithm

Introduction to the GRAPE Algorithm June 8, 2010 Reference: J. Mag. Res. 172, 296 (2005) Journal of Magnetic Resonance 172 (2005) 296 305 www.elsevier.com/locate/jmr Optimal control of coupled spin dynamics: design of NMR pulse sequences

More information

G : Quantum Mechanics II

G : Quantum Mechanics II G5.666: Quantum Mechanics II Notes for Lecture 5 I. REPRESENTING STATES IN THE FULL HILBERT SPACE Given a representation of the states that span the spin Hilbert space, we now need to consider the problem

More information

2.4.8 Heisenberg Algebra, Fock Space and Harmonic Oscillator

2.4.8 Heisenberg Algebra, Fock Space and Harmonic Oscillator .4. SPECTRAL DECOMPOSITION 63 Let P +, P, P 1,..., P p be the corresponding orthogonal complimentary system of projections, that is, P + + P + p P i = I. i=1 Then there exists a corresponding system of

More information

3.024 Electrical, Optical, and Magnetic Properties of Materials Spring 2012 Recitation 1. Office Hours: MWF 9am-10am or by appointment

3.024 Electrical, Optical, and Magnetic Properties of Materials Spring 2012 Recitation 1. Office Hours: MWF 9am-10am or by  appointment Adam Floyd Hannon Office Hours: MWF 9am-10am or by e-mail appointment Topic Outline 1. a. Fourier Transform & b. Fourier Series 2. Linear Algebra Review 3. Eigenvalue/Eigenvector Problems 1. a. Fourier

More information

Quantum Mechanics for Mathematicians: The Heisenberg group and the Schrödinger Representation

Quantum Mechanics for Mathematicians: The Heisenberg group and the Schrödinger Representation Quantum Mechanics for Mathematicians: The Heisenberg group and the Schrödinger Representation Peter Woit Department of Mathematics, Columbia University woit@math.columbia.edu November 30, 2012 In our discussion

More information

The Postulates of Quantum Mechanics

The Postulates of Quantum Mechanics p. 1/23 The Postulates of Quantum Mechanics We have reviewed the mathematics (complex linear algebra) necessary to understand quantum mechanics. We will now see how the physics of quantum mechanics fits

More information

MATH 583A REVIEW SESSION #1

MATH 583A REVIEW SESSION #1 MATH 583A REVIEW SESSION #1 BOJAN DURICKOVIC 1. Vector Spaces Very quick review of the basic linear algebra concepts (see any linear algebra textbook): (finite dimensional) vector space (or linear space),

More information

Numerical Integration of the Wavefunction in FEM

Numerical Integration of the Wavefunction in FEM Numerical Integration of the Wavefunction in FEM Ian Korey Eaves ike26@drexel.edu December 14, 2013 Abstract Although numerous techniques for calculating stationary states of the schrödinger equation are

More information

1 Math 241A-B Homework Problem List for F2015 and W2016

1 Math 241A-B Homework Problem List for F2015 and W2016 1 Math 241A-B Homework Problem List for F2015 W2016 1.1 Homework 1. Due Wednesday, October 7, 2015 Notation 1.1 Let U be any set, g be a positive function on U, Y be a normed space. For any f : U Y let

More information

General Exam Part II, Fall 1998 Quantum Mechanics Solutions

General Exam Part II, Fall 1998 Quantum Mechanics Solutions General Exam Part II, Fall 1998 Quantum Mechanics Solutions Leo C. Stein Problem 1 Consider a particle of charge q and mass m confined to the x-y plane and subject to a harmonic oscillator potential V

More information

MATH 423 Linear Algebra II Lecture 33: Diagonalization of normal operators.

MATH 423 Linear Algebra II Lecture 33: Diagonalization of normal operators. MATH 423 Linear Algebra II Lecture 33: Diagonalization of normal operators. Adjoint operator and adjoint matrix Given a linear operator L on an inner product space V, the adjoint of L is a transformation

More information

Linear Algebra II Lecture 13

Linear Algebra II Lecture 13 Linear Algebra II Lecture 13 Xi Chen 1 1 University of Alberta November 14, 2014 Outline 1 2 If v is an eigenvector of T : V V corresponding to λ, then v is an eigenvector of T m corresponding to λ m since

More information

2. As we shall see, we choose to write in terms of σ x because ( X ) 2 = σ 2 x.

2. As we shall see, we choose to write in terms of σ x because ( X ) 2 = σ 2 x. Section 5.1 Simple One-Dimensional Problems: The Free Particle Page 9 The Free Particle Gaussian Wave Packets The Gaussian wave packet initial state is one of the few states for which both the { x } and

More information

Density Matrices. Chapter Introduction

Density Matrices. Chapter Introduction Chapter 15 Density Matrices 15.1 Introduction Density matrices are employed in quantum mechanics to give a partial description of a quantum system, one from which certain details have been omitted. For

More information

Introduction to Quantum Computing

Introduction to Quantum Computing Introduction to Quantum Computing Petros Wallden Lecture 3: Basic Quantum Mechanics 26th September 2016 School of Informatics, University of Edinburgh Resources 1. Quantum Computation and Quantum Information

More information

NANOSCALE SCIENCE & TECHNOLOGY

NANOSCALE SCIENCE & TECHNOLOGY . NANOSCALE SCIENCE & TECHNOLOGY V Two-Level Quantum Systems (Qubits) Lecture notes 5 5. Qubit description Quantum bit (qubit) is an elementary unit of a quantum computer. Similar to classical computers,

More information

MATH 5640: Functions of Diagonalizable Matrices

MATH 5640: Functions of Diagonalizable Matrices MATH 5640: Functions of Diagonalizable Matrices Hung Phan, UMass Lowell November 27, 208 Spectral theorem for diagonalizable matrices Definition Let V = X Y Every v V is uniquely decomposed as u = x +

More information

Eigenvalues and Eigenvectors

Eigenvalues and Eigenvectors /88 Chia-Ping Chen Department of Computer Science and Engineering National Sun Yat-sen University Linear Algebra Eigenvalue Problem /88 Eigenvalue Equation By definition, the eigenvalue equation for matrix

More information

Propagators for TDDFT

Propagators for TDDFT Propagators for TDDFT A. Castro 1 M. A. L. Marques 2 A. Rubio 3 1 Institut für Theoretische Physik, Fachbereich Physik der Freie Universität Berlin 2 Departamento de Física, Universidade de Coimbra, Portugal.

More information

Differential equations

Differential equations Differential equations Math 7 Spring Practice problems for April Exam Problem Use the method of elimination to find the x-component of the general solution of x y = 6x 9x + y = x 6y 9y Soln: The system

More information

Chapter 7 Iterative Techniques in Matrix Algebra

Chapter 7 Iterative Techniques in Matrix Algebra Chapter 7 Iterative Techniques in Matrix Algebra Per-Olof Persson persson@berkeley.edu Department of Mathematics University of California, Berkeley Math 128B Numerical Analysis Vector Norms Definition

More information

Quantum mechanics in one hour

Quantum mechanics in one hour Chapter 2 Quantum mechanics in one hour 2.1 Introduction The purpose of this chapter is to refresh your knowledge of quantum mechanics and to establish notation. Depending on your background you might

More information

Attempts at relativistic QM

Attempts at relativistic QM Attempts at relativistic QM based on S-1 A proper description of particle physics should incorporate both quantum mechanics and special relativity. However historically combining quantum mechanics and

More information

Linear Algebra using Dirac Notation: Pt. 2

Linear Algebra using Dirac Notation: Pt. 2 Linear Algebra using Dirac Notation: Pt. 2 PHYS 476Q - Southern Illinois University February 6, 2018 PHYS 476Q - Southern Illinois University Linear Algebra using Dirac Notation: Pt. 2 February 6, 2018

More information

v = 1(1 t) + 1(1 + t). We may consider these components as vectors in R n and R m : w 1. R n, w m

v = 1(1 t) + 1(1 + t). We may consider these components as vectors in R n and R m : w 1. R n, w m 20 Diagonalization Let V and W be vector spaces, with bases S = {e 1,, e n } and T = {f 1,, f m } respectively Since these are bases, there exist constants v i and w such that any vectors v V and w W can

More information

Quantum Computing Lecture 2. Review of Linear Algebra

Quantum Computing Lecture 2. Review of Linear Algebra Quantum Computing Lecture 2 Review of Linear Algebra Maris Ozols Linear algebra States of a quantum system form a vector space and their transformations are described by linear operators Vector spaces

More information

Quantum Theory and Group Representations

Quantum Theory and Group Representations Quantum Theory and Group Representations Peter Woit Columbia University LaGuardia Community College, November 1, 2017 Queensborough Community College, November 15, 2017 Peter Woit (Columbia University)

More information

The goal of this chapter is to study linear systems of ordinary differential equations: dt,..., dx ) T

The goal of this chapter is to study linear systems of ordinary differential equations: dt,..., dx ) T 1 1 Linear Systems The goal of this chapter is to study linear systems of ordinary differential equations: ẋ = Ax, x(0) = x 0, (1) where x R n, A is an n n matrix and ẋ = dx ( dt = dx1 dt,..., dx ) T n.

More information

Superoperators for NMR Quantum Information Processing. Osama Usman June 15, 2012

Superoperators for NMR Quantum Information Processing. Osama Usman June 15, 2012 Superoperators for NMR Quantum Information Processing Osama Usman June 15, 2012 Outline 1 Prerequisites 2 Relaxation and spin Echo 3 Spherical Tensor Operators 4 Superoperators 5 My research work 6 References.

More information

Course Notes: Week 1

Course Notes: Week 1 Course Notes: Week 1 Math 270C: Applied Numerical Linear Algebra 1 Lecture 1: Introduction (3/28/11) We will focus on iterative methods for solving linear systems of equations (and some discussion of eigenvalues

More information

Simple one-dimensional potentials

Simple one-dimensional potentials Simple one-dimensional potentials Sourendu Gupta TIFR, Mumbai, India Quantum Mechanics 1 Ninth lecture Outline 1 Outline 2 Energy bands in periodic potentials 3 The harmonic oscillator 4 A charged particle

More information

Dephasing, relaxation and thermalization in one-dimensional quantum systems

Dephasing, relaxation and thermalization in one-dimensional quantum systems Dephasing, relaxation and thermalization in one-dimensional quantum systems Fachbereich Physik, TU Kaiserslautern 26.7.2012 Outline 1 Introduction 2 Dephasing, relaxation and thermalization 3 Particle

More information

Mathematical Physics Homework 10

Mathematical Physics Homework 10 Georgia Institute of Technology Mathematical Physics Homework Conner Herndon November, 5 Several types of orthogonal polynomials frequently occur in various physics problems. For instance, Hermite polynomials

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 18 Outline

More information

Postulates of Quantum Mechanics

Postulates of Quantum Mechanics EXERCISES OF QUANTUM MECHANICS LECTURE Departamento de Física Teórica y del Cosmos 018/019 Exercise 1: Stern-Gerlach experiment Postulates of Quantum Mechanics AStern-Gerlach(SG)deviceisabletoseparateparticlesaccordingtotheirspinalonga

More information

The Exponential of a Matrix

The Exponential of a Matrix The Exponential of a Matrix 5-8- The solution to the exponential growth equation dx dt kx is given by x c e kt It is natural to ask whether you can solve a constant coefficient linear system x A x in a

More information

Lyapunov-based control of quantum systems

Lyapunov-based control of quantum systems Lyapunov-based control of quantum systems Symeon Grivopoulos Bassam Bamieh Department of Mechanical and Environmental Engineering University of California, Santa Barbara, CA 936-57 symeon,bamieh@engineering.ucsb.edu

More information

Open quantum systems

Open quantum systems Open quantum systems Wikipedia: An open quantum system is a quantum system which is found to be in interaction with an external quantum system, the environment. The open quantum system can be viewed as

More information

Math 408 Advanced Linear Algebra

Math 408 Advanced Linear Algebra Math 408 Advanced Linear Algebra Chi-Kwong Li Chapter 4 Hermitian and symmetric matrices Basic properties Theorem Let A M n. The following are equivalent. Remark (a) A is Hermitian, i.e., A = A. (b) x

More information

Introduction to Quantum Information Hermann Kampermann

Introduction to Quantum Information Hermann Kampermann Introduction to Quantum Information Hermann Kampermann Heinrich-Heine-Universität Düsseldorf Theoretische Physik III Summer school Bleubeuren July 014 Contents 1 Quantum Mechanics...........................

More information

Solving Linear Systems of Equations

Solving Linear Systems of Equations November 6, 2013 Introduction The type of problems that we have to solve are: Solve the system: A x = B, where a 11 a 1N a 12 a 2N A =.. a 1N a NN x = x 1 x 2. x N B = b 1 b 2. b N To find A 1 (inverse

More information

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018 Numerical Analysis Preliminary Exam 1 am to 1 pm, August 2, 218 Instructions. You have three hours to complete this exam. Submit solutions to four (and no more) of the following six problems. Please start

More information

Definition (T -invariant subspace) Example. Example

Definition (T -invariant subspace) Example. Example Eigenvalues, Eigenvectors, Similarity, and Diagonalization We now turn our attention to linear transformations of the form T : V V. To better understand the effect of T on the vector space V, we begin

More information

MATH 5524 MATRIX THEORY Problem Set 4

MATH 5524 MATRIX THEORY Problem Set 4 MATH 5524 MATRIX THEORY Problem Set 4 Posted Tuesday 28 March 217. Due Tuesday 4 April 217. [Corrected 3 April 217.] [Late work is due on Wednesday 5 April.] Complete any four problems, 25 points each.

More information

CONTENTS. 2 CLASSICAL DESCRIPTION 2.1 The resonance phenomenon 2.2 The vector picture for pulse EPR experiments 2.3 Relaxation and the Bloch equations

CONTENTS. 2 CLASSICAL DESCRIPTION 2.1 The resonance phenomenon 2.2 The vector picture for pulse EPR experiments 2.3 Relaxation and the Bloch equations CONTENTS Preface Acknowledgements Symbols Abbreviations 1 INTRODUCTION 1.1 Scope of pulse EPR 1.2 A short history of pulse EPR 1.3 Examples of Applications 2 CLASSICAL DESCRIPTION 2.1 The resonance phenomenon

More information

arxiv: v1 [quant-ph] 28 Mar 2012

arxiv: v1 [quant-ph] 28 Mar 2012 PROGRESS IN COMPENSATING PULSE SEQUENCES FOR QUANTUM COMPUTATION J. TRUE MERRILL 1 AND KENNETH R. BROWN June 19, 2018 arxiv:1203.6392v1 [quant-ph] 28 Mar 2012 Schools of Chemistry and Biochemistry; Computational

More information

Quantum Mechanics for Mathematicians: Energy, Momentum, and the Quantum Free Particle

Quantum Mechanics for Mathematicians: Energy, Momentum, and the Quantum Free Particle Quantum Mechanics for Mathematicians: Energy, Momentum, and the Quantum Free Particle Peter Woit Department of Mathematics, Columbia University woit@math.columbia.edu November 28, 2012 We ll now turn to

More information

2 The Density Operator

2 The Density Operator In this chapter we introduce the density operator, which provides an alternative way to describe the state of a quantum mechanical system. So far we have only dealt with situations where the state of a

More information

Math Ordinary Differential Equations

Math Ordinary Differential Equations Math 411 - Ordinary Differential Equations Review Notes - 1 1 - Basic Theory A first order ordinary differential equation has the form x = f(t, x) (11) Here x = dx/dt Given an initial data x(t 0 ) = x

More information

Group representation theory and quantum physics

Group representation theory and quantum physics Group representation theory and quantum physics Olivier Pfister April 29, 2003 Abstract This is a basic tutorial on the use of group representation theory in quantum physics, in particular for such systems

More information

Structured Krylov Subspace Methods for Eigenproblems with Spectral Symmetries

Structured Krylov Subspace Methods for Eigenproblems with Spectral Symmetries Structured Krylov Subspace Methods for Eigenproblems with Spectral Symmetries Fakultät für Mathematik TU Chemnitz, Germany Peter Benner benner@mathematik.tu-chemnitz.de joint work with Heike Faßbender

More information

1 The postulates of quantum mechanics

1 The postulates of quantum mechanics 1 The postulates of quantum mechanics The postulates of quantum mechanics were derived after a long process of trial and error. These postulates provide a connection between the physical world and the

More information

Time-dependent DMRG:

Time-dependent DMRG: The time-dependent DMRG and its applications Adrian Feiguin Time-dependent DMRG: ^ ^ ih Ψ( t) = 0 t t [ H ( t) E ] Ψ( )... In a truncated basis: t=3 τ t=4 τ t=5τ t=2 τ t= τ t=0 Hilbert space S.R.White

More information

Upper triangular forms for some classes of infinite dimensional operators

Upper triangular forms for some classes of infinite dimensional operators Upper triangular forms for some classes of infinite dimensional operators Ken Dykema, 1 Fedor Sukochev, 2 Dmitriy Zanin 2 1 Department of Mathematics Texas A&M University College Station, TX, USA. 2 School

More information

Positive Hamiltonians can give purely exponential decay

Positive Hamiltonians can give purely exponential decay Positive Hamiltonians can give purely exponential decay Paolo Facchi Università di Bari & INFN Italy Joint work with Daniel Burgarth, Aberystwyth University Policeta - San Rufo 26 June 2018 Exponential

More information

-state problems and an application to the free particle

-state problems and an application to the free particle -state problems and an application to the free particle Sourendu Gupta TIFR, Mumbai, India Quantum Mechanics 1 2013 3 September, 2013 Outline 1 Outline 2 The Hilbert space 3 A free particle 4 Keywords

More information

1 Infinite-Dimensional Vector Spaces

1 Infinite-Dimensional Vector Spaces Theoretical Physics Notes 4: Linear Operators In this installment of the notes, we move from linear operators in a finitedimensional vector space (which can be represented as matrices) to linear operators

More information

2.1 Green Functions in Quantum Mechanics

2.1 Green Functions in Quantum Mechanics Chapter 2 Green Functions and Observables 2.1 Green Functions in Quantum Mechanics We will be interested in studying the properties of the ground state of a quantum mechanical many particle system. We

More information

Linear Algebra II Lecture 22

Linear Algebra II Lecture 22 Linear Algebra II Lecture 22 Xi Chen University of Alberta March 4, 24 Outline Characteristic Polynomial, Eigenvalue, Eigenvector and Eigenvalue, Eigenvector and Let T : V V be a linear endomorphism. We

More information

Page 684. Lecture 40: Coordinate Transformations: Time Transformations Date Revised: 2009/02/02 Date Given: 2009/02/02

Page 684. Lecture 40: Coordinate Transformations: Time Transformations Date Revised: 2009/02/02 Date Given: 2009/02/02 Page 684 Lecture 40: Coordinate Transformations: Time Transformations Date Revised: 2009/02/02 Date Given: 2009/02/02 Time Transformations Section 12.5 Symmetries: Time Transformations Page 685 Time Translation

More information

Lecture Notes 2: Review of Quantum Mechanics

Lecture Notes 2: Review of Quantum Mechanics Quantum Field Theory for Leg Spinners 18/10/10 Lecture Notes 2: Review of Quantum Mechanics Lecturer: Prakash Panangaden Scribe: Jakub Závodný This lecture will briefly review some of the basic concepts

More information

Spectrum (functional analysis) - Wikipedia, the free encyclopedia

Spectrum (functional analysis) - Wikipedia, the free encyclopedia 1 of 6 18/03/2013 19:45 Spectrum (functional analysis) From Wikipedia, the free encyclopedia In functional analysis, the concept of the spectrum of a bounded operator is a generalisation of the concept

More information

Consider a system of n ODEs. parameter t, periodic with period T, Let Φ t to be the fundamental matrix of this system, satisfying the following:

Consider a system of n ODEs. parameter t, periodic with period T, Let Φ t to be the fundamental matrix of this system, satisfying the following: Consider a system of n ODEs d ψ t = A t ψ t, dt ψ: R M n 1 C where A: R M n n C is a continuous, (n n) matrix-valued function of real parameter t, periodic with period T, t R k Z A t + kt = A t. Let Φ

More information

5.4 Given the basis e 1, e 2 write the matrices that represent the unitary transformations corresponding to the following changes of basis:

5.4 Given the basis e 1, e 2 write the matrices that represent the unitary transformations corresponding to the following changes of basis: 5 Representations 5.3 Given a three-dimensional Hilbert space, consider the two observables ξ and η that, with respect to the basis 1, 2, 3, arerepresentedby the matrices: ξ ξ 1 0 0 0 ξ 1 0 0 0 ξ 3, ξ

More information

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Classical Iterations We have a problem, We assume that the matrix comes from a discretization of a PDE. The best and most popular model problem is, The matrix will be as large

More information

Exponential integrators and functions of the matrix exponential

Exponential integrators and functions of the matrix exponential Exponential integrators and functions of the matrix exponential Paul Matthews, Stephen Cox, Hala Ashi and Linda Cummings School of Mathematical Sciences, University of Nottingham, UK Introduction to exponential

More information

Automorphic Equivalence Within Gapped Phases

Automorphic Equivalence Within Gapped Phases 1 Harvard University May 18, 2011 Automorphic Equivalence Within Gapped Phases Robert Sims University of Arizona based on joint work with Sven Bachmann, Spyridon Michalakis, and Bruno Nachtergaele 2 Outline:

More information

ACM 104. Homework Set 5 Solutions. February 21, 2001

ACM 104. Homework Set 5 Solutions. February 21, 2001 ACM 04 Homework Set 5 Solutions February, 00 Franklin Chapter 4, Problem 4, page 0 Let A be an n n non-hermitian matrix Suppose that A has distinct eigenvalues λ,, λ n Show that A has the eigenvalues λ,,

More information

Favourable time integration methods for. Non-autonomous evolution equations

Favourable time integration methods for. Non-autonomous evolution equations Favourable time integration methods for non-autonomous evolution equations International Conference on Scientific Computation and Differential Equations (SciCADE) Session on Numerical integration of non-autonomous

More information

Newton s Method and Localization

Newton s Method and Localization Newton s Method and Localization Workshop on Analytical Aspects of Mathematical Physics John Imbrie May 30, 2013 Overview Diagonalizing the Hamiltonian is a goal in quantum theory. I would like to discuss

More information

Numerical Methods I Eigenvalue Problems

Numerical Methods I Eigenvalue Problems Numerical Methods I Eigenvalue Problems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 October 2nd, 2014 A. Donev (Courant Institute) Lecture

More information

Lecture 1: The Equilibrium Green Function Method

Lecture 1: The Equilibrium Green Function Method Lecture 1: The Equilibrium Green Function Method Mark Jarrell April 27, 2011 Contents 1 Why Green functions? 2 2 Different types of Green functions 4 2.1 Retarded, advanced, time ordered and Matsubara

More information

Math 3191 Applied Linear Algebra

Math 3191 Applied Linear Algebra Math 9 Applied Linear Algebra Lecture 9: Diagonalization Stephen Billups University of Colorado at Denver Math 9Applied Linear Algebra p./9 Section. Diagonalization The goal here is to develop a useful

More information

3.5 Finite Rotations in 3D Euclidean Space and Angular Momentum in QM

3.5 Finite Rotations in 3D Euclidean Space and Angular Momentum in QM 3.5 Finite Rotations in 3D Euclidean Space and Angular Momentum in QM An active rotation in 3D position space is defined as the rotation of a vector about some point in a fixed coordinate system (a passive

More information

Likewise, any operator, including the most generic Hamiltonian, can be written in this basis as H11 H

Likewise, any operator, including the most generic Hamiltonian, can be written in this basis as H11 H Finite Dimensional systems/ilbert space Finite dimensional systems form an important sub-class of degrees of freedom in the physical world To begin with, they describe angular momenta with fixed modulus

More information

MATH 581D FINAL EXAM Autumn December 12, 2016

MATH 581D FINAL EXAM Autumn December 12, 2016 MATH 58D FINAL EXAM Autumn 206 December 2, 206 NAME: SIGNATURE: Instructions: there are 6 problems on the final. Aim for solving 4 problems, but do as much as you can. Partial credit will be given on all

More information

Linear Algebra - Part II

Linear Algebra - Part II Linear Algebra - Part II Projection, Eigendecomposition, SVD (Adapted from Sargur Srihari s slides) Brief Review from Part 1 Symmetric Matrix: A = A T Orthogonal Matrix: A T A = AA T = I and A 1 = A T

More information

Krylov Subspace Methods for the Evaluation of Matrix Functions. Applications and Algorithms

Krylov Subspace Methods for the Evaluation of Matrix Functions. Applications and Algorithms Krylov Subspace Methods for the Evaluation of Matrix Functions. Applications and Algorithms 2. First Results and Algorithms Michael Eiermann Institut für Numerische Mathematik und Optimierung Technische

More information

Calculus C (ordinary differential equations)

Calculus C (ordinary differential equations) Calculus C (ordinary differential equations) Lesson 9: Matrix exponential of a symmetric matrix Coefficient matrices with a full set of eigenvectors Solving linear ODE s by power series Solutions to linear

More information

Linear Solvers. Andrew Hazel

Linear Solvers. Andrew Hazel Linear Solvers Andrew Hazel Introduction Thus far we have talked about the formulation and discretisation of physical problems...... and stopped when we got to a discrete linear system of equations. Introduction

More information

Nonlinear Eigenvalue Problems: Theory and Applications

Nonlinear Eigenvalue Problems: Theory and Applications Nonlinear Eigenvalue Problems: Theory and Applications David Bindel 1 Department of Computer Science Cornell University 12 January 217 1 Joint work with Amanda Hood Berkeley 1 / 37 The Computational Science

More information

Identification Methods for Structural Systems

Identification Methods for Structural Systems Prof. Dr. Eleni Chatzi System Stability Fundamentals Overview System Stability Assume given a dynamic system with input u(t) and output x(t). The stability property of a dynamic system can be defined from

More information

Applied Linear Algebra

Applied Linear Algebra Applied Linear Algebra Peter J. Olver School of Mathematics University of Minnesota Minneapolis, MN 55455 olver@math.umn.edu http://www.math.umn.edu/ olver Chehrzad Shakiban Department of Mathematics University

More information

Math 108b: Notes on the Spectral Theorem

Math 108b: Notes on the Spectral Theorem Math 108b: Notes on the Spectral Theorem From section 6.3, we know that every linear operator T on a finite dimensional inner product space V has an adjoint. (T is defined as the unique linear operator

More information

Diagonalizing Hermitian Matrices of Continuous Functions

Diagonalizing Hermitian Matrices of Continuous Functions Int. J. Contemp. Math. Sciences, Vol. 8, 2013, no. 5, 227-234 HIKARI Ltd, www.m-hikari.com Diagonalizing Hermitian Matrices of Continuous Functions Justin Cyr 1, Jason Ekstrand, Nathan Meyers 2, Crystal

More information

The following definition is fundamental.

The following definition is fundamental. 1. Some Basics from Linear Algebra With these notes, I will try and clarify certain topics that I only quickly mention in class. First and foremost, I will assume that you are familiar with many basic

More information

1 Mathematical preliminaries

1 Mathematical preliminaries 1 Mathematical preliminaries The mathematical language of quantum mechanics is that of vector spaces and linear algebra. In this preliminary section, we will collect the various definitions and mathematical

More information

Lecture 2: Linear operators

Lecture 2: Linear operators Lecture 2: Linear operators Rajat Mittal IIT Kanpur The mathematical formulation of Quantum computing requires vector spaces and linear operators So, we need to be comfortable with linear algebra to study

More information

The Two Level Atom. E e. E g. { } + r. H A { e e # g g. cos"t{ e g + g e } " = q e r g

The Two Level Atom. E e. E g. { } + r. H A { e e # g g. cost{ e g + g e }  = q e r g E e = h" 0 The Two Level Atom h" e h" h" 0 E g = " h# 0 g H A = h" 0 { e e # g g } r " = q e r g { } + r $ E r cos"t{ e g + g e } The Two Level Atom E e = µ bb 0 h" h" " r B = B 0ˆ z r B = B " cos#t x

More information