The accurate numerical solution of the Schrödinger equation with an explicitly time-dependent Hamiltonian

Size: px
Start display at page:

Download "The accurate numerical solution of the Schrödinger equation with an explicitly time-dependent Hamiltonian"

Transcription

1 The accurate numerical solution of the Schrödinger equation with an explicitly time-dependent Hamiltonian Marnix Van Daele Department of Applied Mathematics, Computer Science and Statistics Ghent University Congreso Bienal de la Real Sociedad Matemática Española Zaragoza, January 30 - February

2 A reference... This talk is based on V. Ledoux, M. Van Daele Solving the time-dependent Schrödinger problem using the CP approach Computer Physics Communications 185 (2014)

3 Sturm-Liouville problems MATSLISE is a Matlab package for solving Sturm-Liouville and Schrodinger equations It has been developed by Veerle Ledoux under the supervision of Guido Vanden Berghe and VD in a close collaboration with Liviu Ixaru (Bucharest). V. Ledoux, VD Matslise 2.0, a Matlab toolbox for Sturm-Liouville computations, Transactions on Mathematical Software, 22 4 (2016) article 29.

4 Sturm-Liouville problems Find an eigenvalue E and corresponding eigenfunction y(x) 0 such that (p(x)y (x)) + q(x)y(x) = Ew(x)y(x) with boundary conditions a 1 y(a) + a 2 p(a)y (a) = 0, b 1 y(b) + b 2 p(b)y (b) = 0, where a 1 + a 2 0 b 1 + b 2. Schrödinger equation : special case whereby p = w = 1 y + q(x) y = E y

5 Regular Sturm-Liouville problems The eigenvalues of a regular SLP can be ordered as an increasing sequence tending to infinity E 0 < E 1 < E 2 <... E k has index k. The corresponding y k (x) has exactly k zeros on the open interval (a, b). Distinct eigenfunctions are orthogonal with respect to w(x) b a y i (x)y j (x)w(x)dx = 0, i j.

6 How to solve Sturm-Liouville problems Problem: as the index k increases, the corresponding y k become increasingly oscillatory. x y x x 10 4 Standard numerical methods for ODEs encounter difficulties in efficiently estimating the higher eigenvalues. Naive integrators will be forced to take increasingly smaller steps, thereby rendering them exceedingly expensive.

7 Example : the Paine problem y + exp(x) y = E y y(0) = y(π) = 0 The errors ( 10 3 ) obtained with the Numerov algorithm, the Numerov method with correction technique and the EF-Numerov scheme. k E k 10 3 (E k Ẽk) 10 3 (E k ẼCT,k) 10 3 (E k E EF,k )

8 How to solve Sturm-Liouville problems Taking into account the characteristic features of the SL problem, one can construct specialized numerical algorithms having some crucial advantages over general-purpose codes. Some early (seventies to nineties) codes on SL problems : SLEIGN (Bailey et al.) SLEDGE (Fulton-Pruess) SL02F (Marletta-Pryce) SLCPM12 (Ixaru-Vanden Berghe-De Meyer) MATSLISE originates from SLCPM12. In the next slides we focus on the special techniques used in MATSLISE.

9 Basic ideas: 1. Shooting Shooting methods transform the boundary value problem into an initial value problem. One solves the differential equation for a succession of trial values of E which are adjusted till the boundary conditions at both ends can be satisfied at once, at which point we have an eigenvalue. The simplest technique is to shoot from a to b, but multiple shooting is preferred. The eigenvalues are the solutions of a mismatch function φ(e): φ(e) = y L (x m, E)p(x m )y R (x m, E) y R (x m, E)p(x m )y L (x m, E).

10 Basic ideas: 2. Prüfer transformation Suppose we have found an eigenvalue : φ(e) = 0. What is its index? Solution: use the (scaled) Prüfer transformation. 5*pi 4*pi 3*pi 2*pi θ L (x) pi 0 y(x) pi 2*pi θ R (x) 3*pi 4*pi

11 Basic Ideas: 3. Coefficient Approximation Idea behind second order Pruess method: Let a = x 0 < x 1 < x 2 < < x n = b be a partition of [a, b]. Replace (p(x)y (x)) +q(x)y(x) = Ew(x)y(x) in the interval (x i 1, x i ), i = 1,..., n by ( py (x)) + qy(x) = E wy(x). where p, q, w are constant.

12 Basic Ideas: 4. Perturbation theory Higher order methods are obtained by expressing the solution as a series and by adding correction terms to the second order method. All terms in this series can be computed analytically if the coefficient functions are polynomials. Therefor, we first approximate the coefficient functions by polynomials of degree N

13 CPM[N,Q] : Convergence results for problems that are reformulated in Schrödinger form... Let N be the degree of the polynomial approximating q(x) and let Q be the number of correction terms. The corresponding CPM method is denoted is CPM[N,Q]. L.Gr. Ixaru, H. De Meyer and G. Vanden Berghe, CP methods for the Schrödinger equation, revisited, J. Comput. Appl. Math. 88 (1997) The error in the eigenvalue E k, obtained with CPM[N,Q], is of order O(h 2N+2 ) for small E if Q 2 3 N + 1 is of order O(h 2N )/ E for large E if Q δ N0

14 Time-dependent Schrödinger equation ψ(x, t) ı = Ĥ(x, t)ψ(x, t), x R, t > 0 t with the one-dimensional time-dependent Hamiltonian 2 Ĥ(x, t) = 1 + V (x, t), 2µ x 2 initial data ψ(x, 0) = ψ 0 (x) µ is the reduced mass units are chosen such that = 1

15 Standard techniques Standard techniques lead to the linear system ı d Z (t) = H(t)Z (t) dt Z = (Z 1,..., Z N ) T H: N N hermitian matrix

16 Standard technique 1 Discretisation of the spatial variable x Define ψ(x j, t) = Z j (t), j = 1,..., N ı d dt Z j(t) = 1 Z j+1 (t) 2 Z j (t) + Z j 1 (t) 2µ x 2 + V (x j, t)

