Linear Algebra and Matrices

Size: px
Start display at page:

Download "Linear Algebra and Matrices"

Transcription

1 Linear Algebra and Matrices 4 Overview In this chapter we studying true matrix operations, not element operations as was done in earlier chapters. Working with MAT- LAB functions should now be fairly routine. The challenge we are now faced with is understanding linear algebra concepts and the significance of linear algebra as applied to engineering problem solving. Since linear algebra is not a prerequisite for this course, we will proceed with caution as we introduce the various definitions and matrix properties. Matrix Operations In this section the fundamental matrix properties of transpose, dot product, multiplication, matrix power, and matrix polynomials are introduced. Transpose Consider a general rectangular matrix of size by columns) N M (rows Chapter 4: Overview 4 1

2 A [ ] a ij a 11 a 12 a 13 a 21 a 22 a 23 a 31 a 32 a 33 a 41 a 42 a 43 The matrix transpose is the interchanging of the rows and columns of A and is denoted with superscript T In particular the element a ij is now located in the a ji position, that is a ij a ji a 11 a 21 a 31 a 41 A T a 12 a 22 a 32 a 42 a 13 a 23 a 33 a 43 As specific numerical case is B 12 34, B T In MATLAB a matrix B is transposed via B» B [1 2 3;4 5 6] B Chapter 4: Matrix Operations 4 2

3 » B' ans Dot Product The dot product operator should be familiar from analytic geometry kˆ Angle between Plane Formed By Vectors A and B A θ B ˆ j A and B in the plane formed by AB ˆ i A B A B cosθ If the vectors A and B are defined as follows: A a 1 î + a 2 ĵ + a 3 kˆ B b 1 î + b 2 ĵ + b 3 kˆ the dot product A B dot product is the scalar A B 3 i 1 a i b i Chapter 4: Matrix Operations 4 3

4 In general, for an N-dimensional vector, dot product The MATLAB operator for dot product is dot(a,b) Matrix Multiplication A B i 1 a i b i For the matrix multiplication AB C to make sense we first must make sure the number of columns in B matches the number of rows in B We then proceed to multiply each row of A by the columns of B to form a new matrix of dimension rows of A by columns of B, that is A N Note: We might be able to form AB but not BA Mathematically matrix multiplication is such that each element in C is of the form of a row-column dot product Note: For i and j fixed k spans the ith row of A and the jth column of B, thus forming a dot product between a row and column of A and B respectively N M B M P C N P c ij N k 1 a ik b kj Chapter 4: Matrix Operations 4 4

5 A pictorial view of matrix multiplication as row column dot products R 1 A B R 2 R N C 1 C 2 C P Columns Rows M R 1 C 1 R 1 C 2 R 1 C P C R 2 C 1 R 2 C 2 R i C j R N C 1 R N C P Example: A 25 1, B and form AB C The dimensions conform so we may proceed The c 11 element of C is Chapter 4: Matrix Operations 4 5

6 c ( 1 ) The c 22 is 0 c ( 1 ) Solving for all of the remaining entries in like fashion we obtain In MATLAB matrix multiplication follows naturally, except we no not use * instead of.*» A [2 5 1; 0 3-1];» B [1 0 2; ; 5 2 1];» C A*B C Matrix Powers We are familiar with the concept of scalar powers, e.g., a 5 a 3 What about matrix powers? C AB Chapter 4: Matrix Operations 4 6

7 In MATLAB we know that 2 a 11 2 a 12 A.^2 2 a 21 2 a 33 that is each element of the matrix is squared To raise a matrix to a power using the rules of matrix algebra is A 2 A A A 4 A A A A For this operation work the matrix must be square (same number of rows as columns)» A [1 2; 3 4] A » [A^2 A^4] ans Chapter 4: Matrix Operations 4 7

8 Matrix Polynomials Extending the idea of a matrix power a bit further we can talk about matrix polynomials For a scalar x we have previously defined the Nth degree polynomial fx ( ) as fx ( ) a 0 x N + a 1 x N a N 1 x+ a N If x is a matrix, then the corresponding matrix polynomial involves matrix power rather than scalar powers MATLAB has a function, polyvalm(a,x) that evaluates a matrix polynomial much like polyval(a,x) evaluates a polynomial Note: The matrix x must be a square matrix A significant difference between the two is that while polyval returns a vector or a scalar depending upon what the input x is, polyvalm will always return a matrix of the same size as the input matrix x What good are they? They find use in the study of feedback control systems, in particular approximating the state transition matrix (see ECE 3510 (Linear Systems) and ECE 4510 (Feedback & Control) Chapter 4: Matrix Operations 4 8

9 Example: Variants on Practice! p. 130 Use MATLAB to define the following matrices. Then compute the specified matrices, if they exist. Also check your work via a hand calculation. A , B C , D » A [2 1; 0-1; 3 0]; B [1 3; -1 5];» C [3 2; -1-2; 0 2]; D [1 2]; 1. Find CB 2» C*B^2 ans Chapter 4: Matrix Operations 4 9

10 Check this! CB Find C T A» C'*A ans Check this! C T 2 1 A Chapter 4: Matrix Operations 4 10

11 Problems Solving Applied: Protein Molecular Weights (text p ) Here we wish to compute the molecular weight of a particular protein molecule Each protein molecule is composed of different amounts of up to 20 amino acids, each having a specific molecular weight An instrument called a protein sequencer can extract the order of the amino acids in a given protein molecule The protein sequencer output is a row vector containing 20 integers, say protein in MATLAB or when read from a data file is a vector or perhaps a matrix whose rows correspond to many sequencer outputs prot1 [ ]; The value of each integer is the number of molecules of a corresponding amino acid (the list is alphabetical) If we put all of the corresponding amino acids weights in another vector of length 20, say amino_weight, we can find the weight of a particular protein molecule by forming the dot product between the sequencer output vector (matrix) and the amino acids weight vector prot1_weight dot(prot1,amino_weight); For more details see the text Chapter 4: Problems Solving Applied: Protein Molecular Weights (text p ) 4 11

12 Matrix Functions The first section of this chapter discussed matrix transpose and multiplication. The next level of complexity in matrix manipulations are matrix inverse, determinant, and finally eigenvectors and eigenvalues. Matrix Inverse and Rank The inverse of a matrix, A, if it exists, is a matrix, that A 1, such AA 1 I Note: If AA 1 I, then also A 1 A I The true inverse of a matrix only makes sense if A is a square matrix, that is A is N N In general a special numerical algorithm is needed to find the inverse of a matrix For a 2 2 matrix we can write out the equations without too much trouble Chapter 4: Matrix Functions 4 12

13 Consider ab cd AB CD (4.1) We must have aa+ bc 1 ab+ bd 0 ca+ dc 0 cb+ dd 1 (4.2) Solving for ABCand,,, D in terms of abcand,,, d by first eliminating C and D C D c --A d a --B b (4.3) Upon substitution aa cb b c d --A 1 A d a b --B 1 B d ad bc and inserting (4.4) and (4.5) into (4.3) results in C c ad , bc D b ad bc a ad bc (4.4) (4.5) (4.6) Chapter 4: Matrix Functions 4 13

14 In summary, if A ab cd (4.7) A 1 1 ad d b bc c a, for ad bc 0 (4.8) To check (4.8) we take (4.7) times (4.8) AA 1 ab d b ad bc ad bc cd c a ad bc ad bc ad bc ab + ab ad bc ad bc cd cd bc + ad ad bc ad bc (4.9) For the case of the ad bc we see that the inverse only exists if If a matrix is singular or ill-conditioned it does not have an inverse A related quantity to the inverse is the rank of a matrix If we view a matrix as corresponding to a system of equations (row-wise), the number of independent equations is the rank of the matrix Chapter 4: Matrix Functions 4 14

15 If the rank of a matrix is the number of rows in the matrix, then the matrix is nonsingular and the matrix inverse exists A special algorithm can be used to determine numerically the rank of a matrix MATLAB has functions for computing the inverse and rank of a square matrix rank(a) computes the rank of a matrix inv(a) computes the inverse of a matrix if it exists; an error message is printed if the inverse does not exist Example: Consider» A [2 1; 4 3];» rank(a) ans 2» inv(a) ans » A*inv(A) ans A Chapter 4: Matrix Functions 4 15

16 Check to see if the inverse agrees with the formula in (4.8) A (checks) The text author suggests that we first check to see if the inverse exists via the rank test, before attempting to compute the matrix inverse Determinants The determinant is a scalar quantity that arises in matrix problems The determinant of matrix A is denoted by The determinant often appears in problems dealing with the matrix inverse For a 2 2 matrix with A A a 11 a 12 A a 11 a 22 a 12 a 21 a 21 a 22 Note: for the 2 2 A A a 22 a 12 a 21 a 11 Chapter 4: Matrix Functions 4 16

17 A determinant of zero means the matrix is singular (inverse does not exist) For a 3 3 the determinant is computed according to the following rule A a 11 a 12 a 13 a 21 a 22 a 23 Add the product of the solid line linked entries and subtract the product of the dashed line linked entries (3 of each type) a 31 a 32 a 33 a 11 a 22 a 33 + a 12 a 23 a 31 + a 21 a 32 a 13 -a 31 a 22 a 13 a 21 a 12 a 33 a 32 a 23 a 11 The MATLAB function for computing the determinant of a square matrix is det(a) Example: A 2 2 and a 3 3» A [1 2; 3 4];» det(a) ans -2 A 12 A Chapter 4: Matrix Functions 4 17

18 B B 15 ( )9 ( ) + 26 ( )7 ( ) + 48 ( )3 ( ) -75 ( )3 ( ) 42 ( )9 ( ) 86 ( )1 ( ) 0» B [1 2 3; 4 5 6; 7 8 9];» det(b) ans 0» rank(b) ans 2 % Must be three to be invertable!» inv(b) Warning: Matrix is close to singular or badly scaled. Results may be inaccurate. RCOND e ans 1.0e+016 * Example: Variants on Practice! p Use MATLAB to define the following matrices. Then compute he specified matrices and determinants if they exist. For the case of 2 2 and 3 3 determinants check your answers by hand. Do not worry about calculating the 3 3 inverse by hand. Chapter 4: Matrix Functions 4 18

19 E , F » E [2 1 0; 5 7 2; 6 1 0];» F [-1 0 4; 3 2 1; 0-1 5]; 1. Find ( EF T ) 1» rank(e*f') ans 3 # Inverse exits» E*F' ans » inv(e*f') ans Find EF T» E*F' ans » det(e*f') ans -184 Check the determinant by hand calculating using the given above EF T Chapter 4: Matrix Functions 4 19

20 EF T 231 ( )( 1) + 83 ( )( 6) ( )( 1) -( 6) ( 31) ( 1) 38 ( )( 1) 20( 3 )( 2) 184 Problem Solving Applied: A Simple Pattern Recognition Model In the field of pattern recognition we typically have as input to the recognition scheme a set of measurements in vector form, say corresponding to a collection of sensor outputs or pattern features we observe By training the pattern classifier using representative samples from each pattern class, we then have a system that can take a new measurement vector and decide which class it belongs to Applications include image recognition (hand writing, finger prints, radar targets), voice recognition, etc. A statistical model for the measurement vectors of each class is that they are normally (Gaussian) distributed of dimension n, with a particular mean vector and covariance matrix C The covariance matrix tells us how each of the components in the measurement vectors are statistically related to one another for a given class Chapter 4: Problem Solving Applied: A Simple Pattern Recognition Model 4 20

21 C c 11 c 12 c 1n c 21 c 22 c 2n c n1 c n2 c nn Using the model described above the pattern recognition scheme computes a recognition function r ij ( x) for each input vector x The so called maximum likelihood ratio test results in r ij ( x) x T C 1 1 ( m i m j ) --m ( 2 i + m j ) T C 1 ( m i m j ) where the and are mean vectors associated with each m i m j class, C is the covariance matrix, here assumed to be the same for all classes; there are M different classes to choose from By sequencing through all the ij pairs, except i j, we chose the largest and say if a particular observation r kj ( x) is largest then x belongs to class k { 12,,, M} Chapter 4: Problem Solving Applied: A Simple Pattern Recognition Model 4 21

22 Eigenvectors and Eigenvalues Consider A an n n (square) matrix which satisfies AX λx where X is a column vector ( n 1) and λ is a scalar (4.10) Assuming X is nonzero we call X an eigenvector (proper values) of matrix A and λ the corresponding eigenvalue We can rewrite (4.10) as a set of homogeneous equations where I is an n n ( A λi)x 0 identity matrix (4.11) Since X is nonzero, we can only obtain zero on the left side of (4.11) if and only if det( A λi) A λi 0 (4.12) When multiplied out (4.12) becomes what is known as the characteristic equation corresponding to matrix A The roots of the characteristic equation are the eigenvalues of A Since the characteristic polynomial is nth degree, there are n total eigenvalues (roots) The MATLAB function eig(a) returns a column vector containing the eigenvalues of A Chapter 4: Problem Solving Applied: A Simple Pattern Recognition Model 4 22

23 Example: Consider A We must solve λ 10 1 λ λ ( 1 λ)4 ( λ) + 2 λ 2 5λ + 6 The eigenvalues are Check using MATLAB» A [1 1; -2 4];» eig(a) ans ( ) λ λ Chapter 4: Problem Solving Applied: A Simple Pattern Recognition Model 4 23

24 We obtain the corresponding eigenvectors by solving 1 λ i λ i x 1 0 x 2 0, for i 1,2 Case 1: λ 1 3 which implies x 1 0 x 2 0 or x 2 2x 1 Thus the eigenvector corresponding to X 1 α λ 1 is of the form where α 1 can be any number λ2 2 Case 2: For x 1 0 x 2 0 or x 2 x 1 Chapter 4: Problem Solving Applied: A Simple Pattern Recognition Model 4 24

25 Thus the eigenvector corresponding to X 2 α λ 1 is of the form where α 2 can be any number Symmetric Matrices with Distinct Eigenvalues: If the matrix A is n n and symmetric, that is A A T, and the corresponding eigenvalues are distinct, then the eigenvectors will be orthogonal. Orthogonal eigenvectors means that the dot product of say X 1 with X 2 is zero, while the dot product of X 1 with itself gives use the length of squared X 1 Orthonormal eigenvectors means that they are orthogonal, with the additional feature being that they have unit length Note: We can normalize an eigenvector to unit have length as follows: Now, x X 1 i x 2 X i X i X i x x 1 + x 2 x 2 Chapter 4: Problem Solving Applied: A Simple Pattern Recognition Model 4 25

26 An expanded version of the MATLAB function eig() is [Q,d] eig(a); where Q is a matrix whose columns are the eigenvectors of A normalized to unity length and d is a diagonal matrix whose entries are the corresponding eigenvalues of A If A is symmetric and has distinct eigenvalues, then Example: Variant to Practice! p. 139 Consider the matrix 1. Determine the eigenvalues of A» A [0 0-2; 0-2 0; ];» eig(a) ans Q Q T I Identity Matrix Thus λ 1 2, λ 2 1, and λ 3 4 A Chapter 4: Problem Solving Applied: A Simple Pattern Recognition Model 4 26

27 2. Determine the corresponding set of orthonormal eigenvectors Note: The eigenvalues are distinct and A is symmetric, so we expect to have orthogonal (with MATLAB orthonormal) eigenvectors» [Q,d] eig(a);» Q Q Thus Are they orthonormal? If so» Q*Q' ans X 1 01, X 2 0, X QQ T Compute the determinant A λi and verify that for each eigenvalue it is zero» det(a - (-2)*eye(3)) To be more precise we may ans 0 use d(1,1) λ 1 I Chapter 4: Problem Solving Applied: A Simple Pattern Recognition Model 4 27

28 » det(a - (-1)*eye(3)) ans 0» det(a - (4)*eye(3)) ans 0 4. Show that AQ Ad where Q is the matrix containing the eigenvectors as columns and d is the matrix containing the corresponding eigenvalues on the main diagonal and zeros elsewhere» A*Q ans» Q*d ans % They agree! Chapter 4: Problem Solving Applied: A Simple Pattern Recognition Model 4 28

29 Decompositions Matrices, square or rectangular, can be decomposed or factored into products of special matrices Triangular Factorization: For A a square matrix we can always write it as a product of a lower triangular matrix and an upper triangular matrix (LU factorization). A LU. This is accomplished by performing row and column operations on A Assuming U is computed first it may be that interchanging rows is required, thus L may not be in strict lower triangular form The MATLAB function [L,U] lu(a); takes A and returns the upper triangular factor matrix U and the lower triangular factor matrix L such that LU A Example: A » A [1 2 3; 0 4 6; 1-4 7];» [L,U] lu(a);» L Chapter 4: Problem Solving Applied: A Simple Pattern Recognition Model 4 29

30 L » U U» L*U ans QR Factorization: Here factorization of matrix A produces an orthonormal matrix (matrix Q is orthonormal if QQ T I) times an upper triangular matrix, R. A QR The matrix A does not have to be square The MATLAB function [Q,R] qr(a) returns orthonormal matrix Q and upper triangular matrix R such that A QR Note: for A m n, Q is m m and R is m n Chapter 4: Problem Solving Applied: A Simple Pattern Recognition Model 4 30

31 Example: Use A from the above example.» [Q,R] qr(a);» Q Q » R R» Q*R ans rectangu- Singular Value Decomposition (SVD): For an m lar matrix A, the SVD is the triple matrix product A USV where both U and V are orthogonal matrices and S is a diagonal matrix composed of the singular values of A. n Chapter 4: Problem Solving Applied: A Simple Pattern Recognition Model 4 31

32 The MATLAB function [U,S,V} svd(a) returns U as a m m matrix, S as a m n matrix, and V as a n n matrix Chapter 4: Problem Solving Applied: A Simple Pattern Recognition Model 4 32

Math Bootcamp An p-dimensional vector is p numbers put together. Written as. x 1 x =. x p

Math Bootcamp An p-dimensional vector is p numbers put together. Written as. x 1 x =. x p Math Bootcamp 2012 1 Review of matrix algebra 1.1 Vectors and rules of operations An p-dimensional vector is p numbers put together. Written as x 1 x =. x p. When p = 1, this represents a point in the

More information

Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition

Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition Prof. Tesler Math 283 Fall 2016 Also see the separate version of this with Matlab and R commands. Prof. Tesler Diagonalizing

More information

Conceptual Questions for Review

Conceptual Questions for Review Conceptual Questions for Review Chapter 1 1.1 Which vectors are linear combinations of v = (3, 1) and w = (4, 3)? 1.2 Compare the dot product of v = (3, 1) and w = (4, 3) to the product of their lengths.

More information

Linear Algebra Review. Vectors

Linear Algebra Review. Vectors Linear Algebra Review 9/4/7 Linear Algebra Review By Tim K. Marks UCSD Borrows heavily from: Jana Kosecka http://cs.gmu.edu/~kosecka/cs682.html Virginia de Sa (UCSD) Cogsci 8F Linear Algebra review Vectors

More information

CS 246 Review of Linear Algebra 01/17/19

CS 246 Review of Linear Algebra 01/17/19 1 Linear algebra In this section we will discuss vectors and matrices. We denote the (i, j)th entry of a matrix A as A ij, and the ith entry of a vector as v i. 1.1 Vectors and vector operations A vector

More information

Math Linear Algebra Final Exam Review Sheet

Math Linear Algebra Final Exam Review Sheet Math 15-1 Linear Algebra Final Exam Review Sheet Vector Operations Vector addition is a component-wise operation. Two vectors v and w may be added together as long as they contain the same number n of

More information

MATRICES. a m,1 a m,n A =

MATRICES. a m,1 a m,n A = MATRICES Matrices are rectangular arrays of real or complex numbers With them, we define arithmetic operations that are generalizations of those for real and complex numbers The general form a matrix of

More information

Knowledge Discovery and Data Mining 1 (VO) ( )

Knowledge Discovery and Data Mining 1 (VO) ( ) Knowledge Discovery and Data Mining 1 (VO) (707.003) Review of Linear Algebra Denis Helic KTI, TU Graz Oct 9, 2014 Denis Helic (KTI, TU Graz) KDDM1 Oct 9, 2014 1 / 74 Big picture: KDDM Probability Theory

More information

Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition

Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition Prof. Tesler Math 283 Fall 2018 Also see the separate version of this with Matlab and R commands. Prof. Tesler Diagonalizing

More information

Introduction to Matrix Algebra

Introduction to Matrix Algebra Introduction to Matrix Algebra August 18, 2010 1 Vectors 1.1 Notations A p-dimensional vector is p numbers put together. Written as x 1 x =. x p. When p = 1, this represents a point in the line. When p

More information

Review of Linear Algebra

Review of Linear Algebra Review of Linear Algebra Definitions An m n (read "m by n") matrix, is a rectangular array of entries, where m is the number of rows and n the number of columns. 2 Definitions (Con t) A is square if m=

More information

Linear Algebra. Matrices Operations. Consider, for example, a system of equations such as x + 2y z + 4w = 0, 3x 4y + 2z 6w = 0, x 3y 2z + w = 0.

Linear Algebra. Matrices Operations. Consider, for example, a system of equations such as x + 2y z + 4w = 0, 3x 4y + 2z 6w = 0, x 3y 2z + w = 0. Matrices Operations Linear Algebra Consider, for example, a system of equations such as x + 2y z + 4w = 0, 3x 4y + 2z 6w = 0, x 3y 2z + w = 0 The rectangular array 1 2 1 4 3 4 2 6 1 3 2 1 in which the

More information

Linear Algebra Primer

Linear Algebra Primer Linear Algebra Primer David Doria daviddoria@gmail.com Wednesday 3 rd December, 2008 Contents Why is it called Linear Algebra? 4 2 What is a Matrix? 4 2. Input and Output.....................................

More information

EE731 Lecture Notes: Matrix Computations for Signal Processing

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

More information

Matrix Algebra. Matrix Algebra. Chapter 8 - S&B

Matrix Algebra. Matrix Algebra. Chapter 8 - S&B Chapter 8 - S&B Algebraic operations Matrix: The size of a matrix is indicated by the number of its rows and the number of its columns. A matrix with k rows and n columns is called a k n matrix. The number

More information

MATH 240 Spring, Chapter 1: Linear Equations and Matrices

MATH 240 Spring, Chapter 1: Linear Equations and Matrices MATH 240 Spring, 2006 Chapter Summaries for Kolman / Hill, Elementary Linear Algebra, 8th Ed. Sections 1.1 1.6, 2.1 2.2, 3.2 3.8, 4.3 4.5, 5.1 5.3, 5.5, 6.1 6.5, 7.1 7.2, 7.4 DEFINITIONS Chapter 1: Linear

More information

Math 4A Notes. Written by Victoria Kala Last updated June 11, 2017

Math 4A Notes. Written by Victoria Kala Last updated June 11, 2017 Math 4A Notes Written by Victoria Kala vtkala@math.ucsb.edu Last updated June 11, 2017 Systems of Linear Equations A linear equation is an equation that can be written in the form a 1 x 1 + a 2 x 2 +...

More information

Chapter 1: Systems of linear equations and matrices. Section 1.1: Introduction to systems of linear equations

Chapter 1: Systems of linear equations and matrices. Section 1.1: Introduction to systems of linear equations Chapter 1: Systems of linear equations and matrices Section 1.1: Introduction to systems of linear equations Definition: A linear equation in n variables can be expressed in the form a 1 x 1 + a 2 x 2

More information

Linear Algebra Highlights

Linear Algebra Highlights Linear Algebra Highlights Chapter 1 A linear equation in n variables is of the form a 1 x 1 + a 2 x 2 + + a n x n. We can have m equations in n variables, a system of linear equations, which we want to

More information

Econ Slides from Lecture 7

Econ Slides from Lecture 7 Econ 205 Sobel Econ 205 - Slides from Lecture 7 Joel Sobel August 31, 2010 Linear Algebra: Main Theory A linear combination of a collection of vectors {x 1,..., x k } is a vector of the form k λ ix i for

More information

CS 143 Linear Algebra Review

CS 143 Linear Algebra Review CS 143 Linear Algebra Review Stefan Roth September 29, 2003 Introductory Remarks This review does not aim at mathematical rigor very much, but instead at ease of understanding and conciseness. Please see

More information

2. Matrix Algebra and Random Vectors

2. Matrix Algebra and Random Vectors 2. Matrix Algebra and Random Vectors 2.1 Introduction Multivariate data can be conveniently display as array of numbers. In general, a rectangular array of numbers with, for instance, n rows and p columns

More information

Chapters 5 & 6: Theory Review: Solutions Math 308 F Spring 2015

Chapters 5 & 6: Theory Review: Solutions Math 308 F Spring 2015 Chapters 5 & 6: Theory Review: Solutions Math 308 F Spring 205. If A is a 3 3 triangular matrix, explain why det(a) is equal to the product of entries on the diagonal. If A is a lower triangular or diagonal

More information

4. Determinants.

4. Determinants. 4. Determinants 4.1. Determinants; Cofactor Expansion Determinants of 2 2 and 3 3 Matrices 2 2 determinant 4.1. Determinants; Cofactor Expansion Determinants of 2 2 and 3 3 Matrices 3 3 determinant 4.1.

More information

Section 9.2: Matrices.. a m1 a m2 a mn

Section 9.2: Matrices.. a m1 a m2 a mn Section 9.2: Matrices Definition: A matrix is a rectangular array of numbers: a 11 a 12 a 1n a 21 a 22 a 2n A =...... a m1 a m2 a mn In general, a ij denotes the (i, j) entry of A. That is, the entry in

More information

ENGI 9420 Lecture Notes 2 - Matrix Algebra Page Matrix operations can render the solution of a linear system much more efficient.

ENGI 9420 Lecture Notes 2 - Matrix Algebra Page Matrix operations can render the solution of a linear system much more efficient. ENGI 940 Lecture Notes - Matrix Algebra Page.0. Matrix Algebra A linear system of m equations in n unknowns, a x + a x + + a x b (where the a ij and i n n a x + a x + + a x b n n a x + a x + + a x b m

More information

Quiz ) Locate your 1 st order neighbors. 1) Simplify. Name Hometown. Name Hometown. Name Hometown.

Quiz ) Locate your 1 st order neighbors. 1) Simplify. Name Hometown. Name Hometown. Name Hometown. Quiz 1) Simplify 9999 999 9999 998 9999 998 2) Locate your 1 st order neighbors Name Hometown Me Name Hometown Name Hometown Name Hometown Solving Linear Algebraic Equa3ons Basic Concepts Here only real

