Semi-Classical Dynamics Using Hagedorn Wavepackets

Size: px
Start display at page:

Download "Semi-Classical Dynamics Using Hagedorn Wavepackets"

Transcription

1 Semi-Classical Dynamics Using Hagedorn Wavepackets Leila Taghizadeh June 6, 2013 Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

2 Outline 1 The Schrödinger Equation in Semi-Classical Scaling 2 Hagedorn Wavepackets 3 A Numerical Integrator for Hagedorn Wavepackets 4 Conclusion Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

3 Section 1: The Schrödinger Equation in the Semi-Classical Scaling Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

4 The Schrödinger Equation... Consider the time-dependent Schrödinger equation in the semi-classical scaling: ıε ψ t = Hψ, (1) where ψ = ψ(x, t) is the wave function depending on the spatial variable x = (x 1,..., x N ) and time t 0. Here, ε is a small positive number representing the scaled Planck constant and ı is the imaginary unit. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

5 The Schrödinger Equation... The Hamiltonian operator H depends on ε and it is composed of two parts, the kinetic operator T and the potential operator V. Thus we can split H as H = T + V with the following definitions for both operators: T := ε2 2m 2 = j=1 V := V(x), N ε 2 2 2m j x 2, where m j 0 is a particle mass and the real-valued potential V acts as a multiplication operator on ψ. j Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

6 The Schrödinger Equation... Example: In quantum molecular dynamics, equation (1) is a Schrödinger equation for the nuclei on an electronic energy surface. electronic energy surface is a particular eigenvalue of the electronic structure problem which appears as a potential in the time-dependent Schrödinger equation for the nuclei. Here ε 2 is the mass ratio between electrons and nuclei, of magnitude Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

7 The Schrödinger Equation... Numerical approaches to solving equation (1) face two principal difficulties: 1- Highly oscillatory solutions: Typical solutions are wavepackets of width ε, oscillatory with wavelength ε, with the envelope moving at velocity 1. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

8 The Schrödinger Equation... Numerical approaches to solving equation (1) face two principal difficulties: 1- Highly oscillatory solutions: Typical solutions are wavepackets of width ε, oscillatory with wavelength ε, with the envelope moving at velocity High dimension: For n particles, the spatial dimension in (1) is N = 3n. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

