A.l INTRODUCTORY CONCEPTS AND OPERATIONS umnx, = b, az3z3 = b, i = 1,... m (A.l-2)

Size: px
Start display at page:

Download "A.l INTRODUCTORY CONCEPTS AND OPERATIONS umnx, = b, az3z3 = b, i = 1,... m (A.l-2)"

Transcription

1 Computer-Aided Modeling of Reactive Systems by Warren E. Stewart and Michael Caracotsios Copyright John Wiley & Sons, Inc. Appendix A Solution of Linear Algebraic Equations Linear systems of algebraic equations occur often in science and engineering as exact or approximate formulations of various problems. Such systems have appeared many times in this book. Exact linear problems appear in Chapter 2. and iterative linearization schemes are used in Chapters 6 and 7. This chapter gives a brief summary of properties of linear algebraic equation systems. in elementary and partitioned form, and of certain elimination methods for their solution. Gauss-Jordan elimination, Gaussian elimination, LU factorization, and their use on partitioned arrays are described. Some software for computational linear algebra is pointed out, and references for further reading are given. A.l INTRODUCTORY CONCEPTS AND OPERATIONS A system of m linear algebraic equations in n unknowns, a1121 ~ 1 2 x 2... alnxn = bl a a a2nxn = b2 (A.1-1)... arnlxl + ~ ~ 2 x 2 can be written more concisely as n 1 3= umnx, = b, az3z3 = b, i = 1,.... m (A.l-2) Here at3 denotes the coefficient of the jth unknown x3 in the ith equation, and the numbers az3 and b, (hence x3) all are real. Often the number rn of equations is equal to the number n of unknowns. but exceptions are common in optimization and modeling and will be noted in Chapters 6 and 7. Array notations are convenient for such problems. Let the bold letters 177

2 178 Computer-Aided Modelang of Reactive Systems denote, respectively. the coefficient matrix A, the unknown column vector x, and the right-hand column vector b. Another way of representing an array is to enclose the expression for its elements in curly brackets: A = {a,,}, x = {x,}, b = {bt}. Defining the matrix-vector product (A.1-4) in accordance with Eq. (A.1-2), one can summarize Eq. (A.1-1) concisely as AX = b (A. 1-5) Methods for solving Eq. (A.1-1) can then be described in terms of operations on the arrays A and b. Before doing so. we pause to summarize a few essentials of linear algebra: fuller treatments are given in Stewart (1973) and in Xoble and Daniel (1988). Matrices can be added if their corresponding dimensions are equal. The addition is done element by element: A + B = {atj + bt,} (A.l-6) The difference A - B is formed analogously. It follows that two matrices are equal if their corresponding elements are equal; their difference is then a zero matrix 0, with every element equal to zero. RIultiplication of a matrix A by a scalar s is done element by element. and is commutative and associative as shown. Matrices A and B can be multiplied provided that they are conformable in the order written, that is, that the number of columns (column order) of the first matrix equals the number of rows (row order) of the second. The product C of a m x n. matrix A by a n x p matrix B has the elements (A. 1-8) Thus, the element in row z arid column k of the product matrix is the sum over j of the products (element j in row z of the first matrix) times (element j in column k of the second matrix). "hen AB equals BA. we say that the multiplication is tom7nututave; this property is limited to special pairs of square matrices of equal order. The transpose of a matrix A ii AT = {GJT = {a,,} (A. 1-9)

3 Solution of Linear Algebraic Equations 179 Thus, the rows of AT are the columns of A, and the columns of AT are the rows of A. A matrix that equals its transpose is called symmetric. The transpose of a product of square or rectangular matrices is given by (AB)T = BTAT (A.1-10) that is, by the product of the transposed matrices in reverse order. A vector x, by convention. denotes a column of elements, hence a onecolumn matrix {x21}. The transpose xt is a matrix {xlz} by Eq. (A.1-9) and is a row of elements, ordered from left to right The multiplication rule (A.1-8) and its corollary (A 1-10) thus hold directly for conforming products involving vectors. For example, Eq. (A. 1-5) takes the alternate form ztat = bt (A. 1-11) when transposed according to Eq. (A.1-10). Such transpositions arise naturally in certain computations with stoichiometric matrices, as noted in Chapter 2. A set of row or column vectors, vl..... up. is called lanearly zndependent if its only vanishing linear combination C,c,v, is the trivial one, with coefficients c, all zer0.l Such a set provides the baszs vectors vl....,up of a p-dimensional linear space of vectors C, c,v,, with the basas varaables el,.., cp as coordinates. Constructions of basis vectors for the rows or columns of the coefficient matrix arise naturally in solving linear algebraic equations. The number, T. of row vectors in any basis for the rows is called the rank of the matrix. and is also the number of column vectors in any basis for the columns. Equation (A.1-1) has solutions if and only if b is a linear combination of nonzero column vectors of A; then we say that b is in the column space of A. In such cases, if the rank. r, of A equals n there is a unique solution, whereas if r < n there is an infinity of solutions characterized by (n - r) free parameters. The possible outcomes are identified further in Section A.3. The situation is simplest if the matrix A is square (rn = n); then a unique solution vector x exists if and only if the rank of A equals its order n. Such a matrix A has a unique anverse, A-l, defined by and is said to be nonsingular. or regular. Here I is the unit matrix Otherwise. the set is called linearly dependent.

