Linear Algebra Michael Taylor

Total Page:16

File Type:pdf, Size:1020Kb

Linear Algebra Michael Taylor Linear Algebra Michael Taylor Math. Dept., UNC E-mail address: [email protected] 2010 Mathematics Subject Classification. 15-00, 15-01 Key words and phrases. vector spaces, linear transformations, matrices, determinants, eigenvectors, eigenvalues, generalized eigenvectors, inner products, norms, trace, adjoint, unitary, orthogonal transformations, Jordan canonical form, polar decomposition, singular value decomposition, tensor products, exterior algebra, fields, rings, modules, principal ideal domains, groups, quaternions, Clifford algebra, octonions, Noetherian rings Contents Preface xi Some basic notation xvii Chapter 1. Vector spaces, linear transformations, and matrices 1 x1.1. Vector spaces 3 Exercises 7 x1.2. Linear transformations and matrices 9 Exercises 14 x1.3. Basis and dimension 17 Exercises 21 x1.4. Matrix representation of a linear transformation 24 Exercises 26 x1.5. Determinants and invertibility 27 Exercises 35 The Vandermonde determinant 38 x1.6. Applications of row reduction and column reduction 40 Exercises 54 Chapter 2. Eigenvalues, eigenvectors, and generalized eigenvectors 55 x2.1. Eigenvalues and eigenvectors 58 Exercises 61 x2.2. Generalized eigenvectors and the minimal polynomial 65 Exercises 70 vii viii Contents x2.3. Triangular matrices and upper triangularization 72 Exercises 76 x2.4. The Jordan canonical form 78 Exercises 82 Chapter 3. Linear algebra on inner product spaces 83 x3.1. Inner products and norms 86 Exercises 90 x3.2. Norm, trace, and adjoint of a linear transformation 96 Exercises 98 x3.3. Self-adjoint and skew-adjoint transformations 101 Exercises 108 x3.4. Unitary and orthogonal transformations 112 Exercises 117 x3.5. Schur's upper triangular representation 123 Exercises 127 x3.6. Polar decomposition and singular value decomposition 128 Exercises 136 x3.7. The matrix exponential 137 Exercises 147 x3.8. The discrete Fourier transform 152 Exercises 164 Chapter 4. Further basic concepts: duality, convexity, positivity 167 x4.1. Dual spaces 170 Exercises 171 x4.2. Convex sets 173 Exercises 177 x4.3. Quotient spaces 178 Exercises 180 x4.4. Positive matrices and stochastic matrices 181 Exercises 187 Chapter 5. Multilinear algebra 189 x5.1. Multilinear mappings 191 Exercises 192 x5.2. Tensor products 194 Contents ix Exercises 196 x5.3. Exterior algebra 197 Exercises 205 x5.4. Isomorphism Skew(V ) ≈ Λ2V and the Pfaffian 209 Chapter 6. Linear algebra over more general fields 211 x6.1. Vector spaces over more general fields 213 Exercises 222 x6.2. Rational matrices and algebraic numbers 225 Chapter 7. Rings and modules 227 x7.1. Rings and modules 231 Exercises 243 x7.2. Modules over principal ideal domains 245 Exercises 254 x7.3. The Jordan canonical form revisited 258 Exercises 260 x7.4. Integer matrices and algebraic integers 261 Exercises 265 x7.5. Noetherian rings and Noetherian modules 266 x7.6. Polynomial rings over UFDs 273 Chapter 8. Special structures in linear algebra 277 x8.1. Quaternions and matrices of quaternions 280 Exercises 287 x8.2. Algebras 290 x8.3. Clifford algebras 299 Exercises 309 x8.4. Octonions 310 Appendix A. Complementary results 333 xA.1. The fundamental theorem of algebra 335 xA.2. Averaging rotations 337 xA.3. Groups 343 xA.4. Finite fields and other algebraic field extensions 351 Bibliography 363 Index 365 Preface Linear algebra is an important gateway connecting elementary mathematics to more advanced subjects, such as multivariable calculus, systems of dif- ferential equations, differential geometry, and group representations. The purpose of this work is to provide a treatment of this subject in sufficient depth to prepare the reader to tackle such further material. In Chapter 1 we define the class of vector spaces (real or complex) and discuss some basic examples, including Rn and Cn, or, as we denote them, Fn, with F = R or C. We then consider linear transformations between such spaces. In particular, we look at an m × n matrix A as defining a linear transformation A : Fn ! Fm. We define the range R(T ) and null space N (T ) of a linear transformation T : V ! W . In x1.3 we define the notion of basis of a vector space. Vector spaces with finite bases are called finite dimensional. We establish the crucial property that any two bases of such a vector space V have the same number of elements (denoted dim V ). We apply this to other results on bases of vector spaces, culminating in the \fundamental theorem of linear algebra," that if T : V ! W is linear and V is finite dimensional, then dim N (T ) + dim R(T ) = dim V , and discuss some of its important consequences. A linear transformation T : V ! V is said to be invertible provided it is one-to-one and onto, i.e., provided N (T ) = 0 and R(T ) = V . In x1.5 we define the determinant of such T , det T (when V is finite dimensional), and show that T is invertible if and only if det T =6 0. One useful tool in the study of determinants consists of row operations and column operations. In x1.6 we pursue these operations further, and show how applying row reduction to an m × n matrix A works to display a basis of its null space, while applying column reduction to A works to display a basis of its range. xi xii Preface In Chapter 2 we study eigenvalues λj and eigenvectors vj of a linear transformation T : V ! V , satisfying T vj = λjvj. Results of x1.5 imply that λj is a root of the \characteristic polynomial" det(λI − T ). Section 2.2 extends the scope of this study to a treatment of generalized eigen- vectors of T , which are shown to always form a basis of V , when V is a finite-dimensional complex vector space. This ties in with a treatment of properties of nilpotent matrices and triangular matrices, in x2.3. Combining the results on generalized eigenvectors with a closer look at the structure of nilpotent matrices leads to the presentation of the Jordan canonical form for an n × n complex matrix, in x2.4. In Chapter 3 we introduce inner products on vector spaces and endow them with a Euclidean geometry, in particular with a distance and a norm. In x3.2 we discuss two types of norms on linear transformations, the \opera- tor norm" and the \Hilbert-Schmidt norm." Then, in xx3.3{3.4, we discuss some special classes on linear transformations on inner product spaces: self- adjoint, skew-adjoint, unitary, and orthogonal transformations. In x3.5 we establish a theorem of Schur that for each n × n matrix A, there is an or- thonormal basis of Cn with respect to which A takes an upper triangular form. Section 3.6 establishes a polar decomposition result, that each n × n complex matrix can be written as KP , with K unitary and P positive semi- definite, and a related result known as the singular value decomposition of a complex matrix (square or rectangular). In x3.7 we define the matrix exponential etA, for A 2 M(n; C), so that x(t) = etAv solves the differential equation dx=dt = Ax; x(0) = v. We produce a power series for etA and establish some basic properties. The matrix exponential is fundamental to applications of linear algebra to ODE. Here, we use this connection to produce another proof that if A is an n × n complex matrix, then Cn has a basis consisting of generalized eigenvectors of A. The proof given here is completely different from that of x2.2. Section 3.8 takes up the discrete Fourier transform (DFT), acting on functions f : Z ! C that are periodic, of period n. This transform diag- onalizes an important class of operators known as convolution operators. This section also treats a fast implementation of the DFT, known as the Fast Fourier Transform (FFT). Chapter 4 introduces some further basic concepts in the study of linear algebra on real and complex vector spaces. In x4.1 we define the dual space V 0 to a vector space. We associate to a linear map A : V ! W its transpose At : W 0 ! V 0 and establish a natural isomorphism V ≈ (V 0)0 when dim V < 1. Section 4.2 looks at convex subsets of a finite-dimensional vector space. Section 4.3 deals with quotient spaces V=W when W is a linear subspace of V . Preface xiii In x4.4 we study positive matrices, including the important class of sto- chastic matrices. We establish the Perron-Frobenius theorem, which states that, under a further hypothesis called irreducibility, a positive matrix has a positive eigenvector, unique up to scalar multiple, and draw useful corollaries for the behavior of irreducible stochastic matrices. Chapter 5 deals with multilinear maps and related constructions, includ- ing tensor products in x5.2 and exterior algebra in x5.3, which we approach as a further development of the theory of determinants, initiated in x1.5. Results of this chapter are particularly useful in the development of differ- ential geometry and manifold theory, involving studies of tensor fields and differential forms. In Chapter 6 we extend the scope of our study of vector spaces, adding to R and C more general fields F. We define the notion of a field, give a number of additional examples, and describe how results of Chapters 1, 2, 4, and 5 extend to vector spaces over a general field F. Specific fields considered include both finite fields, such as Z=(p), and fields of algebraic numbers. In x6.2 we show that the set A of algebraic numbers, which are roots of polynomials with rational coefficients, are precisely the eigenvalues of square matrices with rational entries. We use this, together with some results of x5.2, to obtain a proof that A is a field, different from that given in x6.1.
Recommended publications
  • Quantum Information
    Quantum Information J. A. Jones Michaelmas Term 2010 Contents 1 Dirac Notation 3 1.1 Hilbert Space . 3 1.2 Dirac notation . 4 1.3 Operators . 5 1.4 Vectors and matrices . 6 1.5 Eigenvalues and eigenvectors . 8 1.6 Hermitian operators . 9 1.7 Commutators . 10 1.8 Unitary operators . 11 1.9 Operator exponentials . 11 1.10 Physical systems . 12 1.11 Time-dependent Hamiltonians . 13 1.12 Global phases . 13 2 Quantum bits and quantum gates 15 2.1 The Bloch sphere . 16 2.2 Density matrices . 16 2.3 Propagators and Pauli matrices . 18 2.4 Quantum logic gates . 18 2.5 Gate notation . 21 2.6 Quantum networks . 21 2.7 Initialization and measurement . 23 2.8 Experimental methods . 24 3 An atom in a laser field 25 3.1 Time-dependent systems . 25 3.2 Sudden jumps . 26 3.3 Oscillating fields . 27 3.4 Time-dependent perturbation theory . 29 3.5 Rabi flopping and Fermi's Golden Rule . 30 3.6 Raman transitions . 32 3.7 Rabi flopping as a quantum gate . 32 3.8 Ramsey fringes . 33 3.9 Measurement and initialisation . 34 1 CONTENTS 2 4 Spins in magnetic fields 35 4.1 The nuclear spin Hamiltonian . 35 4.2 The rotating frame . 36 4.3 On-resonance excitation . 38 4.4 Excitation phases . 38 4.5 Off-resonance excitation . 39 4.6 Practicalities . 40 4.7 The vector model . 40 4.8 Spin echoes . 41 4.9 Measurement and initialisation . 42 5 Photon techniques 43 5.1 Spatial encoding .
    [Show full text]
  • Lecture Notes: Qubit Representations and Rotations
    Phys 711 Topics in Particles & Fields | Spring 2013 | Lecture 1 | v0.3 Lecture notes: Qubit representations and rotations Jeffrey Yepez Department of Physics and Astronomy University of Hawai`i at Manoa Watanabe Hall, 2505 Correa Road Honolulu, Hawai`i 96822 E-mail: [email protected] www.phys.hawaii.edu/∼yepez (Dated: January 9, 2013) Contents mathematical object (an abstraction of a two-state quan- tum object) with a \one" state and a \zero" state: I. What is a qubit? 1 1 0 II. Time-dependent qubits states 2 jqi = αj0i + βj1i = α + β ; (1) 0 1 III. Qubit representations 2 A. Hilbert space representation 2 where α and β are complex numbers. These complex B. SU(2) and O(3) representations 2 numbers are called amplitudes. The basis states are or- IV. Rotation by similarity transformation 3 thonormal V. Rotation transformation in exponential form 5 h0j0i = h1j1i = 1 (2a) VI. Composition of qubit rotations 7 h0j1i = h1j0i = 0: (2b) A. Special case of equal angles 7 In general, the qubit jqi in (1) is said to be in a superpo- VII. Example composite rotation 7 sition state of the two logical basis states j0i and j1i. If References 9 α and β are complex, it would seem that a qubit should have four free real-valued parameters (two magnitudes and two phases): I. WHAT IS A QUBIT? iθ0 α φ0 e jqi = = iθ1 : (3) Let us begin by introducing some notation: β φ1 e 1 state (called \minus" on the Bloch sphere) Yet, for a qubit to contain only one classical bit of infor- 0 mation, the qubit need only be unimodular (normalized j1i = the alternate symbol is |−i 1 to unity) α∗α + β∗β = 1: (4) 0 state (called \plus" on the Bloch sphere) 1 Hence it lives on the complex unit circle, depicted on the j0i = the alternate symbol is j+i: 0 top of Figure 1.
    [Show full text]
  • A Representations of SU(2)
    A Representations of SU(2) In this appendix we provide details of the parameterization of the group SU(2) and differential forms on the group space. An arbitrary representation of the group SU(2) is given by the set of three generators Tk, which satisfy the Lie algebra [Ti,Tj ]=iεijkTk, with ε123 =1. The element of the group is given by the matrix U =exp{iT · ω} , (A.1) 1 where in the fundamental representation Tk = 2 σk, k =1, 2, 3, with 01 0 −i 10 σ = ,σ= ,σ= , 1 10 2 i 0 3 0 −1 standard Pauli matrices, which satisfy the relation σiσj = δij + iεijkσk . The vector ω has components ωk in a given coordinate frame. Geometrically, the matrices U are generators of spinor rotations in three- 3 dimensional space R and the parameters ωk are the corresponding angles of rotation. The Euler parameterization of an arbitrary matrix of SU(2) transformation is defined in terms of three angles θ, ϕ and ψ,as ϕ θ ψ iσ3 iσ2 iσ3 U(ϕ, θ, ψ)=Uz(ϕ)Uy(θ)Uz(ψ)=e 2 e 2 e 2 ϕ ψ ei 2 0 cos θ sin θ ei 2 0 = 2 2 −i ϕ θ θ − ψ 0 e 2 − sin cos 0 e i 2 2 2 i i θ 2 (ψ+ϕ) θ − 2 (ψ−ϕ) cos 2 e sin 2 e = i − − i . (A.2) − θ 2 (ψ ϕ) θ 2 (ψ+ϕ) sin 2 e cos 2 e Thus, the SU(2) group manifold is isomorphic to three-sphere S3.
    [Show full text]
  • Multipartite Quantum States and Their Marginals
    Diss. ETH No. 22051 Multipartite Quantum States and their Marginals A dissertation submitted to ETH ZURICH for the degree of Doctor of Sciences presented by Michael Walter Diplom-Mathematiker arXiv:1410.6820v1 [quant-ph] 24 Oct 2014 Georg-August-Universität Göttingen born May 3, 1985 citizen of Germany accepted on the recommendation of Prof. Dr. Matthias Christandl, examiner Prof. Dr. Gian Michele Graf, co-examiner Prof. Dr. Aram Harrow, co-examiner 2014 Abstract Subsystems of composite quantum systems are described by reduced density matrices, or quantum marginals. Important physical properties often do not depend on the whole wave function but rather only on the marginals. Not every collection of reduced density matrices can arise as the marginals of a quantum state. Instead, there are profound compatibility conditions – such as Pauli’s exclusion principle or the monogamy of quantum entanglement – which fundamentally influence the physics of many-body quantum systems and the structure of quantum information. The aim of this thesis is a systematic and rigorous study of the general relation between multipartite quantum states, i.e., states of quantum systems that are composed of several subsystems, and their marginals. In the first part of this thesis (Chapters 2–6) we focus on the one-body marginals of multipartite quantum states. Starting from a novel ge- ometric solution of the compatibility problem, we then turn towards the phenomenon of quantum entanglement. We find that the one-body marginals through their local eigenvalues can characterize the entan- glement of multipartite quantum states, and we propose the notion of an entanglement polytope for its systematic study.
    [Show full text]
  • Theory of Angular Momentum and Spin
    Chapter 5 Theory of Angular Momentum and Spin Rotational symmetry transformations, the group SO(3) of the associated rotation matrices and the 1 corresponding transformation matrices of spin{ 2 states forming the group SU(2) occupy a very important position in physics. The reason is that these transformations and groups are closely tied to the properties of elementary particles, the building blocks of matter, but also to the properties of composite systems. Examples of the latter with particularly simple transformation properties are closed shell atoms, e.g., helium, neon, argon, the magic number nuclei like carbon, or the proton and the neutron made up of three quarks, all composite systems which appear spherical as far as their charge distribution is concerned. In this section we want to investigate how elementary and composite systems are described. To develop a systematic description of rotational properties of composite quantum systems the consideration of rotational transformations is the best starting point. As an illustration we will consider first rotational transformations acting on vectors ~r in 3-dimensional space, i.e., ~r R3, 2 we will then consider transformations of wavefunctions (~r) of single particles in R3, and finally N transformations of products of wavefunctions like j(~rj) which represent a system of N (spin- Qj=1 zero) particles in R3. We will also review below the well-known fact that spin states under rotations behave essentially identical to angular momentum states, i.e., we will find that the algebraic properties of operators governing spatial and spin rotation are identical and that the results derived for products of angular momentum states can be applied to products of spin states or a combination of angular momentum and spin states.
    [Show full text]
  • Two-State Systems
    1 TWO-STATE SYSTEMS Introduction. Relative to some/any discretely indexed orthonormal basis |n) | ∂ | the abstract Schr¨odinger equation H ψ)=i ∂t ψ) can be represented | | | ∂ | (m H n)(n ψ)=i ∂t(m ψ) n ∂ which can be notated Hmnψn = i ∂tψm n H | ∂ | or again ψ = i ∂t ψ We found it to be the fundamental commutation relation [x, p]=i I which forced the matrices/vectors thus encountered to be ∞-dimensional. If we are willing • to live without continuous spectra (therefore without x) • to live without analogs/implications of the fundamental commutator then it becomes possible to contemplate “toy quantum theories” in which all matrices/vectors are finite-dimensional. One loses some physics, it need hardly be said, but surprisingly much of genuine physical interest does survive. And one gains the advantage of sharpened analytical power: “finite-dimensional quantum mechanics” provides a methodological laboratory in which, not infrequently, the essentials of complicated computational procedures can be exposed with closed-form transparency. Finally, the toy theory serves to identify some unanticipated formal links—permitting ideas to flow back and forth— between quantum mechanics and other branches of physics. Here we will carry the technique to the limit: we will look to “2-dimensional quantum mechanics.” The theory preserves the linearity that dominates the full-blown theory, and is of the least-possible size in which it is possible for the effects of non-commutivity to become manifest. 2 Quantum theory of 2-state systems We have seen that quantum mechanics can be portrayed as a theory in which • states are represented by self-adjoint linear operators ρ ; • motion is generated by self-adjoint linear operators H; • measurement devices are represented by self-adjoint linear operators A.
    [Show full text]
  • 10 Group Theory
    10 Group theory 10.1 What is a group? A group G is a set of elements f, g, h, ... and an operation called multipli- cation such that for all elements f,g, and h in the group G: 1. The product fg is in the group G (closure); 2. f(gh)=(fg)h (associativity); 3. there is an identity element e in the group G such that ge = eg = g; 1 1 1 4. every g in G has an inverse g− in G such that gg− = g− g = e. Physical transformations naturally form groups. The elements of a group might be all physical transformations on a given set of objects that leave invariant a chosen property of the set of objects. For instance, the objects might be the points (x, y) in a plane. The chosen property could be their distances x2 + y2 from the origin. The physical transformations that leave unchanged these distances are the rotations about the origin p x cos ✓ sin ✓ x 0 = . (10.1) y sin ✓ cos ✓ y ✓ 0◆ ✓− ◆✓ ◆ These rotations form the special orthogonal group in 2 dimensions, SO(2). More generally, suppose the transformations T,T0,T00,... change a set of objects in ways that leave invariant a chosen property property of the objects. Suppose the product T 0 T of the transformations T and T 0 represents the action of T followed by the action of T 0 on the objects. Since both T and T 0 leave the chosen property unchanged, so will their product T 0 T . Thus the closure condition is satisfied.
    [Show full text]
  • Lecture 6 — Generalized Eigenspaces & Generalized Weight
    18.745 Introduction to Lie Algebras September 28, 2010 Lecture 6 | Generalized Eigenspaces & Generalized Weight Spaces Prof. Victor Kac Scribe: Andrew Geng and Wenzhe Wei Definition 6.1. Let A be a linear operator on a vector space V over field F and let λ 2 F, then the subspace N Vλ = fv j (A − λI) v = 0 for some positive integer Ng is called a generalized eigenspace of A with eigenvalue λ. Note that the eigenspace of A with eigenvalue λ is a subspace of Vλ. Example 6.1. A is a nilpotent operator if and only if V = V0. Proposition 6.1. Let A be a linear operator on a finite dimensional vector space V over an alge- braically closed field F, and let λ1; :::; λs be all eigenvalues of A, n1; n2; :::; ns be their multiplicities. Then one has the generalized eigenspace decomposition: s M V = Vλi where dim Vλi = ni i=1 Proof. By the Jordan normal form of A in some basis e1; e2; :::en. Its matrix is of the following form: 0 1 Jλ1 B Jλ C A = B 2 C B .. C @ . A ; Jλn where Jλi is an ni × ni matrix with λi on the diagonal, 0 or 1 in each entry just above the diagonal, and 0 everywhere else. Let Vλ1 = spanfe1; e2; :::; en1 g;Vλ2 = spanfen1+1; :::; en1+n2 g; :::; so that Jλi acts on Vλi . i.e. Vλi are A-invariant and Aj = λ I + N , N nilpotent. Vλi i ni i i From the above discussion, we obtain the following decomposition of the operator A, called the classical Jordan decomposition A = As + An where As is the operator which in the basis above is the diagonal part of A, and An is the rest (An = A − As).
    [Show full text]
  • Spectral Quantum Tomography
    www.nature.com/npjqi ARTICLE OPEN Spectral quantum tomography Jonas Helsen 1, Francesco Battistel1 and Barbara M. Terhal1,2 We introduce spectral quantum tomography, a simple method to extract the eigenvalues of a noisy few-qubit gate, represented by a trace-preserving superoperator, in a SPAM-resistant fashion, using low resources in terms of gate sequence length. The eigenvalues provide detailed gate information, supplementary to known gate-quality measures such as the gate fidelity, and can be used as a gate diagnostic tool. We apply our method to one- and two-qubit gates on two different superconducting systems available in the cloud, namely the QuTech Quantum Infinity and the IBM Quantum Experience. We discuss how cross-talk, leakage and non-Markovian errors affect the eigenvalue data. npj Quantum Information (2019) 5:74 ; https://doi.org/10.1038/s41534-019-0189-0 INTRODUCTION of the form λ = exp(−γ)exp(iϕ), contain information about the A central challenge on the path towards large-scale quantum quality of the implemented gate. Intuitively, the parameter γ computing is the engineering of high-quality quantum gates. To captures how much the noisy gate deviates from unitarity due to achieve this goal, many methods that accurately and reliably entanglement with an environment, while the angle ϕ can be characterize quantum gates have been developed. Some of these compared to the rotation angles of the targeted gate U. Hence ϕ methods are scalable, meaning that they require an effort which gives information about how much one over- or under-rotates. scales polynomially in the number of qubits on which the gates The spectrum of S can also be related to familiar gate-quality 1–8 act.
    [Show full text]
  • Calculus and Differential Equations II
    Calculus and Differential Equations II MATH 250 B Linear systems of differential equations Linear systems of differential equations Calculus and Differential Equations II Second order autonomous linear systems We are mostly interested with2 × 2 first order autonomous systems of the form x0 = a x + b y y 0 = c x + d y where x and y are functions of t and a, b, c, and d are real constants. Such a system may be re-written in matrix form as d x x a b = M ; M = : dt y y c d The purpose of this section is to classify the dynamics of the solutions of the above system, in terms of the properties of the matrix M. Linear systems of differential equations Calculus and Differential Equations II Existence and uniqueness (general statement) Consider a linear system of the form dY = M(t)Y + F (t); dt where Y and F (t) are n × 1 column vectors, and M(t) is an n × n matrix whose entries may depend on t. Existence and uniqueness theorem: If the entries of the matrix M(t) and of the vector F (t) are continuous on some open interval I containing t0, then the initial value problem dY = M(t)Y + F (t); Y (t ) = Y dt 0 0 has a unique solution on I . In particular, this means that trajectories in the phase space do not cross. Linear systems of differential equations Calculus and Differential Equations II General solution The general solution to Y 0 = M(t)Y + F (t) reads Y (t) = C1 Y1(t) + C2 Y2(t) + ··· + Cn Yn(t) + Yp(t); = U(t) C + Yp(t); where 0 Yp(t) is a particular solution to Y = M(t)Y + F (t).
    [Show full text]
  • Singles out a Specific Basis
    Quantum Information and Quantum Noise Gabriel T. Landi University of Sao˜ Paulo July 3, 2018 Contents 1 Review of quantum mechanics1 1.1 Hilbert spaces and states........................2 1.2 Qubits and Bloch’s sphere.......................3 1.3 Outer product and completeness....................5 1.4 Operators................................7 1.5 Eigenvalues and eigenvectors......................8 1.6 Unitary matrices.............................9 1.7 Projective measurements and expectation values............ 10 1.8 Pauli matrices.............................. 11 1.9 General two-level systems....................... 13 1.10 Functions of operators......................... 14 1.11 The Trace................................ 17 1.12 Schrodinger’s¨ equation......................... 18 1.13 The Schrodinger¨ Lagrangian...................... 20 2 Density matrices and composite systems 24 2.1 The density matrix........................... 24 2.2 Bloch’s sphere and coherence...................... 29 2.3 Composite systems and the almighty kron............... 32 2.4 Entanglement.............................. 35 2.5 Mixed states and entanglement..................... 37 2.6 The partial trace............................. 39 2.7 Reduced density matrices........................ 42 2.8 Singular value and Schmidt decompositions.............. 44 2.9 Entropy and mutual information.................... 50 2.10 Generalized measurements and POVMs................ 62 3 Continuous variables 68 3.1 Creation and annihilation operators................... 68 3.2 Some important
    [Show full text]
  • SUPPLEMENT on EIGENVALUES and EIGENVECTORS We Give
    SUPPLEMENT ON EIGENVALUES AND EIGENVECTORS We give some extra material on repeated eigenvalues and complex eigenvalues. 1. REPEATED EIGENVALUES AND GENERALIZED EIGENVECTORS For repeated eigenvalues, it is not always the case that there are enough eigenvectors. Let A be an n × n real matrix, with characteristic polynomial m1 mk pA(λ) = (λ1 − λ) ··· (λk − λ) with λ j 6= λ` for j 6= `. Use the following notation for the eigenspace, E(λ j ) = {v : (A − λ j I)v = 0 }. We also define the generalized eigenspace for the eigenvalue λ j by gen m j E (λ j ) = {w : (A − λ j I) w = 0 }, where m j is the multiplicity of the eigenvalue. A vector in E(λ j ) is called a generalized eigenvector. The following is a extension of theorem 7 in the book. 0 m1 mk Theorem (7 ). Let A be an n × n matrix with characteristic polynomial pA(λ) = (λ1 − λ) ··· (λk − λ) , where λ j 6= λ` for j 6= `. Then, the following hold. gen (a) dim(E(λ j )) ≤ m j and dim(E (λ j )) = m j for 1 ≤ j ≤ k. If λ j is complex, then these dimensions are as subspaces of Cn. gen n (b) If B j is a basis for E (λ j ) for 1 ≤ j ≤ k, then B1 ∪ · · · ∪ Bk is a basis of C , i.e., there is always a basis of generalized eigenvectors for all the eigenvalues. If the eigenvalues are all real all the vectors are real, then this gives a basis of Rn. (c) Assume A is a real matrix and all its eigenvalues are real.
    [Show full text]