Contents Introduction Energy nalysis of Convection Equation 4 3 Semi-discrete nalysis 6 4 Fully Discrete nalysis 7 4. Two-stage time discretization...

Size: px
Start display at page:

Download "Contents Introduction Energy nalysis of Convection Equation 4 3 Semi-discrete nalysis 6 4 Fully Discrete nalysis 7 4. Two-stage time discretization..."

Transcription

1 Energy Stability nalysis of Multi-Step Methods on Unstructured Meshes by Michael Giles CFDL-TR-87- March 987 This research was supported by ir Force Oce of Scientic Research contract F C-0084, supervised by Dr.. Wilson.

2 Contents Introduction Energy nalysis of Convection Equation 4 3 Semi-discrete nalysis 6 4 Fully Discrete nalysis 7 4. Two-stage time discretization ameson's four-step method Cell-based Dierencing 0 5. Basic denitions Property Property Extension to 3-D Node-based Dierencing with Triangular/Tetrahedral Cells 4 6. Basic denitions Equivalence to cell-centered dierencing Extension to 3-D nalysis of Systems of Equations 7 7. nalytic equations Semi-discrete equations Discrete equations Euler equations

3 Introduction In an eort to avoid the geometric limitations of structured, logically rectangular meshes, much work is now being done using unstructured meshes for ow calculations around complex geometries. In particular, triangular meshes are becoming popular for twodimensional problems with multiple components [] or grid adaptation [], and tetrahedral cells are being used for three-dimensional aircraft calculations [3]. It is clear that these unstructured meshes will be of increasing importance in computational methods. During this period of rapid development the development of methods for numerical analysis has lagged behind. Questions about the maximum stable time step for explicit methods have been resolved by ad hoc procedures which are based upon the results for structured meshes and a clear understanding of the physical domain of dependence restrictions which are the underlying origin of these limits. The lack of rigorous analysis tools however leads to concerns that current methods may be overly conservative in order to ensure stability in all possible cases. s more three-dimensional calculations are being performed for engineering design and analysis, larger time steps and faster convergence rates can lead to signicant savings in time and money. Thus it is important to develop new methods of analyzing numerical methods on unstructured meshes. The standard approach for analyzing methods on structured grids is to use Fourier analysis, by considering a general solution to be a sum of Fourier modes, and then separately analyze each one [4]. The key point is that on a regular innite grid the eigenmodes are always Fourier modes. On irregular unstructured grids this is clearly not the case and so a dierent approach is needed. The answer is to turn to another classic analysis method, the energy method [4]. This technique denes an energy associated with a solution and then proves stability by showing that the energy is non-increasing. For structured meshes this approach can be much more cumbersome than Fourier analysis, particularly for systems of equations where it can be dicult to pick the correct energy denition, but it is very suitable for unstructured meshes. In this paper we demonstrate the use of the energy method to analyze multi-stage methods for solving the model convective equation on unstructured meshes, using cellbased and node-based spatial dierencing, both of which were developed by ameson [5, 3]. Cell-based dierencing (in which the variable is assumed to be constant within each cell) was the rst developed, but is only rst-order accurate in an integral sense on irregular meshes. In node-based methods the variable is dened at each node, and in general the solution is second order accurate. In performing the energy stability analysis

4 we will assume that all functions (and their derivatives where necessary) are zero on the boundaries, to avoid the complications introduced by boundary contributions. The inclusion of the boundary terms in the analysis would bring us into the subject of the stability analysis of numerical boundary conditions which is an additional subject in its own right and is beyond the scope of this present paper. Here we are simply concerned with nding the requirements for the interior numerical scheme to be stable. few comments are appropriate on the organization of this paper, since it may seem strange that unstructured grids and spatial dierencing are not discussed until the fth section. Section presents the use of the energy method to prove stability for the analytic convective equation and introduces the ideas and formalism which will be used for the discrete methods. Section 3 analyzes semi-discrete methods (spatially discrete but continuous in time) in a very general form and section 4 extends this to fully discrete equations. These two sections assume that the spatial discretization has certain properties, and then the next two sections prove that the cell-based dierencing and the triangular/tetrahedral node-based dierencing do in fact have these properties. The reason for this approach is to emphasize the importance of these properties, in that any scheme satisfying these conditions will be stable. Finally, the last section extends the analysis to systems of equations and analyzes the Euler equations in particular. 3

5 Energy nalysis of Convection Equation The model convection 0: () The `energy' of u(~x; t) in a three-dimensional volume V is dened by E(t) The rate of change of energy is given by de dt Z V Z u (~x; t) dv: () V Z Z V dv (u ) dv u n x ds: (3) The last integral is over the surface of the volume with n x being the x-component of the outward pointing normal. If u 0 then the boundary contribution disappears and we are left with de dt 0; (4) proving that the convection equation is energy-preserving and thus stable. We now repeat this analysis using the formalism which will simplify our later analyses. We begin by dening a scalar product, which is a generalized dot product of two functions, and a norm, which is a generalized magnitude of a function [6]. (u; v) kuk Z V q uv dv (5) (u; u) (6) scalar product and norm have a number of basic properties. 4

6 linearity (u; v + w) (u; v) + (u; w) symmetry (u; v) (v; u) zero norm u 0 ) kuk 0 (7) positive norm u 6 0 ) kuk > 0 triangle inequality ku + vk kuk+kvk In addition this particular scalar product also has the following property. + ; v 0 This comes from the divergence theorem with an assumption that u and/or v is zero so that we can ignore the boundary contributions as discussed in the introduction. n immediate deduction from Property is that dt u; ; u 0: (8) With the energy dened by E kuk, the energy analysis is now almost trivial. de ; u 0 (9) 5

7 3 Semi-discrete nalysis In this section we consider a function u i (t) which is spatially discrete but continuous in time. We assume that we have some discrete spatial dierencing x so x u is a discrete approximation The semi-discrete approximation to the convection equation is then given i dt +(@ xu) i 0 (0) To perform the energy stability analysis we assume that we also have a scalar product (u; v) which has the property Property x v) + (@ x u; v) 0 s with the analytic version of Property, an immediate corollary is x u) 0 () The stability proof is now exactly the same as for the analytic equation. de dt d dt kuk u; du dt u; du dt du + dt ; u x u) 0 () The proof is so simple because all of the hard work is hidden in determining the properties of the dierencing scheme, which is particularly involved on irregular grids. 6

8 4 Fully Discrete nalysis 4. Two-stage time discretization The two-step predictor/corrector method is given by u i u n i t@ x u n i (3) u n+ i u n i t@ x u i u n i t@ x u n i +t@ x t@ x u n i (4) The reason that the ordering of t x is kept as it is in the last equation, is because a very useful technique for accelerating convergence to steady state solutions is to use `local time steps' in which t varies over the domain. In order to analyze this possibility t x cannot be interchanged because the ordering produces dierent results. Because of the variable time steps we dene a new generalized energy E n kt m u n k (5) Note: m is an exponent whereas n is a superscript denoting an iteration time level. We also need to assume an additional property. Property (e i ; e j ) 0 if i 6 j, where e i is a function which has value at node i (or in cell i) and value 0 elsewhere. There are two important corollaries that arise from this assumption. If s is a scalar function then using the linearity of the scalar product it follows that (su; v) i;j i i i;j s i u i v j (e i ; e j ) s i u i v i (e i ; e i ) u i s i v i (e i ; e i ) u i s j v j (e i ; e j ) (u; sv): (6) The reason that this refers to s i being scalar is that we are leaving open for the future the possibility that u i and v i are vectors, in order to analyze systems of equations. 7

