Eigenvalues, Eigenvectors. Eigenvalues and eigenvector will be fundamentally related to the nature of the solutions of state space systems.

Size: px
Start display at page:

Download "Eigenvalues, Eigenvectors. Eigenvalues and eigenvector will be fundamentally related to the nature of the solutions of state space systems."

Transcription

1 Chapter 3 Linear Algebra In this Chapter we provide a review of some basic concepts from Linear Algebra which will be required in order to compute solutions of LTI systems in state space form, discuss controllability and observability, design state feedback controllers, and state observers. The main topics are Vector Spaces. These spaces are a useful concept when solving linear algebraic equations and in particular eigenvectors. A vector space gives a proper foundation for the notion of a state space with a choice of vector space basis being analogous to a change of state coordinates as seen in Section 2.3. Linear Algebraic Systems of Equations. Solving these systems is important when finding eigenvectors and the vector spaces which arise when discussing controllability and observability. Eigenvalues, Eigenvectors. Eigenvalues and eigenvector will be fundamentally related to the nature of the solutions of state space systems. 3.1 Vector Spaces See [Bay99, Sec , 2.2.2, 2.2.3, 2.2.4, 2.2.5]. A vector has a clear geometric interpretation as a directed line segment in either 2- or 3-dimensional space. In that setting notions of magnitude, direction, and dimension have an intuitive meaning. We have already informally used the term vector when referring to the input, output, and state vectors of a system in state space form. The state vectors of the systems we have considered could have components which represent different physical quantities such as displacement, velocity, voltage, and current. As well, there can be more than three components in a vector. In this case, there is no obvious geometrical interpretation for a vector available. In fact, vectors are more generally defined as an abstract concept which does not require a geometric interpretation. For example, the set of continuous functions defined on some interval is a vector space. In this case, there is no immediate interpretation for a magnitude or direction of a vector. The abstract definition of a vector space is a collection of elements called vectors which can be added (vector addition) and multiplied by scalars (scalar multiplication) which belong to a 51

2 52 CHAPTER 3. LINEAR ALGEBRA field. The operations of vector addition and scalar multiplication must satisfy certain axioms such as commutativity, associativity of vector addition (see [Bay99, Pg. 50]). Primarily we will be concerned with the vector space of n-tuples of real numbers R n defined over the field R. Linear dependence A set of r vectors {v 1,...,v r } belonging to a vector space X is said to be linearly dependent if there exists scalars a i, 1 i r such that not all a i = 0 and r a i v i = a 1 v a r v r = 0 (3.1) i=1 Note here we use subscript in a different way than in Chapter 2. That is, the subscript k in v k denotes the kth vector and not a component of a vector as in Chapter 2. We refer to the sum a 1 v a r v r in (3.1) as a linear combination of vectors v 1,...,v r. The a i are called scalar coefficients. Linear independence A set of vectors {v 1,...,v r } belonging to a vector space X is said linearly independent (LI) if it is not linearly dependent. That is, if r a i v i = a 1 v a r v r = 0 a i = 0, 1 i r i=1 Suppose r = 2, linear independence means that v 2 is not a scalar multiple of v 1. That is, the two vectors point in different directions. In general, if a set of r vectors {v 1,...,v r } is linearly dependent, there exists at least one a i nonzero such that a 1 v a r v r = 0 Assuming a 1 0, we can express v 1 in terms of the remaining vectors v 1 = 1 a 1 (a 2 v a r v n ) Hence, if vectors {v 1,..., v r } are linearly dependent, we can write at least one vector as a linear combination of the others. Note that a zero vector is linearly dependent on any vector. Example 14 Suppose the vector space is X = R 3 and we have v 1 = (1, 0, 1) T, v 2 = (2, 1, 2) T, v 3 = (3, 2, 0) T Is {v 1, v 2, v 3 } LI? To show linear dependence we attempt to solve [ ] a 1 v1 v 2 v 3 a 2 = 0 a 3

3 3.1. VECTOR SPACES 53 for some a i 0. We know that a 1 = a 2 = a 3 = 0 if and only if det( [ ] v 1 v 2 v 3 ) 0. In this case we have det = Hence, {v 1, v 2, v 3 } is LI. The determinant provides and easy check for linear independence when the number of components in the vectors equals the number of vectors in the set. When this is not the case, we can reduce the matrix [ v 1 v 2 v r ] to row echelon form in order to determine whether the vectors are LI. Span, dimension, and basis Span Given a set of vectors {v 1,...,v r } belonging to some vector space X, the set of all linear combinations of these vectors is called their span and is denoted span{v 1,...,v r }. For example, suppose X = R 3 and v 1, v 2 X: span{v 1, v 2 } = {sv 1 + tv 2 : s, t R} The set V = span{v 1,...,v r } is a subspace of X and we write V U. That is, V is itself a vector space using the vector addition and scalar multiplication of X and V is closed under the vector addition and scalar multiplication of X (i.e.,, any linear combination of elements in V belong to V ). Example 15 Defining the vectors e 1 = (1, 0,..., 0) T, e 2 = (0, 1, 0,..., 0) T,..., e n = (0, 0, 0,..., 1) T belonging to X = R n. We have R n = span{e 1, e 2,...,e n } The vectors e k are called the standard basis vectors of R n. Example 16 The vectors v 1 = (1, 1, 1) T, v 2 = (1, 1, 0) T, v 3 = (0, 1, 1) T span R 3, i.e., R 3 = span{v 1, v 2, v 3 } Basis A set of vectors {v 1,...,v r } belonging to a vector space X is called a basis if 1. {v 1,...,v r } is LI 2. X = span{v 1,...,v r } This definition implies that any vector in X can be expressed as a unique linear combination of v 1,..., v n. Evidently a set of basis vectors is the minimum number of vectors required to span a vector space. It is important to note that for a given vector space, the choice of basis is not unique. However, the number of elements in a basis is unique and leads to the following definition.