4 180 Computer-Azded Modeling of Reactive Systems of the same order as A. The solution of Eq. (A.l-5) is then expressible as x = A-lb (A. 1-14) whatever the value of the n-vector b. though for computations there are better schemes, as described in the following sections. A.2 OPERATIONS WITH PARTITIONED MATRICES It is frequently useful to classify the equations and/or the variables of a problem into subsets; then Eq. (A. 1-1) can be represented in partitioned forms such as All -412 (A.2-1) ( A21 A2.) (z;) = (2) A31 A32 Here each entry denotes a subarray and is shown accordingly in bold type. Thus, the vector x is partitioned here into two subvectors, and the matrix A is partitioned into six submatrices. The siibmatrix Ahk contains the coefficients in the row subset h for the elements of the subvector xk; thus, these arrays conform for multiplication in the order written. Equations (A.1-4,6,7.8. and 10) lead to analogous rules for addition and multiplication of partitioned arrays: thus. Eq. (A.l-4) yields the formula (A.2-2) for postmultiplication of a partitioned matrix { Ahk} by a conformally partitioned vector {xk}. Equation (A.l-8) yields the formula Chq = [AB]hq = AhkBkq (A.2-3) for the submatrices Chq of a product of conformally partitioned matrices {Ahk} and {Bkq}. Application of Eq. (A.2-2) to Eq. (A.2-1) yields the partitioned equations AllXl + A12x2 = bl -421x1 + A2222 = b2 (A.2-4) A31x1 + A3222 = b3 when the resulting row groups are written out. makes use of Eq. (A.2-3). k The following example

