Matrices and Linear Maps

Total Page:16

File Type:pdf, Size:1020Kb

Matrices and Linear Maps Optimization Models EECS 127 / EECS 227AT Laurent El Ghaoui EECS department UC Berkeley Fall 2018 Fa18 1 / 40 LECTURE 3 Matrices and Linear Maps The Matrix is everywhere. It is all around us. Morpheus Fa18 2 / 40 Outline 1 Introduction Basics 2 Matrices as linear maps Range, rank, and nullspace Eigenvalues and eigenvectors PageRank Matrices with special structure 3 Matrix concepts Matrix factorizations Matrix norms Matrix functions Fa18 3 / 40 Introduction A matrix is a collection of numbers, arranged in columns and rows in a tabular format. Suitably defining operations such as sum, product and norms on matrices, we can treat matrices as elements of a vector space. A matrix defines a linear map between an input and an output space. This leads to the introduction of concepts such as range, rank, nullspace, eigenvalues and eigenvectors, that permit a complete analysis of (finite dimensional) linear maps. Matrices are an ubiquitous tool in engineering for organizing and manipulating data. They constitute the fundamental building block of numerical computation methods. Fa18 4 / 40 A data matrix Figure: Votes of US Senators, 2002-2004. Is there anything beyond just an array of numbers? Fa18 5 / 40 Basics We shall mainly deal with matrices whose elements are real (or sometimes complex) numbers, that is with arrays of the form 2 a11 a12 ··· a1n 3 6 a21 a22 ··· a2n 7 A = 6 7 : 6 . .. 7 4 . 5 am1 am2 ··· amn This matrix has m rows and n columns. m;n m;n In the case of real elements, we say that A 2 R , resp. A 2 C in the case of complex elements. The i-th row of A is the (row) vector [ai1 ··· ain]; the j-th column of A is the > (column) vector [a1j ··· amj ] . The transposition operation works on matrices by exchanging rows and columns, that is > [A ]ij = [A]ji ; where the notation [A]ij (or sometimes also simply Aij ) refers to the element of A positioned in row i and column j. Fa18 6 / 40 Example Matrices for networks A network can be represented as a graph of m nodes connected by n directed arcs. Here, we assume that arcs are ordered pairs of nodes, with at most one arc joining any two nodes; we also assume that there are no self-loops (arcs from a node to itself). We can fully describe such kind of network via the so-called (directed) arc-node incidence matrix, which is an m × n matrix defined as follows: 8 < 1 if arc j starts at node i Aij = −1 if arc j ends at node i ; 1 ≤ i ≤ m; 1 ≤ j ≤ n: (1) : 0 otherwise. Fa18 7 / 40 Example Matrices for networks: example 7 4 5 4 6 1 2 3 5 6 1 3 8 2 A network with m = 6 nodes and n = 8 arcs, with (directed) arc-node incidence matrix 2 1 1 0 0 0 0 0 −1 3 6 −1 0 1 0 0 0 0 1 7 6 7 6 0 −1 −1 −1 1 1 0 0 7 A = 6 7 : 6 0 0 0 1 0 0 −1 0 7 4 0 0 0 0 0 −1 1 0 5 0 0 0 0 −1 0 0 0 Fa18 8 / 40 Basics Matrix products m;n n;p Two matrices can be multiplied if conformably sized, i.e., if A 2 R and B 2 R , m;p then the matrix product AB 2 R is defined as a matrix whose (i; j)-th entry is n X [AB]ij = Aik Bkj : k=1 The matrix product is non-commutative, meaning that, in general, AB 6= BA. The n × n identity matrix (often denoted In, or simply I , depending on context), is a matrix with all zero elements, except for the elements on the diagonal (that is, the elements with row index equal to the column index), which are equal to one. This matrix satisfies AIn = A for every matrix A with n columns, and InB = B for every matrix B with n rows. Fa18 9 / 40 Basics Matrix-vector product m;n m n Let A 2 R be a matrix with columns a1;:::; an 2 R and b 2 R a vector. We define the matrix-vector product by n X m;n n Ab = ak bk ; A 2 R ; b 2 R : k=1 m That is, Ab is a vector in R obtained by forming a linear combination of the columns of A, using the elements in b as coefficients. m;n Similarly, we can multiply matrix A 2 R on the left by (the transpose of) vector c 2 m as follows R m > X > m;n m c A = ck αk ; A 2 R ; c 2 R : k=1 > 1;n That is, c A is a vector in R obtained by forming a linear combination of the rows αk of A, using the elements in c as coefficients. Fa18 10 / 40 Matrix-vector product For a network incidence matrix We describe a flow (of goods, traffic, charge, information,7 etc) across the network as a 4 5n vector x 2 R , where the j-th component of 4x denotes6 the amount flowing through arc j. By convention, we use positive values when 1 2 the flow is in the direction of the arc, and 3 negative5 ones in the opposite case. 6 1 3 8 2 The total flow leaving a given node i is then n X Aij xj = [Ax]i ; j=1 where [Ax]i denotes the i-th component of vector Ax. Fa18 11 / 40 Basics Matrix products m;n A matrix A 2 R can also be seen as a collection of columns, each column being a vector, or as a collection of rows, each row being a (transposed) vector: 2 > 3 α1 > 6 α2 7 A = a a ··· a ; or A = 6 7 ; 1 2 n 6 . 7 4 . 5 > αm m > > n where a1;:::; an 2 R denote the columns of A, and α1 ; : : : ; αm 2 R denote the rows of A. n If the columns of B are given by the vectors bi 2 R , i = 1;:::; p, so that B = [b1 ··· bp], then AB can be written as AB = A b1 ::: bp = Ab1 ::: Abp : In other words, AB results from transforming each column bi of B into Abi . Fa18 12 / 40 Basics Matrix products The matrix-matrix product can also be interpreted as an operation on the rows of > A. Indeed, if A is given by its rows αi , i = 1;:::; m, then AB is the matrix > obtained by transforming each one of these rows into αi B, i = 1;:::; m: 2 > 3 2 > 3 α1 α1 B 6 . 7 6 . 7 AB = 4 . 5 B = 4 . 5 : > > αm αm B Finally, the product AB can be given the interpretation as the sum of so-called > > dyadic matrices (matrices of rank one, of the form ai βi , where βi denote the rows of B: n X > m;n n;p AB = ai βi ; A 2 R ; B 2 R : i=1 For any two conformably sized matrices A; B, it holds that (AB)> = B>A>; Fa18 13 / 40 Matrices as linear maps We can interpret matrices as linear maps (vector-valued functions), or \operators," acting from an \input" space to an \output" space. We recall that a map f : X!Y is linear if any points x and z in X and any scalars λ, µ satisfy f (λx + µz) = λf (x) + µf (z). n m m;n Any linear map f : R ! R can be represented by a matrix A 2 R , mapping n m input vectors x 2 R to output vectors y 2 R : y = Ax: Affine maps are simply linear functions plus a constant term, thus any affine map n m f : R ! R can be represented as f (x) = Ax + b; m;n m for some A 2 R , b 2 R . Fa18 14 / 40 Range, rank, and nullspace Consider a m × n matrix A, and denote by ai , i = 1;:::; n, its i-th column, so that A = [a1 ::: an]. The set of vectors y obtained as a linear combination of the ai 's are of the form n y = Ax for some vector x 2 R . This set is commonly known as the range of A, and is denoted R(A): n R(A) = fAx : x 2 R g : By construction, the range is a subspace. The dimension of R(A) is called the rank of A and denoted with rank(A); by definition the rank represents the number of linearly independent columns of A. The rank is also equal to the number of linearly independent rows of A; that is, the rank of A is the same as that of its transpose A>. Proof here: https://en.wikipedia.org/wiki/Rank_(linear_algebra) As a consequence, we always have the bounds 1 ≤ rank(A) ≤ min(m; n). Fa18 15 / 40 Range, rank, and nullspace m;n The nullspace of the matrix A 2 R is the set of vectors in the input space that are mapped to zero, and is denoted N (A): n N (A) = fx 2 R : Ax = 0g : This set is again a subspace. R(A>) and N (A) are mutually orthogonal subspaces, i.e., N (A)? R(A>). The direct sum of a subspace and its orthogonal complement equals the whole space, thus, n ? > R = N (A) ⊕ N (A) = N (A) ⊕ R(A ): Fa18 16 / 40 Fundamental theorem of linear algebra Theorem 1 m;n > > For any given matrix A 2 R , it holds that N (A)? R(A ) and R(A)? N (A ), hence > n N (A) ⊕ R(A ) = R > m R(A) ⊕ N (A ) = R : n Consequently, we can decompose any vector x 2 R as the sum of two vectors orthogonal to each other, one in the range of A>, and the other in the nullspace of A: x = A>ξ + z; z 2 N (A): m Similarly, we can decompose any vector w 2 R as the sum of two vectors orthogonal to each other, one in the range of A, and the other in the nullspace of A>: w = A' + ζ; ζ 2 N (A>): Fa18 17 / 40 Fundamental theorem of linear algebra Geometry 3 Figure: Illustration of the fundamental theorem of linear algebra in R .
Recommended publications
  • Equivalence of A-Approximate Continuity for Self-Adjoint
    Equivalence of A-Approximate Continuity for Self-Adjoint Expansive Linear Maps a,1 b, ,2 Sz. Gy. R´ev´esz , A. San Antol´ın ∗ aA. R´enyi Institute of Mathematics, Hungarian Academy of Sciences, Budapest, P.O.B. 127, 1364 Hungary bDepartamento de Matem´aticas, Universidad Aut´onoma de Madrid, 28049 Madrid, Spain Abstract Let A : Rd Rd, d 1, be an expansive linear map. The notion of A-approximate −→ ≥ continuity was recently used to give a characterization of scaling functions in a multiresolution analysis (MRA). The definition of A-approximate continuity at a point x – or, equivalently, the definition of the family of sets having x as point of A-density – depend on the expansive linear map A. The aim of the present paper is to characterize those self-adjoint expansive linear maps A , A : Rd Rd for which 1 2 → the respective concepts of Aµ-approximate continuity (µ = 1, 2) coincide. These we apply to analyze the equivalence among dilation matrices for a construction of systems of MRA. In particular, we give a full description for the equivalence class of the dyadic dilation matrix among all self-adjoint expansive maps. If the so-called “four exponentials conjecture” of algebraic number theory holds true, then a similar full description follows even for general self-adjoint expansive linear maps, too. arXiv:math/0703349v2 [math.CA] 7 Sep 2007 Key words: A-approximate continuity, multiresolution analysis, point of A-density, self-adjoint expansive linear map. 1 Supported in part in the framework of the Hungarian-Spanish Scientific and Technological Governmental Cooperation, Project # E-38/04.
    [Show full text]
  • LECTURES on PURE SPINORS and MOMENT MAPS Contents 1
    LECTURES ON PURE SPINORS AND MOMENT MAPS E. MEINRENKEN Contents 1. Introduction 1 2. Volume forms on conjugacy classes 1 3. Clifford algebras and spinors 3 4. Linear Dirac geometry 8 5. The Cartan-Dirac structure 11 6. Dirac structures 13 7. Group-valued moment maps 16 References 20 1. Introduction This article is an expanded version of notes for my lectures at the summer school on `Poisson geometry in mathematics and physics' at Keio University, Yokohama, June 5{9 2006. The plan of these lectures was to give an elementary introduction to the theory of Dirac structures, with applications to Lie group valued moment maps. Special emphasis was given to the pure spinor approach to Dirac structures, developed in Alekseev-Xu [7] and Gualtieri [20]. (See [11, 12, 16] for the more standard approach.) The connection to moment maps was made in the work of Bursztyn-Crainic [10]. Parts of these lecture notes are based on a forthcoming joint paper [1] with Anton Alekseev and Henrique Bursztyn. I would like to thank the organizers of the school, Yoshi Maeda and Guiseppe Dito, for the opportunity to deliver these lectures, and for a greatly enjoyable meeting. I also thank Yvette Kosmann-Schwarzbach and the referee for a number of helpful comments. 2. Volume forms on conjugacy classes We will begin with the following FACT, which at first sight may seem quite unrelated to the theme of these lectures: FACT. Let G be a simply connected semi-simple real Lie group. Then every conjugacy class in G carries a canonical invariant volume form.
    [Show full text]
  • NOTES on DIFFERENTIAL FORMS. PART 3: TENSORS 1. What Is A
    NOTES ON DIFFERENTIAL FORMS. PART 3: TENSORS 1. What is a tensor? 1 n Let V be a finite-dimensional vector space. It could be R , it could be the tangent space to a manifold at a point, or it could just be an abstract vector space. A k-tensor is a map T : V × · · · × V ! R 2 (where there are k factors of V ) that is linear in each factor. That is, for fixed ~v2; : : : ;~vk, T (~v1;~v2; : : : ;~vk−1;~vk) is a linear function of ~v1, and for fixed ~v1;~v3; : : : ;~vk, T (~v1; : : : ;~vk) is a k ∗ linear function of ~v2, and so on. The space of k-tensors on V is denoted T (V ). Examples: n • If V = R , then the inner product P (~v; ~w) = ~v · ~w is a 2-tensor. For fixed ~v it's linear in ~w, and for fixed ~w it's linear in ~v. n • If V = R , D(~v1; : : : ;~vn) = det ~v1 ··· ~vn is an n-tensor. n • If V = R , T hree(~v) = \the 3rd entry of ~v" is a 1-tensor. • A 0-tensor is just a number. It requires no inputs at all to generate an output. Note that the definition of tensor says nothing about how things behave when you rotate vectors or permute their order. The inner product P stays the same when you swap the two vectors, but the determinant D changes sign when you swap two vectors. Both are tensors. For a 1-tensor like T hree, permuting the order of entries doesn't even make sense! ~ ~ Let fb1;:::; bng be a basis for V .
    [Show full text]
  • Tensor Products
    Tensor products Joel Kamnitzer April 5, 2011 1 The definition Let V, W, X be three vector spaces. A bilinear map from V × W to X is a function H : V × W → X such that H(av1 + v2, w) = aH(v1, w) + H(v2, w) for v1,v2 ∈ V, w ∈ W, a ∈ F H(v, aw1 + w2) = aH(v, w1) + H(v, w2) for v ∈ V, w1, w2 ∈ W, a ∈ F Let V and W be vector spaces. A tensor product of V and W is a vector space V ⊗ W along with a bilinear map φ : V × W → V ⊗ W , such that for every vector space X and every bilinear map H : V × W → X, there exists a unique linear map T : V ⊗ W → X such that H = T ◦ φ. In other words, giving a linear map from V ⊗ W to X is the same thing as giving a bilinear map from V × W to X. If V ⊗ W is a tensor product, then we write v ⊗ w := φ(v ⊗ w). Note that there are two pieces of data in a tensor product: a vector space V ⊗ W and a bilinear map φ : V × W → V ⊗ W . Here are the main results about tensor products summarized in one theorem. Theorem 1.1. (i) Any two tensor products of V, W are isomorphic. (ii) V, W has a tensor product. (iii) If v1,...,vn is a basis for V and w1,...,wm is a basis for W , then {vi ⊗ wj }1≤i≤n,1≤j≤m is a basis for V ⊗ W .
    [Show full text]
  • Determinants in Geometric Algebra
    Determinants in Geometric Algebra Eckhard Hitzer 16 June 2003, recovered+expanded May 2020 1 Definition Let f be a linear map1, of a real linear vector space Rn into itself, an endomor- phism n 0 n f : a 2 R ! a 2 R : (1) This map is extended by outermorphism (symbol f) to act linearly on multi- vectors f(a1 ^ a2 ::: ^ ak) = f(a1) ^ f(a2) ::: ^ f(ak); k ≤ n: (2) By definition f is grade-preserving and linear, mapping multivectors to mul- tivectors. Examples are the reflections, rotations and translations described earlier. The outermorphism of a product of two linear maps fg is the product of the outermorphisms f g f[g(a1)] ^ f[g(a2)] ::: ^ f[g(ak)] = f[g(a1) ^ g(a2) ::: ^ g(ak)] = f[g(a1 ^ a2 ::: ^ ak)]; (3) with k ≤ n. The square brackets can safely be omitted. The n{grade pseudoscalars of a geometric algebra are unique up to a scalar factor. This can be used to define the determinant2 of a linear map as det(f) = f(I)I−1 = f(I) ∗ I−1; and therefore f(I) = det(f)I: (4) For an orthonormal basis fe1; e2;:::; eng the unit pseudoscalar is I = e1e2 ::: en −1 q q n(n−1)=2 with inverse I = (−1) enen−1 ::: e1 = (−1) (−1) I, where q gives the number of basis vectors, that square to −1 (the linear space is then Rp;q). According to Grassmann n-grade vectors represent oriented volume elements of dimension n. The determinant therefore shows how these volumes change under linear maps.
    [Show full text]
  • 28. Exterior Powers
    28. Exterior powers 28.1 Desiderata 28.2 Definitions, uniqueness, existence 28.3 Some elementary facts 28.4 Exterior powers Vif of maps 28.5 Exterior powers of free modules 28.6 Determinants revisited 28.7 Minors of matrices 28.8 Uniqueness in the structure theorem 28.9 Cartan's lemma 28.10 Cayley-Hamilton Theorem 28.11 Worked examples While many of the arguments here have analogues for tensor products, it is worthwhile to repeat these arguments with the relevant variations, both for practice, and to be sensitive to the differences. 1. Desiderata Again, we review missing items in our development of linear algebra. We are missing a development of determinants of matrices whose entries may be in commutative rings, rather than fields. We would like an intrinsic definition of determinants of endomorphisms, rather than one that depends upon a choice of coordinates, even if we eventually prove that the determinant is independent of the coordinates. We anticipate that Artin's axiomatization of determinants of matrices should be mirrored in much of what we do here. We want a direct and natural proof of the Cayley-Hamilton theorem. Linear algebra over fields is insufficient, since the introduction of the indeterminate x in the definition of the characteristic polynomial takes us outside the class of vector spaces over fields. We want to give a conceptual proof for the uniqueness part of the structure theorem for finitely-generated modules over principal ideal domains. Multi-linear algebra over fields is surely insufficient for this. 417 418 Exterior powers 2. Definitions, uniqueness, existence Let R be a commutative ring with 1.
    [Show full text]
  • Math 395. Tensor Products and Bases Let V and V Be Finite-Dimensional
    Math 395. Tensor products and bases Let V and V 0 be finite-dimensional vector spaces over a field F . Recall that a tensor product of V and V 0 is a pait (T, t) consisting of a vector space T over F and a bilinear pairing t : V × V 0 → T with the following universal property: for any bilinear pairing B : V × V 0 → W to any vector space W over F , there exists a unique linear map L : T → W such that B = L ◦ t. Roughly speaking, t “uniquely linearizes” all bilinear pairings of V and V 0 into arbitrary F -vector spaces. In class it was proved that if (T, t) and (T 0, t0) are two tensor products of V and V 0, then there exists a unique linear isomorphism T ' T 0 carrying t and t0 (and vice-versa). In this sense, the tensor product of V and V 0 (equipped with its “universal” bilinear pairing from V × V 0!) is unique up to unique isomorphism, and so we may speak of “the” tensor product of V and V 0. You must never forget to think about the data of t when you contemplate the tensor product of V and V 0: it is the pair (T, t) and not merely the underlying vector space T that is the focus of interest. In this handout, we review a method of construction of tensor products (there is another method that involved no choices, but is horribly “big”-looking and is needed when considering modules over commutative rings) and we work out some examples related to the construction.
    [Show full text]
  • 1 the Spin Homomorphism SL2(C) → SO1,3(R) a Summary from Multiple Sources Written by Y
    1 The spin homomorphism SL2(C) ! SO1;3(R) A summary from multiple sources written by Y. Feng and Katherine E. Stange Abstract We will discuss the spin homomorphism SL2(C) ! SO1;3(R) in three manners. Firstly we interpret SL2(C) as acting on the Minkowski 1;3 spacetime R ; secondly by viewing the quadratic form as a twisted 1 1 P × P ; and finally using Clifford groups. 1.1 Introduction The spin homomorphism SL2(C) ! SO1;3(R) is a homomorphism of classical matrix Lie groups. The lefthand group con- sists of 2 × 2 complex matrices with determinant 1. The righthand group consists of 4 × 4 real matrices with determinant 1 which preserve some fixed real quadratic form Q of signature (1; 3). This map is alternately called the spinor map and variations. The image of this map is the identity component + of SO1;3(R), denoted SO1;3(R). The kernel is {±Ig. Therefore, we obtain an isomorphism + PSL2(C) = SL2(C)= ± I ' SO1;3(R): This is one of a family of isomorphisms of Lie groups called exceptional iso- morphisms. In Section 1.3, we give the spin homomorphism explicitly, al- though these formulae are unenlightening by themselves. In Section 1.4 we describe O1;3(R) in greater detail as the group of Lorentz transformations. This document describes this homomorphism from three distinct per- spectives. The first is very concrete, and constructs, using the language of Minkowski space, Lorentz transformations and Hermitian matrices, an ex- 4 plicit action of SL2(C) on R preserving Q (Section 1.5).
    [Show full text]
  • Inner Product Spaces
    CHAPTER 6 Woman teaching geometry, from a fourteenth-century edition of Euclid’s geometry book. Inner Product Spaces In making the definition of a vector space, we generalized the linear structure (addition and scalar multiplication) of R2 and R3. We ignored other important features, such as the notions of length and angle. These ideas are embedded in the concept we now investigate, inner products. Our standing assumptions are as follows: 6.1 Notation F, V F denotes R or C. V denotes a vector space over F. LEARNING OBJECTIVES FOR THIS CHAPTER Cauchy–Schwarz Inequality Gram–Schmidt Procedure linear functionals on inner product spaces calculating minimum distance to a subspace Linear Algebra Done Right, third edition, by Sheldon Axler 164 CHAPTER 6 Inner Product Spaces 6.A Inner Products and Norms Inner Products To motivate the concept of inner prod- 2 3 x1 , x 2 uct, think of vectors in R and R as x arrows with initial point at the origin. x R2 R3 H L The length of a vector in or is called the norm of x, denoted x . 2 k k Thus for x .x1; x2/ R , we have The length of this vector x is p D2 2 2 x x1 x2 . p 2 2 x1 x2 . k k D C 3 C Similarly, if x .x1; x2; x3/ R , p 2D 2 2 2 then x x1 x2 x3 . k k D C C Even though we cannot draw pictures in higher dimensions, the gener- n n alization to R is obvious: we define the norm of x .x1; : : : ; xn/ R D 2 by p 2 2 x x1 xn : k k D C C The norm is not linear on Rn.
    [Show full text]
  • Linear Maps on Rn
    Linear maps on Rn Linear structure of Rn n I The vector space R has a linear structure with two features: n n I Vector addition: For all u; v 2 R we have u + v 2 R with the components (u + v)i = ui + vi for 1 ≤ i ≤ n with respect, say, to the standard basis vectors of Rn. n I Scalar multiplication: For all u 2 R and all c 2 R, we n have cu 2 R with the components (cu)i = cui for 1 ≤ i ≤ n. I Note that these two structures exist independent of any particular basis we choose to represent the coordinates of vectors. cu u+v v u u Convex combination of vectors 2 I The convex combination of any two vectors u; v 2 R is the line segment au + bv joining u and v, where 0 ≤ a ≤ 1, 0 ≤ b ≤ 1 and a + b = 1. v u I Similarly, the convex combination of three vectors u; v; w 2 R3 is the triangle au + bv + cw with vertices u, v and w, where 0 ≤ a; b; c ≤ 1 and a + b + c = 1. w v u Scalar product of vectors 3 I Given two vectors u; v 2 R , with coordinates 2 3 2 3 u1 v1 u = 4u25 v = 4v25 u3 v3 their scalar product is given by 3 X u · v = ui vi = kukkvk cos θ; i=1 q 2 2 2 where kuk = u1 + u2 + u3 and θ is the angle between u and v. Check this formula in R2! v u θ Scalar product and coordinates I Note that the lengths kuk and kvk as well as the angle θ are independent of the three mutually perpendicular axes used to determine the coordinates of u and v.
    [Show full text]
  • Differential Geometry: Discrete Exterior Calculus
    Differential Geometry: Discrete Exterior Calculus [Discrete Exterior Calculus (Thesis). Hirani, 2003] [Discrete Differential Forms for Computational Modeling. Desbrun et al., 2005] [Build Your Own DEC at Home. Elcott et al., 2006] Chains Recall: A k-chain of a simplicial complex Κ is linear combination of the k-simplices in Κ: c = ∑c(σ )⋅σ σ∈Κ k where c is a real-valued function. The dual of a k-chain is a k-cochain which is a linear map taking a k-chain to a real value. Chains and cochains related through evaluation: –Cochains: What we integrate –Chains: What we integrate over Boundary Operator Recall: The boundary ∂σ of a k-simplex σ is the signed union of all (k-1)-faces. ∂ ∂ ∂ ∂ +1 -1 The boundary operator extends linearly to act on chains: ∂c = ∂ ∑c(σ )⋅σ = ∑c(σ )⋅∂σ σ∈Κ k σ∈Κ k Discrete Exterior Derivative Recall: The exterior derivative d:Ωk→ Ωk+1 is the operator on cochains that is the complement of the boundary operator, defined to satisfy Stokes’ Theorem. -1 -2 -1 -3.5 -2 0.5 0.5 2 0 0.5 2 0 0.5 2 1.5 1 1 Since the boundary of the boundary is empty: ∂∂ = 0 dd = 0 The Laplacian Definition: The Laplacian of a function f is a function defined as the divergence of the gradient of f: ∆f = div(∇f ) = ∇ ⋅∇f The Laplacian Definition: The Laplacian of a function f is a function defined as the divergence of the gradient of f: ∆f = div(∇f ) = ∇ ⋅∇f Q.
    [Show full text]
  • 4 Exterior Algebra
    4 Exterior algebra 4.1 Lines and 2-vectors The time has come now to develop some new linear algebra in order to handle the space of lines in a projective space P (V ). In the projective plane we have seen that duality can deal with this but lines in higher dimensional spaces behave differently. From the point of view of linear algebra we are looking at 2-dimensional vector sub- spaces U ⊂ V . To motivate what we shall do, consider how in Euclidean geometry we describe a 2-dimensional subspace of R3. We could describe it through its unit normal n, which is also parallel to u×v where u and v are linearly independent vectors in the space and u×v is the vector cross product. The vector product has the following properties: • u×v = −v×u • (λ1u1 + λ2u2)×v = λ1u1×v + λ2u2×v We shall generalize these properties to vectors in any vector space V – the difference is that the product will not be a vector in V , but will lie in another associated vector space. Definition 12 An alternating bilinear form on a vector space V is a map B : V × V → F such that • B(v, w) = −B(w, v) • B(λ1v1 + λ2v2, w) = λ1B(v1, w) + λ2B(v2, w) This is the skew-symmetric version of the symmetric bilinear forms we used to define quadrics. Given a basis {v1, . , vn}, B is uniquely determined by the skew symmetric matrix B(vi, vj). We can add alternating forms and multiply by scalars so they form a vector space, isomorphic to the space of skew-symmetric n × n matrices.
    [Show full text]