17 Standard technique 2 Spectral decomposition of ψ(x, t): ψ(x, t) = N Z m (t) y m (x) m=1 whereby {y m (x) m N} is an orthonormal basis (of eigenfunctions of some time-independent Hamiltonian) E.C. Titchmarsh Eigenfunction expansions associated with second order differential equations Oxford University Press, Oxford, 1962.

18 Our approach: sector-dependent expansion We use an idea by L.Gr. Ixaru: L.Gr. Ixaru, New Numerical method for the eigenvalue problem of the 2D Schrödinger equation Computer Physics Communications 181 (2010) x [x min, x max ] t [0, T ] Inspired by Ixaru, [0, T ] is divided into sectors.

19 Our approach: sector-dependent expansion Sector k : t [t k 1, t k ] In sector k we approximate V (x, t) by V [k] (x), such that 2 Ĥ(x, t) = 1 + V (x, t) 2µ x 2 is approximated by d 2 Ĥ [k] (x) = 1 2µ dx 2 + V [k] (x)

20 Sectorwise approximation of V (x, t) In [t k 1, t k ] we approximate V (x, t) by V [k] (x) = V (x, (t k 1 + t k )/2) t x t x V (x, t) and V (x, t)

21 Propagation of the solution over one sector Assume ψ(x, t k 1 ) is known In [t k 1, t k ] we approximate the solution ψ(x, t) of the TDSE by ψ [k] (x, t) = N m=1 c [k] m (t)y [k] m (x)

22 Step 1 : choice of {y [k] m (x) m N} Let {y [k] m (x) m N} be the set of orthogonal eigenfunctions of Ĥ[k] (x). This requires the solution of the TISE Ĥ [k] (x)y [k] m (x) = E [k] m y [k] m (x)

23 ı d dt c[k] n (t) = Step 2: Computation of c [k] m (t) Substitute ψ [k] (x, t) = m=1 c [k] m (t)y [k] m (x) ψ(x, t) in the TDSE ı = Ĥ(x, t)ψ(x, t). t m=1 V nm(t) [k] xmax = x min [ V [k] nm(t) + E [k] m δ nm ] c [k] m (t), n = 1, 2, 3,... [ y [k] n (x) V (x, t) V ] [k] (x) y [k] m (x)dx

24 Step 2: Computation of c [k] m (t) Initial values are obtained imposing continuity at t k 1 : ψ [k 1] (x, t k 1 ) = ψ [k] (x, t k 1 ) m=1 c [k 1] m (t k 1 )y [k 1] m (x) = m=1 c [k] m (t k 1 )y [k] m (x). Multiply by y [k] n (x), integrate over x, and use orthonormality in the r.h.s. to obtain c [k] n (t k 1 ) = m=1 s [k] nmc [k 1] m (t k 1 ) s [k] nm = x max x min y [k] n (x)y [k 1] m (x)dx

25 Conclusion: to solve the TDSE in [t k 1, t k ] 1. solve the TISE Ĥ[k] (x)y [k] (x) = E [k] y [k] (x) 2. compute integrals s [k] nm = V nm(t) [k] xmax = x min x max x min y [k] n (x)y [k 1] m (x)dx [ y [k] n (x) V (x, t) V ] [k] (x) y [k] m (x)dx 3. solve a linear system C [k] (t) = A [k] (t)c [k] (t) initial conditions : C [k] (t k 1 ) = S [k] C [k 1] (t k 1 ) [ ] A [k] nm(t) = ı V nm(t) [k] + E [k] n δ nm

26 1. Solution TISE In order to have a computationially efficient approximation technique for the solution of the TISE, and to obtain a uniform high accuracy approximation to the eigenvalues and eigenfunctions we use Constant Perbutation methods as in MATSLISE). Here we use CP methods with a predefined uniform mesh (in order to minimize the number of CP eigenfunction evaluations).

27 2. Computation of the integrals Instead of using standard quadrature rules for integrands with a highly oscillatory or exponential character we use so-called exponentially-fitted quadrature rules especially adapted to this particular problem: the CP approach does not only provide us with the values of the wavefunctions at the meshpoints but also those of their first derivative. Ixaru L. Gr. Ixaru, and G. Vanden Berghe, Exponential Fitting, Kluwer, 2004.

28 Computation of s [k] nm = x max x min y [k] n Suppose one approximates y (x) = 2 µ(v (x) E) y(x) by ȳ (x) = 2 µ( V E)ȳ(x). Since (x)y [k 1] m (x)dx ȳ(x) = f 1 exp(2 µ V Ex) + f2 exp( 2 µ V Ex) one may expect y(x) = f 1 (x) exp(2 µ V Ex) + f2 (x) exp( 2 µ V Ex).

29 Computation of s [k] nm = x max x min y [k] n (x)y [k 1] m (x)dx If y [k] n (x) = f 1 (x) exp(ω [k] n x) + f 2 (x) exp( ω [k] n x) m (x) = g 1 (x) exp(ω [k 1] m x) + g 2 (x) exp( ω [k 1] m x) y [k 1] then y [k] n (x)y [k 1] m (x) = h 1 (x) exp(µ 1 x) + h 2 (x) exp( µ 1 x) +h 3 (x) exp(µ 2 x) + h 4 (x) exp( µ 2 x) µ 1 = ω [k] n + ω [k 1] m and µ 2 = ω [k] n ω [k 1] m

30 Computation of s [k] nm = x max x min y [k] n (x)y [k 1] m (x)dx We choose to use a 4-point Lobatto-EF algorithm of the form X+h X h I(x)dx h 4 n=1 a (0) n I(X + x n h) + h 2 4 n=1 which is exact for the functions a (1) n I (X + x n h) exp(±µ 1 x), exp(±µ 2 x), x exp(±µ 1 x), x exp(±µ 2 x).