5 Solution of Linear Algebraic Equations 181 Example A.l. Symbolic Inversion of a Partitioned Matrix A formal inverse is desired for nonsingular matrices of the form (A.2-5) in which All and A22 are nonsingular (hence square). This result is used in Sections 6.5 and 7.5 for statistical estimation of parameter subsets. Let us denote the inverse by (A.2-6) Then Eqs. (A.1-12) and (A.2-3) require Interpreting this matrix equality as described in Eq. (A.1-6). we obtain four equations for the four unknown submatrices a, p, y, and 6: Premultiplication of Eq. (A.2-9) by A;: gives (A.2-8) (A. 2-9) (A. 2-10) (A.2-11) p = -A-~A (A.2-12) Premultiplication of Eq. (A.2-10) by A; gives = -A-~A 22 21a (A.2-13) Insertion of the last result into Eq. (A.2-8) gives (A. 2-14) whence the submatrix a is (A.2-15) Insertion of Eq. (A.2-12) into Eq. (A.2-11) gives [-AziA~~Aiz + A2216 = I22 (A.2-16)

6 182 Computer-Aided Modeling of Reactive Systems whence the submatrix 6 is (A.2-17) Assembling these results, we obtain the formula A-l = [All - A12A,-:Azl]-' -AF:A12[A22 - AziA;,'Aiz]-l -A;iAzi[Aii - Ai~A;iAzi]-~ [A22- AziA;l'Aiz]-l (A.2-18) for the inverse of a matrix of any order, in terms of operations on its subarrays. A.3 GAUSS-JORDAN REDUCTION Gauss-Jordan reduction is a straightforward elimination method that solves for an additional unknown Xk at each stage. An augmented array (A.3-1) is initialized with the elements of Eq. (A.1-1) and is transformed by stages to the solution. Stage k goes as follows: 1. Find apk. the absolutely largest current element in column k that lies in a row not yet selected for pivoting. If cxpk is negligible. skip to step 4; otherwise, accept it as the pivot for stage k and go to step Eliminate xk from all rows but p by transforming the array as follows: (A.3-2) 3. Kormalize the current pivotal row as follows: 4. thus obtaining a coefficient of unity for x k in the solution. If k < min(rn.n). increase k by 1 and go to 1. Otherwise, the elimination is completed.

7 Solution of Linear Algebraic Equations 183 The use of the largest available pivot element, Qpk. in column k limits the growth of rounding error by ensuring that the multipliers (a,k/a,k) in Eq. (A.3-2) all have magnitude 1 or less. This algorithm takes min(m, n) stages. The total number of pivots accepted is the rank. r. of the equation system.the final array can be decoded by associating each coefficient column with the corresponding variable. Rearranging the array to place the pivotal rows and columns in the order of selection, one can write the results in the partitioned form (A. 3-4) Here I, is the unit matrix of order r, XI is the vector of r pzvotal variables (those whose columns were selected for pivoting), 2 2 is the vector of (n- r) nonpivotal variables, and Ai2 is the r x (n - r) matrix of transformed coefficients of the 22 variables. Expanding this partitioned equation, we obtain the pivotal equation set and the nonpivot a1 equation set XI + A',,x~ = bi (A.3-5) 0 = bk (A.3-6) The possible outcomes of the reduction can now be summarized: 1. If r = rn = n, the solution is unique. Equation (A.3-4) reduces to I,x = x = b' (A. 3-7) 2. and all the equations and variables are pivotal. If r = n < m, the solution is overdetermined. Equation (A.3-4) reduces to I,x = x = bi 0 = bh (A.3-8) (A.3-9) 3. If the vector bi is zero, the problem is consistent and the solution is given by Eq. (A.3-8); otherwise, no n-vector x can satisfy all the equations. Depending on the causes of the discrepancies, one may need to reject or revise certain data. or else seek a compromise solution that minimizes the discrepancies in some sense: see Chapters 2, 6, and 7. If r = m < n, the solution is underdetermined. Equation (A.3-4) reduces to the form in Eq. (A.3-5). with b: = b' since all rows are pivotal when r = m. Thus, the pivotal variables (the set XI) are obtained as explicit functions of the nonpivotal variables

8 184 Computer-Aided Modeling of Reactive Systems 4. (the set 22). The 2 2 variables are called the parameters of the solution. If r is less than both m and n, the reduction yields Eqs. (A.3-5) and (A.3-6). The vector b: provides a numerical consistency test. and the 2 2 variables serve as parameters of the solution. The algorithm just described can also compute the inverse of a nonsingular matrix. For simplicity, consider the equations to be ordered originally so that each diagonal element akk becomes a pivot. Then the foregoing reduction transforms the coefficient matrix A into a unit matrix. It follows that the algorithm is equivalent to premultiplication of the initial array by A-l. A simple way of computing A-'. therefore. is to include a unit matrix in the initial a array. The final array then takes the form A-l(A b I)=(I 2 A-') (A.3-10) giving A-' in the space where I was initially inserted. The inversion can be done more compactly by computing the inverse in the space originally occupied by A. Simple changes in steps 2 and 3 will accomplish this: 1. See above. 2. Extend the range of J in Eq. (A.3-2) to all J # p. After the computation of (c~~k/a,k)('l~) ~ insert that quotient as the new element &,I,. 3. Replace apk by 1. and then divide every element of row p by (4 cypk ' 4. See above. Should A be singular, this method still gives a basts znverse. namely. the inverse of the submatrix of A in which the pivots were found. A version of this algorithm using strictly positive. diagonal pivots is used for constrained parameter estimation in Subroutine GREGPLUS, as described in Sections 6.4 and 7.3: there the determinant of the basis submatrix is obtained directly as the product of the pivotal divisors. Basis inverse matrices also prove useful in Sections 6.6 and 7.5 for interval estimation of parameters and related functions. A.4 GAUSSIAN ELIMINATION Gauss gave a shorter algorithm that introduces fewer roundings. The method has two parts: elimination and backsubstitution. We describe it here for the array a of Eq. (A.3-1) with m = n. Stage k of the Gaussian elimination goes as follows: 1. Find CYpk. the absolutely largest of the elements Crkk..... ank. If Crpk is negligible, stop and declare the matrix singular. Otherwise, accept apk as the pivot for stage k. and (if p > k)

9 Solution of Linear Algebraic Equations interchange rows p and k. thus bringing the pivot element to the (k,k) position. If k < n. eliminate x k from rows k + l?... n by transforming the array as follows [here (Old) denotes element values just before this calculation] : 3. If k < n, increase k by 1 and go to 1. Otherwise, the elimination is completed. At the end of the elimination, the array takes the upper triangular form Associating each coefficient u,~ with the corresponding element of x, we get the transformed equation system ~22x u~,x, = b! (A. 4-3) which is readily solved, beginning with the last equation: (A.4-4) The solution is direct when Eqs. (A.4-4) are applied in the order given, since each right-hand member then contains only quantities already found. For computation of a particular solution vector 2, this method requires + (n3 - n) +n2 operations of multiplication or division. versus + (n3 - n) + n2 for the Gauss-Jordan method. Thus, the Gauss method takes about twothirds as many operations. The computation of an inverse matrix takes O(n3) operations of multiplication or division for either method.

10 186 Com,puter-Aided Modeling of Reactive Systems A.5 LU FACTORIZATION LU factorization is an elegant scheme for computing x for various values of the right-hand vector b. The Gaussian algorithm described in Section A.4 transforms the matrix A into an upper triangular matrix U by operations equivalent to premultiplication of A by a nonsingular matrix. Denoting the latter matrix by L-, one obtains the representation L-~A = u (A.5-1) for the transformation process. Preniultiplication of this formula by L then gives A=LU (A.5-2) as an LU factorization of A. In applications one never computes the matrix L, but works with the lower triangular matrix L- defined by the row interchange list p(k) and the lower triangular array of multipliers mzk = (@k/ckkk) for stages k = 1,..., n of the elimination. For efficient use of computer memory the diagonal multipliers mkk = 1 are not stored, while the other multipliers are saved as the subdiagonal elements of the transformed A matrix [in the region that is empty in Eq. (A.4-2).] Premultiplication of Eq. (A.l-5) by L-l, followed by use of (A.5-1). gives TJx = L- b = b (A.5-3) as a matrix statement of Eq. (A.4-3). Premultiplication of Eq. (A.5-3) by Up1 gives 2 = U-lb (A.5-4) as a formal statement of the back-solution algorithm in Eq. (A.4-4). This two-step processing of b can be summarized as x = U-l(L-lb) (A.5-5) which is faster and gives less rounding error than the alternative of computing the inverse niatrix and then using Eq. (A.1-14). The pivot selection procedure used here is known as partial pivoting, because only one column is searched for the current pivot. A safer but slower procedure. known as full pivoting, is to select the current pivot as the absolutely largest remaining eligible elenient in the current transformed matrix.

11 Solution of Linear Algebraic Equations 187 A.6 SOFTWARE Excellent implementations of linear algebra algorithms are available from several sources. including MATLAB, IMSL, NAG, LINPACK and LA- PACK. LINPACK and LAPACK are available from along with codes for many other numerical algorithms. The LINPACK codes were written for serial machines. whereas LAPACK is designed for efficient utilization of parallel machines as well. LAPACK codes are used where applicable in the software described in this book. PROBLEMS A.A Matrix and Matrix-Vector Multiplication Prove Eq. (A.l-8) by evaluating the contribution of element xk to the zth element of the product vector (AB)Ic = A(Bz). Here A is m x n, B is n x p. and IC is an arbitrary conforming vector. A.B Transposition Rule for Matrix Products Prove Eq. (A.1-10) by use of Eqs. (A.1-8) and (A.1-9). Again. take A to be m x n and B to be n x p. A.C Inversion Formula Verify Eq. (A.2-18) by premultiplication with the matrix of Eq. (A.2-5) according to Eq. (A.2-3). A.D Symmetry and Matrix Inversion Show. by use of Eqs. (A.1-12) and (A.1-lo), that every symmetric invertible matrix A has a symmetric inverse. A.E Inverse of a Matrix Product Consider a product P = ABC of nonsingular matrices of equal order. Show that ( A.E- 1) by forming P-lP and simplifying. This result is used in Chapters 6 and 7 to obtain probability distributions for auxiliary functions of model parameters. A.F Solution of a Linear System Use Gaussian elimination and back-substitution to solve the linear system of Eq. (A.1-2). with m = R = 3. ut3 = l/(i +j - l), and b: = (1.0. O}. The coefficient matrix A given here is called the Hzlbert matrzz; it arises in a nonrecommended brute-force construction of orthogonal polynomials from monomials tj.

12 188 Computer-Aided Modeling of Reactive Systems REFERENCES and FURTHER READING Anderson. E.) Z. Bai, C. Bischof, J. Demmel, J. J. Dongarra. J. Du Croz, A. Greenbaum, S. Hammarling, A. McKenney. S. Ostrouchov. and D. Sorensen, LAPACK Users' Guide, Society for Industrial and Applied hlathematics, Philadelphia (1992). Dongarra, J. J., J. R. Bunch, C. B. Moler, and G. W. Stewart, LINPACK Users' Guide, SIAM, Philadelphia (1979). Golub, G. H., and C. F. Van Loan. Matrix Computations, Johns Hopkins Gniversity Press, Baltimore (1983). Noble, B., and J. W. Daniel, ilpplied Linear Algebra, 3rd edition, Prentice-Hall, Englewood Cliffs) NJ (1988). Press, W. H.. B. P. Flannery, S. A. Teukolsky, and W. T. Vetterling, Numerical Recipes (FORTRAN Version), Cambridge University Press (1989). Stewart, G. W.. Introduction to Matrix Computations, Academic Press, New York (1973).

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. The analysis of many models in the social sciences reduces to the study of systems of equations.