4 54 CHAPTER 3. LINEAR ALGEBRA Dimension If {v 1,...,v r } is a basis of a vector space X, the dimension of X is r and we write dim(x) = r. Example 17 Since det( [ e 1 e 2... e n ] ) = 1, we know {e1, e 2,...,e n } is LI and since R n = span{e 1, e 2,...,e n } we conclude {e 1, e 2,...,e n } is a basis of R n and dim(r n ) = n. Coordinates or representations of vectors In geometry we label points in a three dimensional space with an ordered triple of numbers called the coordinates of the point. These coordinates are determined from a definition of coordinate axes. Sometimes it is more convenient to choose a different coordinate system in which to represent a vector. For example, spherical coordinates may be more convenient than cartesian. A choice of new coordinates can be viewed as a choice of new basis for R 3. We now look at how the representation or coordinates of a vector changes as we vary the basis. Representation of a vector in a vector space Given the ordered basis {v 1,..., v r } of a vector space X, the representation or coordinates of any v X in the basis {v 1,...,v r } is the unique vector of coefficients (a 1,...,a r ) T such that v = r a i v i i=1 Example 18 Find the representation of v = (2, 1, 3) T in the basis {v 1, v 2, v 3 } of R 3, where We solve v 1 = (1, 1, 0) T, v 2 = (1, 0, 1) T, v 3 = (0, 1, 1) T a 1 1 = a a 3 The unique solution of the above system of equation yields the coordinates (a 1, a 2, a 3 ) T = (0, 2, 1) T such that v = 3 i=1 a iv i. We have already used the notion of change of basis in Section 2.3 when considering linear changes of state coordinates. Although previously we introduced the notion of change of state coordinates without any concept of vector space or basis. This relation can be seen by considering the LTI system ẋ = Ax + Bu y = Cx + Du

5 3.2. LINEAR ALGEBRAIC EQUATIONS 55 We can expand x R n in terms of another basis {v 1,...,v n }, v i R n. The coordinates of x in the basis {v 1,...,v n }, v i R n are denoted ξ i : x = ξ 1 v ξ n v n = V ξ where V = [ v 1 v n ], ξ = [ ξ1 ξ n ] T Taking the time derivative of x gives ẋ = V ξ = AV ξ + Bu (3.2) which implies and we have ξ = V 1 AV ξ + V 1 Bu y = CV ξ + Du Hence we observe that a change of basis is equivalent to a linear change of state variables as discussed in Section 2.3 (where no notion of basis or vector space was formally used). 3.2 Linear algebraic equations See [Bay99, Sec. 3.3]. We consider the systems of m linear equations in n variables y = Ax, where A R m n, x R n, y R m (3.3) A number of fundamental questions arise regarding (3.3). When do solutions to (3.3) exist? And if they exist, how many solutions exist? In order to answer these questions we need to define two vector spaces: the range space of A and the null space of A. Range space of A The range space of A, denoted R(A), is the set of all possible linear combinations of the columns of A, i.e., R(A) = {y R m : y = Ax for some x R n } = span{a 1,...,a n }, where a k R m denotes the k column of A. R(A) is sometimes called the column space of A. The matrix A can be thought of a linear mapping from R n to R m, and R(A) is a subspace of R m. Rank of A The rank of A is denoted r(a) and is defined as r(a) = dim(r(a)). Null space of A The null space of A, denoted N(A), is the set of all linear combinations of vectors x satisfying Ax = 0, i.e., N(A) = {x R n : Ax = 0}. Evidently, N(A) is a subspace of R n.

6 56 CHAPTER 3. LINEAR ALGEBRA Nullity of A The nullity of A is denoted q(a), it is defined as q(a) = dim(n(a)). We have the following useful facts r(a) min(n, m) q(a) = n r(a) r(a) = r(a T ) Dimension Theorem dimension of column space equals the dimension of row space r(a) = r(ua) = r(av ), for any nonsingular U R m m, V R n n Solutions to y = Ax exist if and only if y R(A). This is because, Ax is a linear combination of the columns of A. That is, if we let a i R m denote the columns of A we have Ax = [ a 1 a n ] x = a1 x a n x n Evidently, for a solution of (3.3) to exist, y must be expressible as a linear combination of the columns of A. The statement y R(A) is equivalent to r(a) = r( [ A y ] ) or y is LI of the columns of A. When y / R(A) the equations (3.3) are said inconsistent. When y R(A), the equations (3.3) are said consistent and at least one solution exists. This solution is unique iff q(a) = 0. When a solution exists the two cases are Case I r(a) = n and the columns of A are LI and form a basis for R n. In this case, the solution to (3.3) is unique. The solution x is the representation of y in the basis formed by the columns of A. Case II r(a) < n or since q(a) = n r(a) we have q(a) > 0. In this case, an infinite number of solutions exist since Ax 0 = 0 has a nontrivial solution and we can take any scalar multiple of x 0 to generate an infinite number of solutions in the null space of A. Hence, we can add these solutions to x satisfying Ax = y to generate an infinite number of solutions to (3.3). That is, A(x + αx 0 ) = Ax + αax 0 = Ax + 0 = Ax = y, for any α R Solutions to Ax = y are parameterized as x = x p + x h = x p + α 1 n 1 + α 2 n α k n k where x p is called the particular solution satisfying Ax p = y. The homogeneous solution is denoted x h = α 1 n 1 + α 2 n α k n k and satisfies Ax h = A(α 1 n α k n k ) = 0 That is x h N(A) and we have taken q(a) = k, N(A) = span{n 1,...,n k }. Solving Ax = y by hand In order to solve Ax = y we must perform elementary row operations to reduce a matrix to row echelon form (REF) or reduced row echelon form (RREF). Elementary row operations consist of

7 3.2. LINEAR ALGEBRAIC EQUATIONS 57 Multiplying any row by a nonzero scalar Interchanging any two rows Adding a multiple of one row to another row A matrix is in REF if all zero rows are at the bottom rows of the matrix the first nonzero entry from the left in any nonzero row is a one. This one is called a leading one each leading one is to the right of all leading ones above it A matrix is in RREF if it is in REF and each leading one is the only nonzero entry in its column. Examples of matrices in REF are [ ] 0 1 1, where denotes some nonzero number. Examples of matrices in RREF are [ ] , Procedure for Computing N(A), R(A), q(a), r(a), x h 1. Using elementary row operations, reduce the augmented matrix [ A 0 ] to REF. Here A R m n and 0 is a m 1 zero vector. 2. The rank of A, r(a) is the number of nonzero rows in the REF computed in previous step. 3. From the Dimension Theorem we have q(a) = n r(a). 4. The columns of A corresponding to the columns of [ A 0 ] in REF which contain leading ones are a basis for R(A). Be careful, the REF matrix tells you which columns of the original A matrix to pick. 5. Assign nonleading or free variables in the REF of [ A 0 ] to parameters. The number of parameters assigned equals q(a) = n r(a). 6. Solve for the leading or pivot variables in terms of the free variables. The number of pivot variables is r(a). 7. The solution to Ax h = 0 you obtain will be in the form x h = α 1 n 1 + α 2 n α k n k where q(a) = n r(a) = k and N(A) = span{n 1,..., n k }. The α k are the free variables.