31 xmax V nm(t) [k] = x min Computation of y [k] n (x) [ V (x, t) V [k] (x) ] y [k] m (x)dx If V (x, t) is explicitly known and the first derivative w.r.t. x of V (x, t) V [k] (x) can be evaluated, then the same rule can be applied. If this is not the case, then we use a Lobatto-type rule X+h X h I(x)dx h 4 n=1 a (0) n I(X + x n h) which is exact for the functions exp(±µ 1 x), exp(±µ 2 x).

32 3. Solving linear system of ODEs C [k] (t) = A [k] (t)c [k] (t) [ ] A [k] nm(t) = ı V nm(t) [k] + E [k] n δ nm initial conditions : C [k] (t k 1 ) = S [k] C [k 1] (t k 1 ) Idea : use coefficient approximation To obtain a second order method: replace A [k] (t) in [t k 1, t k ] by Ā[k] = A [k] ((t k 1 + t k )/2). In that case Ā[k] is diagonal such that C [k] (t) = exp[(t t k 1 )Ā[k] ]C [k] (t k 1 ), t [t k 1, t k ].

33 3. Solving linear system of ODEs To obtain higher order methods, we use similar techniques as in MATSLISE (perturbation theory and approximation of the coefficient functions by polynomials) C [k] (t) = DT D (t t k 1 )D T C [k] (t k 1 ) with T D (δ) = exp(δa D 0 ) + P 1(δ) + P 2 (δ) +... This is equivalent to using modified Neumann integral series. We have used a fourth order method with T D (δ) = exp(δa D 0 ) + P 1(δ)

34 3. Solving linear system of ODEs We use this fourth order scheme and applied it once over the full sector-length [t k, t k+1 ] or (if needed to ensure accuracy) on a subdivision of the sector [t k, t k+1 ].

35 3. Solving linear system of ODEs Remark: Only second order method is unitary, such that the norm is preserved over time. For the higher order methods, this is not the case. But: the correction terms are small and loss of norm conservation is consequently also likely to be small.

36 Example 1 V (x, t) = x 2 /2 2t x [ 10, 10], t [0, T ] = [0, 20] µ = 1 ψ(x, 0) = (2 n n! π) 1/2 exp( x 2 /2)H n (x) H n :Hermite polynomial of degree n ψ(x, t) = ψ(x, 0) exp( ı(n )t + ıt2 )

37 Example 1: t [0, 5] Re ψ(x, t) Im ψ(x, t) t x t x 10 x = 0.5, t = 0.25, N = 12 n = 2

38 Example 1: t [20, 21] Re ψ(x, t) Im ψ(x, t) t x t x 0 10 x = 0.5, t = 0.25, N = 12 n = 2

39 Error err N = x max ψ [K ] (x, T )ψ [K ] (x, T )dx x max ψ exact (x, T )ψ exact(x, T )dx x min x min err A = max ψ(x, T ) ψ exact (x, T ) x mesh x

40 Example 1 N = 10, K = 10, T = 20 N = 12, K = 5, T = 20 x t err N n = 2 7e-5 1e-10 8e-15 6e-5 6e-11 4e-14 n = 4 1e-3 3e-10 2e-14 7e-4 1e-10 1e-14 n = 6 1e-3 5e-10 2e-14 9e-4 2e-10 6e-14 err A n = 2 1e-4 5e-11 7e-14 5e-4 6e-11 5e-14 n = 4 5e-4 1e-10 6e-14 5e-4 2e-10 7e-14 n = 6 8e-4 1e-10 3e-14 6e-4 1e-10 5e-14 cputime (sec)

41 Example 1 Crank-Nicholson T = 2 T = 5 x t err N n = 2 4e-4 1e-4 5e-3 n = 4 2e-3 5e-4 1e-3 n = 6 4e-3 9e-4 3e-3 err A n = 2 3e-4 8e-5 8e-3 n = n = 6 8e-1 8e-1 6e-1 cputime (sec)

42 Example 2 V (x, t) = (4 3 exp( t)) x 2 /2 x [ 10, 10], t [0, T ] = [0, 12] µ = 1 ψ 0 (x) = ( ) 1 1/4 exp( 1 π 2 (x 2) 2 )

43 Example 2 N = 10, K = 20 N = 15, K = 20 x t err N 2e-3 5e-5 3e-9 2e-3 5e-5 6e-9 6e-11 err A 3e-3 8e-5 1e-5 3e-3 8e-5 3e-7 3e-7 time N = 20, K = 20 x t err N 6e-6 6e-9 6e-11 err A 8e-5 6e-8 2e-9 time

44 Example 2 x = 0.2 and t = 0.02 N K = 1 K = 10 K = e-2 3e-3 2e e-4 3e-5 9e e-5 3e-6 3e e-7 4e-8 2e e-9 3e-11 1e-12

45 Example 3 diatomic molecule in strong laser field (Walker and Preston) V (x, t) = D(1 e αx ) 2 +A cos(ωt)x x [ 1, 4.32] t [0, 100τ] τ = 2π/ω ω = ψ(x, 0) = ψ 0 (x) = σ exp( (ρ 1/2)αx) exp( ρe αx ) µ = 1745 D = α = A = (a.u.) ρ = 2D/ω 0, ω 0 = α 2D/µ and σ =

46 Example 3 x = x max x min 64 N = 15 K = 20 t τ/10 τ/20 τ/50 τ/100 τ/200 τ/400 err N 3e-3 1e-4 1e-6 2e-9 5e-10 5e-10 err A 1e-2 7e-4 2e-5 1e-6 8e-8 5e-9 time

47 Conclusions We illustrated a new method to solve the TDSE. CP technique can be used in the spatial discretization of a time-dependent Schrödinger equation for efficient and accurate time stepping in the resulting ODE system

MATSLISE, a Matlab package for solving Sturm-Liouville and Schrodinger equations

MATSLISE, a Matlab package for solving Sturm-Liouville and Schrodinger equations MATSLISE, a Matlab package for solving Sturm-Liouville and Schrodinger equations M. Van Daele Department of Applied Mathematics, Computer Science and Statistics Ghent University University of Zaragoza

More information

Deferred correction based on exponentially-fitted mono-implicit Runge-Kutta methods