Linear Algebra. The analysis of many models in the social sciences reduces to the study of systems of equations. POLI 7 - Mathematical and Statistical Foundations Prof S Saiegh Fall Lecture Notes - Class 4 October 4, Linear Algebra The analysis of many models in the social sciences reduces to the study of systems

More information

Review Questions REVIEW QUESTIONS 71

Review Questions REVIEW QUESTIONS 71 REVIEW QUESTIONS 71 MATLAB, is [42]. For a comprehensive treatment of error analysis and perturbation theory for linear systems and many other problems in linear algebra, see [126, 241]. An overview of

More information

LAPACK-Style Codes for Pivoted Cholesky and QR Updating. Hammarling, Sven and Higham, Nicholas J. and Lucas, Craig. MIMS EPrint: 2006.

LAPACK-Style Codes for Pivoted Cholesky and QR Updating. Hammarling, Sven and Higham, Nicholas J. and Lucas, Craig. MIMS EPrint: 2006. LAPACK-Style Codes for Pivoted Cholesky and QR Updating Hammarling, Sven and Higham, Nicholas J. and Lucas, Craig 2007 MIMS EPrint: 2006.385 Manchester Institute for Mathematical Sciences School of Mathematics

More information

LAPACK-Style Codes for Pivoted Cholesky and QR Updating

LAPACK-Style Codes for Pivoted Cholesky and QR Updating LAPACK-Style Codes for Pivoted Cholesky and QR Updating Sven Hammarling 1, Nicholas J. Higham 2, and Craig Lucas 3 1 NAG Ltd.,Wilkinson House, Jordan Hill Road, Oxford, OX2 8DR, England, sven@nag.co.uk,

More information

Finite Mathematics Chapter 2. where a, b, c, d, h, and k are real numbers and neither a and b nor c and d are both zero.

Finite Mathematics Chapter 2. where a, b, c, d, h, and k are real numbers and neither a and b nor c and d are both zero. Finite Mathematics Chapter 2 Section 2.1 Systems of Linear Equations: An Introduction Systems of Equations Recall that a system of two linear equations in two variables may be written in the general form

More information

Introduction to Matrices

Introduction to Matrices POLS 704 Introduction to Matrices Introduction to Matrices. The Cast of Characters A matrix is a rectangular array (i.e., a table) of numbers. For example, 2 3 X 4 5 6 (4 3) 7 8 9 0 0 0 Thismatrix,with4rowsand3columns,isoforder

More information

MATRIX ALGEBRA AND SYSTEMS OF EQUATIONS. + + x 1 x 2. x n 8 (4) 3 4 2

MATRIX ALGEBRA AND SYSTEMS OF EQUATIONS. + + x 1 x 2. x n 8 (4) 3 4 2 MATRIX ALGEBRA AND SYSTEMS OF EQUATIONS SYSTEMS OF EQUATIONS AND MATRICES Representation of a linear system The general system of m equations in n unknowns can be written a x + a 2 x 2 + + a n x n b a

More information

1 Multiply Eq. E i by λ 0: (λe i ) (E i ) 2 Multiply Eq. E j by λ and add to Eq. E i : (E i + λe j ) (E i )

1 Multiply Eq. E i by λ 0: (λe i ) (E i ) 2 Multiply Eq. E j by λ and add to Eq. E i : (E i + λe j ) (E i ) Direct Methods for Linear Systems Chapter Direct Methods for Solving Linear Systems Per-Olof Persson persson@berkeleyedu Department of Mathematics University of California, Berkeley Math 18A Numerical

More information

Review of Vectors and Matrices

Review of Vectors and Matrices A P P E N D I X D Review of Vectors and Matrices D. VECTORS D.. Definition of a Vector Let p, p, Á, p n be any n real numbers and P an ordered set of these real numbers that is, P = p, p, Á, p n Then P

More information

AMS 209, Fall 2015 Final Project Type A Numerical Linear Algebra: Gaussian Elimination with Pivoting for Solving Linear Systems

AMS 209, Fall 2015 Final Project Type A Numerical Linear Algebra: Gaussian Elimination with Pivoting for Solving Linear Systems AMS 209, Fall 205 Final Project Type A Numerical Linear Algebra: Gaussian Elimination with Pivoting for Solving Linear Systems. Overview We are interested in solving a well-defined linear system given