8 58 CHAPTER 3. LINEAR ALGEBRA Procedure for Computing x p 1. Reduce the augmented matrix [ A y ] to RREF. If the RREF has a leading one in the last column, no solution exists i.e., y / R(A) or the equations are inconsistent. 2. Introduce parameters for nonleading or free variables and solve for leading or pivot variables. The solution you obtain takes the form x = x p + α 1 n 1 + α 2 n α k n k where q(a) = k and N(A) = span{n 1,...,n k }. Evidently, if you are required to compute x p, as a byproduct you obtain N(A), R(A), q(a), r(a), x h. Example 19 Given A = , y = Find N(A), R(A), q(a), r(a), x h, x p. Note that n = 4, m = 3. Since we require x p we reduce the augmented matrix [ A y ] to RREF ,2R 2 R 3 R 3, ,R 1 R 2, 4R 1 R 3 R ,R 1 2R 2 R The number of nonzero rows in RREF (or REF) is the rank of A. Hence, r(a) = 2. We assign parameters to free variables x 3, x 4. x 3 = t, x 4 = s, t R s R Next we solve for pivot variables x 1, x 2 : x 1 = x 3 = t x 2 = 4 x 3 2x 4 = 4 t 2s Hence the solution can be written x = x p + tn 1 + sn 2 = t s 2 0 (3.4) 0 0 1

9 3.2. LINEAR ALGEBRAIC EQUATIONS 59 Hence, the null space is given by 1 0 N(A) = span{n 1, n 2 } = span{ 1 1, 2 0 } 0 1 The dimension of N(A) is q(a) = n 2 = 2. A basis for R(A) is obtained by picking the column of A which correspond to the leading ones in the RREF of [ A y ]. In this case, the leading ones are in column 1 and 2. Hence, 0 1 R(A) = span{b 1, b 2 } = span{ 1, 2 } 2 0 We remark that the third column of A is b 1 + b 2 and the fourth column is 2b 2. As expected, y R(A) and in this case y = 4b 2. Solving Ax = y by MATLAB MATLAB provides a number of useful commands for computing N(A), R(A), q(a), r(a), x h, x p rref(a) computes the RREF of A. rrefmovie(a) shows the sequence of row operations to get RREF. rank(a) computes r(a) using a singular value decomposition. null(a) computes an orthonormalized basis for N(A). null(a, r ) computes a basis for N(A) in rational number form from rref output. orth(a) computes an orthonormalized basis for R(A). MATLAB s linear systems of equations commands y=[-4-8 0] ; A=[ ; ; ]; AM=[A y]; Augmented matrix disp( Reduced row echelon form ); rref(am) disp( Basis for N(A) ); null(a, r ) disp( r(a) ); rank(a) disp( orth(a) ); orth(a) Program Output: >> Reduced row echelon form

10 60 CHAPTER 3. LINEAR ALGEBRA ans = Basis for N(A) ans = r(a) ans = 2 Orthonormalized basis for R(A) ans = Eigenvalues, eigenvectors See [Bay99, Sec. 4.1, 4.2, 4.3, 4.4.1, 4.4.2, 4.4.5]. For square matrices A R n n, a number λ C is an eigenvalue of A if there exists a nonzero vector v C n such that Av = λv (3.5) In this case v is called an eigenvector of A. Evidently (3.5) implies (A λi)v = 0 (3.6) We know v 0 iff det(a λi) = 0, and we know the number of LI solutions to (3.6) is the nullity of A λi or q(a λi). The set of all eigenvectors corresponding to an eigenvalue λ is a vector space and called the eigenspace of λ. We denote the eigenspace E λ (A) = {v C n : Av = λv}. Note that an eigenspace contains the zero vector and is a subspace of C n. Recall that φ(λ) = det(λi A) (3.7)

11 3.3. EIGENVALUES, EIGENVECTORS 61 is the characteristic polynomial of A, and the nth degree polynomial equation φ(λ) = det(λi A) = 0 (3.8) is the characteristic equation of A. Evidently the roots of the characteristic equation of A are the eigenvalues of A. [ ] a11 a Example 20 Consider A = 12. The characteristic polynomial of A is a 21 a 22 ([ ]) λ a11 a φ(λ) = det 12 a 21 λ a 22 = (λ a 11 )(λ a 22 ) a 12 a 21 = λ 2 λ(a 11 + a 22 ) + a 11 a 22 a 12 a 21 = λ 2 λ trace(a) + det(a) where trace(a) is the sum of the diagonal entries of A. Eigenvalues are given by the roots of the characteristic equation: λ = 1 2 (a 11 + a 22 ± (a 11 + a 22 ) 2 4(a 11 a 22 a 12 a 21 )) = 1 2 (a 11 + a 22 ± (a 11 a 22 ) 2 + 4a 12 a 21 ) We make the following useful observations about eigenvalues and eigenvectors: Eigenvectors and eigenvalues have a geometric interpretation. If v is an eigenvector of A, the effect of multiplying A by v is simple when the eigenvalue λ corresponding to v is real: it involves a scaling of v by λ. Eigenvectors are not unique. They can be scaled by any number. If A has complex eigenvalues, they appear in complex pairs. If λ C has a corresponding eigenvector x, this implies λ has a corresponding eigenvector x ( denotes complex conjugate). This is because A 1 exists iff A has no zero eigenvalues. Ax = λx (Ax) = (λx) Ax = λ x All eigenvalues of a symmetric matrix (i.e., A T = A) are real. All eigenvalues of a skew-symmetric matrix (i.e., A T = A) are purely imaginary. For A R n n we have trace(a) = n i=1 λ i and det(a) = Π n i=1 λ i.