Deferred correction based on exponentially-fitted mono-implicit Runge-Kutta methods Deferred correction based on exponentially-fitted mono-implicit Runge-Kutta methods M. Van Daele Department of Applied Mathematics, Computer Science and Statistics Ghent University 3th International Conference

More information

Solving Sturm-Liouville problems by piecewise perturbation methods, revisited

Solving Sturm-Liouville problems by piecewise perturbation methods, revisited biblio.ugent.be The UGent Institutional Repository is the electronic archiving and dissemination platform for all UGent research publications. Ghent University has implemented a mandate stipulating that

More information

THE SLEIGN2 STURM-LIOUVILLE CODE

THE SLEIGN2 STURM-LIOUVILLE CODE THE SLEIGN2 STURM-LIOUVILLE CODE P.B. BAILEY, W.N. EVERITT, AND A. ZETTL Dedicated to the inheritance from C. Sturm and J. Liouville Abstract. The SLEIGN2 code is based on the ideas and methods of the

More information

The Schrodinger Wave Equation (Engel 2.4) In QM, the behavior of a particle is described by its wave function Ψ(x,t) which we get by solving:

The Schrodinger Wave Equation (Engel 2.4) In QM, the behavior of a particle is described by its wave function Ψ(x,t) which we get by solving: When do we use Quantum Mechanics? (Engel 2.1) Basically, when λ is close in magnitude to the dimensions of the problem, and to the degree that the system has a discrete energy spectrum The Schrodinger

More information

Numerical Solution of Singular Eigenvalue Problems for ODEs with a Focus on Problems Posed on Semi-Infinite Intervals

Numerical Solution of Singular Eigenvalue Problems for ODEs with a Focus on Problems Posed on Semi-Infinite Intervals INSTITUTE FOR ANALYSIS AND SCIENTIFIC COMPUTING VIENNA UNIVERSITY OF TECHNOLOGY Numerical Solution of Singular Eigenvalue Problems for ODEs with a Focus on Problems Posed on Semi-Infinite Intervals R.

More information

Degree Master of Science in Mathematical Modelling and Scientific Computing Mathematical Methods I Thursday, 12th January 2012, 9:30 a.m.- 11:30 a.m.

Degree Master of Science in Mathematical Modelling and Scientific Computing Mathematical Methods I Thursday, 12th January 2012, 9:30 a.m.- 11:30 a.m. Degree Master of Science in Mathematical Modelling and Scientific Computing Mathematical Methods I Thursday, 12th January 2012, 9:30 a.m.- 11:30 a.m. Candidates should submit answers to a maximum of four

More information

Lecture IX. Definition 1 A non-singular Sturm 1 -Liouville 2 problem consists of a second order linear differential equation of the form.

Lecture IX. Definition 1 A non-singular Sturm 1 -Liouville 2 problem consists of a second order linear differential equation of the form. Lecture IX Abstract When solving PDEs it is often necessary to represent the solution in terms of a series of orthogonal functions. One way to obtain an orthogonal family of functions is by solving a particular

More information

On the existence of an eigenvalue below the essential spectrum

On the existence of an eigenvalue below the essential spectrum On the existence of an eigenvalue below the essential spectrum B.M.Brown, D.K.R.M c Cormack Department of Computer Science, Cardiff University of Wales, Cardiff, PO Box 916, Cardiff CF2 3XF, U.K. A. Zettl

More information

Varied Factor Ordering in 2-D Quantum Gravity and Sturm-Liouville Theory

Varied Factor Ordering in 2-D Quantum Gravity and Sturm-Liouville Theory Varied Factor Ordering in 2-D Quantum Gravity and Sturm-Liouville Theory Justin Rivera Wentworth Institute of Technology May 26, 2016 Justin Rivera (Wentworth Institute of Technology) Varied Factor Ordering

More information

Numerical Solution of Singular ODE Eigenvalue Problems in Electronic Structure Computations

Numerical Solution of Singular ODE Eigenvalue Problems in Electronic Structure Computations Numerical Solution of Singular ODE Eigenvalue Problems in Electronic Structure Computations Robert Hammerling Vienna University of Technology Center for Computational Materials Science Gußhausstraße 25

More information

P-stable Exponentially fitted Obrechkoff methods

P-stable Exponentially fitted Obrechkoff methods P-stable Exponentially fitted Obrechkoff methods Marnix Van Daele, G. Vanden Berghe Marnix.VanDaele@UGent.be Vakgroep Toegepaste Wiskunde en Informatica Universiteit Gent SciCADE 7 p. /4 Outline Introduction

More information

Quantum Mechanics: Vibration and Rotation of Molecules