More information

POLI270 - Linear Algebra

POLI270 - Linear Algebra POLI7 - Linear Algebra Septemer 8th Basics a x + a x +... + a n x n b () is the linear form where a, b are parameters and x n are variables. For a given equation such as x +x you only need a variable and

More information

Algebraic Equations. 2.0 Introduction. Nonsingular versus Singular Sets of Equations. A set of linear algebraic equations looks like this:

Algebraic Equations. 2.0 Introduction. Nonsingular versus Singular Sets of Equations. A set of linear algebraic equations looks like this: Chapter 2. 2.0 Introduction Solution of Linear Algebraic Equations A set of linear algebraic equations looks like this: a 11 x 1 + a 12 x 2 + a 13 x 3 + +a 1N x N =b 1 a 21 x 1 + a 22 x 2 + a 23 x 3 +

More information

GAUSSIAN ELIMINATION AND LU DECOMPOSITION (SUPPLEMENT FOR MA511)

GAUSSIAN ELIMINATION AND LU DECOMPOSITION (SUPPLEMENT FOR MA511) GAUSSIAN ELIMINATION AND LU DECOMPOSITION (SUPPLEMENT FOR MA511) D. ARAPURA Gaussian elimination is the go to method for all basic linear classes including this one. We go summarize the main ideas. 1.

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 February 6, 2018 Linear Algebra (MTH

More information

A Review of Matrix Analysis

A Review of Matrix Analysis Matrix Notation Part Matrix Operations Matrices are simply rectangular arrays of quantities Each quantity in the array is called an element of the matrix and an element can be either a numerical value

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

Algorithm 853: an Efficient Algorithm for Solving Rank-Deficient Least Squares Problems

Algorithm 853: an Efficient Algorithm for Solving Rank-Deficient Least Squares Problems Algorithm 853: an Efficient Algorithm for Solving Rank-Deficient Least Squares Problems LESLIE FOSTER and RAJESH KOMMU San Jose State University Existing routines, such as xgelsy or xgelsd in LAPACK, for

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

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

Chapter 2 Notes, Linear Algebra 5e Lay

Chapter 2 Notes, Linear Algebra 5e Lay Contents.1 Operations with Matrices..................................1.1 Addition and Subtraction.............................1. Multiplication by a scalar............................ 3.1.3 Multiplication

More information

B553 Lecture 5: Matrix Algebra Review

B553 Lecture 5: Matrix Algebra Review B553 Lecture 5: Matrix Algebra Review Kris Hauser January 19, 2012 We have seen in prior lectures how vectors represent points in R n and gradients of functions. Matrices represent linear transformations

More information

Matrices and Matrix Algebra.

Matrices and Matrix Algebra. Matrices and Matrix Algebra 3.1. Operations on Matrices Matrix Notation and Terminology Matrix: a rectangular array of numbers, called entries. A matrix with m rows and n columns m n A n n matrix : a square

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

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

Linear Equations in Linear Algebra

Linear Equations in Linear Algebra 1 Linear Equations in Linear Algebra 1.1 SYSTEMS OF LINEAR EQUATIONS LINEAR EQUATION x 1,, x n A linear equation in the variables equation that can be written in the form a 1 x 1 + a 2 x 2 + + a n x n

More information

Systems of Linear Equations and Matrices

Systems of Linear Equations and Matrices Chapter 1 Systems of Linear Equations and Matrices System of linear algebraic equations and their solution constitute one of the major topics studied in the course known as linear algebra. In the first

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

NAG Fortran Library Routine Document F04CFF.1

NAG Fortran Library Routine Document F04CFF.1 F04 Simultaneous Linear Equations NAG Fortran Library Routine Document Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised

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

Linear Algebra March 16, 2019

Linear Algebra March 16, 2019 Linear Algebra March 16, 2019 2 Contents 0.1 Notation................................ 4 1 Systems of linear equations, and matrices 5 1.1 Systems of linear equations..................... 5 1.2 Augmented

More information

Systems of Linear Equations and Matrices

Systems of Linear Equations and Matrices Chapter 1 Systems of Linear Equations and Matrices System of linear algebraic equations and their solution constitute one of the major topics studied in the course known as linear algebra. In the first

More information

Chapter 1 Matrices and Systems of Equations

Chapter 1 Matrices and Systems of Equations Chapter 1 Matrices and Systems of Equations System of Linear Equations 1. A linear equation in n unknowns is an equation of the form n i=1 a i x i = b where a 1,..., a n, b R and x 1,..., x n are variables.

More information

NAG Library Routine Document F07HAF (DPBSV)

NAG Library Routine Document F07HAF (DPBSV) NAG Library Routine Document (DPBSV) Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised terms and other implementation-dependent

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 Algebra (part 1) : Matrices and Systems of Linear Equations (by Evan Dummit, 2016, v. 2.02)

Linear Algebra (part 1) : Matrices and Systems of Linear Equations (by Evan Dummit, 2016, v. 2.02) Linear Algebra (part ) : Matrices and Systems of Linear Equations (by Evan Dummit, 206, v 202) Contents 2 Matrices and Systems of Linear Equations 2 Systems of Linear Equations 2 Elimination, Matrix Formulation

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

Generalized interval arithmetic on compact matrix Lie groups

Generalized interval arithmetic on compact matrix Lie groups myjournal manuscript No. (will be inserted by the editor) Generalized interval arithmetic on compact matrix Lie groups Hermann Schichl, Mihály Csaba Markót, Arnold Neumaier Faculty of Mathematics, University

More information

The matrix will only be consistent if the last entry of row three is 0, meaning 2b 3 + b 2 b 1 = 0.

The matrix will only be consistent if the last entry of row three is 0, meaning 2b 3 + b 2 b 1 = 0. ) Find all solutions of the linear system. Express the answer in vector form. x + 2x + x + x 5 = 2 2x 2 + 2x + 2x + x 5 = 8 x + 2x + x + 9x 5 = 2 2 Solution: Reduce the augmented matrix [ 2 2 2 8 ] to