9 The second corollary is similar to the rst. If s and t and two scalar functions, and js i j < jt i j for each i, then ksuk i;j i i i;j s i u i s j u j (e i ; e j ) s i u i (e i ; e i ) t i u i (e i ; e i ) t i u i t j u j (e i ; e j ) ktuk: (7) We now proceed with the stability analysis as before. t m u n+ kt m u n k (t m (u n t@ x u n +t@ x t@ x u n ) ; t m (u n t@ x u n +t@ x t@ x u n )) (t m u n ; t m u n ) t x u n t + x t@ x u n + t m u n ; t x t@ x u n t m u n ; t x u n t x u n ; t x t@ x u n t x u n t + x t@ x u n + t +m u n x u n t +m u n x t@ x u n t +m (t@ x u n ) x (t@ x u n ) (8) The rst corollary was used in the above equation to `switch' the time step terms from one side of the scalar product to the other. In order to eliminate the last two terms using Corollary, we now choose m. The third term can be rearranged using Property to obtain u p n+ t u p n t p t u n + p t t@ x u n Thus the method is stable provided (9) p x p t v kvk (0) for all v. We now introduce the last assumed property for the spatial discretization. Property 3 for all v. There exists a function (t max ) i such that p t x p tmax v kvk 8

10 Given this property, then provided t i (t max ) i it follows that p x p t v p p x t v p p x tmax s t t max v s t t max v! kvk () and so the two-step method is stable. The second corollary of Property was used to obtain two of the inequalities in the above equation. To obtain steady state solutions as quickly as possible one would use t i (t max ) i but for time accurate calculations requiring a uniform time step one would have to use tmin i (t max ) i. 4. ameson's four-step method ameson's four-step method is u () u n 4 t@ xu n u () u n 3 t@ xu () u (3) u n t@ xu () u n+ u n t@ x u (3) () ) u n+ u n t@ x u n + t@ xt@ x u n 6 t@ xt@ x t@ x u n + 4 t@ xt@ x t@ x t@ x u n (3) Substitution of this into the energy norm, and using the usual methods to eliminate and reduce terms, leads to u p n+ t u p n t p x t@ x t@ x u n p x t@ x t@ x t@ x u n 8 kvk p p x t v (4) where v p x t@ x t@ x u n. Thus it is stable provided t p t max. The same procedure can be used to analyze other multi-stage schemes. 9

11 5 Cell-based Dierencing 5. Basic denitions Consider a two-dimensional, innite, irregular grid which is composed of polygonal cells C i. Variables are dened to be constant in each cell, so u i is the value of a function u in C i. On the cell face separating cells C i and C j, u is dened to be the average of the values on either side, (u i +u j ) and ~n ij is the unit vector normal to the face pointing outwards from C i, so ~n ji ~n ij. Figure illustrates all of these denitions. If u(x; y) is a continuous dierentiable function, then the mean value C i is given i i Z C d in a cell i Z un x dl (5) where i is the area of the cell, and the latter integral is around the boundary of C i with n x being the x-component of the outward normal. Hence we dene the discrete dierential x to be (@ x u) i i un x l (6) The integral has been replaced by a summation over the faces forming with l being the length of the face. This denition is equivalent to that used by ameson et al [5]. The scalar product for this spatial discretization is dened by (u; v) i i u i v i (7) It is obvious that this denition satises the basic requirements for a scalar product and Property. The hard part is to demonstrate that it satises Properties and 3. 0

12 5. Property By linearity, x v) + (@ x u; v) i;j u i v j [(e i x e j ) + (@ x e i ; e j )] (8) where e i is again the function which is in cell i and 0 elsewhere. Thus it is necessary and sucient to prove that (e i x e j ) + (@ x e i ; e j ) 0 (9) for all i; j. There are three cases to consider, depending whether i is equal to j, and if not whether i belongs to the set N j of nodes which are neighbors to j (meaning that C i and C j share a common face). a) i j (@ x e i ; e i ) (e i x e i ) n x l Z n x Z () d C i 0 (30) The fact that n x l 0 will be used several times later on in other proofs. b) i 6 j; i6 N j (@ x e i ; e j ) (e i x e j ) 0 (3) x e j is only non-zero on the cells neighboring C j. c) i 6 j, in j (e i x e j ) + (@ x e i ; e j ) n x ij + n x ji 0 (3) since the outward normals to each cell are in opposite directions. This completes the proof that cell-based dierencing satises Property.

13 5.3 Property 3 We need to prove that there exists a function t such that for all v. p x p t v kvk (33) Let (t) i i jn x jl (34) Then p x p t v i i t i x p t v 0 t i i On the face shared by cells C i and C j, p t v p t vnx l pt v i n x l p t v nx pt v i + pt v pt v jn i j (35). Hence j (n xl) ij (36) The rst sum is zero because n x l 0. Substituting this equation into Equation (35) we nd that the contribution due to cell C i is 0 t p t vnx l t i pt pt 4 v v (n x l) ij (n x l) ij i j i t i i t i i j t i i j p j t v p j t v jn x lj ij jn x lj ij pt + v jn x lj ij jn x lj ij j j j j pt v j j 4 j 3 jn x lj ij 5 4 j 3 t v jn x lj ij 5 j t v jn xlj ij (37) j jn i The key result which is used in establishing the inequality in the above equation, is that for any pair of real numbers f and g, (f g) >0 ) jfjjgj< (f +g ). Summing

14 over all of the cells we nally get p t@ x p t v i j t v j jn i t v j jn xlj ij in j jn x lj ij j j v j kvk (38) This completes the proof that the cell-based dierencing satises Property 3, with (t max ) i i jn x jl (39) Not only does this give a sucient condition for stability (when combined with the theory of the last section); it also gives the necessary condition for regular quadrilateral. Using Fourier analysis it can be shown that for a uniform grid of parallelograms the stability limit is where 8 < : t t max (40) two-step method p four-step method and t max y where is the area of the cells and y is dened in Figure. This equation for t max is exactly the same as is given by the present theory. 5.4 Extension to 3-D The extension to three-dimensional grids is actually very straightforward. ll that changes is that cell areas i become cell volumes V i, and face lengths l become face areas. With these minor changes all of the theory and the proofs carry over directly (although it becomes much harder to visualize some of the steps involved). The discrete dierential operator and maximum time step are (@ x u) i V i (t max ) i V i u n x (4) jn x j (4) 3

15 6 Node-based Dierencing with Triangular/Tetrahedral Cells 6. Basic denitions In node-based schemes the variables are dened at the nodes of the computational cells, and because of a critical step in the proofs to be presented we only consider triangular cells. ssociated with each node i is the `supercell' Ci 0 formed by the union of the triangles with node i, as shown in Figure 3. The discrete dierential x is dened by (@ x u) i 0 0 i u 0 n 0 xl 0 (43) with u 0 on a face dened as the average of the values at the two nodes at either end. The scalar product is dened by associating of the area of each triangular cell with 3 each of its nodes. (u; v) i 3 iu i v i (44) gain it is obvious that this denition satises the basic requirements for a scalar product and Property. 6. Equivalence to cell-centered dierencing To prove that the node-based dierencing satises properties and 3, we will show that the node-based dierencing is equivalent to a cell-based dierencing on an alternative cell with a modied area, and hence the proofs of the last section are equally applicable to node-based dierencing. Figure 3 shows the alternative cell C i for the cell-based dierencing, which is formed by joining the centroids of the triangles surrounding node i. The important geometric relation is that ~x a 3 (~x i + ~x j + ~x k ); ~x b 3 (~x i + ~x j + ~x l ) (45) ) (l~n) ij 3 Thus the contribution of node j to (@ x u) i is 0 i h l~n 0 kj + l~n 0 jli u j h l~n 0 kj + l~n 0 jli 4 (46) 0 i 3 (ln x) ij u j (47)