Quantum Mechanics: Vibration and Rotation of Molecules Quantum Mechanics: Vibration and Rotation of Molecules 8th April 2008 I. 1-Dimensional Classical Harmonic Oscillator The classical picture for motion under a harmonic potential (mass attached to spring

More information

Ordinary Differential Equations II

Ordinary Differential Equations II Ordinary Differential Equations II February 23 2017 Separation of variables Wave eq. (PDE) 2 u t (t, x) = 2 u 2 c2 (t, x), x2 c > 0 constant. Describes small vibrations in a homogeneous string. u(t, x)

More information

Physics 342 Lecture 17. Midterm I Recap. Lecture 17. Physics 342 Quantum Mechanics I

Physics 342 Lecture 17. Midterm I Recap. Lecture 17. Physics 342 Quantum Mechanics I Physics 342 Lecture 17 Midterm I Recap Lecture 17 Physics 342 Quantum Mechanics I Monday, March 1th, 28 17.1 Introduction In the context of the first midterm, there are a few points I d like to make about

More information

4 Power Series Solutions: Frobenius Method

4 Power Series Solutions: Frobenius Method 4 Power Series Solutions: Frobenius Method Now the ODE adventure takes us to series solutions for ODEs, a technique A & W, that is often viable, valuable and informative. These can be readily applied Sec.

More information

Separation of Variables in Linear PDE: One-Dimensional Problems

Separation of Variables in Linear PDE: One-Dimensional Problems Separation of Variables in Linear PDE: One-Dimensional Problems Now we apply the theory of Hilbert spaces to linear differential equations with partial derivatives (PDE). We start with a particular example,

More information

A Catalogue of Sturm-Liouville differential equations

A Catalogue of Sturm-Liouville differential equations A Catalogue of Sturm-Liouville differential equations W.N. Everitt Dedicated to all scientists who, down the long years, have contributed to Sturm-Liouville theory. Abstract. The idea for this catalogue

More information

The Schrodinger Equation and Postulates Common operators in QM: Potential Energy. Often depends on position operator: Kinetic Energy 1-D case:

The Schrodinger Equation and Postulates Common operators in QM: Potential Energy. Often depends on position operator: Kinetic Energy 1-D case: The Schrodinger Equation and Postulates Common operators in QM: Potential Energy Often depends on position operator: Kinetic Energy 1-D case: 3-D case Time Total energy = Hamiltonian To find out about

More information

Introduction to Sturm-Liouville Theory

Introduction to Sturm-Liouville Theory Introduction to R. C. Trinity University Partial Differential Equations April 10, 2014 Sturm-Liouville problems Definition: A (second order) Sturm-Liouville (S-L) problem consists of A Sturm-Liouville

More information

Numerical Solution of Singular ODE. Eigenvalue Problems in Electronic Structure. Computations

Numerical Solution of Singular ODE. Eigenvalue Problems in Electronic Structure. Computations Numerical Solution of Singular ODE Eigenvalue Problems in Electronic Structure Computations b,,1 Robert Hammerling Othmar Koch a,2 Christa Simon a Ewa B. Weinmüller a a Vienna University of Technology,

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

SPECTRAL METHODS: ORTHOGONAL POLYNOMIALS

SPECTRAL METHODS: ORTHOGONAL POLYNOMIALS SPECTRAL METHODS: ORTHOGONAL POLYNOMIALS 31 October, 2007 1 INTRODUCTION 2 ORTHOGONAL POLYNOMIALS Properties of Orthogonal Polynomials 3 GAUSS INTEGRATION Gauss- Radau Integration Gauss -Lobatto Integration

More information

Lecture 4.6: Some special orthogonal functions

Lecture 4.6: Some special orthogonal functions Lecture 4.6: Some special orthogonal functions Matthew Macauley Department of Mathematical Sciences Clemson University http://www.math.clemson.edu/~macaule/ Math 4340, Advanced Engineering Mathematics

More information

Differentiation and Integration

Differentiation and Integration Differentiation and Integration (Lectures on Numerical Analysis for Economists II) Jesús Fernández-Villaverde 1 and Pablo Guerrón 2 February 12, 2018 1 University of Pennsylvania 2 Boston College Motivation

More information

Midterm Solution

Midterm Solution 18303 Midterm Solution Problem 1: SLP with mixed boundary conditions Consider the following regular) Sturm-Liouville eigenvalue problem consisting in finding scalars λ and functions v : [0, b] R b > 0),

More information

( ) = 9φ 1, ( ) = 4φ 2.

( ) = 9φ 1, ( ) = 4φ 2. Chemistry 46 Dr Jean M Standard Homework Problem Set 6 Solutions The Hermitian operator A ˆ is associated with the physical observable A Two of the eigenfunctions of A ˆ are and These eigenfunctions are

More information

Quantum Physics III (8.06) Spring 2007 FINAL EXAMINATION Monday May 21, 9:00 am You have 3 hours.

Quantum Physics III (8.06) Spring 2007 FINAL EXAMINATION Monday May 21, 9:00 am You have 3 hours. Quantum Physics III (8.06) Spring 2007 FINAL EXAMINATION Monday May 21, 9:00 am You have 3 hours. There are 10 problems, totalling 180 points. Do all problems. Answer all problems in the white books provided.

More information

5.1 Classical Harmonic Oscillator

5.1 Classical Harmonic Oscillator Chapter 5 Harmonic Oscillator 5.1 Classical Harmonic Oscillator m l o l Hooke s Law give the force exerting on the mass as: f = k(l l o ) where l o is the equilibrium length of the spring and k is the

More information

Collection of formulae Quantum mechanics. Basic Formulas Division of Material Science Hans Weber. Operators

Collection of formulae Quantum mechanics. Basic Formulas Division of Material Science Hans Weber. Operators Basic Formulas 17-1-1 Division of Material Science Hans Weer The de Broglie wave length λ = h p The Schrödinger equation Hψr,t = i h t ψr,t Stationary states Hψr,t = Eψr,t Collection of formulae Quantum

More information

REVIEW: The Matching Method Algorithm

REVIEW: The Matching Method Algorithm Lecture 26: Numerov Algorithm for Solving the Time-Independent Schrödinger Equation 1 REVIEW: The Matching Method Algorithm Need for a more general method The shooting method for solving the time-independent

More information

Before you begin read these instructions carefully:

Before you begin read these instructions carefully: NATURAL SCIENCES TRIPOS Part IB & II (General) Friday, 27 May, 2016 9:00 am to 12:00 pm MATHEMATICS (2) Before you begin read these instructions carefully: You may submit answers to no more than six questions.

More information

Lecture 3 Dynamics 29

Lecture 3 Dynamics 29 Lecture 3 Dynamics 29 30 LECTURE 3. DYNAMICS 3.1 Introduction Having described the states and the observables of a quantum system, we shall now introduce the rules that determine their time evolution.

More information

PART IV Spectral Methods

PART IV Spectral Methods PART IV Spectral Methods Additional References: R. Peyret, Spectral methods for incompressible viscous flow, Springer (2002), B. Mercier, An introduction to the numerical analysis of spectral methods,

More information

Quantum Mechanics Solutions. λ i λ j v j v j v i v i.

Quantum Mechanics Solutions. λ i λ j v j v j v i v i. Quantum Mechanics Solutions 1. (a) If H has an orthonormal basis consisting of the eigenvectors { v i } of A with eigenvalues λ i C, then A can be written in terms of its spectral decomposition as A =