More information

MAC1105-College Algebra. Chapter 5-Systems of Equations & Matrices

MAC1105-College Algebra. Chapter 5-Systems of Equations & Matrices MAC05-College Algebra Chapter 5-Systems of Equations & Matrices 5. Systems of Equations in Two Variables Solving Systems of Two Linear Equations/ Two-Variable Linear Equations A system of equations is

More information

Definition of Equality of Matrices. Example 1: Equality of Matrices. Consider the four matrices

Definition of Equality of Matrices. Example 1: Equality of Matrices. Consider the four matrices IT 131: Mathematics for Science Lecture Notes 3 Source: Larson, Edwards, Falvo (2009): Elementary Linear Algebra, Sixth Edition. Matrices 2.1 Operations with Matrices This section and the next introduce

More information

Basic Concepts in Linear Algebra

Basic Concepts in Linear Algebra Basic Concepts in Linear Algebra Grady B Wright Department of Mathematics Boise State University February 2, 2015 Grady B Wright Linear Algebra Basics February 2, 2015 1 / 39 Numerical Linear Algebra Linear

More information

Matrix operations Linear Algebra with Computer Science Application

Matrix operations Linear Algebra with Computer Science Application Linear Algebra with Computer Science Application February 14, 2018 1 Matrix operations 11 Matrix operations If A is an m n matrix that is, a matrix with m rows and n columns then the scalar entry in the

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

Linear Algebra. Solving Linear Systems. Copyright 2005, W.R. Winfrey

Linear Algebra. Solving Linear Systems. Copyright 2005, W.R. Winfrey Copyright 2005, W.R. Winfrey Topics Preliminaries Echelon Form of a Matrix Elementary Matrices; Finding A -1 Equivalent Matrices LU-Factorization Topics Preliminaries Echelon Form of a Matrix Elementary

More information

Review of Basic Concepts in Linear Algebra

Review of Basic Concepts in Linear Algebra Review of Basic Concepts in Linear Algebra Grady B Wright Department of Mathematics Boise State University September 7, 2017 Math 565 Linear Algebra Review September 7, 2017 1 / 40 Numerical Linear Algebra

More information

The Solution of Linear Systems AX = B

The Solution of Linear Systems AX = B Chapter 2 The Solution of Linear Systems AX = B 21 Upper-triangular Linear Systems We will now develop the back-substitution algorithm, which is useful for solving a linear system of equations that has

More information

Presentation by: H. Sarper. Chapter 2 - Learning Objectives

Presentation by: H. Sarper. Chapter 2 - Learning Objectives Chapter Basic Linear lgebra to accompany Introduction to Mathematical Programming Operations Research, Volume, th edition, by Wayne L. Winston and Munirpallam Venkataramanan Presentation by: H. Sarper

More information

Review of Matrices and Block Structures

Review of Matrices and Block Structures CHAPTER 2 Review of Matrices and Block Structures Numerical linear algebra lies at the heart of modern scientific computing and computational science. Today it is not uncommon to perform numerical computations

More information

LINEAR SYSTEMS, MATRICES, AND VECTORS

LINEAR SYSTEMS, MATRICES, AND VECTORS ELEMENTARY LINEAR ALGEBRA WORKBOOK CREATED BY SHANNON MARTIN MYERS LINEAR SYSTEMS, MATRICES, AND VECTORS Now that I ve been teaching Linear Algebra for a few years, I thought it would be great to integrate

More information

7.6 The Inverse of a Square Matrix

7.6 The Inverse of a Square Matrix 7.6 The Inverse of a Square Matrix Copyright Cengage Learning. All rights reserved. What You Should Learn Verify that two matrices are inverses of each other. Use Gauss-Jordan elimination to find inverses

More information

Roundoff Error. Monday, August 29, 11

Roundoff Error. Monday, August 29, 11 Roundoff Error A round-off error (rounding error), is the difference between the calculated approximation of a number and its exact mathematical value. Numerical analysis specifically tries to estimate

More information

MTH501- Linear Algebra MCQS MIDTERM EXAMINATION ~ LIBRIANSMINE ~

MTH501- Linear Algebra MCQS MIDTERM EXAMINATION ~ LIBRIANSMINE ~ MTH501- Linear Algebra MCQS MIDTERM EXAMINATION ~ LIBRIANSMINE ~ Question No: 1 (Marks: 1) If for a linear transformation the equation T(x) =0 has only the trivial solution then T is One-to-one Onto Question

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

1 Matrices and Systems of Linear Equations

1 Matrices and Systems of Linear Equations Linear Algebra (part ) : Matrices and Systems of Linear Equations (by Evan Dummit, 207, v 260) Contents Matrices and Systems of Linear Equations Systems of Linear Equations Elimination, Matrix Formulation

More information

Appendix C Vector and matrix algebra

Appendix C Vector and matrix algebra Appendix C Vector and matrix algebra Concepts Scalars Vectors, rows and columns, matrices Adding and subtracting vectors and matrices Multiplying them by scalars Products of vectors and matrices, scalar

More information

MATH 213 Linear Algebra and ODEs Spring 2015 Study Sheet for Midterm Exam. Topics

MATH 213 Linear Algebra and ODEs Spring 2015 Study Sheet for Midterm Exam. Topics MATH 213 Linear Algebra and ODEs Spring 2015 Study Sheet for Midterm Exam This study sheet will not be allowed during the test Books and notes will not be allowed during the test Calculators and cell phones

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

3. Replace any row by the sum of that row and a constant multiple of any other row.