9 The Schrödinger Equation... Because of the highly oscillatory solution behavior, grid-based methods need very fine resolution for small ε and hence become computationally expensive or infeasible. This also precludes the approximation of the wave function on sparse grids in higher dimensions, because the necessary smoothness requirements for this technique are not met for small ε. The model reduction from full quantum dynamics to Gaussian wavepacket dynamics allows for computationally efficient algorithms, but is often not accurate enough. The Gaussian wavepackets are written as: ) ( ı ψ(x, t) = exp ε (1 2 (x q(t))t C(t)(x q(t))+p(t)(x q(t))+ζ(t)), where C(t) is a complex symmetric matrix and ζ(t) C is a phase and normalization parameter. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

10 The Schrödinger Equation... Hagedorn constructed parameter-dependent L 2 -orthonormal basis functions and presented Hagedorn s wavepackets. In 2009, Lubich et. al. turned the Hagedorn functions into a computational tool for the numerical solution of (1). The main goal of this talk is to explain Lubich s approach of numerical solution of equation (1) using Hagedorn s wavepackets. We focus on the conceptual and algorithmic aspects of the approach. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

11 Section 2: Hagedorn Wavepackets Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

12 Hagedorn Parametrization of Gaussian Wavepackets In this section, we review Hagedorn s parametrization of Gaussian wave packets and his parameter-dependent orthonormal basis functions. In Hagedorn s approach, a Gaussian wavepacket is parameterized as: ϕ ε 0 [q, p, Q, P](x) = (πε) N 4(det Q) 1 2 exp [ ı 2ε (x q)t PQ 1 (x q)+ ı ε pt (x q) ], (2) where q R N and p R N represent the position and momentum, respectively, and Q and P are complex N N matrices satisfying the relations Q T P P T Q = 0, (3) which we call them symplecticity relations. Q P P Q = 2 ıi. (4) Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

13 Hagedorn Parametrization of Gaussian Wavepackets Here, Q T denotes the transpose of Q, and Q is the transpose and complex conjugate matrix. Relations (3) and (4) imply that both Q and P are invertible. Lemma Let Q and P be complex N N matrices that satisfy the relations (3) and (4). Then, Q and P are invertible, and C = PQ 1 is complex symmetric with the positive definite imaginary part Im C = (QQ ) 1. (5) Conversely, every complex symmetric matrix C with positive definite imaginary part can be written as C = PQ 1 with matrices Q and P satisfying the relations (3) and (4). Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

14 Hagedorn Parametrization of Gaussian Wavepackets Proof. Multiplying the equation (4) from the left and right with the vectors v C N and v C N, respectively yields (Qv) (Pv) (Pv) (Qv) = 2 ı v 2, which shows that v = 0 is the only vector in the null-space of Q or P. Hence, these matrices are invertible. Because, if there is v 0 that is in the null-space of P and Q, so we have Pv = 0 and Qv = 0, respectively. This is a contradiction! Multiplying the equation (3) from the left with (Q 1 ) T and from the right with Q 1 gives PQ 1 (Q 1 ) T P T = 0 and thus shows that PQ 1 = (PQ 1 ) T. So, C = PQ 1 is complex symmetric. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

15 Hagedorn Parametrization of Gaussian Wavepackets Furthermore, we have (Im C)(QQ ) = 1 2 ı (PQ 1 (Q 1 ) P )QQ = 1 2 ı (PQ (Q ) 1 (P Q)Q ) = 1 2 ı (PQ (Q ) 1 (Q P 2 ıi)q ) = 1 2 ı PQ 1 2 ı (Q ) 1 Q PQ ı (Q ) 1 (2 ıi)q = 1 2 ı PQ 1 2 ı PQ + I = I. = (Im C) = (QQ ) 1. where we use the equation (4) for substituting P Q = Q P 2 ıi. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

16 Hagedorn Parametrization of Gaussian Wavepackets Conversely, for a complex symmetric matrix C with positive definite imaginary part we set Q = (Im C) 1/2 and P = CQ. It is easily verified that these matrices satisfy the relations (3) and (4): and Q T P P T Q = [(ImC) 1/2 ] T [C][(ImC) 1/2 ] [(ImC) 1/2 ] T [C] T [(ImC) 1/2 ] = 0 Q P P Q = [(ImC) 1/2 ] [C][(ImC) 1/2 ] [(ImC) 1/2 ] [C] [(ImC) 1/2 = 2 ıim([(imc) 1/2 ] [C][(ImC) 1/2 ]) = 2 ı[(imc) 1/2 ] [ImC][(ImC) 1/2 ] = 2 ı[(imc) 1/2 ] [(ImC) 1/2 ] = 2 ı[(imc) ] 1/2 [(ImC) 1/2 ] = 2 ıi. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

17 Relationship with Symplectic Matrices Definition A real matrix Y R 2N 2N is symplectic if it satisfies the relation ( ) Y T 0 I JY = J with J =. (6) I 0 Note that the relations (3) and (4) are equivalent to stating that the matrix ( ) Re Q Im Q Y = Re P Im P is symplectic. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

18 Gaussian Wavepackets and Quadratic Hamiltonians Gaussian wavepackets with appropriately evolving parameters are exact solutions to the time-dependent Schrödinger equation (1) in the case of a quadratic potential V. It turns out that the equations of motion assume a particularly appealing form with Hagedorn s parametrization. Consider the classical equations of motion associated with (1), q = p m, ṗ = V(q). (7) Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

19 Gaussian Wavepackets and Quadratic Hamiltonians Also, consider their linearization along (q(t), p(t)), Q = P m, Ṗ = 2 V(q)Q, (8) and the classical action integral S(t) = t 0 ( p(s) 2 2m ) V(q(s)) ds. (9) Then, there is the following result for Gaussian Wavepackets in a Quadratic Potential due to Hagedorn 1980: Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

20 Gaussian Wavepackets in a Quadratic Potential Theorem Let V be a quadratic potential, and let (q(t), p(t), Q(t), P(t)) for 0 t t be a solution of the classical equations (7) and (8) and S(t) the corresponding action (9). Assume that Q(0) and P(0) satisfy the symplecticity relations. Then, Q(t) and P(t) satisfy the symplecticity relations for all times t, and ψ(x, t) = e ıs(t) ε ϕ ε 0 [q(t), p(t), Q(t), P(t)](x) (10) is a solution of the time-dependent Schrödinger equation (1). Proof. The fact that symplecticity relations are preserved under (8), is a consequence of the next lemma below. A direct, lengthy calculation shows that (10) is a solution of the Schrödinger equation (1). Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

21 Gaussian Wavepackets in a Quadratic Potential Lemma Suppose that Q(t), P(t) C N N satisfy the differential equations Q(t) = F(t)P(t) Ṗ(t) = G(t)Q(t) with real symmetric matrices F(t) and G(t). If the symplecticity relations hold at t = 0, then they hold for all t. Proof. We have d dt (QT P P T Q) = Q T P + Q T Ṗ ṖT Q P T Q = (FP) T P + Q T GQ (GQ) T Q P T FP = P T F T P + Q T GQ Q T G T Q P T FP = P T FP + Q T GQ Q T GQ P T FP = 0. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

22 Gaussian Wavepackets in a Quadratic Potential Thus, We have Q T P P T Q = C = Q T P P T Q = 0. d dt (Q P P Q) = Q P + Q Ṗ Ṗ Q P Q = P FP + Q GQ Q GQ P FP = 0 and consequently, Q P P Q = C, then Q P P Q = 2 ıi. Because (Q P P Q)(0) = 2 ıi. We proved that if the symplecticity relations hold at t = 0, then they hold for all t. We set F = 1 m and G = 2 V(q) to complete the proof. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

23 Ladder Operators In this section, we introduce the ladder operators to construct the Hagedorn functions. An analogous construction via appropriate parameter-dependent ladder operators yields the Hagedorn functions. Let ε > 0 be the small semi-classical parameter in the Schrödinger equation (1). We let q, p R N position and momentum parameters, and Q, P C N N complex matrices satisfying the symplecticity relations. We denote the position and momentum operators by ˆq = (ˆq j ) N j=1 and ˆp = (ˆp j ) N j=1, respectively. So for ψ, we have (ˆqψ)(x) = xψ(x), (ˆpψ)(x) = ıε ψ(x) (x R N ). Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

24 Ladder Operators Also, we consider the commutator relation 1 ıε [ˆq j,ˆp k ] = δ jk. (11) Hagedorn (1998) introduces the parameter-dependent lowering and raising ladder operators A = (A j ) N j=1 and A = (A j )N j=1 as A = A[q, p, Q, P] = ı 2ε (P T (ˆq q) Q T (ˆp p)) A = A [q, p, Q, P] = ı 2ε (P (ˆq q) Q (ˆp p)). (12) Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

25 Ladder Operators In this section, we state some key properties of the ladder operators as follows. Lemma If Q and P satisfy the symplecticity relations, then we have the commutator identities [A j, A k ] = δ jk. (13) Moreover, A j is adjoint to A j on the Schwartz space S: A k ϕ ψ = ϕ A jψ ϕ,ψ S. (14) Note that the Schwartz space is the function space S = {f L 2 (,+ ) ; sup x α f (β) (x) <, α,β N}. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

26 Ladder Operators Proof. With Q = (Q jk ) and P = (P jk ), we have (we let q = p = 0 for simplicity) [A j, A ı N k ] = [ (P ljˆq l Q ljˆp l ), 2ε l=1 ı N ( P mkˆq m Q mkˆp m )] 2ε m=1 ( = 1 N )( N ) (P ljˆq l Q ljˆp l ) ( P mkˆq m Q mkˆp m ) 2ε l=1 m=1 ( 1 N )( N ) ( P mkˆq m Q mkˆp m ) (P ljˆq l Q ljˆp l ) 2ε m=1 l=1 Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

27 Ladder Operators = 1 2ε N 1 2ε N m=1 l=1 l=1 m=1 = 1 2ε N l=1 m=1 N (P ljˆq l Q ljˆp l )( P mkˆq m Q mkˆp m ) N ( P mkˆq m Q mkˆp m )(P ljˆq l Q ljˆp l ) N P lj Pmk (ˆq lˆq m ˆq mˆq l )+ P mk Q lj (ˆq mˆp l ˆp lˆq m ) + Q mk P lj (ˆp mˆq l ˆq lˆp m )+Q lj Qmk (ˆp lˆp m ˆp mˆp l ) = 1 N N ( P mk Q lj Q mk P lj )( ıεδ lm ) 2ε l=1 m=1 where we use the commutator relation 1 ıε [ˆq j,ˆp k ] = δ jk. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

28 Ladder Operators This simplifies to [A j, A k ] = ı 2 N ( P lj Qlk + Q lj Plk ) = ı 2 ( Q P + P Q) k,j. l=1 By the symplecticity relations, this equals ı 2 ( 2 ıi) k,j and δ jk. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

29 Ladder Operators To verify (14), we write out A j ϕ ψ = ı d ( P ljˆq l Q ljˆp l )ϕ 2ε ψ l=1 = ϕ ı d (P ljˆq l Q ljˆp l )ψ = ϕ A j ψ, 2ε l=1 where we just use that ˆq l and ˆp l are self-adjoint operators and also we use the property of inner product ax, y = a x, y = x, ay. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

30 Hagedorn Wavepackets Lemma If Q and P satisfy the symplecticity relations, then the complex Gaussian ϕ 0 = ϕ ε 0 [q, p, Q, P] spans the null-space of A. Proof. If ϕ S is in the null-space of A, then we must have ϕ {x Ax = 0}: 0 = Aϕ = ı ) (P T (ˆq q) Q T (ˆp p) ϕ(x) 2ε = ı 2ε P T (ˆqϕ(x) qϕ(x))+ ı 2ε Q T (ˆpϕ(x) pϕ(x)) = ı 2ε P T (xϕ(x) qϕ(x))+ ı 2ε Q T ( ıε ϕ(x) pϕ(x)) = Q T ( ıε ϕ(x) pϕ(x)) P T (x q)ϕ(x) = Q T ( ıε ϕ(x) pϕ(x)) = P T (x q)ϕ(x). Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

31 Hagedorn Wavepackets So, we have ıε ϕ(x) pϕ(x) = PQ 1 (x q)ϕ(x). Then ϕ must satisfy the linear system of partial differential equations ıε ϕ(x) pϕ(x) = C(x q)ϕ(x) with the complex symmetric matrix C = PQ 1. Multiples of ϕ 0 are the only non-trivial solutions of this equation. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

32 Hagedorn Functions Hagedorn constructs a complete L 2 -orthonormal set of functions by ϕ k (x) = ϕ ε k [q, p, Q, P](x), ϕ k+ j = 1 kj + 1 A j ϕ k. (15) for multi-indices k = (k 1,..., k N ) with non-negative integers k j. And, j = e j = ( ) denotes the jth unit vector. It then turns out that these functions are orthonormal. Moreover, we have ϕ k j = 1 kj A j ϕ k. (16) Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

33 Hagedorn Functions The above relations imply since, QA + QA = 2 (ˆq q), ε QA + QA ( ) ı = Q ( P(ˆq q) Q(ˆp p)) 2ε = ı 2ε ( Q P(ˆq q) QP(ˆq q) ) = ı (ˆq q)(q P QP) 2ε 2 = (ˆq q). ε ( + Q ı ) (P(ˆq q) Q(ˆp p)) 2ε Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

34 Hagedorn Functions Multiplying (15) and (16) by Q and Q and then adding them, we have Q( k j + 1ϕ k+ j ) = (QA + QA)ϕ k Q( k j ϕ k j ), and recalling QA + QA = relation ( ) Q k j + 1ϕ k+ j (x) = 2 ε (ˆq q), we obtain the recurrence 2 ε (ˆq q)ϕ k(x) Q ( ) k j ϕ k j (x). (17) where j = e j = ( ) denotes the jth unit vector. This relation permits us to compute the functions ϕ k at any given value x. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

35 Hagedorn Functions The following theorem describes the Hagedorn functions. Theorem The functions ϕ k = ϕ ε k [q, p, Q, P] defined by ϕ ε 0 [q, p, Q, P](x) = (πε) N 4(det Q) 1 2 exp [ ı 2ε (x q)t PQ 1 (x q)+ ı ε pt (x q) ], and ϕ k+ j = 1 kj + 1 A j ϕ k. form a complete L 2 -orthonormal set of functions. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

36 Evolution of Ladder Operators Under Quadratic Hamiltonians Proof. The orthonormality of the functions ϕ k follows from their property as eigenfunctions of the symmetric operator AA. The completeness is obtained by an extension of the arguments in the proof of completeness of the Hermite functions. Along a solution (q(t), p(t), Q(t), P(t)) of the classical equations of motion, we consider the time-dependent operators A j (t) = A j [q(t), p(t), Q(t), P(t)] and A j (t) = A j [q(t), p(t), Q(t), P(t)]. The next lemma represents the derivatives of these operators. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

37 Evolution of Ladder Operators Under Quadratic Hamiltonians Lemma In the case of a quadratic potential V : ψ(x) x 2 ψ(x), we have Ȧ j = 1 ıε [A j, H] and Ȧ j = 1 ıε [A j, H]. Proof. With classical equations of motion (7) and (8), we obtain for A(t) = (A j (t)) Ȧ = 1 ıε (QT V(ˆq)+ 1 m PTˆp). The same expression is obtained for 1 ıε [A, H] on using the commutator relations 1 ıε [ˆq j,ˆp k ] = δ jk and the ensuing 1 ıε [ˆq j,ˆp k 2] = δ jk 2ˆp k and 1 ıε [ˆq2 j,ˆp k ] = δ jk 2ˆq j. The result for A is obtained by taking complex conjugates. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

38 Hagedorn Functions in a Quadratic Potential We now have all ingredients for the following remarkable result due to Hagedorn, Theorem Let V be a quadratic potential, and let (q(t), p(t), Q(t), P(t)) be a solution of the classical equations of motion (7) and (8), and S(t) the corresponding action (9). Assume that Q(0) and P(0) satisfy the symplecticity relations. Then, for every multi-index k, ψ(x, t) = e ıs(t) ε ϕ ε k [q(t), p(t), Q(t), P(t)](x) is a solution of the time-dependent Schrödinger equation (1). Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

39 Hagedorn Functions in a Quadratic Potential Proof. We know from (10) in the previous theorem, that the statement is correct for k = 0. In view of the construction of the functions ϕ k by ϕ k+ j = 1 kj +1 A j ϕ k, the result follows by induction if we can show that with a solution ψ(., t), also A jψ(., t) is a solution of the Schrödinger equation (1). ψ(., t) is a solution of the Schrödinger equation (1). Thus ıε t ψ = Hψ. Also, we have [A j, H]ψ = A j Hψ HA jψ. So, ıε t (A j ψ) = ıεȧ j ψ + A j Hψ = ( ıεȧ j ψ +[A j, H]ψ)+HA j ψ = HA j ψ. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

40 Approximation Solutions to the Schrödinger equation We will approximate solutions to the Schrödinger equation (1) in the form ψ(x, t) ψ K (x, t) = e ıs(t) ε with a finite multi-index set K. c k (t)ϕ k (x, t) (18) k K In the following section, we give a fully discrete, explicit, and time-reversible timestepping algorithm to propagate the Gaussian parameters q(t), p(t), Q(t), P(t), the phase S(t), and the coefficients c k (t) of a Hagedorn wavepacket (18). Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

41 Section 3: A Numerical Integrator for Hagedorn Wavepackets Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

42 A Splitting Method for Time Integration We describe an algorithm by Faou, Gradinaru and Lubich (2008) for the approximate solution of the time-dependent Schrödinger equation (1) ıε ψ = Hψ t with the Hamiltonian H = T + V, in the semi-classical regime using Hagedorn wave packets. The method is based on the splitting between the kinetic operator and potential operator T = ε2 2m 2 V = V(x). Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

43 A Splitting Method for Time Integration We consider the free linear Schrödinger equation ıε ψ t and the equation with only a potential = ε2 2m 2 ψ (19) ıε ψ t = V(x)ψ. (20) The potential will be further decomposed into its quadratic part at the current position q and the non-quadratic remainder. So we have H = T + U q(t) + W q(t). Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

44 A Splitting Method for Time Integration We now describe the three main ingredients in the time-stepping algorithm. Starting with a Hagedorn wavepacket (18) as initial data for the Schrödinger equation, we make use of the following: 1- We can solve exactly the free linear Schrödinger equation (19), with the wave function remaining in the Hagedorn wavepacket form (18) with unaltered coefficients c k. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

45 A Splitting Method for Time Integration We now describe the three main ingredients in the time-stepping algorithm. Starting with a Hagedorn wavepacket (18) as initial data for the Schrödinger equation, we make use of the following: 1- We can solve exactly the free linear Schrödinger equation (19), with the wave function remaining in the Hagedorn wavepacket form (18) with unaltered coefficients c k. 2- For a quadratic potential, we can solve exactly the potential equation (20) with the wave function remaining in the Hagedorn wavepacket form (18) with the same coefficients c k. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

46 A Splitting Method for Time Integration We now describe the three main ingredients in the time-stepping algorithm. Starting with a Hagedorn wavepacket (18) as initial data for the Schrödinger equation, we make use of the following: 1- We can solve exactly the free linear Schrödinger equation (19), with the wave function remaining in the Hagedorn wavepacket form (18) with unaltered coefficients c k. 2- For a quadratic potential, we can solve exactly the potential equation (20) with the wave function remaining in the Hagedorn wavepacket form (18) with the same coefficients c k. 3- For an arbitrary potential, we can compute the Galerkin approximation of the potential equation (20) on the linear space spanned by the functions ϕ k with fixed parameters q, p, Q, P, letting the coefficients c k in the formulation (18) vary. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

47 Kinetic Part and Quadratic Potential We will use the following propositions, which are direct consequences of the previous Theorem. Theorem A time-dependent Hagedorn wavepackets (18) solves the free linear Schrödinger equation (19) if q(t) = q(0)+ t m p(0), Q(t) = Q(0)+ t m P(0), (21) S(t) = S(0)+ t 2m p(0) 2, and p(t) = p(0), P(t) = P(0), c k (t) = c k (0). Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

48 Kinetic Part and Quadratic Potential Theorem Let U(x) be a quadratic potential. A time-dependent Hagedorn wavepackets (18) solves the potential equation (20) with V = U if p(t) = p(0) t U(q(0)), P(t) = P(0) t 2 U(q(0))Q(0), (22) S(t) = S(0) tu(q(0)), and q(t) = q(0), Q(t) = Q(0), c k (t) = c k (0). Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

49 The Practical Time-Stepping Algorithm We now give a full algorithmic description. Assume that the stepsize t is given, and let the real N-vectors q n, p n, the complex N N matrices Q n, P n, the real scalar S n, and the complex coefficient vector c n = (c n k ) k K be such that ψ n = e ısn ε ck n ϕε k [qn, p n, Q n, P n ] k K is an approximation to the solution of the Schrödinger equation at time t n = n t. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

50 The Practical Time-Stepping Algorithm To compute the approximation ψ n+1 at time t n+1 = t n + t we proceed as follows: Half-step of the kinetic part: 1. Compute q n+1/2, Q n+1/2, and S n+1/2, : q n+1/2 = q n + t 2m pn, Q n+1/2 = Q n + t 2m Pn, (23) S n+1/2, = S n + t 4m pn 2. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

51 The Practical Time-Stepping Algorithm Full step of the potential part: 2. Compute p n+1, P n+1, and S n+1/2,+ : p n+1 = p n t V(q n+1/2 ), P n+1 = P n t 2 V(q n+1/2 )Q n+1/2, (24) S n+1/2,+ = S n+1/2, tv(q n+1/2 ). Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

52 The Practical Time-Stepping Algorithm Half-step of the kinetic part: 3. Compute q n+1, Q n+1, and S n+1 : q n+1 = q n+1/2 + t 2m pn+1, Q n+1 = Q n+1/2 + t 2m Pn+1, (25) S n+1 = S n+1/2,+ + t 4m pn+1 2. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

53 Numerical Results Example: Let s consider the time-dependent Schrödinger equation on R 2 and the modified Henon-Heiles potential V(x) = 1 2 (x x 2 2 )2 + 2x 1 x x 3 1. As initial value we take the normalized Gaussian wavepacket in Hagedorn s parametrization with the identity matrix Q 0 = I and P 0 = ıi, localized around q 0 = ( 0.1, 0) T and with p 0 = (0, 0.1) T. We apply the numerical method with the stepsize t = 0.1 and coefficients c k for k = (k 1, k 2 ) such that (1+k 1 )(1+k 2 ) 8 and 20 basis functions. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

54 Comparison with the Fourier method Error vs. time in a 2D example (Henon-Heiles) Hagedorn with 20 basis functions at the left, Fourier with 2 20 basis functions at the right. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

55 Error Behaviour Maximum error vs. number of basis functions at t = 1, t = 5. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

56 Conclusion Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

57 Conclusion We considered the approximation of multi-particle quantum dynamics in the semiclassical regime by Hagedorn wavepackets, which are products of complex Gaussians with polynomials that form an orthonormal L 2 basis and preserve their type under propagation in Schrödinger equations with quadratic potentials. We built a time-reversible, fully explicit time-stepping algorithm to approximate the solution of the Hagedorn wavepacket dynamics. The algorithm is based on a splitting of the Hamiltonian operator into the kinetic and potential parts, as well as on a splitting of the potential into its local quadratic approximation and the remainder. The algorithm preserves the symplecticity relations and the L 2 norm of the wavepackets. Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

58 References C. Lubich, From quantum to classical molecular dynamics: reduced models and numerical analysis, EMS, Zürich, E. Faou, V. Gradinaru, C. Lubich, Computing semi-classical quantum dynamics with Hagedorn wavepackets, SIAM J. Sci. Comp. 31 (2009), G. A. Hagedorn, Raising and lowering operators for semi-classical wavepackets, Ann. Physics 269 (1998), Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

59 Thank you for your attention... Leila Taghizadeh () Semi-Classical Dynamics Using Hagedorn Wavepackets June 6, / 56

Reduced models and numerical analysis in molecular quantum dynamics I. Variational approximation

Reduced models and numerical analysis in molecular quantum dynamics I. Variational approximation Reduced models and numerical analysis in molecular quantum dynamics I. Variational approximation Christian Lubich Univ. Tübingen Bressanone/Brixen, 14 February 2011 Computational challenges and buzzwords

More information

A Time Splitting for the Semiclassical Schrödinger Equation

A Time Splitting for the Semiclassical Schrödinger Equation A Time Splitting for the Semiclassical Schrödinger Equation V. Gradinaru Seminar for Applied Mathematics, ETH Zürich, CH 809, Zürich, Switzerland vasile.gradinaru@sam.math.ethz.ch and G. A. Hagedorn Department

More information

A Minimal Uncertainty Product for One Dimensional Semiclassical Wave Packets

A Minimal Uncertainty Product for One Dimensional Semiclassical Wave Packets A Minimal Uncertainty Product for One Dimensional Semiclassical Wave Packets George A. Hagedorn Happy 60 th birthday, Mr. Fritz! Abstract. Although real, normalized Gaussian wave packets minimize the product

More information

Non Adiabatic Transitions near Avoided Crossings: Theory and Numerics

Non Adiabatic Transitions near Avoided Crossings: Theory and Numerics Non Adiabatic Transitions near Avoided Crossings: Theory and Numerics Raoul Bourquin a, Vasile Gradinaru a, George A. Hagedorn b April 8, 2011 Abstract We present a review of rigorous mathematical results

More information

We do not derive F = ma; we conclude F = ma by induction from. a large series of observations. We use it as long as its predictions agree

We do not derive F = ma; we conclude F = ma by induction from. a large series of observations. We use it as long as its predictions agree THE SCHRÖDINGER EQUATION (A REVIEW) We do not derive F = ma; we conclude F = ma by induction from a large series of observations. We use it as long as its predictions agree with our experiments. As with

More information

Generating Function and a Rodrigues Formula for the Polynomials in d Dimensional Semiclassical Wave Packets

Generating Function and a Rodrigues Formula for the Polynomials in d Dimensional Semiclassical Wave Packets Generating Function and a Rodrigues Formula for the Polynomials in d Dimensional Semiclassical Wave Packets George A. Hagedorn Department of Mathematics and Center for Statistical Mechanics and Mathematical

More information

Simple Harmonic Oscillator

Simple Harmonic Oscillator Classical harmonic oscillator Linear force acting on a particle (Hooke s law): F =!kx From Newton s law: F = ma = m d x dt =!kx " d x dt + # x = 0, # = k / m Position and momentum solutions oscillate in

More information

The Time{Dependent Born{Oppenheimer Approximation and Non{Adiabatic Transitions

The Time{Dependent Born{Oppenheimer Approximation and Non{Adiabatic Transitions The Time{Dependent Born{Oppenheimer Approximation and Non{Adiabatic Transitions George A. Hagedorn Department of Mathematics, and Center for Statistical Mechanics, Mathematical Physics, and Theoretical

More information

Linear Algebra: Matrix Eigenvalue Problems

Linear Algebra: Matrix Eigenvalue Problems CHAPTER8 Linear Algebra: Matrix Eigenvalue Problems Chapter 8 p1 A matrix eigenvalue problem considers the vector equation (1) Ax = λx. 8.0 Linear Algebra: Matrix Eigenvalue Problems Here A is a given

More information

We start with some important background material in classical and quantum mechanics.

We start with some important background material in classical and quantum mechanics. Chapter Basics We start with some important background material in classical and quantum mechanics.. Classical mechanics Lagrangian mechanics Compared to Newtonian mechanics, Lagrangian mechanics has the

More information

Mathematical Introduction

Mathematical Introduction Chapter 1 Mathematical Introduction HW #1: 164, 165, 166, 181, 182, 183, 1811, 1812, 114 11 Linear Vector Spaces: Basics 111 Field A collection F of elements a,b etc (also called numbers or scalars) with

More information

Non Adiabatic Transitions in a Simple Born Oppenheimer Scattering System

Non Adiabatic Transitions in a Simple Born Oppenheimer Scattering System 1 Non Adiabatic Transitions in a Simple Born Oppenheimer Scattering System George A. Hagedorn Department of Mathematics and Center for Statistical Mechanics, Mathematical Physics, and Theoretical Chemistry

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

4 Quantum Mechanical Description of NMR

4 Quantum Mechanical Description of NMR 4 Quantum Mechanical Description of NMR Up to this point, we have used a semi-classical description of NMR (semi-classical, because we obtained M 0 using the fact that the magnetic dipole moment is quantized).

More information

Molecular propagation through crossings and avoided crossings of electron energy levels

Molecular propagation through crossings and avoided crossings of electron energy levels Molecular propagation through crossings and avoided crossings of electron energy levels George A. Hagedorn Department of Mathematics and Center for Statistical Mechanics and Mathematical Physics Virginia

More information

Page 404. Lecture 22: Simple Harmonic Oscillator: Energy Basis Date Given: 2008/11/19 Date Revised: 2008/11/19

Page 404. Lecture 22: Simple Harmonic Oscillator: Energy Basis Date Given: 2008/11/19 Date Revised: 2008/11/19 Page 404 Lecture : Simple Harmonic Oscillator: Energy Basis Date Given: 008/11/19 Date Revised: 008/11/19 Coordinate Basis Section 6. The One-Dimensional Simple Harmonic Oscillator: Coordinate Basis Page

More information

2. The Schrödinger equation for one-particle problems. 5. Atoms and the periodic table of chemical elements

2. The Schrödinger equation for one-particle problems. 5. Atoms and the periodic table of chemical elements 1 Historical introduction The Schrödinger equation for one-particle problems 3 Mathematical tools for quantum chemistry 4 The postulates of quantum mechanics 5 Atoms and the periodic table of chemical

More information

MP463 QUANTUM MECHANICS

MP463 QUANTUM MECHANICS MP463 QUANTUM MECHANICS Introduction Quantum theory of angular momentum Quantum theory of a particle in a central potential - Hydrogen atom - Three-dimensional isotropic harmonic oscillator (a model of

More information

MATH 205C: STATIONARY PHASE LEMMA

MATH 205C: STATIONARY PHASE LEMMA MATH 205C: STATIONARY PHASE LEMMA For ω, consider an integral of the form I(ω) = e iωf(x) u(x) dx, where u Cc (R n ) complex valued, with support in a compact set K, and f C (R n ) real valued. Thus, I(ω)

More information

THE SIEGEL UPPER HALF SPACE IS A MARSDEN WEINSTEIN QUOTIENT: SYMPLECTIC REDUCTION AND GAUSSIAN WAVE PACKETS

THE SIEGEL UPPER HALF SPACE IS A MARSDEN WEINSTEIN QUOTIENT: SYMPLECTIC REDUCTION AND GAUSSIAN WAVE PACKETS THE SIEGEL UPPER HALF SPACE IS A MARSDEN WEINSTEIN QUOTIENT: SYMPLECTIC REDUCTION AND GAUSSIAN WAVE PACKETS TOMOKI OHSAWA Abstract. We show that the Siegel upper half space Σ d is identified with the Marsden

More information

Under evolution for a small time δt the area A(t) = q p evolves into an area

Under evolution for a small time δt the area A(t) = q p evolves into an area Physics 106a, Caltech 6 November, 2018 Lecture 11: Hamiltonian Mechanics II Towards statistical mechanics Phase space volumes are conserved by Hamiltonian dynamics We can use many nearby initial conditions

More information

PHY 407 QUANTUM MECHANICS Fall 05 Problem set 1 Due Sep

PHY 407 QUANTUM MECHANICS Fall 05 Problem set 1 Due Sep Problem set 1 Due Sep 15 2005 1. Let V be the set of all complex valued functions of a real variable θ, that are periodic with period 2π. That is u(θ + 2π) = u(θ), for all u V. (1) (i) Show that this V

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

Variational Principles for Nonlinear Eigenvalue Problems

Variational Principles for Nonlinear Eigenvalue Problems Variational Principles for Nonlinear Eigenvalue Problems Heinrich Voss voss@tuhh.de Hamburg University of Technology Institute of Mathematics TUHH Heinrich Voss Variational Principles for Nonlinear EVPs

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

A linear algebra proof of the fundamental theorem of algebra

A linear algebra proof of the fundamental theorem of algebra A linear algebra proof of the fundamental theorem of algebra Andrés E. Caicedo May 18, 2010 Abstract We present a recent proof due to Harm Derksen, that any linear operator in a complex finite dimensional

More information

Lecture #5: Begin Quantum Mechanics: Free Particle and Particle in a 1D Box

Lecture #5: Begin Quantum Mechanics: Free Particle and Particle in a 1D Box 561 Fall 017 Lecture #5 page 1 Last time: Lecture #5: Begin Quantum Mechanics: Free Particle and Particle in a 1D Box 1-D Wave equation u x = 1 u v t * u(x,t): displacements as function of x,t * nd -order:

More information

NONLINEAR PROPAGATION OF WAVE PACKETS. Ritsumeikan University, and 22

NONLINEAR PROPAGATION OF WAVE PACKETS. Ritsumeikan University, and 22 NONLINEAR PROPAGATION OF WAVE PACKETS CLOTILDE FERMANIAN KAMMERER Ritsumeikan University, 21-1 - 21 and 22 Our aim in this lecture is to explain the proof of a recent Theorem obtained in collaboration

More information

A linear algebra proof of the fundamental theorem of algebra

A linear algebra proof of the fundamental theorem of algebra A linear algebra proof of the fundamental theorem of algebra Andrés E. Caicedo May 18, 2010 Abstract We present a recent proof due to Harm Derksen, that any linear operator in a complex finite dimensional

More information

QUATERNIONS AND ROTATIONS

QUATERNIONS AND ROTATIONS QUATERNIONS AND ROTATIONS SVANTE JANSON 1. Introduction The purpose of this note is to show some well-known relations between quaternions and the Lie groups SO(3) and SO(4) (rotations in R 3 and R 4 )

More information

Mathematical Methods wk 2: Linear Operators

Mathematical Methods wk 2: Linear Operators John Magorrian, magog@thphysoxacuk These are work-in-progress notes for the second-year course on mathematical methods The most up-to-date version is available from http://www-thphysphysicsoxacuk/people/johnmagorrian/mm

More information

Exponentially Accurate Semiclassical Tunneling Wave Functions in One Dimension

Exponentially Accurate Semiclassical Tunneling Wave Functions in One Dimension Exponentially Accurate Semiclassical Tunneling Wave Functions in One Dimension Vasile Gradinaru Seminar for Applied Mathematics ETH Zürich CH 8092 Zürich, Switzerland, George A. Hagedorn Department of

More information

Quantum Mechanics: Postulates

Quantum Mechanics: Postulates Quantum Mechanics: Postulates 25th March 2008 I. Physical meaning of the Wavefunction Postulate 1: The wavefunction attempts to describe a quantum mechanical entity (photon, electron, x-ray, etc.) through

More information

Math Linear Algebra II. 1. Inner Products and Norms

Math Linear Algebra II. 1. Inner Products and Norms Math 342 - Linear Algebra II Notes 1. Inner Products and Norms One knows from a basic introduction to vectors in R n Math 254 at OSU) that the length of a vector x = x 1 x 2... x n ) T R n, denoted x,

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

GQE ALGEBRA PROBLEMS

GQE ALGEBRA PROBLEMS GQE ALGEBRA PROBLEMS JAKOB STREIPEL Contents. Eigenthings 2. Norms, Inner Products, Orthogonality, and Such 6 3. Determinants, Inverses, and Linear (In)dependence 4. (Invariant) Subspaces 3 Throughout

More information

Homework 11 Solutions. Math 110, Fall 2013.

Homework 11 Solutions. Math 110, Fall 2013. Homework 11 Solutions Math 110, Fall 2013 1 a) Suppose that T were self-adjoint Then, the Spectral Theorem tells us that there would exist an orthonormal basis of P 2 (R), (p 1, p 2, p 3 ), consisting

More information

LECTURE 5: THE METHOD OF STATIONARY PHASE

LECTURE 5: THE METHOD OF STATIONARY PHASE LECTURE 5: THE METHOD OF STATIONARY PHASE Some notions.. A crash course on Fourier transform For j =,, n, j = x j. D j = i j. For any multi-index α = (α,, α n ) N n. α = α + + α n. α! = α! α n!. x α =

More information

Continuous quantum states, Particle on a line and Uncertainty relations

Continuous quantum states, Particle on a line and Uncertainty relations Continuous quantum states, Particle on a line and Uncertainty relations So far we have considered k-level (discrete) quantum systems. Now we turn our attention to continuous quantum systems, such as a

More information

5. Orthogonal matrices

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

More information

APPENDIX A. Background Mathematics. A.1 Linear Algebra. Vector algebra. Let x denote the n-dimensional column vector with components x 1 x 2.

APPENDIX A. Background Mathematics. A.1 Linear Algebra. Vector algebra. Let x denote the n-dimensional column vector with components x 1 x 2. APPENDIX A Background Mathematics A. Linear Algebra A.. Vector algebra Let x denote the n-dimensional column vector with components 0 x x 2 B C @. A x n Definition 6 (scalar product). The scalar product

More information

Methods for sparse analysis of high-dimensional data, II

Methods for sparse analysis of high-dimensional data, II Methods for sparse analysis of high-dimensional data, II Rachel Ward May 26, 2011 High dimensional data with low-dimensional structure 300 by 300 pixel images = 90, 000 dimensions 2 / 55 High dimensional

More information

arxiv: v1 [math.ds] 18 Nov 2008

arxiv: v1 [math.ds] 18 Nov 2008 arxiv:0811.2889v1 [math.ds] 18 Nov 2008 Abstract Quaternions And Dynamics Basile Graf basile.graf@epfl.ch February, 2007 We give a simple and self contained introduction to quaternions and their practical

More information

SPRING 2006 PRELIMINARY EXAMINATION SOLUTIONS

SPRING 2006 PRELIMINARY EXAMINATION SOLUTIONS SPRING 006 PRELIMINARY EXAMINATION SOLUTIONS 1A. Let G be the subgroup of the free abelian group Z 4 consisting of all integer vectors (x, y, z, w) such that x + 3y + 5z + 7w = 0. (a) Determine a linearly

More information

Ir O D = D = ( ) Section 2.6 Example 1. (Bottom of page 119) dim(v ) = dim(l(v, W )) = dim(v ) dim(f ) = dim(v )

Ir O D = D = ( ) Section 2.6 Example 1. (Bottom of page 119) dim(v ) = dim(l(v, W )) = dim(v ) dim(f ) = dim(v ) Section 3.2 Theorem 3.6. Let A be an m n matrix of rank r. Then r m, r n, and, by means of a finite number of elementary row and column operations, A can be transformed into the matrix ( ) Ir O D = 1 O

More information

Hilbert Space Problems

Hilbert Space Problems Hilbert Space Problems Prescribed books for problems. ) Hilbert Spaces, Wavelets, Generalized Functions and Modern Quantum Mechanics by Willi-Hans Steeb Kluwer Academic Publishers, 998 ISBN -7923-523-9

More information

Quantum mechanics. Chapter The quantum mechanical formalism

Quantum mechanics. Chapter The quantum mechanical formalism Chapter 5 Quantum mechanics 5.1 The quantum mechanical formalism The realisation, by Heisenberg, that the position and momentum of a quantum mechanical particle cannot be measured simultaneously renders

More information

Linear algebra 2. Yoav Zemel. March 1, 2012

Linear algebra 2. Yoav Zemel. March 1, 2012 Linear algebra 2 Yoav Zemel March 1, 2012 These notes were written by Yoav Zemel. The lecturer, Shmuel Berger, should not be held responsible for any mistake. Any comments are welcome at zamsh7@gmail.com.

More information

Linear Algebra 2 Spectral Notes

Linear Algebra 2 Spectral Notes Linear Algebra 2 Spectral Notes In what follows, V is an inner product vector space over F, where F = R or C. We will use results seen so far; in particular that every linear operator T L(V ) has a complex

More information

1. For the case of the harmonic oscillator, the potential energy is quadratic and hence the total Hamiltonian looks like: d 2 H = h2

1. For the case of the harmonic oscillator, the potential energy is quadratic and hence the total Hamiltonian looks like: d 2 H = h2 15 Harmonic Oscillator 1. For the case of the harmonic oscillator, the potential energy is quadratic and hence the total Hamiltonian looks like: d 2 H = h2 2mdx + 1 2 2 kx2 (15.1) where k is the force

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

1. What is the determinant of the following matrix? a 1 a 2 4a 3 2a 2 b 1 b 2 4b 3 2b c 1. = 4, then det

1. What is the determinant of the following matrix? a 1 a 2 4a 3 2a 2 b 1 b 2 4b 3 2b c 1. = 4, then det What is the determinant of the following matrix? 3 4 3 4 3 4 4 3 A 0 B 8 C 55 D 0 E 60 If det a a a 3 b b b 3 c c c 3 = 4, then det a a 4a 3 a b b 4b 3 b c c c 3 c = A 8 B 6 C 4 D E 3 Let A be an n n matrix

More information

DS-GA 1002 Lecture notes 0 Fall Linear Algebra. These notes provide a review of basic concepts in linear algebra.

DS-GA 1002 Lecture notes 0 Fall Linear Algebra. These notes provide a review of basic concepts in linear algebra. DS-GA 1002 Lecture notes 0 Fall 2016 Linear Algebra These notes provide a review of basic concepts in linear algebra. 1 Vector spaces You are no doubt familiar with vectors in R 2 or R 3, i.e. [ ] 1.1

More information

L. Levaggi A. Tabacco WAVELETS ON THE INTERVAL AND RELATED TOPICS

L. Levaggi A. Tabacco WAVELETS ON THE INTERVAL AND RELATED TOPICS Rend. Sem. Mat. Univ. Pol. Torino Vol. 57, 1999) L. Levaggi A. Tabacco WAVELETS ON THE INTERVAL AND RELATED TOPICS Abstract. We use an abstract framework to obtain a multilevel decomposition of a variety

More information

Theorem 5.3. Let E/F, E = F (u), be a simple field extension. Then u is algebraic if and only if E/F is finite. In this case, [E : F ] = deg f u.

Theorem 5.3. Let E/F, E = F (u), be a simple field extension. Then u is algebraic if and only if E/F is finite. In this case, [E : F ] = deg f u. 5. Fields 5.1. Field extensions. Let F E be a subfield of the field E. We also describe this situation by saying that E is an extension field of F, and we write E/F to express this fact. If E/F is a field

More information

University of Colorado Denver Department of Mathematical and Statistical Sciences Applied Linear Algebra Ph.D. Preliminary Exam January 23, 2015

University of Colorado Denver Department of Mathematical and Statistical Sciences Applied Linear Algebra Ph.D. Preliminary Exam January 23, 2015 University of Colorado Denver Department of Mathematical and Statistical Sciences Applied Linear Algebra PhD Preliminary Exam January 23, 2015 Name: Exam Rules: This exam lasts 4 hours and consists of

More information

Generators for Continuous Coordinate Transformations

Generators for Continuous Coordinate Transformations Page 636 Lecture 37: Coordinate Transformations: Continuous Passive Coordinate Transformations Active Coordinate Transformations Date Revised: 2009/01/28 Date Given: 2009/01/26 Generators for Continuous

More information

4.3 Lecture 18: Quantum Mechanics

4.3 Lecture 18: Quantum Mechanics CHAPTER 4. QUANTUM SYSTEMS 73 4.3 Lecture 18: Quantum Mechanics 4.3.1 Basics Now that we have mathematical tools of linear algebra we are ready to develop a framework of quantum mechanics. The framework

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

Elementary maths for GMT

Elementary maths for GMT Elementary maths for GMT Linear Algebra Part 2: Matrices, Elimination and Determinant m n matrices The system of m linear equations in n variables x 1, x 2,, x n a 11 x 1 + a 12 x 2 + + a 1n x n = b 1

More information

PY 351 Modern Physics - Lecture notes, 3

PY 351 Modern Physics - Lecture notes, 3 PY 351 Modern Physics - Lecture notes, 3 Copyright by Claudio Rebbi, Boston University, October 2016. These notes cannot be duplicated and distributed without explicit permission of the author. Time dependence

More information

Section 9 Variational Method. Page 492

Section 9 Variational Method. Page 492 Section 9 Variational Method Page 492 Page 493 Lecture 27: The Variational Method Date Given: 2008/12/03 Date Revised: 2008/12/03 Derivation Section 9.1 Variational Method: Derivation Page 494 Motivation

More information

Linear Algebra- Final Exam Review

Linear Algebra- Final Exam Review Linear Algebra- Final Exam Review. Let A be invertible. Show that, if v, v, v 3 are linearly independent vectors, so are Av, Av, Av 3. NOTE: It should be clear from your answer that you know the definition.

More information

We can instead solve the problem algebraically by introducing up and down ladder operators b + and b

We can instead solve the problem algebraically by introducing up and down ladder operators b + and b Physics 17c: Statistical Mechanics Second Quantization Ladder Operators in the SHO It is useful to first review the use of ladder operators in the simple harmonic oscillator. Here I present the bare bones

More information

Integral-free Wigner functions

Integral-free Wigner functions Integral-free Wigner functions A. Teğmen Physics Department, Ankara University, 0600 Ankara, TURKEY tegmen@science.ankara.edu.tr Abstract arxiv:math-ph/070208v 6 Feb 2007 Wigner phase space quasi-probability

More information

Linear Algebra Lecture Notes-II

Linear Algebra Lecture Notes-II Linear Algebra Lecture Notes-II Vikas Bist Department of Mathematics Panjab University, Chandigarh-64 email: bistvikas@gmail.com Last revised on March 5, 8 This text is based on the lectures delivered

More information

Computational Methods CMSC/AMSC/MAPL 460. Eigenvalues and Eigenvectors. Ramani Duraiswami, Dept. of Computer Science

Computational Methods CMSC/AMSC/MAPL 460. Eigenvalues and Eigenvectors. Ramani Duraiswami, Dept. of Computer Science Computational Methods CMSC/AMSC/MAPL 460 Eigenvalues and Eigenvectors Ramani Duraiswami, Dept. of Computer Science Eigen Values of a Matrix Recap: A N N matrix A has an eigenvector x (non-zero) with corresponding

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

Lecture 7. 1 Wavepackets and Uncertainty 1. 2 Wavepacket Shape Changes 4. 3 Time evolution of a free wave packet 6. 1 Φ(k)e ikx dk. (1.

Lecture 7. 1 Wavepackets and Uncertainty 1. 2 Wavepacket Shape Changes 4. 3 Time evolution of a free wave packet 6. 1 Φ(k)e ikx dk. (1. Lecture 7 B. Zwiebach February 8, 06 Contents Wavepackets and Uncertainty Wavepacket Shape Changes 4 3 Time evolution of a free wave packet 6 Wavepackets and Uncertainty A wavepacket is a superposition

More information

Quantum Mechanics I Physics 5701

Quantum Mechanics I Physics 5701 Quantum Mechanics I Physics 5701 Z. E. Meziani 02/24//2017 Physics 5701 Lecture Commutation of Observables and First Consequences of the Postulates Outline 1 Commutation Relations 2 Uncertainty Relations

More information

Introduction to Electronic Structure Theory

Introduction to Electronic Structure Theory Introduction to Electronic Structure Theory C. David Sherrill School of Chemistry and Biochemistry Georgia Institute of Technology June 2002 Last Revised: June 2003 1 Introduction The purpose of these

More information

LINEAR SYSTEMS AND MATRICES

LINEAR SYSTEMS AND MATRICES CHAPTER 3 LINEAR SYSTEMS AND MATRICES SECTION 3. INTRODUCTION TO LINEAR SYSTEMS This initial section takes account of the fact that some students remember only hazily the method of elimination for and

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

Linear Algebra. Min Yan

Linear Algebra. Min Yan Linear Algebra Min Yan January 2, 2018 2 Contents 1 Vector Space 7 1.1 Definition................................. 7 1.1.1 Axioms of Vector Space..................... 7 1.1.2 Consequence of Axiom......................

More information

Chem 3502/4502 Physical Chemistry II (Quantum Mechanics) 3 Credits Fall Semester 2006 Christopher J. Cramer. Lecture 5, January 27, 2006

Chem 3502/4502 Physical Chemistry II (Quantum Mechanics) 3 Credits Fall Semester 2006 Christopher J. Cramer. Lecture 5, January 27, 2006 Chem 3502/4502 Physical Chemistry II (Quantum Mechanics) 3 Credits Fall Semester 2006 Christopher J. Cramer Lecture 5, January 27, 2006 Solved Homework (Homework for grading is also due today) We are told

More information

Physics 217 Problem Set 1 Due: Friday, Aug 29th, 2008

Physics 217 Problem Set 1 Due: Friday, Aug 29th, 2008 Problem Set 1 Due: Friday, Aug 29th, 2008 Course page: http://www.physics.wustl.edu/~alford/p217/ Review of complex numbers. See appendix K of the textbook. 1. Consider complex numbers z = 1.5 + 0.5i and

More information

EE731 Lecture Notes: Matrix Computations for Signal Processing

EE731 Lecture Notes: Matrix Computations for Signal Processing EE731 Lecture Notes: Matrix Computations for Signal Processing James P. Reilly c Department of Electrical and Computer Engineering McMaster University September 22, 2005 0 Preface This collection of ten

More information

Definite versus Indefinite Linear Algebra. Christian Mehl Institut für Mathematik TU Berlin Germany. 10th SIAM Conference on Applied Linear Algebra

Definite versus Indefinite Linear Algebra. Christian Mehl Institut für Mathematik TU Berlin Germany. 10th SIAM Conference on Applied Linear Algebra Definite versus Indefinite Linear Algebra Christian Mehl Institut für Mathematik TU Berlin Germany 10th SIAM Conference on Applied Linear Algebra Monterey Bay Seaside, October 26-29, 2009 Indefinite Linear

More information

Chapter 10 Operators of the scalar Klein Gordon field. from my book: Understanding Relativistic Quantum Field Theory.

Chapter 10 Operators of the scalar Klein Gordon field. from my book: Understanding Relativistic Quantum Field Theory. Chapter 10 Operators of the scalar Klein Gordon field from my book: Understanding Relativistic Quantum Field Theory Hans de Vries November 11, 2008 2 Chapter Contents 10 Operators of the scalar Klein Gordon

More information

Derivation of Mean-Field Dynamics for Fermions

Derivation of Mean-Field Dynamics for Fermions IST Austria Mathematical Many Body Theory and its Applications Bilbao, June 17, 2016 Derivation = show that solution of microscopic eq. is close to solution of effective eq. (with fewer degrees of freedom)

More information

Existence Theory: Green s Functions

Existence Theory: Green s Functions Chapter 5 Existence Theory: Green s Functions In this chapter we describe a method for constructing a Green s Function The method outlined is formal (not rigorous) When we find a solution to a PDE by constructing

More information

Physics 215 Quantum Mechanics 1 Assignment 5

Physics 215 Quantum Mechanics 1 Assignment 5 Physics 15 Quantum Mechanics 1 Assignment 5 Logan A. Morrison February 10, 016 Problem 1 A particle of mass m is confined to a one-dimensional region 0 x a. At t 0 its normalized wave function is 8 πx

More information

PHY 396 K. Problem set #5. Due October 9, 2008.

PHY 396 K. Problem set #5. Due October 9, 2008. PHY 396 K. Problem set #5. Due October 9, 2008.. First, an exercise in bosonic commutation relations [â α, â β = 0, [â α, â β = 0, [â α, â β = δ αβ. ( (a Calculate the commutators [â αâ β, â γ, [â αâ β,

More information

Linear Algebra in Hilbert Space

Linear Algebra in Hilbert Space Physics 342 Lecture 16 Linear Algebra in Hilbert Space Lecture 16 Physics 342 Quantum Mechanics I Monday, March 1st, 2010 We have seen the importance of the plane wave solutions to the potentialfree Schrödinger

More information

A PRIMER ON SESQUILINEAR FORMS

A PRIMER ON SESQUILINEAR FORMS A PRIMER ON SESQUILINEAR FORMS BRIAN OSSERMAN This is an alternative presentation of most of the material from 8., 8.2, 8.3, 8.4, 8.5 and 8.8 of Artin s book. Any terminology (such as sesquilinear form

More information

Statistical Interpretation

Statistical Interpretation Physics 342 Lecture 15 Statistical Interpretation Lecture 15 Physics 342 Quantum Mechanics I Friday, February 29th, 2008 Quantum mechanics is a theory of probability densities given that we now have an

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

Lecture 12. The harmonic oscillator

Lecture 12. The harmonic oscillator Lecture 12 The harmonic oscillator 107 108 LECTURE 12. THE HARMONIC OSCILLATOR 12.1 Introduction In this chapter, we are going to find explicitly the eigenfunctions and eigenvalues for the time-independent

More information

Lecture 7. Econ August 18

Lecture 7. Econ August 18 Lecture 7 Econ 2001 2015 August 18 Lecture 7 Outline First, the theorem of the maximum, an amazing result about continuity in optimization problems. Then, we start linear algebra, mostly looking at familiar

More information

Stat 159/259: Linear Algebra Notes

Stat 159/259: Linear Algebra Notes Stat 159/259: Linear Algebra Notes Jarrod Millman November 16, 2015 Abstract These notes assume you ve taken a semester of undergraduate linear algebra. In particular, I assume you are familiar with the

More information

Matrix Theory. A.Holst, V.Ufnarovski

Matrix Theory. A.Holst, V.Ufnarovski Matrix Theory AHolst, VUfnarovski 55 HINTS AND ANSWERS 9 55 Hints and answers There are two different approaches In the first one write A as a block of rows and note that in B = E ij A all rows different

More information

Chap 3. Linear Algebra

Chap 3. Linear Algebra Chap 3. Linear Algebra Outlines 1. Introduction 2. Basis, Representation, and Orthonormalization 3. Linear Algebraic Equations 4. Similarity Transformation 5. Diagonal Form and Jordan Form 6. Functions

More information

Matrix Theory, Math6304 Lecture Notes from Sept 11, 2012 taken by Tristan Whalen

Matrix Theory, Math6304 Lecture Notes from Sept 11, 2012 taken by Tristan Whalen Matrix Theory, Math6304 Lecture Notes from Sept 11, 2012 taken by Tristan Whalen 1 Further Review continued Warm-up Let A, B M n and suppose det(a) = 0.Defineamatrixvaluedfunctionasfollows: F (t) =(A +

More information

October 25, 2013 INNER PRODUCT SPACES

October 25, 2013 INNER PRODUCT SPACES October 25, 2013 INNER PRODUCT SPACES RODICA D. COSTIN Contents 1. Inner product 2 1.1. Inner product 2 1.2. Inner product spaces 4 2. Orthogonal bases 5 2.1. Existence of an orthogonal basis 7 2.2. Orthogonal

More information

Methods for sparse analysis of high-dimensional data, II

Methods for sparse analysis of high-dimensional data, II Methods for sparse analysis of high-dimensional data, II Rachel Ward May 23, 2011 High dimensional data with low-dimensional structure 300 by 300 pixel images = 90, 000 dimensions 2 / 47 High dimensional

More information

Definition 2.3. We define addition and multiplication of matrices as follows.

Definition 2.3. We define addition and multiplication of matrices as follows. 14 Chapter 2 Matrices In this chapter, we review matrix algebra from Linear Algebra I, consider row and column operations on matrices, and define the rank of a matrix. Along the way prove that the row

More information

PLEASE LET ME KNOW IF YOU FIND TYPOS (send to

PLEASE LET ME KNOW IF YOU FIND TYPOS (send  to Teoretisk Fysik KTH Advanced QM (SI2380), Lecture 2 (Summary of concepts) 1 PLEASE LET ME KNOW IF YOU FIND TYPOS (send email to langmann@kth.se) The laws of QM 1. I now discuss the laws of QM and their

More information

QMI PRELIM Problem 1. All problems have the same point value. If a problem is divided in parts, each part has equal value. Show all your work.

QMI PRELIM Problem 1. All problems have the same point value. If a problem is divided in parts, each part has equal value. Show all your work. QMI PRELIM 013 All problems have the same point value. If a problem is divided in parts, each part has equal value. Show all your work. Problem 1 L = r p, p = i h ( ) (a) Show that L z = i h y x ; (cyclic

More information

Representation theory and quantum mechanics tutorial Spin and the hydrogen atom

Representation theory and quantum mechanics tutorial Spin and the hydrogen atom Representation theory and quantum mechanics tutorial Spin and the hydrogen atom Justin Campbell August 3, 2017 1 Representations of SU 2 and SO 3 (R) 1.1 The following observation is long overdue. Proposition

More information

Physics 582, Problem Set 4 Solutions

Physics 582, Problem Set 4 Solutions Physics 582, Problem Set 4 Solutions TAs: Hart Goldman and Ramanjit Sohal Fall 2018 1. PATH INTEGRAL FOR A PARTICLE IN A DOUBLE POTENTIAL WELL 1. In real time, q 0, T/2 q 0, T/2 = q 0 e i HT q 0 = where

More information