More information

Project: Vibration of Diatomic Molecules

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

More information

Introduction to Quantum Mechanics PVK - Solutions. Nicolas Lanzetti

Introduction to Quantum Mechanics PVK - Solutions. Nicolas Lanzetti Introduction to Quantum Mechanics PVK - Solutions Nicolas Lanzetti lnicolas@student.ethz.ch 1 Contents 1 The Wave Function and the Schrödinger Equation 3 1.1 Quick Checks......................................

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

Differential Equations

Differential Equations Differential Equations Problem Sheet 1 3 rd November 2011 First-Order Ordinary Differential Equations 1. Find the general solutions of the following separable differential equations. Which equations are

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 Schroedinger equation

The Schroedinger equation The Schroedinger equation After Planck, Einstein, Bohr, de Broglie, and many others (but before Born), the time was ripe for a complete theory that could be applied to any problem involving nano-scale

More information

Section 12.6: Non-homogeneous Problems

Section 12.6: Non-homogeneous Problems Section 12.6: Non-homogeneous Problems 1 Introduction Up to this point all the problems we have considered are we what we call homogeneous problems. This means that for an interval < x < l the problems

More information

Final Exam May 4, 2016

Final Exam May 4, 2016 1 Math 425 / AMCS 525 Dr. DeTurck Final Exam May 4, 2016 You may use your book and notes on this exam. Show your work in the exam book. Work only the problems that correspond to the section that you prepared.

More information

Basic Quantum Mechanics

Basic Quantum Mechanics Frederick Lanni 10feb'12 Basic Quantum Mechanics Part I. Where Schrodinger's equation comes from. A. Planck's quantum hypothesis, formulated in 1900, was that exchange of energy between an electromagnetic

More information

Lecture 6 Quantum Mechanical Systems and Measurements

Lecture 6 Quantum Mechanical Systems and Measurements Lecture 6 Quantum Mechanical Systems and Measurements Today s Program: 1. Simple Harmonic Oscillator (SHO). Principle of spectral decomposition. 3. Predicting the results of measurements, fourth postulate

More information

Journal of Computational and Applied Mathematics. Relations among eigenvalues of left-definite Sturm Liouville problems

Journal of Computational and Applied Mathematics. Relations among eigenvalues of left-definite Sturm Liouville problems Journal of Computational and Applied Mathematics 236 (2012) 3426 3433 Contents lists available at SciVerse ScienceDirect Journal of Computational and Applied Mathematics journal homepage: www.elsevier.com/locate/cam

More information

Calculation of the Eigenvalues for Wood-Saxon s. Potential by Using Numerov Method

Calculation of the Eigenvalues for Wood-Saxon s. Potential by Using Numerov Method Adv. Theor. Appl. Mech., Vol. 5, 2012, no. 1, 23-31 Calculation of the Eigenvalues for Wood-Saxon s Potential by Using Numerov Method A. H. Fatah Iraq-Kurdistan Region-Sulaimani University College of Science-Physics

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

Splitting and composition methods for the time dependent Schrödinger equation

Splitting and composition methods for the time dependent Schrödinger equation Splitting and composition methods for the time dependent Schrödinger equation S. Blanes, joint work with F. Casas and A. Murua Instituto de Matemática Multidisciplinar Universidad Politécnica de Valencia,

More information

Before you begin read these instructions carefully.

Before you begin read these instructions carefully. MATHEMATICAL TRIPOS Part IB Tuesday, 5 June, 2012 9:00 am to 12:00 pm PAPER 1 Before you begin read these instructions carefully. Each question in Section II carries twice the number of marks of each question

More information

One-dimensional Schrödinger equation

One-dimensional Schrödinger equation Chapter 1 One-dimensional Schrödinger equation In this chapter we will start from the harmonic oscillator to introduce a general numerical methodology to solve the one-dimensional, time-independent Schrödinger

More information

Solution of Fourth Order Obstacle Problems Using Quintic B-Splines

Solution of Fourth Order Obstacle Problems Using Quintic B-Splines Applied Mathematical Sciences, Vol. 6, 202, no. 94, 465-4662 Solution of Fourth Order Obstacle Problems Using Quintic B-Splines Shahid S. Siddiqi, Ghazala Akram and Kalsoom Arshad Department of Mathematics

More information

Degenerate Perturbation Theory. 1 General framework and strategy

Degenerate Perturbation Theory. 1 General framework and strategy Physics G6037 Professor Christ 12/22/2015 Degenerate Perturbation Theory The treatment of degenerate perturbation theory presented in class is written out here in detail. The appendix presents the underlying

More information

Notes on excitation of an atom or molecule by an electromagnetic wave field. F. Lanni / 11feb'12 / rev9sept'14