12 62 CHAPTER 3. LINEAR ALGEBRA The eigenvalues of an upper or lower triangular matrix can be read off of its diagonal entries. This is because φ(λ) = Π n i=1 (λ a ii) = 0, where a ij denotes the (i, j)th entry of A. The eigenvalues of an upper or lower block triangular matrix is the union of eigenvalues of the submatrices appearing on its block diagonal. the eigenvalue of A and A T are the same. If λ is an eigenvalue of A, then λ m, m 0 is an eigenvalue of A m, and any eigenvector of A is an eigenvector of A m. If λ is an eigenvalue of A, then 1/λ is an eigenvalue of A 1, and any eigenvector of A is an eigenvector of A 1. Numerical methods which compute eigenvalues do not solve for the roots of the characteristic equation as this is not numerically stable. Diagonalizing matrices We suppose A R n n has n LI eigenvectors. Such matrices are said non-defective. We denote this set of eigenvectors as {v 1,...,v n }. We define a modal matrix as the matrix whose columns are the eigenvectors of A: M = [ v 1 v n ] (3.9) If we compute  = M 1 AM (3.10) we find that  is a diagonal matrix. This is because AM = [ Av 1 Av n ] = [ λ1 v 1 λ n v n ] = M diag(λ1,..., λ n ) = M (3.11) where λ λ 2 0 diag(λ 1,...,λ n ) = λ n Example 21 Given A = The eigenvalues of A can be read off the diagonal entries for upper or lower triangular matrices. Hence, in this case we have λ 1 = 2 with algebraic multiplicity m 1 = 1 and λ 2 = 1

13 3.3. EIGENVALUES, EIGENVECTORS 63 with algebraic multiplicity m 2 = 2. We compute eigenvector associated with λ 1 by solving the homogeneous linear system (λ 1 I A)x = (2I A)x = x = Since λ 1 I A is already in RREF we assign x 3 = t, t R and solve for pivot variables which implies For λ 2 we solve x 1 = t x 2 = 0 1 x = t 0, t R (I A)x = x = The augmented matrix [ I A 0 ] in RREF is We assign parameters to free variables: x 1 = s, x 2 = t, where s, t R. And solve for the pivot variable to get 1 0 x = 0 s + 1 t, s, t R 0 0 We remark that q(i A) = 2 = m 2 and hence the matrix A has three LI eigenvectors and we can diagonalize it: Â = M 1 AM = A = diag(1, 1, 2) Example 22 Given A = As before, we can read the eigenvalues of A off its diagonal entries as A is upper triangular. Hence we have λ 1 = 2 with algebraic multiplicity m 1 = 1 and λ 2 = 1 with algebraic multiplicity m 2 = 2.

14 64 CHAPTER 3. LINEAR ALGEBRA We compute the eigenvector associated with λ 1 = 2 from (2I A)x = x = Since 2I A is in REF we assign free variables x 3 = t, t R and solve for pivot variables x 1, x 2 : x 2 = 3t, x 1 = 3t + 2t = 5t Hence For λ 2 we have 5 x = 3 t, 1 t R (I A)x = x = Reducing the augmented system to REF gives Assigning x 1 = t and solving for x 2 = x 3 = 0 gives 1 x = 0 t, t R 0 In this case we only have two LI eigenvectors and diagonalization is not possible. In general, if for each distinct eigenvalue λ j we have q(λ j I A) = m j, i.e., the nullity of λ j I A equals the algebraic multiplicity of λ j then it is possible to diagonalize A. If on the other hand q(λ j I A) < m j for some j, we cannot diagonalize A. The number q(λ j I A) is called the geometric multiplicity of λ j. In general, the algebraic multiplicity is greater than or equal to the geometric multiplicity, and when they are equal diagonalization is possible. Since q(λ j I A) 1 we observe that if a matrix has distinct eigenvalues, it can always be diagonalized. It turns out that for symmetric matrices (i.e., A = A T ), n LI eigenvectors can always be found and that the eigenvalues of A are real. Similarly skew-symmetric matrices (i.e., A T = A) and unitary matrices (i.e., A T = A 1 ) have n LI eigenvectors and can also always be diagonalized. It should also be noted that although not all matrices can be diagonalized, any matrix can be put into a block diagonal so-called Jordan Form which is almost diagonal : see [Bay99, pg. 172]. The Jordan form of a matrix has the form J = blockdiag{j 1,...,J p }

15 3.3. EIGENVALUES, EIGENVECTORS 65 where J i R r i r i, 1 i p, p i=1 r i = n, and λ i λ i λ i J i = λ i λ i λ i The matrices J i are called Jordan blocks and have an eigenvalue on its diagonal entries and ones on its superdiagonal (except when r i = 1). It can be readily shown that each J i has only one LI eigenvector. Note that in general there are many possible choices of r i such that the above conditions hold. To see this we consider a 5 5 matrix with algebraic multiplicities m 1 = 4 and m 2 = 1. Such a matrix could have one of 5 possible Jordan forms depending on the geometric multiplicity of λ 1. If the geometric multiplicity q(λ 1 I A) = 1 then the Jordan form has 1 Jordan block associated with λ 1 : λ λ λ λ λ 2 If the geometric multiplicity q(λ 1 I A) = 2 then 2 Jordan blocks are associated with λ 1 and we have two possible cases λ λ λ λ λ 2 λ λ λ λ λ 2 When q(λ 1 I A) = 3 then 3 Jordan blocks are associated with λ 1 and we have 1 possible case λ λ λ λ λ 2

16 66 CHAPTER 3. LINEAR ALGEBRA And finally when q(λ 1 I A) = m 1 = 4 the matrix is diagonalizable which is a special case of the Jordan form: λ λ λ λ λ 2 Diagonalizing LTI state space models Just as we can diagonalize matrices, we can also transform the state coordinates of an LTI state space system model by diagonalizing its system matrix. Example ẋ = x + 0 u [ ] y = x The eigenvalues of the system matrix are determined from λ det(λi A) = det 1 λ λ + 3 Taking an expansion down column 3 gives det(λi A) = (λ + 3)((λ + 1)(λ 2) + 2) = λ(λ + 3)(λ 1) Hence we have distinct eigenvalues λ 1 = 0, λ 2 = 1, λ 3 = 3. Computing eigenvectors 2 λ 1 = 0 x = 1 t, t R 1 4 λ 2 = 1 x = 4 t, t R 1 0 λ 3 = 3 x = 0 t, t R 1 Hence a change of coordinates Mξ = x puts 1 the system into the form ξ = Âξ + ˆBu y = Ĉξ (3.12) 1 Note that compared to Section 2.3 we have changed convention in our definition of new coordinates from ξ = Mx to Mξ = x.

17 3.3. EIGENVALUES, EIGENVECTORS 67 where the matrices Â, ˆB, Ĉ are given byâ = M 1 AM ˆB = M 1 B Ĉ = CM We have and we obtain M = M 1 = 1/4 1/ /4 1/2 1 Â = diag(0, 1, 3) ˆB = 1/4 1/2 0 0 = 1/4 3/4 1/ /4 [ ] Ĉ = = [ When a system has an A-matrix which is diagonal (assuming eigenvalues are real), we sometimes say it is in modal form. Note that since eigenvectors are not uniquely defined, neither are the matrices ˆB, Ĉ. The JCF we saw in Chapter 2 is a generalization of the modal form. MATLAB has the command [CSYS,T]= canon(sys, modal ) transforms a systemsys into modal form. In this case if ξ denote the modal form coordinates, ξ = Tx. ]