16 since ) (@ x u) i 0 i 3 jn i 0 i 3 jn i 0 i 3 u i (n x l) ij u i jn i u j (n x l) ij (u i+u j ) (n x l) ij u n x l (48) n x l 0 (49) Thus the denition x u for node-based dierencing on Ci 0 is identical to the denition x u for cell-based dierencing on C i, except that it uses 3 0 i instead of i. For regular grids these two are equal but in general for irregular grids they will not be equal. Examining all of the proofs in the last section on cell-based dierencing, the fact that i is the area of the computational cell is not required in any of the proofs, and so any value for i can be used provided that value is consistently used in the denition x, the scalar product and t max. lso interesting is that when using local time-steps the important expressions are p t max u and t x u, and in both cases the area terms cancel out leaving only u i jn x jl and u n x l jn x jl respectively. Thus the cell area plays a i very minor role and the important terms are due to the faces. Returning to the node-based dierencing, all of the proofs for properties and 3 apply directly with t max 3 0 i jn x jl (50) It is interesting that the maximum time step depends on the faces for the equivalent cell-based algorithm. It suggests that in some sense the cell-based dierencing is more natural or more basic. 6.3 Extension to 3-D The extension to 3-D is quite natural, with the cells for the equivalent cell-based algorithm being constructed by joining the centroids of the tetrahedra. by (@ x u) i V 0 0 i u 0 n 0 x 0 5 x is dened

17 4 V i 0 u n x cell-based (5) and t max 4 V i 0 jn x j (5) 6

18 7 nalysis of Systems of Equations 7. nalytic equations To extend the preceding analyses to rst order systems of equations we begin by considering the following 0 (53) u is now a vector of dimension m and and B are constant m m matrices. The scalar product is now dened as (u; v) Z V u T v dv: (54) Property is still satised since ; v Z u T v dv u T v n x d 0 (55) provided we ignore boundary contributions. lso it is clear from the denition of the scalar product that (u; v) T u; v : (56) Using these results the energy stability analysis proceeds as follows. ; ; u ; T ; BT u u; u; B (57) For de dt to be zero for all possible u requires that and B both be symmetric. For the present purposes we are only interested in hyperbolic, energy-preserving systems and so we will assume that this is the case. 7

19 7. Semi-discrete equations The semi-discrete analysis assumes that for any symmetric matrix (u; v) (u; v); (58) in addition to the usual basid properties and Property. It is clear that these are all satised by the scalar product denitions for both cell-centered and node-centered dierencing in which (u; v) i u T i v i i (59) The non-bold i is the cell area as dened earlier. corollary from this assumption is that x u) x u)] 0; (60) (u; B@ y u) y u)] 0: (6) Hence the stability analysis of the semi-discrete equation, is simply de dt du dt xu + B@ y u 0; (6) u; du dt x u) (u; B@ y u) 0: (63) 7.3 Discrete equations The analysis of the fully discrete equations also proceeds almost exactly as before. Omitting the tedious algebra, the nal result for the two-step method is p u n+ t u p n t and so it is stable provided + p t (@ x +B@ y ) n u p t (@ x +B@ y ) t (@ x +B@ y ) u n (64) p t (@ x +B@ y ) p t v kvk (65) 8

20 for all v. For the cell-centered dierencing, this is true if t i < (t max ) i where (t max ) i i The matrix norm jcj is dened by jcj max v jn x +Bn y jl: (66) jcvj ; (67) jvj so that jcvj jcjjvj. If C is symmetric then the norm is equal to the absolute magnitude of the largest eigenvalue of C. The proof that the given denition of t max is sucient is again very similar to the scalar proof. p t (@ x + B@ y ) p t v i i i i i i i i j j t i i (n x +Bn y ) p t v l t i q t j (n x +Bn y ) 4 ij v j l ij i jn 8 i t i < T q t 4 i : j (n x +Bn y ) ij v j 8 t i < 4 i : q j N i j N i j N i 8 t i < 4 i : 8 t i < 4 i : 8 t i < 4 i : t j (n x +Bn y ) ij v j l ij l ij 9 ; 9 q t j (n x +Bn y ) ij v q j t j (n x +Bn y ) ij v j lij l ij j ; N i 9 q t j jv j j t j jv j j jn x +Bn y j ij jn x +Bn y j ij l ij l ij ; q j N i j N i j N i j N i 9 t j jv j j +t j jv j j jn x +Bn y j ij jn x +Bn y j ij l ij l ij ; 9 8 < 9 ; : ; j N i jn x +Bn y j ij l ij jn i t j jv j j jn x +Bn y j ij l ij t j jv j j in j jn x +Bn y j ij l ij i jv j j j N i t j jv j j jn x +Bn y j ij l ij kvk (68) 9

21 7.4 Euler equations barbanel and Gottlieb [7] have shown that with an appropriate choice of variables the linearized Euler equations can be written in the above rst-order form with symmetric matrices and B equal to 0 q u c 0 0 q q c u 0 c 0 0 u 0 q 0 c 0 u C ; B 0 q v 0 q c 0 0 v 0 0 q c 0 v q c 0 0 c v With these denitions it is a straightforward exercise to show that the eigenvalues of n x +Bn y are ~u:~n, ~u:~n, ~u:~n c and ~u:~n+c, where ~u:~n is the normal ow velocity and c is the speed of sound. Thus it follows that for the cell-based dierencing the time step limit is given by C (69) (t max ) i i (j~u:~nj+c) l (70) It can be shown that for low Mach number ow over a regular square mesh this `maximum time step' is a factor p smaller than the value obtained by Fourier analysis, but they are equal in the limit of high Mach number or high cell aspect ratio or high cell skewing. Thus for practical purposes it is a sucient and almost necessary condition for numerical stability. s before the theory extends easily to three dimensions, and for the Euler equations the resultant time step limit for cell-based dierencing is (t max ) i V i (j~u:~nj+c) (7) 0

22 References [] D. Mavriplis and. ameson. Multigrid solution of the Euler equations on unstructured and adaptive meshes. In S. McCormick, editor, Proceedings of the Third Copper Mountain Conference on Multigrid Methods: Lecture Notes in Pure and pplied Mathematics. Marcel Dekker Inc, 987. [] R. Lohner, K. Morgan,. Peraire, and O.C. Zienkiewicz. Finite element methods for high speed ows. I Paper 85-53, 985. [3]. ameson, T.. Baker, and N.P. Weatherill. Calculation of inviscid transonic ow over a complete aircraft. I Paper 86{003, 986. [4] R.D. Richtmyer and K.W. Morton. Dierence Methods for Initial-Value Problems. Wiley-Interscience, nd edition, 967. Reprint edn (994) Krieger Publishing Company, Malabar. [5]. ameson, W. Schmidt, and E. Turkel. Numerical solutions of the Euler equations by nite volume methods with Runge{Kutta time stepping schemes. I Paper 8-59, 98. [6]. Mathews and R.L. Walker. Mathematical Methods of Physics. W.. Benjamin, Inc., 970. [7] S. barbanel and D. Gottlieb. Optimal time splitting for two and three dimensional Navier-Stokes equations with mixed derivatives. ICSE Report No. 80-6, 980.

23 P PPPPPPPPPP C j 6~n ij l ij - C CC? ~n ji C CC C i C````````` Figure : Geometric denitions for cell-based dierencing rea 6? y Figure : Denition of y for regular skewed mesh

24 ~n 0 kj j K ~n ij k a PP P l i P PPPPPPPPPPPPPP P ~n 0 0 i Figure 3: Geometric denitions for node-based dierencing 3

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