Notes on excitation of an atom or molecule by an electromagnetic wave field. F. Lanni / 11feb'12 / rev9sept'14 Notes on excitation of an atom or molecule by an electromagnetic wave field. F. Lanni / 11feb'12 / rev9sept'14 Because the wavelength of light (400-700nm) is much greater than the diameter of an atom (0.07-0.35

More information

Lecture 5: Harmonic oscillator, Morse Oscillator, 1D Rigid Rotor

Lecture 5: Harmonic oscillator, Morse Oscillator, 1D Rigid Rotor Lecture 5: Harmonic oscillator, Morse Oscillator, 1D Rigid Rotor It turns out that the boundary condition of the wavefunction going to zero at infinity is sufficient to quantize the value of energy that

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

The Particle in a Box

The Particle in a Box Page 324 Lecture 17: Relation of Particle in a Box Eigenstates to Position and Momentum Eigenstates General Considerations on Bound States and Quantization Continuity Equation for Probability Date Given:

More information

Exponentially Fitted Symplectic Runge-Kutta-Nyström methods

Exponentially Fitted Symplectic Runge-Kutta-Nyström methods Appl. Math. Inf. Sci. 7, No. 1, 81-85 (2013) 81 Applied Mathematics & Information Sciences An International Journal Exponentially Fitted Symplectic Runge-Kutta-Nyström methods Th. Monovasilis 1, Z. Kalogiratou

More information

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

(L, t) = 0, t > 0. (iii)

(L, t) = 0, t > 0. (iii) . Sturm Liouville Boundary Value Problems 69 where E is Young s modulus and ρ is the mass per unit volume. If the end x = isfixed, then the boundary condition there is u(, t) =, t >. (ii) Suppose that

More information

Convergent and divergent series, solutions of the Prolate Spheroidal differential equation

Convergent and divergent series, solutions of the Prolate Spheroidal differential equation Convergent and divergent series, solutions of the Prolate Spheroidal differential equation Françoise Richard-Jung (joint work with F. Fauvet, J.P. Ramis, J. Thomann) LJK, BP 53, 38041 Grenoble Cedex, France

More information

1 Time reversal. 1.1 Without spin. Time-dependent Schrödinger equation: 2m + V (r) ψ (r, t) (7) Local time-reversal transformation, T :

1 Time reversal. 1.1 Without spin. Time-dependent Schrödinger equation: 2m + V (r) ψ (r, t) (7) Local time-reversal transformation, T : 1 Time reversal 1.1 Without spin Time-dependent Schrödinger equation: i t ψ (r, t = Local time-reversal transformation, T : Transformed Schrödinger equation d (f T (t dt ] 2m + V (r ψ (r, t (1 t 1 < t

More information

An Overly Simplified and Brief Review of Differential Equation Solution Methods. 1. Some Common Exact Solution Methods for Differential Equations

An Overly Simplified and Brief Review of Differential Equation Solution Methods. 1. Some Common Exact Solution Methods for Differential Equations An Overly Simplified and Brief Review of Differential Equation Solution Methods We will be dealing with initial or boundary value problems. A typical initial value problem has the form y y 0 y(0) 1 A typical

More information

1 Time-Dependent Two-State Systems: Rabi Oscillations

1 Time-Dependent Two-State Systems: Rabi Oscillations Advanced kinetics Solution 7 April, 16 1 Time-Dependent Two-State Systems: Rabi Oscillations a In order to show how Ĥintt affects a bound state system in first-order time-dependent perturbation theory

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

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

C. Show your answer in part B agrees with your answer in part A in the limit that the constant c 0.

C. Show your answer in part B agrees with your answer in part A in the limit that the constant c 0. Problem #1 A. A projectile of mass m is shot vertically in the gravitational field. Its initial velocity is v o. Assuming there is no air resistance, how high does m go? B. Now assume the projectile is

More information

Harmonic Oscillator I

Harmonic Oscillator I Physics 34 Lecture 7 Harmonic Oscillator I Lecture 7 Physics 34 Quantum Mechanics I Monday, February th, 008 We can manipulate operators, to a certain extent, as we would algebraic expressions. By considering

More information

Quantum Computing Lecture 3. Principles of Quantum Mechanics. Anuj Dawar

Quantum Computing Lecture 3. Principles of Quantum Mechanics. Anuj Dawar Quantum Computing Lecture 3 Principles of Quantum Mechanics Anuj Dawar What is Quantum Mechanics? Quantum Mechanics is a framework for the development of physical theories. It is not itself a physical

More information

Lecture 12: Detailed balance and Eigenfunction methods

Lecture 12: Detailed balance and Eigenfunction methods Miranda Holmes-Cerfon Applied Stochastic Analysis, Spring 2015 Lecture 12: Detailed balance and Eigenfunction methods Readings Recommended: Pavliotis [2014] 4.5-4.7 (eigenfunction methods and reversibility),

More information

Quiz 6: Modern Physics Solution

Quiz 6: Modern Physics Solution Quiz 6: Modern Physics Solution Name: Attempt all questions. Some universal constants: Roll no: h = Planck s constant = 6.63 10 34 Js = Reduced Planck s constant = 1.06 10 34 Js 1eV = 1.6 10 19 J d 2 TDSE

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 Simulation of Spin Dynamics

Numerical Simulation of Spin Dynamics Numerical Simulation of Spin Dynamics Marie Kubinova MATH 789R: Advanced Numerical Linear Algebra Methods with Applications November 18, 2014 Introduction Discretization in time Computing the subpropagators

More information

Lecture 6. Four postulates of quantum mechanics. The eigenvalue equation. Momentum and energy operators. Dirac delta function. Expectation values

Lecture 6. Four postulates of quantum mechanics. The eigenvalue equation. Momentum and energy operators. Dirac delta function. Expectation values Lecture 6 Four postulates of quantum mechanics The eigenvalue equation Momentum and energy operators Dirac delta function Expectation values Objectives Learn about eigenvalue equations and operators. Learn

More information

An operator is a transformation that takes a function as an input and produces another function (usually).

An operator is a transformation that takes a function as an input and produces another function (usually). Formalism of Quantum Mechanics Operators Engel 3.2 An operator is a transformation that takes a function as an input and produces another function (usually). Example: In QM, most operators are linear:

More information

Research Article A Note on the Discrete Spectrum of Gaussian Wells (I): The Ground State Energy in One Dimension

Research Article A Note on the Discrete Spectrum of Gaussian Wells (I): The Ground State Energy in One Dimension Mathematical Physics Volume 016, Article ID 15769, 4 pages http://dx.doi.org/10.1155/016/15769 Research Article A Note on the Discrete Spectrum of Gaussian Wells (I: The Ground State Energy in One Dimension

More information

For a system with more than one electron, we can t solve the Schrödinger Eq. exactly. We must develop methods of approximation, such as

For a system with more than one electron, we can t solve the Schrödinger Eq. exactly. We must develop methods of approximation, such as VARIATIO METHOD For a system with more than one electron, we can t solve the Schrödinger Eq. exactly. We must develop methods of approximation, such as Variation Method Perturbation Theory Combination

More information

Exercises : Questions

Exercises : Questions Exercises 18.05.2017: Questions Problem 1 where Calculate the following commutators: a) [ Ĥ, ˆp ], b) [ Ĥ, ˆr ], Ĥ = 1 2m ˆp2 + V ˆr), 1) ˆp 2 = ˆp 2 x + ˆp 2 y + ˆp 2 z and V ˆr) = V ˆx, ŷ, ẑ) is an arbitrary