18

19 Bibliography [Bay99] John S. Bay. Fundamentals of linear state space systems. McGraw-Hill, [Che99] Chi-Tsong Chen. Linear System Theory and Design. Oxford, New York, NY, 3rd edition, [Max68] J.C. Maxwell. On governors. Proceedings of the Royal Society of London, 16: ,

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

Study Guide for Linear Algebra Exam 2

Study Guide for Linear Algebra Exam 2 Study Guide for Linear Algebra Exam 2 Term Vector Space Definition A Vector Space is a nonempty set V of objects, on which are defined two operations, called addition and multiplication by scalars (real

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

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

Remark By definition, an eigenvector must be a nonzero vector, but eigenvalue could be zero.

Remark By definition, an eigenvector must be a nonzero vector, but eigenvalue could be zero. Sec 6 Eigenvalues and Eigenvectors Definition An eigenvector of an n n matrix A is a nonzero vector x such that A x λ x for some scalar λ A scalar λ is called an eigenvalue of A if there is a nontrivial

More information

and let s calculate the image of some vectors under the transformation T.

and let s calculate the image of some vectors under the transformation T. Chapter 5 Eigenvalues and Eigenvectors 5. Eigenvalues and Eigenvectors Let T : R n R n be a linear transformation. Then T can be represented by a matrix (the standard matrix), and we can write T ( v) =

More information

MAT Linear Algebra Collection of sample exams

MAT Linear Algebra Collection of sample exams MAT 342 - Linear Algebra Collection of sample exams A-x. (0 pts Give the precise definition of the row echelon form. 2. ( 0 pts After performing row reductions on the augmented matrix for a certain system

More information

IMPORTANT DEFINITIONS AND THEOREMS REFERENCE SHEET

IMPORTANT DEFINITIONS AND THEOREMS REFERENCE SHEET IMPORTANT DEFINITIONS AND THEOREMS REFERENCE SHEET This is a (not quite comprehensive) list of definitions and theorems given in Math 1553. Pay particular attention to the ones in red. Study Tip For each

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

IMPORTANT DEFINITIONS AND THEOREMS REFERENCE SHEET

IMPORTANT DEFINITIONS AND THEOREMS REFERENCE SHEET IMPORTANT DEFINITIONS AND THEOREMS REFERENCE SHEET This is a (not quite comprehensive) list of definitions and theorems given in Math 1553. Pay particular attention to the ones in red. Study Tip For each

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

SECTION 3.3. PROBLEM 22. The null space of a matrix A is: N(A) = {X : AX = 0}. Here are the calculations of AX for X = a,b,c,d, and e. =

SECTION 3.3. PROBLEM 22. The null space of a matrix A is: N(A) = {X : AX = 0}. Here are the calculations of AX for X = a,b,c,d, and e. = SECTION 3.3. PROBLEM. The null space of a matrix A is: N(A) {X : AX }. Here are the calculations of AX for X a,b,c,d, and e. Aa [ ][ ] 3 3 [ ][ ] Ac 3 3 [ ] 3 3 [ ] 4+4 6+6 Ae [ ], Ab [ ][ ] 3 3 3 [ ]

More information

Linear Algebra Practice Problems

Linear Algebra Practice Problems Linear Algebra Practice Problems Math 24 Calculus III Summer 25, Session II. Determine whether the given set is a vector space. If not, give at least one axiom that is not satisfied. Unless otherwise stated,

More information

Chapter 5 Eigenvalues and Eigenvectors

Chapter 5 Eigenvalues and Eigenvectors Chapter 5 Eigenvalues and Eigenvectors Outline 5.1 Eigenvalues and Eigenvectors 5.2 Diagonalization 5.3 Complex Vector Spaces 2 5.1 Eigenvalues and Eigenvectors Eigenvalue and Eigenvector If A is a n n

More information

Solving a system by back-substitution, checking consistency of a system (no rows of the form

Solving a system by back-substitution, checking consistency of a system (no rows of the form MATH 520 LEARNING OBJECTIVES SPRING 2017 BROWN UNIVERSITY SAMUEL S. WATSON Week 1 (23 Jan through 27 Jan) Definition of a system of linear equations, definition of a solution of a linear system, elementary

More information

Remark 1 By definition, an eigenvector must be a nonzero vector, but eigenvalue could be zero.

Remark 1 By definition, an eigenvector must be a nonzero vector, but eigenvalue could be zero. Sec 5 Eigenvectors and Eigenvalues In this chapter, vector means column vector Definition An eigenvector of an n n matrix A is a nonzero vector x such that A x λ x for some scalar λ A scalar λ is called

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

MA 265 FINAL EXAM Fall 2012

MA 265 FINAL EXAM Fall 2012 MA 265 FINAL EXAM Fall 22 NAME: INSTRUCTOR S NAME:. There are a total of 25 problems. You should show work on the exam sheet, and pencil in the correct answer on the scantron. 2. No books, notes, or calculators

More information

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

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

More information

Solutions to Final Exam

Solutions to Final Exam Solutions to Final Exam. Let A be a 3 5 matrix. Let b be a nonzero 5-vector. Assume that the nullity of A is. (a) What is the rank of A? 3 (b) Are the rows of A linearly independent? (c) Are the columns

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

CSL361 Problem set 4: Basic linear algebra

CSL361 Problem set 4: Basic linear algebra CSL361 Problem set 4: Basic linear algebra February 21, 2017 [Note:] If the numerical matrix computations turn out to be tedious, you may use the function rref in Matlab. 1 Row-reduced echelon matrices

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

Linear System Theory

Linear System Theory Linear System Theory Wonhee Kim Lecture 4 Apr. 4, 2018 1 / 40 Recap Vector space, linear space, linear vector space Subspace Linearly independence and dependence Dimension, Basis, Change of Basis 2 / 40

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

MAC Module 12 Eigenvalues and Eigenvectors. Learning Objectives. Upon completing this module, you should be able to:

MAC Module 12 Eigenvalues and Eigenvectors. Learning Objectives. Upon completing this module, you should be able to: MAC Module Eigenvalues and Eigenvectors Learning Objectives Upon completing this module, you should be able to: Solve the eigenvalue problem by finding the eigenvalues and the corresponding eigenvectors

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

MATH 20F: LINEAR ALGEBRA LECTURE B00 (T. KEMP)

MATH 20F: LINEAR ALGEBRA LECTURE B00 (T. KEMP) MATH 20F: LINEAR ALGEBRA LECTURE B00 (T KEMP) Definition 01 If T (x) = Ax is a linear transformation from R n to R m then Nul (T ) = {x R n : T (x) = 0} = Nul (A) Ran (T ) = {Ax R m : x R n } = {b R m

More information

Equality: Two matrices A and B are equal, i.e., A = B if A and B have the same order and the entries of A and B are the same.

Equality: Two matrices A and B are equal, i.e., A = B if A and B have the same order and the entries of A and B are the same. Introduction Matrix Operations Matrix: An m n matrix A is an m-by-n array of scalars from a field (for example real numbers) of the form a a a n a a a n A a m a m a mn The order (or size) of A is m n (read

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

LINEAR ALGEBRA SUMMARY SHEET.

LINEAR ALGEBRA SUMMARY SHEET. LINEAR ALGEBRA SUMMARY SHEET RADON ROSBOROUGH https://intuitiveexplanationscom/linear-algebra-summary-sheet/ This document is a concise collection of many of the important theorems of linear algebra, organized

More information

What is on this week. 1 Vector spaces (continued) 1.1 Null space and Column Space of a matrix

What is on this week. 1 Vector spaces (continued) 1.1 Null space and Column Space of a matrix Professor Joana Amorim, jamorim@bu.edu What is on this week Vector spaces (continued). Null space and Column Space of a matrix............................. Null Space...........................................2

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

1. In this problem, if the statement is always true, circle T; otherwise, circle F.

1. In this problem, if the statement is always true, circle T; otherwise, circle F. Math 1553, Extra Practice for Midterm 3 (sections 45-65) Solutions 1 In this problem, if the statement is always true, circle T; otherwise, circle F a) T F If A is a square matrix and the homogeneous equation

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

Math 323 Exam 2 Sample Problems Solution Guide October 31, 2013

Math 323 Exam 2 Sample Problems Solution Guide October 31, 2013 Math Exam Sample Problems Solution Guide October, Note that the following provides a guide to the solutions on the sample problems, but in some cases the complete solution would require more work or justification

More information

SUMMARY OF MATH 1600

SUMMARY OF MATH 1600 SUMMARY OF MATH 1600 Note: The following list is intended as a study guide for the final exam. It is a continuation of the study guide for the midterm. It does not claim to be a comprehensive list. You

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

LINEAR ALGEBRA REVIEW

LINEAR ALGEBRA REVIEW LINEAR ALGEBRA REVIEW SPENCER BECKER-KAHN Basic Definitions Domain and Codomain. Let f : X Y be any function. This notation means that X is the domain of f and Y is the codomain of f. This means that for

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

System of Linear Equations

System of Linear Equations Math 20F Linear Algebra Lecture 2 1 System of Linear Equations Slide 1 Definition 1 Fix a set of numbers a ij, b i, where i = 1,, m and j = 1,, n A system of m linear equations in n variables x j, is given

More information

MAC Module 12 Eigenvalues and Eigenvectors

MAC Module 12 Eigenvalues and Eigenvectors MAC 23 Module 2 Eigenvalues and Eigenvectors Learning Objectives Upon completing this module, you should be able to:. Solve the eigenvalue problem by finding the eigenvalues and the corresponding eigenvectors

More information

Math 205, Summer I, Week 4b: Continued. Chapter 5, Section 8

Math 205, Summer I, Week 4b: Continued. Chapter 5, Section 8 Math 205, Summer I, 2016 Week 4b: Continued Chapter 5, Section 8 2 5.8 Diagonalization [reprint, week04: Eigenvalues and Eigenvectors] + diagonaliization 1. 5.8 Eigenspaces, Diagonalization A vector v

More information

Quizzes for Math 304

Quizzes for Math 304 Quizzes for Math 304 QUIZ. A system of linear equations has augmented matrix 2 4 4 A = 2 0 2 4 3 5 2 a) Write down this system of equations; b) Find the reduced row-echelon form of A; c) What are the pivot

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

235 Final exam review questions

235 Final exam review questions 5 Final exam review questions Paul Hacking December 4, 0 () Let A be an n n matrix and T : R n R n, T (x) = Ax the linear transformation with matrix A. What does it mean to say that a vector v R n is an

More information

DIAGONALIZATION. In order to see the implications of this definition, let us consider the following example Example 1. Consider the matrix

DIAGONALIZATION. In order to see the implications of this definition, let us consider the following example Example 1. Consider the matrix DIAGONALIZATION Definition We say that a matrix A of size n n is diagonalizable if there is a basis of R n consisting of eigenvectors of A ie if there are n linearly independent vectors v v n such that

More information

Math Final December 2006 C. Robinson

Math Final December 2006 C. Robinson Math 285-1 Final December 2006 C. Robinson 2 5 8 5 1 2 0-1 0 1. (21 Points) The matrix A = 1 2 2 3 1 8 3 2 6 has the reduced echelon form U = 0 0 1 2 0 0 0 0 0 1. 2 6 1 0 0 0 0 0 a. Find a basis for the

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 II Tutorial solutions #1 A = x 1

Linear algebra II Tutorial solutions #1 A = x 1 Linear algebra II Tutorial solutions #. Find the eigenvalues and the eigenvectors of the matrix [ ] 5 2 A =. 4 3 Since tra = 8 and deta = 5 8 = 7, the characteristic polynomial is f(λ) = λ 2 (tra)λ+deta

More information

Algorithms to Compute Bases and the Rank of a Matrix

Algorithms to Compute Bases and the Rank of a Matrix Algorithms to Compute Bases and the Rank of a Matrix Subspaces associated to a matrix Suppose that A is an m n matrix The row space of A is the subspace of R n spanned by the rows of A The column space

More information

A matrix is a rectangular array of. objects arranged in rows and columns. The objects are called the entries. is called the size of the matrix, and

A matrix is a rectangular array of. objects arranged in rows and columns. The objects are called the entries. is called the size of the matrix, and Section 5.5. Matrices and Vectors A matrix is a rectangular array of objects arranged in rows and columns. The objects are called the entries. A matrix with m rows and n columns is called an m n matrix.

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

(b) If a multiple of one row of A is added to another row to produce B then det(b) =det(a).

(b) If a multiple of one row of A is added to another row to produce B then det(b) =det(a). .(5pts) Let B = 5 5. Compute det(b). (a) (b) (c) 6 (d) (e) 6.(5pts) Determine which statement is not always true for n n matrices A and B. (a) If two rows of A are interchanged to produce B, then det(b)

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

Definitions for Quizzes

Definitions for Quizzes Definitions for Quizzes Italicized text (or something close to it) will be given to you. Plain text is (an example of) what you should write as a definition. [Bracketed text will not be given, nor does

More information

A matrix is a rectangular array of. objects arranged in rows and columns. The objects are called the entries. is called the size of the matrix, and

A matrix is a rectangular array of. objects arranged in rows and columns. The objects are called the entries. is called the size of the matrix, and Section 5.5. Matrices and Vectors A matrix is a rectangular array of objects arranged in rows and columns. The objects are called the entries. A matrix with m rows and n columns is called an m n matrix.

More information

Generalized eigenvector - Wikipedia, the free encyclopedia

Generalized eigenvector - Wikipedia, the free encyclopedia 1 of 30 18/03/2013 20:00 Generalized eigenvector From Wikipedia, the free encyclopedia In linear algebra, for a matrix A, there may not always exist a full set of linearly independent eigenvectors that

More information

(a) II and III (b) I (c) I and III (d) I and II and III (e) None are true.

(a) II and III (b) I (c) I and III (d) I and II and III (e) None are true. 1 Which of the following statements is always true? I The null space of an m n matrix is a subspace of R m II If the set B = {v 1,, v n } spans a vector space V and dimv = n, then B is a basis for V III

More information

Solutions to Final Practice Problems Written by Victoria Kala Last updated 12/5/2015

Solutions to Final Practice Problems Written by Victoria Kala Last updated 12/5/2015 Solutions to Final Practice Problems Written by Victoria Kala vtkala@math.ucsb.edu Last updated /5/05 Answers This page contains answers only. See the following pages for detailed solutions. (. (a x. See

More information

Generalized Eigenvectors and Jordan Form

Generalized Eigenvectors and Jordan Form Generalized Eigenvectors and Jordan Form We have seen that an n n matrix A is diagonalizable precisely when the dimensions of its eigenspaces sum to n. So if A is not diagonalizable, there is at least

More information

Solutions to practice questions for the final

Solutions to practice questions for the final Math A UC Davis, Winter Prof. Dan Romik Solutions to practice questions for the final. You are given the linear system of equations x + 4x + x 3 + x 4 = 8 x + x + x 3 = 5 x x + x 3 x 4 = x + x + x 4 =

More information

W2 ) = dim(w 1 )+ dim(w 2 ) for any two finite dimensional subspaces W 1, W 2 of V.

W2 ) = dim(w 1 )+ dim(w 2 ) for any two finite dimensional subspaces W 1, W 2 of V. MA322 Sathaye Final Preparations Spring 2017 The final MA 322 exams will be given as described in the course web site (following the Registrar s listing. You should check and verify that you do not have

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

1. Let m 1 and n 1 be two natural numbers such that m > n. Which of the following is/are true?

1. Let m 1 and n 1 be two natural numbers such that m > n. Which of the following is/are true? . Let m and n be two natural numbers such that m > n. Which of the following is/are true? (i) A linear system of m equations in n variables is always consistent. (ii) A linear system of n equations in

More information

MATH 323 Linear Algebra Lecture 12: Basis of a vector space (continued). Rank and nullity of a matrix.

MATH 323 Linear Algebra Lecture 12: Basis of a vector space (continued). Rank and nullity of a matrix. MATH 323 Linear Algebra Lecture 12: Basis of a vector space (continued). Rank and nullity of a matrix. Basis Definition. Let V be a vector space. A linearly independent spanning set for V is called a basis.

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

Lecture Notes in Linear Algebra

Lecture Notes in Linear Algebra Lecture Notes in Linear Algebra Dr. Abdullah Al-Azemi Mathematics Department Kuwait University February 4, 2017 Contents 1 Linear Equations and Matrices 1 1.2 Matrices............................................

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 M1 - FIB. Contents: 5. Matrices, systems of linear equations and determinants 6. Vector space 7. Linear maps 8.

Linear Algebra M1 - FIB. Contents: 5. Matrices, systems of linear equations and determinants 6. Vector space 7. Linear maps 8. Linear Algebra M1 - FIB Contents: 5 Matrices, systems of linear equations and determinants 6 Vector space 7 Linear maps 8 Diagonalization Anna de Mier Montserrat Maureso Dept Matemàtica Aplicada II Translation:

More information

NOTES on LINEAR ALGEBRA 1

NOTES on LINEAR ALGEBRA 1 School of Economics, Management and Statistics University of Bologna Academic Year 207/8 NOTES on LINEAR ALGEBRA for the students of Stats and Maths This is a modified version of the notes by Prof Laura

More information

Warm-up. True or false? Baby proof. 2. The system of normal equations for A x = y has solutions iff A x = y has solutions

Warm-up. True or false? Baby proof. 2. The system of normal equations for A x = y has solutions iff A x = y has solutions Warm-up True or false? 1. proj u proj v u = u 2. The system of normal equations for A x = y has solutions iff A x = y has solutions 3. The normal equations are always consistent Baby proof 1. Let A be

More information

Math Computation Test 1 September 26 th, 2016 Debate: Computation vs. Theory Whatever wins, it ll be Huuuge!

Math Computation Test 1 September 26 th, 2016 Debate: Computation vs. Theory Whatever wins, it ll be Huuuge! Math 5- Computation Test September 6 th, 6 Debate: Computation vs. Theory Whatever wins, it ll be Huuuge! Name: Answer Key: Making Math Great Again Be sure to show your work!. (8 points) Consider the following

More information

Chapter 7. Linear Algebra: Matrices, Vectors,

Chapter 7. Linear Algebra: Matrices, Vectors, Chapter 7. Linear Algebra: Matrices, Vectors, Determinants. Linear Systems Linear algebra includes the theory and application of linear systems of equations, linear transformations, and eigenvalue problems.

More information

Numerical Linear Algebra Homework Assignment - Week 2

Numerical Linear Algebra Homework Assignment - Week 2 Numerical Linear Algebra Homework Assignment - Week 2 Đoàn Trần Nguyên Tùng Student ID: 1411352 8th October 2016 Exercise 2.1: Show that if a matrix A is both triangular and unitary, then it is diagonal.

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

Chapter 3. Determinants and Eigenvalues

Chapter 3. Determinants and Eigenvalues Chapter 3. Determinants and Eigenvalues 3.1. Determinants With each square matrix we can associate a real number called the determinant of the matrix. Determinants have important applications to the theory

More information

Row Space and Column Space of a Matrix

Row Space and Column Space of a Matrix Row Space and Column Space of a Matrix 1/18 Summary: To a m n matrix A = (a ij ), we can naturally associate subspaces of K n and of K m, called the row space of A and the column space of A, respectively.

More information

7. Dimension and Structure.

7. Dimension and Structure. 7. Dimension and Structure 7.1. Basis and Dimension Bases for Subspaces Example 2 The standard unit vectors e 1, e 2,, e n are linearly independent, for if we write (2) in component form, then we obtain

More information

Math 1553, Introduction to Linear Algebra

Math 1553, Introduction to Linear Algebra Learning goals articulate what students are expected to be able to do in a course that can be measured. This course has course-level learning goals that pertain to the entire course, and section-level

More information

University of Colorado at Denver Mathematics Department Applied Linear Algebra Preliminary Exam With Solutions 16 January 2009, 10:00 am 2:00 pm

University of Colorado at Denver Mathematics Department Applied Linear Algebra Preliminary Exam With Solutions 16 January 2009, 10:00 am 2:00 pm University of Colorado at Denver Mathematics Department Applied Linear Algebra Preliminary Exam With Solutions 16 January 2009, 10:00 am 2:00 pm Name: The proctor will let you read the following conditions

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

BASIC ALGORITHMS IN LINEAR ALGEBRA. Matrices and Applications of Gaussian Elimination. A 2 x. A T m x. A 1 x A T 1. A m x

BASIC ALGORITHMS IN LINEAR ALGEBRA. Matrices and Applications of Gaussian Elimination. A 2 x. A T m x. A 1 x A T 1. A m x BASIC ALGORITHMS IN LINEAR ALGEBRA STEVEN DALE CUTKOSKY Matrices and Applications of Gaussian Elimination Systems of Equations Suppose that A is an n n matrix with coefficents in a field F, and x = (x,,

More information

MATH 304 Linear Algebra Lecture 34: Review for Test 2.

MATH 304 Linear Algebra Lecture 34: Review for Test 2. MATH 304 Linear Algebra Lecture 34: Review for Test 2. Topics for Test 2 Linear transformations (Leon 4.1 4.3) Matrix transformations Matrix of a linear mapping Similar matrices Orthogonality (Leon 5.1

More information

1. General Vector Spaces

1. General Vector Spaces 1.1. Vector space axioms. 1. General Vector Spaces Definition 1.1. Let V be a nonempty set of objects on which the operations of addition and scalar multiplication are defined. By addition we mean a rule

More information

Linear equations in linear algebra

Linear equations in linear algebra Linear equations in linear algebra Samy Tindel Purdue University Differential equations and linear algebra - MA 262 Taken from Differential equations and linear algebra Pearson Collections Samy T. Linear

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

Eigenvalues and Eigenvectors A =

Eigenvalues and Eigenvectors A = Eigenvalues and Eigenvectors Definition 0 Let A R n n be an n n real matrix A number λ R is a real eigenvalue of A if there exists a nonzero vector v R n such that A v = λ v The vector v is called an eigenvector

More information

Math 315: Linear Algebra Solutions to Assignment 7

Math 315: Linear Algebra Solutions to Assignment 7 Math 5: Linear Algebra s to Assignment 7 # Find the eigenvalues of the following matrices. (a.) 4 0 0 0 (b.) 0 0 9 5 4. (a.) The characteristic polynomial det(λi A) = (λ )(λ )(λ ), so the eigenvalues are

More information

MATH 583A REVIEW SESSION #1

MATH 583A REVIEW SESSION #1 MATH 583A REVIEW SESSION #1 BOJAN DURICKOVIC 1. Vector Spaces Very quick review of the basic linear algebra concepts (see any linear algebra textbook): (finite dimensional) vector space (or linear space),

More information

Solutions of Linear system, vector and matrix equation

Solutions of Linear system, vector and matrix equation Goals: Solutions of Linear system, vector and matrix equation Solutions of linear system. Vectors, vector equation. Matrix equation. Math 112, Week 2 Suggested Textbook Readings: Sections 1.3, 1.4, 1.5

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

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

ft-uiowa-math2550 Assignment OptionalFinalExamReviewMultChoiceMEDIUMlengthForm due 12/31/2014 at 10:36pm CST

ft-uiowa-math2550 Assignment OptionalFinalExamReviewMultChoiceMEDIUMlengthForm due 12/31/2014 at 10:36pm CST me me ft-uiowa-math255 Assignment OptionalFinalExamReviewMultChoiceMEDIUMlengthForm due 2/3/2 at :3pm CST. ( pt) Library/TCNJ/TCNJ LinearSystems/problem3.pg Give a geometric description of the following

More information

Eigenvalues and Eigenvectors

Eigenvalues and Eigenvectors Eigenvalues and Eigenvectors week -2 Fall 26 Eigenvalues and eigenvectors The most simple linear transformation from R n to R n may be the transformation of the form: T (x,,, x n ) (λ x, λ 2,, λ n x n

More information

Comps Study Guide for Linear Algebra

Comps Study Guide for Linear Algebra Comps Study Guide for Linear Algebra Department of Mathematics and Statistics Amherst College September, 207 This study guide was written to help you prepare for the linear algebra portion of the Comprehensive

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 16: Eigenvalue Problems; Similarity Transformations Xiangmin Jiao Stony Brook University Xiangmin Jiao Numerical Analysis I 1 / 18 Eigenvalue

More information

Chapter 2: Matrix Algebra

Chapter 2: Matrix Algebra Chapter 2: Matrix Algebra (Last Updated: October 12, 2016) These notes are derived primarily from Linear Algebra and its applications by David Lay (4ed). Write A = 1. Matrix operations [a 1 a n. Then entry

More information

DM554 Linear and Integer Programming. Lecture 9. Diagonalization. Marco Chiarandini

DM554 Linear and Integer Programming. Lecture 9. Diagonalization. Marco Chiarandini DM554 Linear and Integer Programming Lecture 9 Marco Chiarandini Department of Mathematics & Computer Science University of Southern Denmark Outline 1. More on 2. 3. 2 Resume Linear transformations and

More information