3. Replace any row by the sum of that row and a constant multiple of any other row. Section. Solution of Linear Systems by Gauss-Jordan Method A matrix is an ordered rectangular array of numbers, letters, symbols or algebraic expressions. A matrix with m rows and n columns has size or

More information

Notes on Row Reduction

Notes on Row Reduction Notes on Row Reduction Francis J. Narcowich Department of Mathematics Texas A&M University September The Row-Reduction Algorithm The row-reduced form of a matrix contains a great deal of information, both

More information

Inverting Matrices. 1 Properties of Transpose. 2 Matrix Algebra. P. Danziger 3.2, 3.3

Inverting Matrices. 1 Properties of Transpose. 2 Matrix Algebra. P. Danziger 3.2, 3.3 3., 3.3 Inverting Matrices P. Danziger 1 Properties of Transpose Transpose has higher precedence than multiplication and addition, so AB T A ( B T and A + B T A + ( B T As opposed to the bracketed expressions

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

CHAPTER 6. Direct Methods for Solving Linear Systems

CHAPTER 6. Direct Methods for Solving Linear Systems CHAPTER 6 Direct Methods for Solving Linear Systems. Introduction A direct method for approximating the solution of a system of n linear equations in n unknowns is one that gives the exact solution to

More information

ORIE 6300 Mathematical Programming I August 25, Recitation 1

ORIE 6300 Mathematical Programming I August 25, Recitation 1 ORIE 6300 Mathematical Programming I August 25, 2016 Lecturer: Calvin Wylie Recitation 1 Scribe: Mateo Díaz 1 Linear Algebra Review 1 1.1 Independence, Spanning, and Dimension Definition 1 A (usually infinite)

More information

OR MSc Maths Revision Course

OR MSc Maths Revision Course OR MSc Maths Revision Course Tom Byrne School of Mathematics University of Edinburgh t.m.byrne@sms.ed.ac.uk 15 September 2017 General Information Today JCMB Lecture Theatre A, 09:30-12:30 Mathematics revision

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

DM559 Linear and Integer Programming. Lecture 2 Systems of Linear Equations. Marco Chiarandini

DM559 Linear and Integer Programming. Lecture 2 Systems of Linear Equations. Marco Chiarandini DM559 Linear and Integer Programming Lecture Marco Chiarandini Department of Mathematics & Computer Science University of Southern Denmark Outline 1. Outline 1. 3 A Motivating Example You are organizing

More information

NAG Library Routine Document F08UBF (DSBGVX)

NAG Library Routine Document F08UBF (DSBGVX) NAG Library Routine Document (DSBGVX) Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised terms and other implementation-dependent

More information

Applied Numerical Linear Algebra. Lecture 8

Applied Numerical Linear Algebra. Lecture 8 Applied Numerical Linear Algebra. Lecture 8 1/ 45 Perturbation Theory for the Least Squares Problem When A is not square, we define its condition number with respect to the 2-norm to be k 2 (A) σ max (A)/σ

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

Digital Workbook for GRA 6035 Mathematics

Digital Workbook for GRA 6035 Mathematics Eivind Eriksen Digital Workbook for GRA 6035 Mathematics November 10, 2014 BI Norwegian Business School Contents Part I Lectures in GRA6035 Mathematics 1 Linear Systems and Gaussian Elimination........................

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

MAC Module 2 Systems of Linear Equations and Matrices II. Learning Objectives. Upon completing this module, you should be able to :

MAC Module 2 Systems of Linear Equations and Matrices II. Learning Objectives. Upon completing this module, you should be able to : MAC 0 Module Systems of Linear Equations and Matrices II Learning Objectives Upon completing this module, you should be able to :. Find the inverse of a square matrix.. Determine whether a matrix is invertible..

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

MATRICES. knowledge on matrices Knowledge on matrix operations. Matrix as a tool of solving linear equations with two or three unknowns.

MATRICES. knowledge on matrices Knowledge on matrix operations. Matrix as a tool of solving linear equations with two or three unknowns. MATRICES After studying this chapter you will acquire the skills in knowledge on matrices Knowledge on matrix operations. Matrix as a tool of solving linear equations with two or three unknowns. List of

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

Linear Equations and Matrix

Linear Equations and Matrix 1/60 Chia-Ping Chen Professor Department of Computer Science and Engineering National Sun Yat-sen University Linear Algebra Gaussian Elimination 2/60 Alpha Go Linear algebra begins with a system of linear

More information

Matrices. Chapter What is a Matrix? We review the basic matrix operations. An array of numbers a a 1n A = a m1...

Matrices. Chapter What is a Matrix? We review the basic matrix operations. An array of numbers a a 1n A = a m1... Chapter Matrices We review the basic matrix operations What is a Matrix? An array of numbers a a n A = a m a mn with m rows and n columns is a m n matrix Element a ij in located in position (i, j The elements

More information

3. Vector spaces 3.1 Linear dependence and independence 3.2 Basis and dimension. 5. Extreme points and basic feasible solutions

3. Vector spaces 3.1 Linear dependence and independence 3.2 Basis and dimension. 5. Extreme points and basic feasible solutions A. LINEAR ALGEBRA. CONVEX SETS 1. Matrices and vectors 1.1 Matrix operations 1.2 The rank of a matrix 2. Systems of linear equations 2.1 Basic solutions 3. Vector spaces 3.1 Linear dependence and independence

More information

APPENDIX: MATHEMATICAL INDUCTION AND OTHER FORMS OF PROOF

APPENDIX: MATHEMATICAL INDUCTION AND OTHER FORMS OF PROOF ELEMENTARY LINEAR ALGEBRA WORKBOOK/FOR USE WITH RON LARSON S TEXTBOOK ELEMENTARY LINEAR ALGEBRA CREATED BY SHANNON MARTIN MYERS APPENDIX: MATHEMATICAL INDUCTION AND OTHER FORMS OF PROOF When you are done

More information

Matrix notation. A nm : n m : size of the matrix. m : no of columns, n: no of rows. Row matrix n=1 [b 1, b 2, b 3,. b m ] Column matrix m=1

Matrix notation. A nm : n m : size of the matrix. m : no of columns, n: no of rows. Row matrix n=1 [b 1, b 2, b 3,. b m ] Column matrix m=1 Matrix notation A nm : n m : size of the matrix m : no of columns, n: no of rows Row matrix n=1 [b 1, b 2, b 3,. b m ] Column matrix m=1 n = m square matrix Symmetric matrix Upper triangular matrix: matrix

More information

HOUSEHOLDER REDUCTION

HOUSEHOLDER REDUCTION Syracuse University SURFACE Electrical Engineering and Computer Science Technical Reports College of Engineering and Computer Science 12-1990 HOUSEHOLDER REDUCTION Per Brinch Hansen Syracuse University,

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

Direct Methods for Solving Linear Systems. Simon Fraser University Surrey Campus MACM 316 Spring 2005 Instructor: Ha Le

Direct Methods for Solving Linear Systems. Simon Fraser University Surrey Campus MACM 316 Spring 2005 Instructor: Ha Le Direct Methods for Solving Linear Systems Simon Fraser University Surrey Campus MACM 316 Spring 2005 Instructor: Ha Le 1 Overview General Linear Systems Gaussian Elimination Triangular Systems The LU Factorization

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

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

NAG Library Routine Document F08JDF (DSTEVR)

NAG Library Routine Document F08JDF (DSTEVR) F08 Least-squares and Eigenvalue Problems (LAPACK) NAG Library Routine Document (DSTEVR) Note: before using this routine, please read the Users Note for your implementation to check the interpretation

More information

Linear Algebra: Lecture notes from Kolman and Hill 9th edition.

Linear Algebra: Lecture notes from Kolman and Hill 9th edition. Linear Algebra: Lecture notes from Kolman and Hill 9th edition Taylan Şengül March 20, 2019 Please let me know of any mistakes in these notes Contents Week 1 1 11 Systems of Linear Equations 1 12 Matrices

More information

Chapter 4. Solving Systems of Equations. Chapter 4

Chapter 4. Solving Systems of Equations. Chapter 4 Solving Systems of Equations 3 Scenarios for Solutions There are three general situations we may find ourselves in when attempting to solve systems of equations: 1 The system could have one unique solution.

More information

More Gaussian Elimination and Matrix Inversion

More Gaussian Elimination and Matrix Inversion Week7 More Gaussian Elimination and Matrix Inversion 7 Opening Remarks 7 Introduction 235 Week 7 More Gaussian Elimination and Matrix Inversion 236 72 Outline 7 Opening Remarks 235 7 Introduction 235 72

More information

ELEMENTARY LINEAR ALGEBRA

ELEMENTARY LINEAR ALGEBRA ELEMENTARY LINEAR ALGEBRA K R MATTHEWS DEPARTMENT OF MATHEMATICS UNIVERSITY OF QUEENSLAND First Printing, 99 Chapter LINEAR EQUATIONS Introduction to linear equations A linear equation in n unknowns x,

More information

NAG Toolbox for Matlab nag_lapack_dggev (f08wa)

NAG Toolbox for Matlab nag_lapack_dggev (f08wa) NAG Toolbox for Matlab nag_lapack_dggev () 1 Purpose nag_lapack_dggev () computes for a pair of n by n real nonsymmetric matrices ða; BÞ the generalized eigenvalues and, optionally, the left and/or right

More information

a11 a A = : a 21 a 22

a11 a A = : a 21 a 22 Matrices The study of linear systems is facilitated by introducing matrices. Matrix theory provides a convenient language and notation to express many of the ideas concisely, and complicated formulas are

More information

Linear Algebra II. 2 Matrices. Notes 2 21st October Matrix algebra

Linear Algebra II. 2 Matrices. Notes 2 21st October Matrix algebra MTH6140 Linear Algebra II Notes 2 21st October 2010 2 Matrices You have certainly seen matrices before; indeed, we met some in the first chapter of the notes Here we revise matrix algebra, consider row

More information

Matrices and systems of linear equations

Matrices and systems of linear equations Matrices and systems of linear equations Samy Tindel Purdue University Differential equations and linear algebra - MA 262 Taken from Differential equations and linear algebra by Goode and Annin Samy T.

More information

Math Camp Lecture 4: Linear Algebra. Xiao Yu Wang. Aug 2010 MIT. Xiao Yu Wang (MIT) Math Camp /10 1 / 88

Math Camp Lecture 4: Linear Algebra. Xiao Yu Wang. Aug 2010 MIT. Xiao Yu Wang (MIT) Math Camp /10 1 / 88 Math Camp 2010 Lecture 4: Linear Algebra Xiao Yu Wang MIT Aug 2010 Xiao Yu Wang (MIT) Math Camp 2010 08/10 1 / 88 Linear Algebra Game Plan Vector Spaces Linear Transformations and Matrices Determinant

More information

Gaussian elimination

Gaussian elimination Gaussian elimination October 14, 2013 Contents 1 Introduction 1 2 Some definitions and examples 2 3 Elementary row operations 7 4 Gaussian elimination 11 5 Rank and row reduction 16 6 Some computational

More information

5.7 Cramer's Rule 1. Using Determinants to Solve Systems Assumes the system of two equations in two unknowns

5.7 Cramer's Rule 1. Using Determinants to Solve Systems Assumes the system of two equations in two unknowns 5.7 Cramer's Rule 1. Using Determinants to Solve Systems Assumes the system of two equations in two unknowns (1) possesses the solution and provided that.. The numerators and denominators are recognized

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