More information

Physics 250 Green s functions for ordinary differential equations

Physics 250 Green s functions for ordinary differential equations Physics 25 Green s functions for ordinary differential equations Peter Young November 25, 27 Homogeneous Equations We have already discussed second order linear homogeneous differential equations, which

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

7. Numerical Solutions of the TISE

7. Numerical Solutions of the TISE 7. Numerical Solutions of the TISE Copyright c 2015 2016, Daniel V. Schroeder Besides the infinite square well, there aren t many potentials V (x) for which you can find the energies and eigenfunctions

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

Journal of Mathematical Analysis and Applications

Journal of Mathematical Analysis and Applications J. Math. Anal. Appl. 381 (2011) 506 512 Contents lists available at ScienceDirect Journal of Mathematical Analysis and Applications www.elsevier.com/locate/jmaa Inverse indefinite Sturm Liouville problems

More information

CHAPTER 6 Quantum Mechanics II

CHAPTER 6 Quantum Mechanics II CHAPTER 6 Quantum Mechanics II 6.1 6.2 6.3 6.4 6.5 6.6 6.7 The Schrödinger Wave Equation Expectation Values Infinite Square-Well Potential Finite Square-Well Potential Three-Dimensional Infinite-Potential

More information

Physics 202 Laboratory 5. Linear Algebra 1. Laboratory 5. Physics 202 Laboratory

Physics 202 Laboratory 5. Linear Algebra 1. Laboratory 5. Physics 202 Laboratory Physics 202 Laboratory 5 Linear Algebra Laboratory 5 Physics 202 Laboratory We close our whirlwind tour of numerical methods by advertising some elements of (numerical) linear algebra. There are three

More information

EXISTENCE OF SOLUTIONS FOR BOUNDARY VALUE PROBLEMS ON INFINITE INTERVALS. We consider the second order nonlinear differential equation

EXISTENCE OF SOLUTIONS FOR BOUNDARY VALUE PROBLEMS ON INFINITE INTERVALS. We consider the second order nonlinear differential equation Dynamic Systems and Applications 17 (28) 653-662 EXISTECE OF SOLUTIOS FOR BOUDARY VALUE PROBLEMS O IFIITE ITERVALS İSMAİL YASLA Department of Mathematics, Pamukkale University, Denizli 27, Turkey ABSTRACT.

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

Power Series Solutions to the Legendre Equation

Power Series Solutions to the Legendre Equation Power Series Solutions to the Legendre Equation Department of Mathematics IIT Guwahati The Legendre equation The equation (1 x 2 )y 2xy + α(α + 1)y = 0, (1) where α is any real constant, is called Legendre

More information

Course and Wavelets and Filter Banks

Course and Wavelets and Filter Banks Course 18.327 and 1.130 Wavelets and Filter Bans Numerical solution of PDEs: Galerin approximation; wavelet integrals (projection coefficients, moments and connection coefficients); convergence Numerical

More information

The Density Matrix for the Ground State of 1-d Impenetrable Bosons in a Harmonic Trap

The Density Matrix for the Ground State of 1-d Impenetrable Bosons in a Harmonic Trap The Density Matrix for the Ground State of 1-d Impenetrable Bosons in a Harmonic Trap Institute of Fundamental Sciences Massey University New Zealand 29 August 2017 A. A. Kapaev Memorial Workshop Michigan

More information

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 28 PART II Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 29 BOUNDARY VALUE PROBLEMS (I) Solving a TWO

More information

Quantum Physics Lecture 8

Quantum Physics Lecture 8 Quantum Physics ecture 8 Steady state Schroedinger Equation (SSSE): eigenvalue & eigenfunction particle in a box re-visited Wavefunctions and energy states normalisation probability density Expectation

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

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

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

More information

6 Non-homogeneous Heat Problems

6 Non-homogeneous Heat Problems 6 Non-homogeneous Heat Problems Up to this point all the problems we have considered for the heat or wave equation we what we call homogeneous problems. This means that for an interval < x < l the problems

More information

Chapter 1. Introduction. 1.1 Symmetry in Physics What is a Symmetry?

Chapter 1. Introduction. 1.1 Symmetry in Physics What is a Symmetry? Chapter 1 Introduction As far as I can see, all a priori statements in physics have their origin in symmetry. Hermann Weyl 1 1.1 Symmetry in Physics Symmetry is a fundamental human concern, as evidenced

More information

Limit-point / limit-circle classification of second-order differential operators and PT -QM

Limit-point / limit-circle classification of second-order differential operators and PT -QM Limit-point / limit-circle classification of second-order differential operators and PT -QM TU Ilmenau 19th December 2016 TU Ilmenau Seite 1 / 24 TU Ilmenau Seite 2 / 24 PT -symmetry Definition (Bender

More information

Quantum Mechanics Solutions

Quantum Mechanics Solutions Quantum Mechanics Solutions (a (i f A and B are Hermitian, since (AB = B A = BA, operator AB is Hermitian if and only if A and B commute So, we know that [A,B] = 0, which means that the Hilbert space H

More information

TP computing lab - Integrating the 1D stationary Schrödinger eq

TP computing lab - Integrating the 1D stationary Schrödinger eq TP computing lab - Integrating the 1D stationary Schrödinger equation September 21, 2010 The stationary 1D Schrödinger equation The time-independent (stationary) Schrödinger equation is given by Eψ(x)

More information

18.06 Problem Set 9 - Solutions Due Wednesday, 21 November 2007 at 4 pm in

18.06 Problem Set 9 - Solutions Due Wednesday, 21 November 2007 at 4 pm in 8.6 Problem Set 9 - Solutions Due Wednesday, 2 November 27 at 4 pm in 2-6. Problem : (5) When A = SΛS is a real-symmetric (or Hermitian) matrix, its eigenvectors can be chosen orthonormal and hence S =

More information