More information

Elementary maths for GMT

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

More information

Glossary of Linear Algebra Terms. Prepared by Vince Zaccone For Campus Learning Assistance Services at UCSB

Glossary of Linear Algebra Terms. Prepared by Vince Zaccone For Campus Learning Assistance Services at UCSB Glossary of Linear Algebra Terms Basis (for a subspace) A linearly independent set of vectors that spans the space Basic Variable A variable in a linear system that corresponds to a pivot column in the

More information

Matrices and Determinants

Matrices and Determinants Chapter1 Matrices and Determinants 11 INTRODUCTION Matrix means an arrangement or array Matrices (plural of matrix) were introduced by Cayley in 1860 A matrix A is rectangular array of m n numbers (or

More information

(Mathematical Operations with Arrays) Applied Linear Algebra in Geoscience Using MATLAB

(Mathematical Operations with Arrays) Applied Linear Algebra in Geoscience Using MATLAB Applied Linear Algebra in Geoscience Using MATLAB (Mathematical Operations with Arrays) Contents Getting Started Matrices Creating Arrays Linear equations Mathematical Operations with Arrays Using Script

More information

Numerical Linear Algebra

Numerical Linear Algebra Numerical Linear Algebra The two principal problems in linear algebra are: Linear system Given an n n matrix A and an n-vector b, determine x IR n such that A x = b Eigenvalue problem Given an n n matrix

More information

Chapter 4 - MATRIX ALGEBRA. ... a 2j... a 2n. a i1 a i2... a ij... a in

Chapter 4 - MATRIX ALGEBRA. ... a 2j... a 2n. a i1 a i2... a ij... a in Chapter 4 - MATRIX ALGEBRA 4.1. Matrix Operations A a 11 a 12... a 1j... a 1n a 21. a 22.... a 2j... a 2n. a i1 a i2... a ij... a in... a m1 a m2... a mj... a mn The entry in the ith row and the jth column

More information

MATH 315 Linear Algebra Homework #1 Assigned: August 20, 2018

MATH 315 Linear Algebra Homework #1 Assigned: August 20, 2018 Homework #1 Assigned: August 20, 2018 Review the following subjects involving systems of equations and matrices from Calculus II. Linear systems of equations Converting systems to matrix form Pivot entry

More information

Vectors To begin, let us describe an element of the state space as a point with numerical coordinates, that is x 1. x 2. x =

Vectors To begin, let us describe an element of the state space as a point with numerical coordinates, that is x 1. x 2. x = Linear Algebra Review Vectors To begin, let us describe an element of the state space as a point with numerical coordinates, that is x 1 x x = 2. x n Vectors of up to three dimensions are easy to diagram.

More information

Introduction to Matrices

Introduction to Matrices 214 Analysis and Design of Feedback Control Systems Introduction to Matrices Derek Rowell October 2002 Modern system dynamics is based upon a matrix representation of the dynamic equations governing the

More information

Some Notes on Linear Algebra

Some Notes on Linear Algebra Some Notes on Linear Algebra prepared for a first course in differential equations Thomas L Scofield Department of Mathematics and Statistics Calvin College 1998 1 The purpose of these notes is to present

More information

Matrix & Linear Algebra

Matrix & Linear Algebra Matrix & Linear Algebra Jamie Monogan University of Georgia For more information: http://monogan.myweb.uga.edu/teaching/mm/ Jamie Monogan (UGA) Matrix & Linear Algebra 1 / 84 Vectors Vectors Vector: A

More information

Notes on Linear Algebra

Notes on Linear Algebra 1 Notes on Linear Algebra Jean Walrand August 2005 I INTRODUCTION Linear Algebra is the theory of linear transformations Applications abound in estimation control and Markov chains You should be familiar

More information

Linear Algebra Primer

Linear Algebra Primer Introduction Linear Algebra Primer Daniel S. Stutts, Ph.D. Original Edition: 2/99 Current Edition: 4//4 This primer was written to provide a brief overview of the main concepts and methods in elementary

More information

Section 9.2: Matrices. Definition: A matrix A consists of a rectangular array of numbers, or elements, arranged in m rows and n columns.

Section 9.2: Matrices. Definition: A matrix A consists of a rectangular array of numbers, or elements, arranged in m rows and n columns. Section 9.2: Matrices Definition: A matrix A consists of a rectangular array of numbers, or elements, arranged in m rows and n columns. That is, a 11 a 12 a 1n a 21 a 22 a 2n A =...... a m1 a m2 a mn A

More information

Final Review Written by Victoria Kala SH 6432u Office Hours R 12:30 1:30pm Last Updated 11/30/2015

Final Review Written by Victoria Kala SH 6432u Office Hours R 12:30 1:30pm Last Updated 11/30/2015 Final Review Written by Victoria Kala vtkala@mathucsbedu SH 6432u Office Hours R 12:30 1:30pm Last Updated 11/30/2015 Summary This review contains notes on sections 44 47, 51 53, 61, 62, 65 For your final,

More information

The Singular Value Decomposition

The Singular Value Decomposition The Singular Value Decomposition Philippe B. Laval KSU Fall 2015 Philippe B. Laval (KSU) SVD Fall 2015 1 / 13 Review of Key Concepts We review some key definitions and results about matrices that will

More information

Math 102, Winter Final Exam Review. Chapter 1. Matrices and Gaussian Elimination

Math 102, Winter Final Exam Review. Chapter 1. Matrices and Gaussian Elimination Math 0, Winter 07 Final Exam Review Chapter. Matrices and Gaussian Elimination { x + x =,. Different forms of a system of linear equations. Example: The x + 4x = 4. [ ] [ ] [ ] vector form (or the column

More information

Linear Algebra: Matrix Eigenvalue Problems

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

More information

MAT 2037 LINEAR ALGEBRA I web:

MAT 2037 LINEAR ALGEBRA I web: MAT 237 LINEAR ALGEBRA I 2625 Dokuz Eylül University, Faculty of Science, Department of Mathematics web: Instructor: Engin Mermut http://kisideuedutr/enginmermut/ HOMEWORK 2 MATRIX ALGEBRA Textbook: Linear

More information

Chapter 2:Determinants. Section 2.1: Determinants by cofactor expansion

Chapter 2:Determinants. Section 2.1: Determinants by cofactor expansion Chapter 2:Determinants Section 2.1: Determinants by cofactor expansion [ ] a b Recall: The 2 2 matrix is invertible if ad bc 0. The c d ([ ]) a b function f = ad bc is called the determinant and it associates

More information

18.06SC Final Exam Solutions

18.06SC Final Exam Solutions 18.06SC Final Exam Solutions 1 (4+7=11 pts.) Suppose A is 3 by 4, and Ax = 0 has exactly 2 special solutions: 1 2 x 1 = 1 and x 2 = 1 1 0 0 1 (a) Remembering that A is 3 by 4, find its row reduced echelon

More information

OHSx XM511 Linear Algebra: Solutions to Online True/False Exercises

OHSx XM511 Linear Algebra: Solutions to Online True/False Exercises This document gives the solutions to all of the online exercises for OHSx XM511. The section ( ) numbers refer to the textbook. TYPE I are True/False. Answers are in square brackets [. Lecture 02 ( 1.1)

More information

Fundamentals of Engineering Analysis (650163)

Fundamentals of Engineering Analysis (650163) Philadelphia University Faculty of Engineering Communications and Electronics Engineering Fundamentals of Engineering Analysis (6563) Part Dr. Omar R Daoud Matrices: Introduction DEFINITION A matrix is

More information

Basic Elements of Linear Algebra

Basic Elements of Linear Algebra A Basic Review of Linear Algebra Nick West nickwest@stanfordedu September 16, 2010 Part I Basic Elements of Linear Algebra Although the subject of linear algebra is much broader than just vectors and matrices,

More information

2 b 3 b 4. c c 2 c 3 c 4

2 b 3 b 4. c c 2 c 3 c 4 OHSx XM511 Linear Algebra: Multiple Choice Questions for Chapter 4 a a 2 a 3 a 4 b b 1. What is the determinant of 2 b 3 b 4 c c 2 c 3 c 4? d d 2 d 3 d 4 (a) abcd (b) abcd(a b)(b c)(c d)(d a) (c) abcd(a

More information

MTH 464: Computational Linear Algebra

MTH 464: Computational Linear Algebra MTH 464: Computational Linear Algebra Lecture Outlines Exam 2 Material Prof. M. Beauregard Department of Mathematics & Statistics Stephen F. Austin State University March 2, 2018 Linear Algebra (MTH 464)

More information

Basic Concepts in Matrix Algebra

Basic Concepts in Matrix Algebra Basic Concepts in Matrix Algebra An column array of p elements is called a vector of dimension p and is written as x p 1 = x 1 x 2. x p. The transpose of the column vector x p 1 is row vector x = [x 1

More information

Online Exercises for Linear Algebra XM511

Online Exercises for Linear Algebra XM511 This document lists the online exercises for XM511. The section ( ) numbers refer to the textbook. TYPE I are True/False. Lecture 02 ( 1.1) Online Exercises for Linear Algebra XM511 1) The matrix [3 2

More information

Math 240 Calculus III

Math 240 Calculus III The Calculus III Summer 2015, Session II Wednesday, July 8, 2015 Agenda 1. of the determinant 2. determinants 3. of determinants What is the determinant? Yesterday: Ax = b has a unique solution when A

More information

MATRIX ALGEBRA. or x = (x 1,..., x n ) R n. y 1 y 2. x 2. x m. y m. y = cos θ 1 = x 1 L x. sin θ 1 = x 2. cos θ 2 = y 1 L y.

MATRIX ALGEBRA. or x = (x 1,..., x n ) R n. y 1 y 2. x 2. x m. y m. y = cos θ 1 = x 1 L x. sin θ 1 = x 2. cos θ 2 = y 1 L y. as Basics Vectors MATRIX ALGEBRA An array of n real numbers x, x,, x n is called a vector and it is written x = x x n or x = x,, x n R n prime operation=transposing a column to a row Basic vector operations

More information

33AH, WINTER 2018: STUDY GUIDE FOR FINAL EXAM

33AH, WINTER 2018: STUDY GUIDE FOR FINAL EXAM 33AH, WINTER 2018: STUDY GUIDE FOR FINAL EXAM (UPDATED MARCH 17, 2018) The final exam will be cumulative, with a bit more weight on more recent material. This outline covers the what we ve done since the

More information

Gaussian Elimination and Back Substitution

Gaussian Elimination and Back Substitution Jim Lambers MAT 610 Summer Session 2009-10 Lecture 4 Notes These notes correspond to Sections 31 and 32 in the text Gaussian Elimination and Back Substitution The basic idea behind methods for solving

More information

Quantum Computing Lecture 2. Review of Linear Algebra

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

More information

Linear Algebra Review. Fei-Fei Li

Linear Algebra Review. Fei-Fei Li Linear Algebra Review Fei-Fei Li 1 / 37 Vectors Vectors and matrices are just collections of ordered numbers that represent something: movements in space, scaling factors, pixel brightnesses, etc. A vector

More information

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

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

More information

3 Matrix Algebra. 3.1 Operations on matrices

3 Matrix Algebra. 3.1 Operations on matrices 3 Matrix Algebra A matrix is a rectangular array of numbers; it is of size m n if it has m rows and n columns. A 1 n matrix is a row vector; an m 1 matrix is a column vector. For example: 1 5 3 5 3 5 8

More information

Chapter 3. Linear and Nonlinear Systems

Chapter 3. Linear and Nonlinear Systems 59 An expert is someone who knows some of the worst mistakes that can be made in his subject, and how to avoid them Werner Heisenberg (1901-1976) Chapter 3 Linear and Nonlinear Systems In this chapter

More information

MATH 369 Linear Algebra

MATH 369 Linear Algebra Assignment # Problem # A father and his two sons are together 00 years old. The father is twice as old as his older son and 30 years older than his younger son. How old is each person? Problem # 2 Determine

More information

Introduction to Quantitative Techniques for MSc Programmes SCHOOL OF ECONOMICS, MATHEMATICS AND STATISTICS MALET STREET LONDON WC1E 7HX

Introduction to Quantitative Techniques for MSc Programmes SCHOOL OF ECONOMICS, MATHEMATICS AND STATISTICS MALET STREET LONDON WC1E 7HX Introduction to Quantitative Techniques for MSc Programmes SCHOOL OF ECONOMICS, MATHEMATICS AND STATISTICS MALET STREET LONDON WC1E 7HX September 2007 MSc Sep Intro QT 1 Who are these course for? The September

More information

Quick Tour of Linear Algebra and Graph Theory

Quick Tour of Linear Algebra and Graph Theory Quick Tour of Linear Algebra and Graph Theory CS224W: Social and Information Network Analysis Fall 2014 David Hallac Based on Peter Lofgren, Yu Wayne Wu, and Borja Pelato s previous versions Matrices and

More information

MATH2210 Notebook 2 Spring 2018

MATH2210 Notebook 2 Spring 2018 MATH2210 Notebook 2 Spring 2018 prepared by Professor Jenny Baglivo c Copyright 2009 2018 by Jenny A. Baglivo. All Rights Reserved. 2 MATH2210 Notebook 2 3 2.1 Matrices and Their Operations................................

More information

Matrices and Linear Algebra

Matrices and Linear Algebra Contents Quantitative methods for Economics and Business University of Ferrara Academic year 2017-2018 Contents 1 Basics 2 3 4 5 Contents 1 Basics 2 3 4 5 Contents 1 Basics 2 3 4 5 Contents 1 Basics 2

More information

Examples and MatLab. Vector and Matrix Material. Matrix Addition R = A + B. Matrix Equality A = B. Matrix Multiplication R = A * B.

Examples and MatLab. Vector and Matrix Material. Matrix Addition R = A + B. Matrix Equality A = B. Matrix Multiplication R = A * B. Vector and Matrix Material Examples and MatLab Matrix = Rectangular array of numbers, complex numbers or functions If r rows & c columns, r*c elements, r*c is order of matrix. A is n * m matrix Square

More information

Linear Algebra and Matrix Inversion

Linear Algebra and Matrix Inversion Jim Lambers MAT 46/56 Spring Semester 29- Lecture 2 Notes These notes correspond to Section 63 in the text Linear Algebra and Matrix Inversion Vector Spaces and Linear Transformations Matrices are much

More information

Problem Set (T) If A is an m n matrix, B is an n p matrix and D is a p s matrix, then show

Problem Set (T) If A is an m n matrix, B is an n p matrix and D is a p s matrix, then show MTH 0: Linear Algebra Department of Mathematics and Statistics Indian Institute of Technology - Kanpur Problem Set Problems marked (T) are for discussions in Tutorial sessions (T) If A is an m n matrix,

More information

Lecture Summaries for Linear Algebra M51A

Lecture Summaries for Linear Algebra M51A These lecture summaries may also be viewed online by clicking the L icon at the top right of any lecture screen. Lecture Summaries for Linear Algebra M51A refers to the section in the textbook. Lecture

More information

1 Matrices and Systems of Linear Equations. a 1n a 2n

1 Matrices and Systems of Linear Equations. a 1n a 2n March 31, 2013 16-1 16. Systems of Linear Equations 1 Matrices and Systems of Linear Equations An m n matrix is an array A = (a ij ) of the form a 11 a 21 a m1 a 1n a 2n... a mn where each a ij is a real

More information

Solution of Linear Equations

Solution of Linear Equations Solution of Linear Equations (Com S 477/577 Notes) Yan-Bin Jia Sep 7, 07 We have discussed general methods for solving arbitrary equations, and looked at the special class of polynomial equations A subclass

More information

Matrix Arithmetic. j=1

Matrix Arithmetic. j=1 An m n matrix is an array A = Matrix Arithmetic a 11 a 12 a 1n a 21 a 22 a 2n a m1 a m2 a mn of real numbers a ij An m n matrix has m rows and n columns a ij is the entry in the i-th row and j-th column

More information

Foundations of Matrix Analysis

Foundations of Matrix Analysis 1 Foundations of Matrix Analysis In this chapter we recall the basic elements of linear algebra which will be employed in the remainder of the text For most of the proofs as well as for the details, the

More information

Applied Linear Algebra in Geoscience Using MATLAB

Applied Linear Algebra in Geoscience Using MATLAB Applied Linear Algebra in Geoscience Using MATLAB Contents Getting Started Creating Arrays Mathematical Operations with Arrays Using Script Files and Managing Data Two-Dimensional Plots Programming in

More information

Chap 3. Linear Algebra

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

More information

c c c c c c c c c c a 3x3 matrix C= has a determinant determined by

c c c c c c c c c c a 3x3 matrix C= has a determinant determined by Linear Algebra Determinants and Eigenvalues Introduction: Many important geometric and algebraic properties of square matrices are associated with a single real number revealed by what s known as the determinant.

More information

CPE 310: Numerical Analysis for Engineers

CPE 310: Numerical Analysis for Engineers CPE 310: Numerical Analysis for Engineers Chapter 2: Solving Sets of Equations Ahmed Tamrawi Copyright notice: care has been taken to use only those web images deemed by the instructor to be in the public

More information

A Review of Linear Algebra

A Review of Linear Algebra A Review of Linear Algebra Gerald Recktenwald Portland State University Mechanical Engineering Department gerry@me.pdx.edu These slides are a supplement to the book Numerical Methods with Matlab: Implementations

More information

Math 520 Exam 2 Topic Outline Sections 1 3 (Xiao/Dumas/Liaw) Spring 2008

Math 520 Exam 2 Topic Outline Sections 1 3 (Xiao/Dumas/Liaw) Spring 2008 Math 520 Exam 2 Topic Outline Sections 1 3 (Xiao/Dumas/Liaw) Spring 2008 Exam 2 will be held on Tuesday, April 8, 7-8pm in 117 MacMillan What will be covered The exam will cover material from the lectures

More information

Matrix Algebra for Engineers Jeffrey R. Chasnov

Matrix Algebra for Engineers Jeffrey R. Chasnov Matrix Algebra for Engineers Jeffrey R. Chasnov The Hong Kong University of Science and Technology The Hong Kong University of Science and Technology Department of Mathematics Clear Water Bay, Kowloon

More information

ELE/MCE 503 Linear Algebra Facts Fall 2018

ELE/MCE 503 Linear Algebra Facts Fall 2018 ELE/MCE 503 Linear Algebra Facts Fall 2018 Fact N.1 A set of vectors is linearly independent if and only if none of the vectors in the set can be written as a linear combination of the others. Fact N.2

More information

Linear Systems and Matrices

Linear Systems and Matrices Department of Mathematics The Chinese University of Hong Kong 1 System of m linear equations in n unknowns (linear system) a 11 x 1 + a 12 x 2 + + a 1n x n = b 1 a 21 x 1 + a 22 x 2 + + a 2n x n = b 2.......

More information

6 EIGENVALUES AND EIGENVECTORS

6 EIGENVALUES AND EIGENVECTORS 6 EIGENVALUES AND EIGENVECTORS INTRODUCTION TO EIGENVALUES 61 Linear equations Ax = b come from steady state problems Eigenvalues have their greatest importance in dynamic problems The solution of du/dt

More information

ELEMENTARY LINEAR ALGEBRA WITH APPLICATIONS. 1. Linear Equations and Matrices

ELEMENTARY LINEAR ALGEBRA WITH APPLICATIONS. 1. Linear Equations and Matrices ELEMENTARY LINEAR ALGEBRA WITH APPLICATIONS KOLMAN & HILL NOTES BY OTTO MUTZBAUER 11 Systems of Linear Equations 1 Linear Equations and Matrices Numbers in our context are either real numbers or complex

More information

x + 2y + 3z = 8 x + 3y = 7 x + 2z = 3

x + 2y + 3z = 8 x + 3y = 7 x + 2z = 3 Chapter 2: Solving Linear Equations 23 Elimination Using Matrices As we saw in the presentation, we can use elimination to make a system of linear equations into an upper triangular system that is easy

More information

Math Camp II. Basic Linear Algebra. Yiqing Xu. Aug 26, 2014 MIT

Math Camp II. Basic Linear Algebra. Yiqing Xu. Aug 26, 2014 MIT Math Camp II Basic Linear Algebra Yiqing Xu MIT Aug 26, 2014 1 Solving Systems of Linear Equations 2 Vectors and Vector Spaces 3 Matrices 4 Least Squares Systems of Linear Equations Definition A linear

More information

Linear Algebra- Final Exam Review

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

More information

q n. Q T Q = I. Projections Least Squares best fit solution to Ax = b. Gram-Schmidt process for getting an orthonormal basis from any basis.

q n. Q T Q = I. Projections Least Squares best fit solution to Ax = b. Gram-Schmidt process for getting an orthonormal basis from any basis. Exam Review Material covered by the exam [ Orthogonal matrices Q = q 1... ] q n. Q T Q = I. Projections Least Squares best fit solution to Ax = b. Gram-Schmidt process for getting an orthonormal basis

More information

Chapter 5. Linear Algebra. A linear (algebraic) equation in. unknowns, x 1, x 2,..., x n, is. an equation of the form

Chapter 5. Linear Algebra. A linear (algebraic) equation in. unknowns, x 1, x 2,..., x n, is. an equation of the form Chapter 5. Linear Algebra A linear (algebraic) equation in n unknowns, x 1, x 2,..., x n, is an equation of the form a 1 x 1 + a 2 x 2 + + a n x n = b where a 1, a 2,..., a n and b are real numbers. 1

More information

1. Select the unique answer (choice) for each problem. Write only the answer.

1. Select the unique answer (choice) for each problem. Write only the answer. MATH 5 Practice Problem Set Spring 7. Select the unique answer (choice) for each problem. Write only the answer. () Determine all the values of a for which the system has infinitely many solutions: x +

More information

Matrices. Chapter Definitions and Notations

Matrices. Chapter Definitions and Notations Chapter 3 Matrices 3. Definitions and Notations Matrices are yet another mathematical object. Learning about matrices means learning what they are, how they are represented, the types of operations which

More information

MATH 235. Final ANSWERS May 5, 2015

MATH 235. Final ANSWERS May 5, 2015 MATH 235 Final ANSWERS May 5, 25. ( points) Fix positive integers m, n and consider the vector space V of all m n matrices with entries in the real numbers R. (a) Find the dimension of V and prove your

More information

Jim Lambers MAT 610 Summer Session Lecture 1 Notes

Jim Lambers MAT 610 Summer Session Lecture 1 Notes Jim Lambers MAT 60 Summer Session 2009-0 Lecture Notes Introduction This course is about numerical linear algebra, which is the study of the approximate solution of fundamental problems from linear algebra

More information

Phys 201. Matrices and Determinants

Phys 201. Matrices and Determinants Phys 201 Matrices and Determinants 1 1.1 Matrices 1.2 Operations of matrices 1.3 Types of matrices 1.4 Properties of matrices 1.5 Determinants 1.6 Inverse of a 3 3 matrix 2 1.1 Matrices A 2 3 7 =! " 1

More information

1. Linear systems of equations. Chapters 7-8: Linear Algebra. Solution(s) of a linear system of equations (continued)

1. Linear systems of equations. Chapters 7-8: Linear Algebra. Solution(s) of a linear system of equations (continued) 1 A linear system of equations of the form Sections 75, 78 & 81 a 11 x 1 + a 12 x 2 + + a 1n x n = b 1 a 21 x 1 + a 22 x 2 + + a 2n x n = b 2 a m1 x 1 + a m2 x 2 + + a mn x n = b m can be written in matrix

More information

2. Every linear system with the same number of equations as unknowns has a unique solution.

2. Every linear system with the same number of equations as unknowns has a unique solution. 1. For matrices A, B, C, A + B = A + C if and only if A = B. 2. Every linear system with the same number of equations as unknowns has a unique solution. 3. Every linear system with the same number of equations

More information