More information

2 Multidimensional Hyperbolic Problemss where A(u) =f u (u) B(u) =g u (u): (7.1.1c) Multidimensional nite dierence schemes can be simple extensions of

2 Multidimensional Hyperbolic Problemss where A(u) =f u (u) B(u) =g u (u): (7.1.1c) Multidimensional nite dierence schemes can be simple extensions of Chapter 7 Multidimensional Hyperbolic Problems 7.1 Split and Unsplit Dierence Methods Our study of multidimensional parabolic problems in Chapter 5 has laid most of the groundwork for our present task

More information

Linear Algebra (part 1) : Vector Spaces (by Evan Dummit, 2017, v. 1.07) 1.1 The Formal Denition of a Vector Space

Linear Algebra (part 1) : Vector Spaces (by Evan Dummit, 2017, v. 1.07) 1.1 The Formal Denition of a Vector Space Linear Algebra (part 1) : Vector Spaces (by Evan Dummit, 2017, v. 1.07) Contents 1 Vector Spaces 1 1.1 The Formal Denition of a Vector Space.................................. 1 1.2 Subspaces...................................................

More information

Mathematics Research Report No. MRR 003{96, HIGH RESOLUTION POTENTIAL FLOW METHODS IN OIL EXPLORATION Stephen Roberts 1 and Stephan Matthai 2 3rd Febr

Mathematics Research Report No. MRR 003{96, HIGH RESOLUTION POTENTIAL FLOW METHODS IN OIL EXPLORATION Stephen Roberts 1 and Stephan Matthai 2 3rd Febr HIGH RESOLUTION POTENTIAL FLOW METHODS IN OIL EXPLORATION Stephen Roberts and Stephan Matthai Mathematics Research Report No. MRR 003{96, Mathematics Research Report No. MRR 003{96, HIGH RESOLUTION POTENTIAL

More information

DS-GA 1002 Lecture notes 0 Fall Linear Algebra. These notes provide a review of basic concepts in linear algebra.

DS-GA 1002 Lecture notes 0 Fall Linear Algebra. These notes provide a review of basic concepts in linear algebra. DS-GA 1002 Lecture notes 0 Fall 2016 Linear Algebra These notes provide a review of basic concepts in linear algebra. 1 Vector spaces You are no doubt familiar with vectors in R 2 or R 3, i.e. [ ] 1.1

More information

A MULTIGRID ALGORITHM FOR. Richard E. Ewing and Jian Shen. Institute for Scientic Computation. Texas A&M University. College Station, Texas SUMMARY

A MULTIGRID ALGORITHM FOR. Richard E. Ewing and Jian Shen. Institute for Scientic Computation. Texas A&M University. College Station, Texas SUMMARY A MULTIGRID ALGORITHM FOR THE CELL-CENTERED FINITE DIFFERENCE SCHEME Richard E. Ewing and Jian Shen Institute for Scientic Computation Texas A&M University College Station, Texas SUMMARY In this article,

More information

SPECTRAL METHODS ON ARBITRARY GRIDS. Mark H. Carpenter. Research Scientist. Aerodynamic and Acoustic Methods Branch. NASA Langley Research Center

SPECTRAL METHODS ON ARBITRARY GRIDS. Mark H. Carpenter. Research Scientist. Aerodynamic and Acoustic Methods Branch. NASA Langley Research Center SPECTRAL METHODS ON ARBITRARY GRIDS Mark H. Carpenter Research Scientist Aerodynamic and Acoustic Methods Branch NASA Langley Research Center Hampton, VA 368- David Gottlieb Division of Applied Mathematics

More information

Linear Algebra 2 Spectral Notes

Linear Algebra 2 Spectral Notes Linear Algebra 2 Spectral Notes In what follows, V is an inner product vector space over F, where F = R or C. We will use results seen so far; in particular that every linear operator T L(V ) has a complex

More information

4 Linear Algebra Review

4 Linear Algebra Review Linear Algebra Review For this topic we quickly review many key aspects of linear algebra that will be necessary for the remainder of the text 1 Vectors and Matrices For the context of data analysis, the

More information

Interpolation Functions for General Element Formulation

Interpolation Functions for General Element Formulation CHPTER 6 Interpolation Functions 6.1 INTRODUCTION The structural elements introduced in the previous chapters were formulated on the basis of known principles from elementary strength of materials theory.

More information

The Convergence of Mimetic Discretization

The Convergence of Mimetic Discretization The Convergence of Mimetic Discretization for Rough Grids James M. Hyman Los Alamos National Laboratory T-7, MS-B84 Los Alamos NM 87545 and Stanly Steinberg Department of Mathematics and Statistics University

More information

Lecture 2: Review of Prerequisites. Table of contents

Lecture 2: Review of Prerequisites. Table of contents Math 348 Fall 217 Lecture 2: Review of Prerequisites Disclaimer. As we have a textbook, this lecture note is for guidance and supplement only. It should not be relied on when preparing for exams. In this

More information

PDE Solvers for Fluid Flow

PDE Solvers for Fluid Flow PDE Solvers for Fluid Flow issues and algorithms for the Streaming Supercomputer Eran Guendelman February 5, 2002 Topics Equations for incompressible fluid flow 3 model PDEs: Hyperbolic, Elliptic, Parabolic

More information

Contents. 2.1 Vectors in R n. Linear Algebra (part 2) : Vector Spaces (by Evan Dummit, 2017, v. 2.50) 2 Vector Spaces

Contents. 2.1 Vectors in R n. Linear Algebra (part 2) : Vector Spaces (by Evan Dummit, 2017, v. 2.50) 2 Vector Spaces Linear Algebra (part 2) : Vector Spaces (by Evan Dummit, 2017, v 250) Contents 2 Vector Spaces 1 21 Vectors in R n 1 22 The Formal Denition of a Vector Space 4 23 Subspaces 6 24 Linear Combinations and

More information

Finite volume method on unstructured grids

Finite volume method on unstructured grids Finite volume method on unstructured grids Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in/~praveen

More information

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

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

More information

hapter 8 Simulation/Realization 8 Introduction Given an nth-order state-space description of the form x_ (t) = f (x(t) u(t) t) (state evolution equati

hapter 8 Simulation/Realization 8 Introduction Given an nth-order state-space description of the form x_ (t) = f (x(t) u(t) t) (state evolution equati Lectures on Dynamic Systems and ontrol Mohammed Dahleh Munther Dahleh George Verghese Department of Electrical Engineering and omputer Science Massachuasetts Institute of Technology c hapter 8 Simulation/Realization

More information

An explicit nite element method for convection-dominated compressible viscous Stokes system with inow boundary

An explicit nite element method for convection-dominated compressible viscous Stokes system with inow boundary Journal of Computational and Applied Mathematics 156 (2003) 319 343 www.elsevier.com/locate/cam An explicit nite element method for convection-dominated compressible viscous Stokes system with inow boundary

More information

Iterative procedure for multidimesional Euler equations Abstracts A numerical iterative scheme is suggested to solve the Euler equations in two and th

Iterative procedure for multidimesional Euler equations Abstracts A numerical iterative scheme is suggested to solve the Euler equations in two and th Iterative procedure for multidimensional Euler equations W. Dreyer, M. Kunik, K. Sabelfeld, N. Simonov, and K. Wilmanski Weierstra Institute for Applied Analysis and Stochastics Mohrenstra e 39, 07 Berlin,

More information

Calculus and linear algebra for biomedical engineering Week 3: Matrices, linear systems of equations, and the Gauss algorithm

Calculus and linear algebra for biomedical engineering Week 3: Matrices, linear systems of equations, and the Gauss algorithm Calculus and linear algebra for biomedical engineering Week 3: Matrices, linear systems of equations, and the Gauss algorithm Hartmut Führ fuehr@matha.rwth-aachen.de Lehrstuhl A für Mathematik, RWTH Aachen

More information

A mixed nite volume element method based on rectangular mesh for biharmonic equations

A mixed nite volume element method based on rectangular mesh for biharmonic equations Journal of Computational and Applied Mathematics 7 () 7 3 www.elsevier.com/locate/cam A mixed nite volume element method based on rectangular mesh for biharmonic equations Tongke Wang College of Mathematical

More information

On reaching head-to-tail ratios for balanced and unbalanced coins

On reaching head-to-tail ratios for balanced and unbalanced coins Journal of Statistical Planning and Inference 0 (00) 0 0 www.elsevier.com/locate/jspi On reaching head-to-tail ratios for balanced and unbalanced coins Tamas Lengyel Department of Mathematics, Occidental

More information

Math 497 R1 Winter 2018 Navier-Stokes Regularity

Math 497 R1 Winter 2018 Navier-Stokes Regularity Math 497 R Winter 208 Navier-Stokes Regularity Lecture : Sobolev Spaces and Newtonian Potentials Xinwei Yu Jan. 0, 208 Based on..2 of []. Some ne properties of Sobolev spaces, and basics of Newtonian potentials.

More information

October 7, :8 WSPC/WS-IJWMIP paper. Polynomial functions are renable

October 7, :8 WSPC/WS-IJWMIP paper. Polynomial functions are renable International Journal of Wavelets, Multiresolution and Information Processing c World Scientic Publishing Company Polynomial functions are renable Henning Thielemann Institut für Informatik Martin-Luther-Universität

More information

ADAPTIVE ITERATION TO STEADY STATE OF FLOW PROBLEMS KARL H ORNELL 1 and PER L OTSTEDT 2 1 Dept of Information Technology, Scientic Computing, Uppsala

ADAPTIVE ITERATION TO STEADY STATE OF FLOW PROBLEMS KARL H ORNELL 1 and PER L OTSTEDT 2 1 Dept of Information Technology, Scientic Computing, Uppsala ADAPTIVE ITERATION TO STEADY STATE OF FLOW PROBLEMS KARL H ORNELL 1 and PER L OTSTEDT 2 1 Dept of Information Technology, Scientic Computing, Uppsala University, SE-75104 Uppsala, Sweden. email: karl@tdb.uu.se

More information

PARAMETER IDENTIFICATION IN THE FREQUENCY DOMAIN. H.T. Banks and Yun Wang. Center for Research in Scientic Computation

PARAMETER IDENTIFICATION IN THE FREQUENCY DOMAIN. H.T. Banks and Yun Wang. Center for Research in Scientic Computation PARAMETER IDENTIFICATION IN THE FREQUENCY DOMAIN H.T. Banks and Yun Wang Center for Research in Scientic Computation North Carolina State University Raleigh, NC 7695-805 Revised: March 1993 Abstract In

More information

Elementary linear algebra

Elementary linear algebra Chapter 1 Elementary linear algebra 1.1 Vector spaces Vector spaces owe their importance to the fact that so many models arising in the solutions of specific problems turn out to be vector spaces. The

More information

MODELLING OF FLEXIBLE MECHANICAL SYSTEMS THROUGH APPROXIMATED EIGENFUNCTIONS L. Menini A. Tornambe L. Zaccarian Dip. Informatica, Sistemi e Produzione

MODELLING OF FLEXIBLE MECHANICAL SYSTEMS THROUGH APPROXIMATED EIGENFUNCTIONS L. Menini A. Tornambe L. Zaccarian Dip. Informatica, Sistemi e Produzione MODELLING OF FLEXIBLE MECHANICAL SYSTEMS THROUGH APPROXIMATED EIGENFUNCTIONS L. Menini A. Tornambe L. Zaccarian Dip. Informatica, Sistemi e Produzione, Univ. di Roma Tor Vergata, via di Tor Vergata 11,

More information

Application of turbulence. models to high-lift airfoils. By Georgi Kalitzin

Application of turbulence. models to high-lift airfoils. By Georgi Kalitzin Center for Turbulence Research Annual Research Briefs 997 65 Application of turbulence models to high-lift airfoils By Georgi Kalitzin. Motivation and objectives Accurate prediction of the ow over an airfoil

More information

4.1 Eigenvalues, Eigenvectors, and The Characteristic Polynomial

4.1 Eigenvalues, Eigenvectors, and The Characteristic Polynomial Linear Algebra (part 4): Eigenvalues, Diagonalization, and the Jordan Form (by Evan Dummit, 27, v ) Contents 4 Eigenvalues, Diagonalization, and the Jordan Canonical Form 4 Eigenvalues, Eigenvectors, and

More information

New concepts: Span of a vector set, matrix column space (range) Linearly dependent set of vectors Matrix null space

New concepts: Span of a vector set, matrix column space (range) Linearly dependent set of vectors Matrix null space Lesson 6: Linear independence, matrix column space and null space New concepts: Span of a vector set, matrix column space (range) Linearly dependent set of vectors Matrix null space Two linear systems:

More information

Math 413/513 Chapter 6 (from Friedberg, Insel, & Spence)

Math 413/513 Chapter 6 (from Friedberg, Insel, & Spence) Math 413/513 Chapter 6 (from Friedberg, Insel, & Spence) David Glickenstein December 7, 2015 1 Inner product spaces In this chapter, we will only consider the elds R and C. De nition 1 Let V be a vector

More information

Linear Algebra. 1.1 Introduction to vectors 1.2 Lengths and dot products. January 28th, 2013 Math 301. Monday, January 28, 13

Linear Algebra. 1.1 Introduction to vectors 1.2 Lengths and dot products. January 28th, 2013 Math 301. Monday, January 28, 13 Linear Algebra 1.1 Introduction to vectors 1.2 Lengths and dot products January 28th, 2013 Math 301 Notation for linear systems 12w +4x + 23y +9z =0 2u + v +5w 2x +2y +8z =1 5u + v 6w +2x +4y z =6 8u 4v

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

IE 5531: Engineering Optimization I

IE 5531: Engineering Optimization I IE 5531: Engineering Optimization I Lecture 15: Nonlinear optimization Prof. John Gunnar Carlsson November 1, 2010 Prof. John Gunnar Carlsson IE 5531: Engineering Optimization I November 1, 2010 1 / 24

More information

Linearized methods for ordinary di erential equations

Linearized methods for ordinary di erential equations Applied Mathematics and Computation 104 (1999) 109±19 www.elsevier.nl/locate/amc Linearized methods for ordinary di erential equations J.I. Ramos 1 Departamento de Lenguajes y Ciencias de la Computacion,

More information

A Finite Element Method for an Ill-Posed Problem. Martin-Luther-Universitat, Fachbereich Mathematik/Informatik,Postfach 8, D Halle, Abstract

A Finite Element Method for an Ill-Posed Problem. Martin-Luther-Universitat, Fachbereich Mathematik/Informatik,Postfach 8, D Halle, Abstract A Finite Element Method for an Ill-Posed Problem W. Lucht Martin-Luther-Universitat, Fachbereich Mathematik/Informatik,Postfach 8, D-699 Halle, Germany Abstract For an ill-posed problem which has its origin

More information

Ole Christensen 3. October 20, Abstract. We point out some connections between the existing theories for

Ole Christensen 3. October 20, Abstract. We point out some connections between the existing theories for Frames and pseudo-inverses. Ole Christensen 3 October 20, 1994 Abstract We point out some connections between the existing theories for frames and pseudo-inverses. In particular, using the pseudo-inverse

More information

Eect of boundary vorticity discretization on explicit stream-function vorticity calculations

Eect of boundary vorticity discretization on explicit stream-function vorticity calculations INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 25; 49:37 393 Published online 26 May 25 in Wiley InterScience (www.interscience.wiley.com). DOI:.2/d. Eect of boundary

More information

2 Introduction T(,t) = = L Figure..: Geometry of the prismatical rod of Eample... T = u(,t) = L T Figure..2: Geometry of the taut string of Eample..2.

2 Introduction T(,t) = = L Figure..: Geometry of the prismatical rod of Eample... T = u(,t) = L T Figure..2: Geometry of the taut string of Eample..2. Chapter Introduction. Problems Leading to Partial Dierential Equations Many problems in science and engineering are modeled and analyzed using systems of partial dierential equations. Realistic models

More information

290 J.M. Carnicer, J.M. Pe~na basis (u 1 ; : : : ; u n ) consisting of minimally supported elements, yet also has a basis (v 1 ; : : : ; v n ) which f

290 J.M. Carnicer, J.M. Pe~na basis (u 1 ; : : : ; u n ) consisting of minimally supported elements, yet also has a basis (v 1 ; : : : ; v n ) which f Numer. Math. 67: 289{301 (1994) Numerische Mathematik c Springer-Verlag 1994 Electronic Edition Least supported bases and local linear independence J.M. Carnicer, J.M. Pe~na? Departamento de Matematica

More information

Multistage Schemes With Multigrid for Euler and Navier-Stokes Equations

Multistage Schemes With Multigrid for Euler and Navier-Stokes Equations NASA Technical Paper 363 Multistage Schemes With Multigrid for Euler and Navier-Stokes Equations Components and Analysis R. C. Swanson Langley Research Center Hampton, Virginia Eli Turkel Tel-Aviv University

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

n i,j+1/2 q i,j * qi+1,j * S i+1/2,j

n i,j+1/2 q i,j * qi+1,j * S i+1/2,j Helsinki University of Technology CFD-group/ The Laboratory of Applied Thermodynamics MEMO No CFD/TERMO-5-97 DATE: December 9,997 TITLE A comparison of complete vs. simplied viscous terms in boundary layer

More information

MODIFIED STREAMLINE DIFFUSION SCHEMES FOR CONVECTION-DIFFUSION PROBLEMS. YIN-TZER SHIH AND HOWARD C. ELMAN y

MODIFIED STREAMLINE DIFFUSION SCHEMES FOR CONVECTION-DIFFUSION PROBLEMS. YIN-TZER SHIH AND HOWARD C. ELMAN y MODIFIED STREAMLINE DIFFUSION SCHEMES FOR CONVECTION-DIFFUSION PROBLEMS YIN-TZER SHIH AND HOWARD C. ELMAN y Abstract. We consider the design of robust and accurate nite element approximation methods for

More information

Chapter 2. Solving Systems of Equations. 2.1 Gaussian elimination

Chapter 2. Solving Systems of Equations. 2.1 Gaussian elimination Chapter 2 Solving Systems of Equations A large number of real life applications which are resolved through mathematical modeling will end up taking the form of the following very simple looking matrix

More information

Vector Space Basics. 1 Abstract Vector Spaces. 1. (commutativity of vector addition) u + v = v + u. 2. (associativity of vector addition)

Vector Space Basics. 1 Abstract Vector Spaces. 1. (commutativity of vector addition) u + v = v + u. 2. (associativity of vector addition) Vector Space Basics (Remark: these notes are highly formal and may be a useful reference to some students however I am also posting Ray Heitmann's notes to Canvas for students interested in a direct computational

More information

Spurious Chaotic Solutions of Dierential. Equations. Sigitas Keras. September Department of Applied Mathematics and Theoretical Physics

Spurious Chaotic Solutions of Dierential. Equations. Sigitas Keras. September Department of Applied Mathematics and Theoretical Physics UNIVERSITY OF CAMBRIDGE Numerical Analysis Reports Spurious Chaotic Solutions of Dierential Equations Sigitas Keras DAMTP 994/NA6 September 994 Department of Applied Mathematics and Theoretical Physics

More information

Lecture 2: Linear Algebra Review

Lecture 2: Linear Algebra Review EE 227A: Convex Optimization and Applications January 19 Lecture 2: Linear Algebra Review Lecturer: Mert Pilanci Reading assignment: Appendix C of BV. Sections 2-6 of the web textbook 1 2.1 Vectors 2.1.1

More information

2 JOSE BURILLO It was proved by Thurston [2, Ch.8], using geometric methods, and by Gersten [3], using combinatorial methods, that the integral 3-dime

2 JOSE BURILLO It was proved by Thurston [2, Ch.8], using geometric methods, and by Gersten [3], using combinatorial methods, that the integral 3-dime DIMACS Series in Discrete Mathematics and Theoretical Computer Science Volume 00, 1997 Lower Bounds of Isoperimetric Functions for Nilpotent Groups Jose Burillo Abstract. In this paper we prove that Heisenberg

More information

Oct : Lecture 15: Surface Integrals and Some Related Theorems

Oct : Lecture 15: Surface Integrals and Some Related Theorems 90 MIT 3.016 Fall 2005 c W.C Carter Lecture 15 Oct. 21 2005: Lecture 15: Surface Integrals and Some Related Theorems Reading: Kreyszig Sections: 9.4 pp:485 90), 9.5 pp:491 495) 9.6 pp:496 505) 9.7 pp:505

More information

Numerical Integration exact integration is not needed to achieve the optimal convergence rate of nite element solutions ([, 9, 11], and Chapter 7). In

Numerical Integration exact integration is not needed to achieve the optimal convergence rate of nite element solutions ([, 9, 11], and Chapter 7). In Chapter 6 Numerical Integration 6.1 Introduction After transformation to a canonical element,typical integrals in the element stiness or mass matrices (cf. (5.5.8)) have the forms Q = T ( )N s Nt det(j

More information

Abstract. A front tracking method is used to construct weak solutions to

Abstract. A front tracking method is used to construct weak solutions to A Front Tracking Method for Conservation Laws with Boundary Conditions K. Hvistendahl Karlsen, K.{A. Lie, and N. H. Risebro Abstract. A front tracking method is used to construct weak solutions to scalar

More information

Chapter 3 Least Squares Solution of y = A x 3.1 Introduction We turn to a problem that is dual to the overconstrained estimation problems considered s

Chapter 3 Least Squares Solution of y = A x 3.1 Introduction We turn to a problem that is dual to the overconstrained estimation problems considered s Lectures on Dynamic Systems and Control Mohammed Dahleh Munther A. Dahleh George Verghese Department of Electrical Engineering and Computer Science Massachuasetts Institute of Technology 1 1 c Chapter

More information

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

1 Vectors. Notes for Bindel, Spring 2017 Numerical Analysis (CS 4220)

1 Vectors. Notes for Bindel, Spring 2017 Numerical Analysis (CS 4220) Notes for 2017-01-30 Most of mathematics is best learned by doing. Linear algebra is no exception. You have had a previous class in which you learned the basics of linear algebra, and you will have plenty

More information

2 GOVERNING EQUATIONS

2 GOVERNING EQUATIONS 2 GOVERNING EQUATIONS 9 2 GOVERNING EQUATIONS For completeness we will take a brief moment to review the governing equations for a turbulent uid. We will present them both in physical space coordinates

More information

t x 0.25

t x 0.25 Journal of ELECTRICAL ENGINEERING, VOL. 52, NO. /s, 2, 48{52 COMPARISON OF BROYDEN AND NEWTON METHODS FOR SOLVING NONLINEAR PARABOLIC EQUATIONS Ivan Cimrak If the time discretization of a nonlinear parabolic

More information

The Finite Volume Mesh

The Finite Volume Mesh FMIA F Moukalled L Mangani M Darwish An Advanced Introduction with OpenFOAM and Matlab This textbook explores both the theoretical foundation of the Finite Volume Method (FVM) and its applications in Computational

More information

4.3 - Linear Combinations and Independence of Vectors

4.3 - Linear Combinations and Independence of Vectors - Linear Combinations and Independence of Vectors De nitions, Theorems, and Examples De nition 1 A vector v in a vector space V is called a linear combination of the vectors u 1, u,,u k in V if v can be

More information

514 YUNHAI WU ET AL. rate is shown to be asymptotically independent of the time and space mesh parameters and the number of subdomains, provided that

514 YUNHAI WU ET AL. rate is shown to be asymptotically independent of the time and space mesh parameters and the number of subdomains, provided that Contemporary Mathematics Volume 218, 1998 Additive Schwarz Methods for Hyperbolic Equations Yunhai Wu, Xiao-Chuan Cai, and David E. Keyes 1. Introduction In recent years, there has been gratifying progress

More information

quantitative information on the error caused by using the solution of the linear problem to describe the response of the elastic material on a corner

quantitative information on the error caused by using the solution of the linear problem to describe the response of the elastic material on a corner Quantitative Justication of Linearization in Nonlinear Hencky Material Problems 1 Weimin Han and Hong-ci Huang 3 Abstract. The classical linear elasticity theory is based on the assumption that the size

More information

Linear Regression and Its Applications

Linear Regression and Its Applications Linear Regression and Its Applications Predrag Radivojac October 13, 2014 Given a data set D = {(x i, y i )} n the objective is to learn the relationship between features and the target. We usually start

More information

Linear Equations and Vectors

Linear Equations and Vectors Chapter Linear Equations and Vectors Linear Algebra, Fall 6 Matrices and Systems of Linear Equations Figure. Linear Algebra, Fall 6 Figure. Linear Algebra, Fall 6 Figure. Linear Algebra, Fall 6 Unique

More information

Finite Volume Method

Finite Volume Method Finite Volume Method An Introduction Praveen. C CTFD Division National Aerospace Laboratories Bangalore 560 037 email: praveen@cfdlab.net April 7, 2006 Praveen. C (CTFD, NAL) FVM CMMACS 1 / 65 Outline

More information

Iterative Methods for Linear Systems

Iterative Methods for Linear Systems Iterative Methods for Linear Systems 1. Introduction: Direct solvers versus iterative solvers In many applications we have to solve a linear system Ax = b with A R n n and b R n given. If n is large the

More information

ground state degeneracy ground state energy

ground state degeneracy ground state energy Searching Ground States in Ising Spin Glass Systems Steven Homer Computer Science Department Boston University Boston, MA 02215 Marcus Peinado German National Research Center for Information Technology

More information

OpenStax-CNX module: m Vectors. OpenStax College. Abstract

OpenStax-CNX module: m Vectors. OpenStax College. Abstract OpenStax-CNX module: m49412 1 Vectors OpenStax College This work is produced by OpenStax-CNX and licensed under the Creative Commons Attribution License 4.0 In this section you will: Abstract View vectors

More information

Chapter Stability Robustness Introduction Last chapter showed how the Nyquist stability criterion provides conditions for the stability robustness of

Chapter Stability Robustness Introduction Last chapter showed how the Nyquist stability criterion provides conditions for the stability robustness of Lectures on Dynamic Systems and Control Mohammed Dahleh Munther A Dahleh George Verghese Department of Electrical Engineering and Computer Science Massachuasetts Institute of Technology c Chapter Stability

More information

MULTIGRID CALCULATIONS FOB. CASCADES. Antony Jameson and Feng Liu Princeton University, Princeton, NJ 08544

MULTIGRID CALCULATIONS FOB. CASCADES. Antony Jameson and Feng Liu Princeton University, Princeton, NJ 08544 MULTIGRID CALCULATIONS FOB. CASCADES Antony Jameson and Feng Liu Princeton University, Princeton, NJ 0544 1. Introduction Development of numerical methods for internal flows such as the flow in gas turbines

More information

October 25, 2013 INNER PRODUCT SPACES

October 25, 2013 INNER PRODUCT SPACES October 25, 2013 INNER PRODUCT SPACES RODICA D. COSTIN Contents 1. Inner product 2 1.1. Inner product 2 1.2. Inner product spaces 4 2. Orthogonal bases 5 2.1. Existence of an orthogonal basis 7 2.2. Orthogonal

More information

Math 443/543 Graph Theory Notes 5: Graphs as matrices, spectral graph theory, and PageRank

Math 443/543 Graph Theory Notes 5: Graphs as matrices, spectral graph theory, and PageRank Math 443/543 Graph Theory Notes 5: Graphs as matrices, spectral graph theory, and PageRank David Glickenstein November 3, 4 Representing graphs as matrices It will sometimes be useful to represent graphs

More information

Accuracy-Preserving Source Term Quadrature for Third-Order Edge-Based Discretization

Accuracy-Preserving Source Term Quadrature for Third-Order Edge-Based Discretization Preprint accepted in Journal of Computational Physics. https://doi.org/0.06/j.jcp.07.04.075 Accuracy-Preserving Source Term Quadrature for Third-Order Edge-Based Discretization Hiroaki Nishikawa and Yi

More information

Math 302 Outcome Statements Winter 2013

Math 302 Outcome Statements Winter 2013 Math 302 Outcome Statements Winter 2013 1 Rectangular Space Coordinates; Vectors in the Three-Dimensional Space (a) Cartesian coordinates of a point (b) sphere (c) symmetry about a point, a line, and a

More information

Numerical Integration for Multivariable. October Abstract. We consider the numerical integration of functions with point singularities over

Numerical Integration for Multivariable. October Abstract. We consider the numerical integration of functions with point singularities over Numerical Integration for Multivariable Functions with Point Singularities Yaun Yang and Kendall E. Atkinson y October 199 Abstract We consider the numerical integration of functions with point singularities

More information

Adaptive linear quadratic control using policy. iteration. Steven J. Bradtke. University of Massachusetts.

Adaptive linear quadratic control using policy. iteration. Steven J. Bradtke. University of Massachusetts. Adaptive linear quadratic control using policy iteration Steven J. Bradtke Computer Science Department University of Massachusetts Amherst, MA 01003 bradtke@cs.umass.edu B. Erik Ydstie Department of Chemical

More information

CONVERGENCE OF GAUGE METHOD FOR INCOMPRESSIBLE FLOW CHENG WANG AND JIAN-GUO LIU

CONVERGENCE OF GAUGE METHOD FOR INCOMPRESSIBLE FLOW CHENG WANG AND JIAN-GUO LIU MATHEMATICS OF COMPUTATION Volume 69, Number 232, Pages 135{1407 S 0025-571(00)0124-5 Article electronically published on March 24, 2000 CONVERGENCE OF GAUGE METHOD FOR INCOMPRESSIBLE FLOW CHENG WANG AND

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Numerical Methods for Partial Differential Equations Finite Difference Methods

More information

Rigid Geometric Transformations

Rigid Geometric Transformations Rigid Geometric Transformations Carlo Tomasi This note is a quick refresher of the geometry of rigid transformations in three-dimensional space, expressed in Cartesian coordinates. 1 Cartesian Coordinates

More information

VII Selected Topics. 28 Matrix Operations

VII Selected Topics. 28 Matrix Operations VII Selected Topics Matrix Operations Linear Programming Number Theoretic Algorithms Polynomials and the FFT Approximation Algorithms 28 Matrix Operations We focus on how to multiply matrices and solve

More information

Solving Large Nonlinear Sparse Systems

Solving Large Nonlinear Sparse Systems Solving Large Nonlinear Sparse Systems Fred W. Wubs and Jonas Thies Computational Mechanics & Numerical Mathematics University of Groningen, the Netherlands f.w.wubs@rug.nl Centre for Interdisciplinary

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

Math 471 (Numerical methods) Chapter 3 (second half). System of equations

Math 471 (Numerical methods) Chapter 3 (second half). System of equations Math 47 (Numerical methods) Chapter 3 (second half). System of equations Overlap 3.5 3.8 of Bradie 3.5 LU factorization w/o pivoting. Motivation: ( ) A I Gaussian Elimination (U L ) where U is upper triangular

More information

Numerical computation of three-dimensional incompressible Navier Stokes equations in primitive variable form by DQ method

Numerical computation of three-dimensional incompressible Navier Stokes equations in primitive variable form by DQ method INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2003; 43:345 368 (DOI: 10.1002/d.566) Numerical computation of three-dimensional incompressible Navier Stokes equations

More information

Rening the submesh strategy in the two-level nite element method: application to the advection diusion equation

Rening the submesh strategy in the two-level nite element method: application to the advection diusion equation INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2002; 39:161 187 (DOI: 10.1002/d.219) Rening the submesh strategy in the two-level nite element method: application to

More information

Problem Set 9 Due: In class Tuesday, Nov. 27 Late papers will be accepted until 12:00 on Thursday (at the beginning of class).

Problem Set 9 Due: In class Tuesday, Nov. 27 Late papers will be accepted until 12:00 on Thursday (at the beginning of class). Math 3, Fall Jerry L. Kazdan Problem Set 9 Due In class Tuesday, Nov. 7 Late papers will be accepted until on Thursday (at the beginning of class).. Suppose that is an eigenvalue of an n n matrix A and

More information

Convergence and Error Bound Analysis for the Space-Time CESE Method

Convergence and Error Bound Analysis for the Space-Time CESE Method Convergence and Error Bound Analysis for the Space-Time CESE Method Daoqi Yang, 1 Shengtao Yu, Jennifer Zhao 3 1 Department of Mathematics Wayne State University Detroit, MI 480 Department of Mechanics

More information

The dissertation of Bin Jiang is approved: Chair Date Date Date Date University of California at Santa Barbara 999

The dissertation of Bin Jiang is approved: Chair Date Date Date Date University of California at Santa Barbara 999 Non-overlapping Domain Decomposition and Heterogeneous Modeling Used in Solving Free Boundary Problems by Bin Jiang A dissertation submitted in partial satisfaction of the requirements for the degree of

More information

Applications in Fluid Mechanics

Applications in Fluid Mechanics CHAPTER 8 Applications in Fluid 8.1 INTRODUCTION The general topic of fluid mechanics encompasses a wide range of problems of interest in engineering applications. The most basic definition of a fluid

More information

. (a) Express [ ] as a non-trivial linear combination of u = [ ], v = [ ] and w =[ ], if possible. Otherwise, give your comments. (b) Express +8x+9x a

. (a) Express [ ] as a non-trivial linear combination of u = [ ], v = [ ] and w =[ ], if possible. Otherwise, give your comments. (b) Express +8x+9x a TE Linear Algebra and Numerical Methods Tutorial Set : Two Hours. (a) Show that the product AA T is a symmetric matrix. (b) Show that any square matrix A can be written as the sum of a symmetric matrix

More information

N.G.Bean, D.A.Green and P.G.Taylor. University of Adelaide. Adelaide. Abstract. process of an MMPP/M/1 queue is not a MAP unless the queue is a

N.G.Bean, D.A.Green and P.G.Taylor. University of Adelaide. Adelaide. Abstract. process of an MMPP/M/1 queue is not a MAP unless the queue is a WHEN IS A MAP POISSON N.G.Bean, D.A.Green and P.G.Taylor Department of Applied Mathematics University of Adelaide Adelaide 55 Abstract In a recent paper, Olivier and Walrand (994) claimed that the departure

More information

First, Second, and Third Order Finite-Volume Schemes for Diffusion

First, Second, and Third Order Finite-Volume Schemes for Diffusion First, Second, and Third Order Finite-Volume Schemes for Diffusion Hiro Nishikawa 51st AIAA Aerospace Sciences Meeting, January 10, 2013 Supported by ARO (PM: Dr. Frederick Ferguson), NASA, Software Cradle.

More information

f(z)dz = 0. P dx + Qdy = D u dx v dy + i u dy + v dx. dxdy + i x = v

f(z)dz = 0. P dx + Qdy = D u dx v dy + i u dy + v dx. dxdy + i x = v MA525 ON CAUCHY'S THEOREM AND GREEN'S THEOREM DAVID DRASIN (EDITED BY JOSIAH YODER) 1. Introduction No doubt the most important result in this course is Cauchy's theorem. Every critical theorem in the

More information

ON THE ARITHMETIC-GEOMETRIC MEAN INEQUALITY AND ITS RELATIONSHIP TO LINEAR PROGRAMMING, BAHMAN KALANTARI

ON THE ARITHMETIC-GEOMETRIC MEAN INEQUALITY AND ITS RELATIONSHIP TO LINEAR PROGRAMMING, BAHMAN KALANTARI ON THE ARITHMETIC-GEOMETRIC MEAN INEQUALITY AND ITS RELATIONSHIP TO LINEAR PROGRAMMING, MATRIX SCALING, AND GORDAN'S THEOREM BAHMAN KALANTARI Abstract. It is a classical inequality that the minimum of

More information

Novel determination of dierential-equation solutions: universal approximation method

Novel determination of dierential-equation solutions: universal approximation method Journal of Computational and Applied Mathematics 146 (2002) 443 457 www.elsevier.com/locate/cam Novel determination of dierential-equation solutions: universal approximation method Thananchai Leephakpreeda

More information

Multiple Integrals and Vector Calculus (Oxford Physics) Synopsis and Problem Sets; Hilary 2015

Multiple Integrals and Vector Calculus (Oxford Physics) Synopsis and Problem Sets; Hilary 2015 Multiple Integrals and Vector Calculus (Oxford Physics) Ramin Golestanian Synopsis and Problem Sets; Hilary 215 The outline of the material, which will be covered in 14 lectures, is as follows: 1. Introduction

More information

Multiple Integrals and Vector Calculus: Synopsis

Multiple Integrals and Vector Calculus: Synopsis Multiple Integrals and Vector Calculus: Synopsis Hilary Term 28: 14 lectures. Steve Rawlings. 1. Vectors - recap of basic principles. Things which are (and are not) vectors. Differentiation and integration

More information

Linear Algebra. Linear Equations and Matrices. Copyright 2005, W.R. Winfrey

Linear Algebra. Linear Equations and Matrices. Copyright 2005, W.R. Winfrey Copyright 2005, W.R. Winfrey Topics Preliminaries Systems of Linear Equations Matrices Algebraic Properties of Matrix Operations Special Types of Matrices and Partitioned Matrices Matrix Transformations

More information

DETERMINANTS, COFACTORS, AND INVERSES

DETERMINANTS, COFACTORS, AND INVERSES DEERMIS, COFCORS, D IVERSES.0 GEERL Determinants originally were encountered in the solution of simultaneous linear equations, so we will use that perspective here. general statement of this problem is:

More information

Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations

Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations NASA/CR-1998-208741 ICASE Report No. 98-51 Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations David L. Darmofal Massachusetts Institute of Technology, Cambridge,

More information