Lecture Note 3: Stationary Iterative Methods

Size: px
Start display at page:

Download "Lecture Note 3: Stationary Iterative Methods"

Transcription

1 MATH 5330: Computationa Methods of Linear Agebra Lecture Note 3: Stationary Iterative Methods Xianyi Zeng Department of Mathematica Sciences, UTEP Stationary Iterative Methods The Gaussian eimination (or in genera most direct methods) requires O(n 3 ) computationa cost, which is not acceptabe when n is arge For exampe, et us consider the direct numerica simuation of the Navier-Stoes equation on a unit cube in 3D; we discretize the domain with N 3 cubes and compute the soutions up to t = T The Navier-Stoes equation has five variabes at each node, hence the soution vector is u R 5N 3 When an impicit/expicit (IMEX) method is used for the time-integration, the time step size scaes with /N and the tota number of time steps is O(N) For each time step, there is a noninear equation to sove: f(u n+ ) = g(u n ), to update the soution from one time step (u n ) to the next (u n+ ) Let K be the average number of iterations in the Newton method to sove this noninear system, in tota we need to sove a inear system O(KN) times, and each such inear system is of the size 5N 3 5N 3 If a direct method is used for the inear soves, the tota computationa cost is: O((5N 3 ) 3 ) O(KN) = O(KN 0 ), which is prohibitive even for moderate vaue of N The target of stationary iterative methods is to reduce the computationa cost with inear soves to magnitudes smaer than O(n 3 ) Particuary in soving Ax = b, et us write A = M +(A M) for some matrix M and the inear system as: Mx = (A M)x+b () In an iterative method, we start with an initia guess x 0 and try to improve the resut soving for x +, = 0,, : Mx + = (A M)x +b, or equivaenty x + = M (A M)x +M b () Let s oo at the ast equation, ceary a requirement for the iterative method to mae sense is that the inear system associated with M shoud be easy to sove in the sense that the cost is no more than O(n ) Two such choices are diagona matrices ( O(n)) and trianguar matrices ( O(n )) Next, we aso want to mae sure that if there exists a soution x, then x x as + Finay, providing that x x, we hope x x to be reasonaby sma for ony a few number of iterations These are the questions we d ie to answer for any iterative method in this ecture Or simpy iterative methods in this section

2 Let A be non-singuar and x soves Ax = b, we first oo at the convergence Define ε = x x as the error vector in the -th iteration, then: or equivaenty: Mε + = M(x + x) = [ (A M)x +b] [ (A M)x+b] = (A M)ε, ε + = Gε, G = M (A M) (3) The growth matrix G remains the same for a iterations (hence the name stationary iterative methods ), thus we obtain an estimate on the error ε : ε = G ε 0 = ε G ε 0 (4) Thus we have ε 0 for any ε 0 if G 0 when, for which a sufficient and necessary condition is given by Theorem Remar Stricty speaing, we do not need G 0 to deduce ε if we can choose ε 0 carefuy In an extreme case if ε 0 is in the nu space of some G 0 (which happens with 0 = in the fooish case when M = A), the error becomes zero after 0 iterations Theorem G 0 as if and ony if ρ(g) <, where the spectra radius ρ(g) is the maximum absoute vaue of a the eigenvaues of G Proof We consider the Jordan canonica form G=QJQ, where Q is invertibe and J is given by: J λ J J =, J = λ =,,m (5) Jm λ n n Here λ,,λ m are the eigenvaues of G, which may not be different from each other; and n + + n m = n To this end G =QJ Q and we just need to show J 0 if and ony if ρ(g)< or equivaenty λ < for a Because J = diag(j, J,, J m), we ony need to show J 0 if and ony if λ < The ast point is straightforward as: n n ( ( ) λ ) ( λ ) ( ) λ n + λ n + ( ( J ) λ ) ( λ ) n λ n ( = ) ( ) λ n λ n ( ) λ and the fact that each entry converges to zero as n n, (6) In fact, if G = M (A M) has spectra radius smaer than, we can drop the assumption that A is non-singuar (it remains true, though), as stated by the next theorem Theorem If ρ(g) <, then A is invertibe

3 Proof Because A=M(I G), we just need to show that I G is invertibe for the first part Indeed, if (I G)x = 0 for some vector x R n, then x = Ix = Gx = G x = = G x 0 by Theorem ; hence the nu space of I G contains ony the zero vector and I G is invertibe The condition of the preceding theorem is in genera very difficut to chec; and a more convenient one is based on the inequaity G G Hence a necessary condition is given by G < for some induced matrix norm Jacobi Method A simpest iterative method is given by choosing M as the diagona part of A, this is caed the Jacobi method Let A=L+D+U, where L, D, and U are the ower-tridiagona part, diagona part, and upper-tridiagona part, respectivey (not to be confused with the LU or LDU decomposition!) Then in the Jacobi method, M = D and () reduces to: x + = D (L+U)x +D b () The growth matrix G = D (L+U) is: G = a a a nn 0 a a n a 0 a n = a n a n 0 a n a nn a a n a n a 0 a a a 0 a n a nn 0 () If the diagona eements of A are sufficienty arge, say: a ii > a ij, i =,,, n, (3) j i then we have G < By the argument at the end of Section, we see that the Jacobi method converges if A is diagonay dominant, ie, if A satisfies (3) (3) actuay provides a way to estimate the number of iterations needed in order to achieve certain accuracy Let: then by (4) ε ρ jac ε0 ρ jac = max i j i a ij a ii <, (4) To see an exampe of diagona-dominate inear systems, we consider the impicit method to sove the system of ordinary differentia equations: dx dt = f(x) 3

4 Let x m and x m+ be the soutions at t m and t m+ = t m + t m, respectivey; then we update the soution from x m to x m+ by: x m+ x m t m = f(x m )+ f(x m) x (x m+ x m ), f(x which invoves the inear system with A m = I + t m) m x Thus we can aways find a diagonadominate matrix A m by choosing a sma t m 3 Gauss-Seide Method The Jacobi method can be written component-by-component as: for i =,,, n : (3) x +;i = ij x ;j +b j j ia a ii Here we denote x = [x ;i ] One argument about the Jacobi method is that we re not using the most updated information in the soution, ie it is aways the components of x that appear on the right hand side of the updating formua A modification that aways use the most recent data and saves some storage is the foowing: for i =,,, n : (3) x +;i = a ij x +;j ij x ;j +b j j>ia a ii j<i This agorithm is nown as the Gauss-Seide method; and it is equivaent to the choice M = D +L: x + = (D +L) (Ux b) (33) The Gauss-Seide method aso guarantees convergence for arbitrary initia data for diagonay dominant matrices Particuary, simiar to (4) we can derive a decay rate: j>i a ij ρ gs = max i a ii j<i a ij (34) We prove in the exercises (D +L) U ρ gs and hence deduce that ε ρ gs ε 0 Comparing (4) and (34) we see for the same diagonay dominant matrix A, ρ gs ρ jac ; hence the Gauss-Seide method in genera converges faster than the Jacobi method, at the cost of soving a trianguar system instead of a diagona one at each iteration Because soving the inear system L + D invoves forward substitution, the method described before is aso caed the forward Gauss-Seide method Simiary, we can choose M = D + U and estabishing simiar convergent resut for diagonay dominant matrices; and this method is caed the bacward Gauss-Seide method Finay, we show the convergence of the forward Gauss-Seide method for another type of very important matrices, namey the symmetric positive-definite ones This is a direct resut of the foowing theorem and Theorem 4

5 Theorem 3 Let A be symmetric positive-definite, then G = (L+D) L t satisfies ρ(g) < Proof Ceary D has a its diagona entries positive and it is non-singuar; thus we may write: G = [D (D LD +I)D ] L t = D ( L+I) Lt D, where L = D LD Let λ C be any eigenvaue of G, since: ( L+I) Lt = D GD, λ is aso an eigenvaue of G=( L+I) Lt Choose z C n as a unit eigenvector of G corresponding to λ, ie L t z = λ( L+I)z Define à = L+I + L t = D (L+D +L t )D = D AD, then à is aso symmetric positivedefinite Let us define α = z Lz and denote α = a + ib, a,b R; we aso denote z = x + iy where x,y R n Then we have: where we used the assumption z z = Next, we compute z Ãz: α = α = z Lt z = λz ( L+I)z = λ(+α), z Ãz = z ( L+I + L t )z = (+λ)z ( L+I)z = (+λ)(+α) = +α+α = +a However, by the positive definiteness of Ã, we have: Thus by λ = α/(+α) we have: z Ãz = (x t iy t )Ã(x+iy) = xt Ãx+y t Ãy > 0 +a > 0 λ = a ib +a+ib = a +b +a+a +b < The proof is competed by noting that ρ(g) = ρ( G) and the choice of λ is arbitrary 4 SOR Method The successive over-reaxation method (SOR) taes a inear combination of the Jacobi method and the Gauss-Seide method to provide more contro over the convergence rate Particuary, we choose M = M ω = ω D +L for some ω > 0 Letting ω = the method tens to the Jacobi method and setting ω = the method corresponds to the forward Gauss-Seide For the SOR with ω > 0, we have: ( ) ( ) ω G = G ω = ω D +L ω D +U It can be shown that if A is symmetric positive-definite and 0 < ω <, then the SOR method converges The proof is simiar to that of Theorem 3, and the detais are eft as an exercise 5

6 Note that due to a theorem of by Kahan [], ρ(g ω ) ω ; hence a necessary condition for the SOR method to converge is aso 0 < ω < A major purpose of the SOR method is that it aows peope to tune ω in order to minimize ρ(g ω ) for some specia matrices For exampe, if A is symmetric positive-definite and aso tridiagona, then ρ(g gs ) = ρ(g jac ) < and the optima choice for SOR is: ω = + ρ(g jac ) In this case, ρ(g ω ) = ω, which is optima by the Kahan theorem 5 Reated Topics: Acceeration and Preconditioners The acceeration technique tries to improve the convergence of an existing iterative method Suppose we obtained x, x,, x from the standard iterative method, then the pan is to compute a inear combination: y = ν i ()x i, (5) i=0 so that y represents a better approximation to the exact soution Note that a natura condition on the coefficients is i=0 ν i()=, so that if a iterates are exact, so is y If we define a poynomia: and extend its definition to matrices naturay, we have: p (x) = ν 0 ()+ν ()x+ +ν ()x (5) y x = p (G)ε 0, where x is the exact soution Hence the target is to minimize p (G) in a certain norm The Chebyshev semi-iterative method for symmetric matrices maes use of the fact that the eigenvaues of p (G) are p (λ), where λ is any eigenvaue of G Knowing that any eigenvaue of G ies between and, the method utiizes the Chebyshev poynomias c (x) defined recursivey by c 0 (x) =, c (x) = x, and c + (x) = xc (x) c (x), and define: λ min p (x) = c (µ) c ( + x λ min ), λ max λ min where µ = + λ max λ min, < λ min < λ max < are the smaest and argest eigenvaues of G, respectivey There are two benefits of using the Chebyshev poynomias First, c (x) satisfies c (x) on [,] and it grow rapidy off this interva; thus the foowing estimate expects to be sma: y x c (µ) ε 0 Secondy, the recursive reation in the Chebyshev poynomias enabes the foowing agorithm that competey removes the need to compute the iterates x but cacuate y directy: y + = ω + (y y +γz )+y, Mz = b Ay, 6

7 where γ = λ min λ max, ω + = λ min λ max λ max λ min c (µ) c + (µ) Another use of the iterative methods is to construct preconditioners A (eft) preconditioner P modifies the origina equation Ax = b to: P Ax = P b (53) In genera, the preconditioner depends highy on the probems to be soved, such as the ow-mach preconditioner for ow-speed aerodynamic probems From a pure inear agebra point of view, though, the iterative method provides a cass of preconditioners given by P = M In this case, we sti need to sove a non-trivia system with M A, but the hope is that M A wi be better conditioned than A itsef Corresponding to the previous methods, we have the foowing preconditioners: Exercises P jac = D, P gs = (L+D), P sor = (L+ω D) Exercise Use mathematica induction to show (6) in the case n = 3 Exercise Let A be diagonay dominant and we want to compete the proof that the Gauss- Seide method converges Particuary et G = (L+D) U, show that G ρ gs, which is given by (34) Hint: Use the definition of induced matrix norms, we just need to show that for a x =, there is y ρ gs, where y = Gx And for this purpose, use Dy = Ly Ux Exercise 3 Show that if A is symmetric, diagonay dominant, and a its diagona eements are positive, then A is positive definite Hint: Show that x t Ax 0 and derive the condition for the equaity to hod For this purpose, use the inequaity a ij x i y j ( a ij x i + ) a ji x j Exercise 4 Prove that if A is symmetric positive definite, then the SOR method with 0 < ω < converges Exercise 5 Let us consider the SOR method with ω > 0, show that: detg ω = ω n Then deduce that ρ(g ω ) ω, the Kahan theorem Hint: The determinant of a matrix A is the product of a the eigenvaues of A References [] Wiiam Morton Kahan Gauss-Seide methods of soving arge systems of inear equations PhD thesis, University of Toronto, 958 7

Algorithms to solve massively under-defined systems of multivariate quadratic equations

Algorithms to solve massively under-defined systems of multivariate quadratic equations Agorithms to sove massivey under-defined systems of mutivariate quadratic equations Yasufumi Hashimoto Abstract It is we known that the probem to sove a set of randomy chosen mutivariate quadratic equations

More information

CS229 Lecture notes. Andrew Ng

CS229 Lecture notes. Andrew Ng CS229 Lecture notes Andrew Ng Part IX The EM agorithm In the previous set of notes, we taked about the EM agorithm as appied to fitting a mixture of Gaussians. In this set of notes, we give a broader view

More information

18-660: Numerical Methods for Engineering Design and Optimization

18-660: Numerical Methods for Engineering Design and Optimization 8-660: Numerica Methods for Engineering esign and Optimization in i epartment of ECE Carnegie Meon University Pittsburgh, PA 523 Side Overview Conjugate Gradient Method (Part 4) Pre-conditioning Noninear

More information

Problem set 6 The Perron Frobenius theorem.

Problem set 6 The Perron Frobenius theorem. Probem set 6 The Perron Frobenius theorem. Math 22a4 Oct 2 204, Due Oct.28 In a future probem set I want to discuss some criteria which aow us to concude that that the ground state of a sef-adjoint operator

More information

4 Separation of Variables

4 Separation of Variables 4 Separation of Variabes In this chapter we describe a cassica technique for constructing forma soutions to inear boundary vaue probems. The soution of three cassica (paraboic, hyperboic and eiptic) PDE

More information

A Brief Introduction to Markov Chains and Hidden Markov Models

A Brief Introduction to Markov Chains and Hidden Markov Models A Brief Introduction to Markov Chains and Hidden Markov Modes Aen B MacKenzie Notes for December 1, 3, &8, 2015 Discrete-Time Markov Chains You may reca that when we first introduced random processes,

More information

Week 6 Lectures, Math 6451, Tanveer

Week 6 Lectures, Math 6451, Tanveer Fourier Series Week 6 Lectures, Math 645, Tanveer In the context of separation of variabe to find soutions of PDEs, we encountered or and in other cases f(x = f(x = a 0 + f(x = a 0 + b n sin nπx { a n

More information

Math 124B January 31, 2012

Math 124B January 31, 2012 Math 124B January 31, 212 Viktor Grigoryan 7 Inhomogeneous boundary vaue probems Having studied the theory of Fourier series, with which we successfuy soved boundary vaue probems for the homogeneous heat

More information

Homework #04 Answers and Hints (MATH4052 Partial Differential Equations)

Homework #04 Answers and Hints (MATH4052 Partial Differential Equations) Homework #4 Answers and Hints (MATH452 Partia Differentia Equations) Probem 1 (Page 89, Q2) Consider a meta rod ( < x < ), insuated aong its sides but not at its ends, which is initiay at temperature =

More information

Higher dimensional PDEs and multidimensional eigenvalue problems

Higher dimensional PDEs and multidimensional eigenvalue problems Higher dimensiona PEs and mutidimensiona eigenvaue probems 1 Probems with three independent variabes Consider the prototypica equations u t = u (iffusion) u tt = u (W ave) u zz = u (Lapace) where u = u

More information

THE REACHABILITY CONES OF ESSENTIALLY NONNEGATIVE MATRICES

THE REACHABILITY CONES OF ESSENTIALLY NONNEGATIVE MATRICES THE REACHABILITY CONES OF ESSENTIALLY NONNEGATIVE MATRICES by Michae Neumann Department of Mathematics, University of Connecticut, Storrs, CT 06269 3009 and Ronad J. Stern Department of Mathematics, Concordia

More information

MATH 172: MOTIVATION FOR FOURIER SERIES: SEPARATION OF VARIABLES

MATH 172: MOTIVATION FOR FOURIER SERIES: SEPARATION OF VARIABLES MATH 172: MOTIVATION FOR FOURIER SERIES: SEPARATION OF VARIABLES Separation of variabes is a method to sove certain PDEs which have a warped product structure. First, on R n, a inear PDE of order m is

More information

C. Fourier Sine Series Overview

C. Fourier Sine Series Overview 12 PHILIP D. LOEWEN C. Fourier Sine Series Overview Let some constant > be given. The symboic form of the FSS Eigenvaue probem combines an ordinary differentia equation (ODE) on the interva (, ) with a

More information

XSAT of linear CNF formulas

XSAT of linear CNF formulas XSAT of inear CN formuas Bernd R. Schuh Dr. Bernd Schuh, D-50968 Kön, Germany; bernd.schuh@netcoogne.de eywords: compexity, XSAT, exact inear formua, -reguarity, -uniformity, NPcompeteness Abstract. Open

More information

BALANCING REGULAR MATRIX PENCILS

BALANCING REGULAR MATRIX PENCILS BALANCING REGULAR MATRIX PENCILS DAMIEN LEMONNIER AND PAUL VAN DOOREN Abstract. In this paper we present a new diagona baancing technique for reguar matrix pencis λb A, which aims at reducing the sensitivity

More information

Investigation on spectrum of the adjacency matrix and Laplacian matrix of graph G l

Investigation on spectrum of the adjacency matrix and Laplacian matrix of graph G l Investigation on spectrum of the adjacency matrix and Lapacian matrix of graph G SHUHUA YIN Computer Science and Information Technoogy Coege Zhejiang Wani University Ningbo 3500 PEOPLE S REPUBLIC OF CHINA

More information

ORTHOGONAL MULTI-WAVELETS FROM MATRIX FACTORIZATION

ORTHOGONAL MULTI-WAVELETS FROM MATRIX FACTORIZATION J. Korean Math. Soc. 46 2009, No. 2, pp. 281 294 ORHOGONAL MLI-WAVELES FROM MARIX FACORIZAION Hongying Xiao Abstract. Accuracy of the scaing function is very crucia in waveet theory, or correspondingy,

More information

MA 201: Partial Differential Equations Lecture - 10

MA 201: Partial Differential Equations Lecture - 10 MA 201: Partia Differentia Equations Lecture - 10 Separation of Variabes, One dimensiona Wave Equation Initia Boundary Vaue Probem (IBVP) Reca: A physica probem governed by a PDE may contain both boundary

More information

Appendix of the Paper The Role of No-Arbitrage on Forecasting: Lessons from a Parametric Term Structure Model

Appendix of the Paper The Role of No-Arbitrage on Forecasting: Lessons from a Parametric Term Structure Model Appendix of the Paper The Roe of No-Arbitrage on Forecasting: Lessons from a Parametric Term Structure Mode Caio Ameida cameida@fgv.br José Vicente jose.vaentim@bcb.gov.br June 008 1 Introduction In this

More information

VALIDATED CONTINUATION FOR EQUILIBRIA OF PDES

VALIDATED CONTINUATION FOR EQUILIBRIA OF PDES VALIDATED CONTINUATION FOR EQUILIBRIA OF PDES SARAH DAY, JEAN-PHILIPPE LESSARD, AND KONSTANTIN MISCHAIKOW Abstract. One of the most efficient methods for determining the equiibria of a continuous parameterized

More information

Mat 1501 lecture notes, penultimate installment

Mat 1501 lecture notes, penultimate installment Mat 1501 ecture notes, penutimate instament 1. bounded variation: functions of a singe variabe optiona) I beieve that we wi not actuay use the materia in this section the point is mainy to motivate the

More information

Coupling of LWR and phase transition models at boundary

Coupling of LWR and phase transition models at boundary Couping of LW and phase transition modes at boundary Mauro Garaveo Dipartimento di Matematica e Appicazioni, Università di Miano Bicocca, via. Cozzi 53, 20125 Miano Itay. Benedetto Piccoi Department of

More information

Lecture Notes 4: Fourier Series and PDE s

Lecture Notes 4: Fourier Series and PDE s Lecture Notes 4: Fourier Series and PDE s 1. Periodic Functions A function fx defined on R is caed a periodic function if there exists a number T > such that fx + T = fx, x R. 1.1 The smaest number T for

More information

Math 124B January 17, 2012

Math 124B January 17, 2012 Math 124B January 17, 212 Viktor Grigoryan 3 Fu Fourier series We saw in previous ectures how the Dirichet and Neumann boundary conditions ead to respectivey sine and cosine Fourier series of the initia

More information

1D Heat Propagation Problems

1D Heat Propagation Problems Chapter 1 1D Heat Propagation Probems If the ambient space of the heat conduction has ony one dimension, the Fourier equation reduces to the foowing for an homogeneous body cρ T t = T λ 2 + Q, 1.1) x2

More information

VALIDATED CONTINUATION FOR EQUILIBRIA OF PDES

VALIDATED CONTINUATION FOR EQUILIBRIA OF PDES SIAM J. NUMER. ANAL. Vo. 0, No. 0, pp. 000 000 c 200X Society for Industria and Appied Mathematics VALIDATED CONTINUATION FOR EQUILIBRIA OF PDES SARAH DAY, JEAN-PHILIPPE LESSARD, AND KONSTANTIN MISCHAIKOW

More information

The Symmetric and Antipersymmetric Solutions of the Matrix Equation A 1 X 1 B 1 + A 2 X 2 B A l X l B l = C and Its Optimal Approximation

The Symmetric and Antipersymmetric Solutions of the Matrix Equation A 1 X 1 B 1 + A 2 X 2 B A l X l B l = C and Its Optimal Approximation The Symmetric Antipersymmetric Soutions of the Matrix Equation A 1 X 1 B 1 + A 2 X 2 B 2 + + A X B C Its Optima Approximation Ying Zhang Member IAENG Abstract A matrix A (a ij) R n n is said to be symmetric

More information

Distributed average consensus: Beyond the realm of linearity

Distributed average consensus: Beyond the realm of linearity Distributed average consensus: Beyond the ream of inearity Usman A. Khan, Soummya Kar, and José M. F. Moura Department of Eectrica and Computer Engineering Carnegie Meon University 5 Forbes Ave, Pittsburgh,

More information

Bourgain s Theorem. Computational and Metric Geometry. Instructor: Yury Makarychev. d(s 1, s 2 ).

Bourgain s Theorem. Computational and Metric Geometry. Instructor: Yury Makarychev. d(s 1, s 2 ). Bourgain s Theorem Computationa and Metric Geometry Instructor: Yury Makarychev 1 Notation Given a metric space (X, d) and S X, the distance from x X to S equas d(x, S) = inf d(x, s). s S The distance

More information

Smoothers for ecient multigrid methods in IGA

Smoothers for ecient multigrid methods in IGA Smoothers for ecient mutigrid methods in IGA Cemens Hofreither, Stefan Takacs, Water Zuehner DD23, Juy 2015 supported by The work was funded by the Austrian Science Fund (FWF): NFN S117 (rst and third

More information

17 Lecture 17: Recombination and Dark Matter Production

17 Lecture 17: Recombination and Dark Matter Production PYS 652: Astrophysics 88 17 Lecture 17: Recombination and Dark Matter Production New ideas pass through three periods: It can t be done. It probaby can be done, but it s not worth doing. I knew it was

More information

Primal and dual active-set methods for convex quadratic programming

Primal and dual active-set methods for convex quadratic programming Math. Program., Ser. A 216) 159:469 58 DOI 1.17/s117-15-966-2 FULL LENGTH PAPER Prima and dua active-set methods for convex quadratic programming Anders Forsgren 1 Phiip E. Gi 2 Eizabeth Wong 2 Received:

More information

6 Wave Equation on an Interval: Separation of Variables

6 Wave Equation on an Interval: Separation of Variables 6 Wave Equation on an Interva: Separation of Variabes 6.1 Dirichet Boundary Conditions Ref: Strauss, Chapter 4 We now use the separation of variabes technique to study the wave equation on a finite interva.

More information

Introduction to Simulation - Lecture 13. Convergence of Multistep Methods. Jacob White. Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy

Introduction to Simulation - Lecture 13. Convergence of Multistep Methods. Jacob White. Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Introduction to Simuation - Lecture 13 Convergence of Mutistep Methods Jacob White Thans to Deepa Ramaswamy, Micha Rewiensi, and Karen Veroy Outine Sma Timestep issues for Mutistep Methods Loca truncation

More information

221B Lecture Notes Notes on Spherical Bessel Functions

221B Lecture Notes Notes on Spherical Bessel Functions Definitions B Lecture Notes Notes on Spherica Besse Functions We woud ike to sove the free Schrödinger equation [ h d r R(r) = h k R(r). () m r dr r m R(r) is the radia wave function ψ( x) = R(r)Y m (θ,

More information

NOISE-INDUCED STABILIZATION OF STOCHASTIC DIFFERENTIAL EQUATIONS

NOISE-INDUCED STABILIZATION OF STOCHASTIC DIFFERENTIAL EQUATIONS NOISE-INDUCED STABILIZATION OF STOCHASTIC DIFFERENTIAL EQUATIONS TONY ALLEN, EMILY GEBHARDT, AND ADAM KLUBALL 3 ADVISOR: DR. TIFFANY KOLBA 4 Abstract. The phenomenon of noise-induced stabiization occurs

More information

FRST Multivariate Statistics. Multivariate Discriminant Analysis (MDA)

FRST Multivariate Statistics. Multivariate Discriminant Analysis (MDA) 1 FRST 531 -- Mutivariate Statistics Mutivariate Discriminant Anaysis (MDA) Purpose: 1. To predict which group (Y) an observation beongs to based on the characteristics of p predictor (X) variabes, using

More information

Integrating Factor Methods as Exponential Integrators

Integrating Factor Methods as Exponential Integrators Integrating Factor Methods as Exponentia Integrators Borisav V. Minchev Department of Mathematica Science, NTNU, 7491 Trondheim, Norway Borko.Minchev@ii.uib.no Abstract. Recenty a ot of effort has been

More information

Lecture Notes for Math 251: ODE and PDE. Lecture 34: 10.7 Wave Equation and Vibrations of an Elastic String

Lecture Notes for Math 251: ODE and PDE. Lecture 34: 10.7 Wave Equation and Vibrations of an Elastic String ecture Notes for Math 251: ODE and PDE. ecture 3: 1.7 Wave Equation and Vibrations of an Eastic String Shawn D. Ryan Spring 212 ast Time: We studied other Heat Equation probems with various other boundary

More information

Scott Cohen. November 10, Abstract. The method of Block Cyclic Reduction (BCR) is described in the context of

Scott Cohen. November 10, Abstract. The method of Block Cyclic Reduction (BCR) is described in the context of ycic Reduction Scott ohen November, 99 bstract The method of ock ycic Reduction (R) is described in the context of soving Poisson's equation with Dirichet boundary conditions The numerica instabiityof

More information

SUPPLEMENTARY MATERIAL TO INNOVATED SCALABLE EFFICIENT ESTIMATION IN ULTRA-LARGE GAUSSIAN GRAPHICAL MODELS

SUPPLEMENTARY MATERIAL TO INNOVATED SCALABLE EFFICIENT ESTIMATION IN ULTRA-LARGE GAUSSIAN GRAPHICAL MODELS ISEE 1 SUPPLEMENTARY MATERIAL TO INNOVATED SCALABLE EFFICIENT ESTIMATION IN ULTRA-LARGE GAUSSIAN GRAPHICAL MODELS By Yingying Fan and Jinchi Lv University of Southern Caifornia This Suppementary Materia

More information

Global Optimality Principles for Polynomial Optimization Problems over Box or Bivalent Constraints by Separable Polynomial Approximations

Global Optimality Principles for Polynomial Optimization Problems over Box or Bivalent Constraints by Separable Polynomial Approximations Goba Optimaity Principes for Poynomia Optimization Probems over Box or Bivaent Constraints by Separabe Poynomia Approximations V. Jeyakumar, G. Li and S. Srisatkunarajah Revised Version II: December 23,

More information

Convergence Property of the Iri-Imai Algorithm for Some Smooth Convex Programming Problems

Convergence Property of the Iri-Imai Algorithm for Some Smooth Convex Programming Problems Convergence Property of the Iri-Imai Agorithm for Some Smooth Convex Programming Probems S. Zhang Communicated by Z.Q. Luo Assistant Professor, Department of Econometrics, University of Groningen, Groningen,

More information

arxiv: v1 [math.co] 17 Dec 2018

arxiv: v1 [math.co] 17 Dec 2018 On the Extrema Maximum Agreement Subtree Probem arxiv:1812.06951v1 [math.o] 17 Dec 2018 Aexey Markin Department of omputer Science, Iowa State University, USA amarkin@iastate.edu Abstract Given two phyogenetic

More information

Some Measures for Asymmetry of Distributions

Some Measures for Asymmetry of Distributions Some Measures for Asymmetry of Distributions Georgi N. Boshnakov First version: 31 January 2006 Research Report No. 5, 2006, Probabiity and Statistics Group Schoo of Mathematics, The University of Manchester

More information

Introduction to Simulation - Lecture 14. Multistep Methods II. Jacob White. Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy

Introduction to Simulation - Lecture 14. Multistep Methods II. Jacob White. Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Introduction to Simuation - Lecture 14 Mutistep Methods II Jacob White Thans to Deepa Ramaswamy, Micha Rewiensi, and Karen Veroy Outine Sma Timestep issues for Mutistep Methods Reminder about LTE minimization

More information

Reliability: Theory & Applications No.3, September 2006

Reliability: Theory & Applications No.3, September 2006 REDUNDANCY AND RENEWAL OF SERVERS IN OPENED QUEUING NETWORKS G. Sh. Tsitsiashvii M.A. Osipova Vadivosto, Russia 1 An opened queuing networ with a redundancy and a renewa of servers is considered. To cacuate

More information

Uniprocessor Feasibility of Sporadic Tasks with Constrained Deadlines is Strongly conp-complete

Uniprocessor Feasibility of Sporadic Tasks with Constrained Deadlines is Strongly conp-complete Uniprocessor Feasibiity of Sporadic Tasks with Constrained Deadines is Strongy conp-compete Pontus Ekberg and Wang Yi Uppsaa University, Sweden Emai: {pontus.ekberg yi}@it.uu.se Abstract Deciding the feasibiity

More information

Haar Decomposition and Reconstruction Algorithms

Haar Decomposition and Reconstruction Algorithms Jim Lambers MAT 773 Fa Semester 018-19 Lecture 15 and 16 Notes These notes correspond to Sections 4.3 and 4.4 in the text. Haar Decomposition and Reconstruction Agorithms Decomposition Suppose we approximate

More information

Methods for Ordinary Differential Equations. Jacob White

Methods for Ordinary Differential Equations. Jacob White Introduction to Simuation - Lecture 12 for Ordinary Differentia Equations Jacob White Thanks to Deepak Ramaswamy, Jaime Peraire, Micha Rewienski, and Karen Veroy Outine Initia Vaue probem exampes Signa

More information

A NOTE ON QUASI-STATIONARY DISTRIBUTIONS OF BIRTH-DEATH PROCESSES AND THE SIS LOGISTIC EPIDEMIC

A NOTE ON QUASI-STATIONARY DISTRIBUTIONS OF BIRTH-DEATH PROCESSES AND THE SIS LOGISTIC EPIDEMIC (January 8, 2003) A NOTE ON QUASI-STATIONARY DISTRIBUTIONS OF BIRTH-DEATH PROCESSES AND THE SIS LOGISTIC EPIDEMIC DAMIAN CLANCY, University of Liverpoo PHILIP K. POLLETT, University of Queensand Abstract

More information

Wave Equation Dirichlet Boundary Conditions

Wave Equation Dirichlet Boundary Conditions Wave Equation Dirichet Boundary Conditions u tt x, t = c u xx x, t, < x 1 u, t =, u, t = ux, = fx u t x, = gx Look for simpe soutions in the form ux, t = XxT t Substituting into 13 and dividing

More information

CONGRUENCES. 1. History

CONGRUENCES. 1. History CONGRUENCES HAO BILLY LEE Abstract. These are notes I created for a seminar tak, foowing the papers of On the -adic Representations and Congruences for Coefficients of Moduar Forms by Swinnerton-Dyer and

More information

Math 220B - Summer 2003 Homework 1 Solutions

Math 220B - Summer 2003 Homework 1 Solutions Math 0B - Summer 003 Homework Soutions Consider the eigenvaue probem { X = λx 0 < x < X satisfies symmetric BCs x = 0, Suppose f(x)f (x) x=b x=a 0 for a rea-vaued functions f(x) which satisfy the boundary

More information

Completion. is dense in H. If V is complete, then U(V) = H.

Completion. is dense in H. If V is complete, then U(V) = H. Competion Theorem 1 (Competion) If ( V V ) is any inner product space then there exists a Hibert space ( H H ) and a map U : V H such that (i) U is 1 1 (ii) U is inear (iii) UxUy H xy V for a xy V (iv)

More information

4 1-D Boundary Value Problems Heat Equation

4 1-D Boundary Value Problems Heat Equation 4 -D Boundary Vaue Probems Heat Equation The main purpose of this chapter is to study boundary vaue probems for the heat equation on a finite rod a x b. u t (x, t = ku xx (x, t, a < x < b, t > u(x, = ϕ(x

More information

An explicit Jordan Decomposition of Companion matrices

An explicit Jordan Decomposition of Companion matrices An expicit Jordan Decomposition of Companion matrices Fermín S V Bazán Departamento de Matemática CFM UFSC 88040-900 Forianópois SC E-mai: fermin@mtmufscbr S Gratton CERFACS 42 Av Gaspard Coriois 31057

More information

David Eigen. MA112 Final Paper. May 10, 2002

David Eigen. MA112 Final Paper. May 10, 2002 David Eigen MA112 Fina Paper May 1, 22 The Schrodinger equation describes the position of an eectron as a wave. The wave function Ψ(t, x is interpreted as a probabiity density for the position of the eectron.

More information

STABILITY OF A PARAMETRICALLY EXCITED DAMPED INVERTED PENDULUM 1. INTRODUCTION

STABILITY OF A PARAMETRICALLY EXCITED DAMPED INVERTED PENDULUM 1. INTRODUCTION Journa of Sound and Vibration (996) 98(5), 643 65 STABILITY OF A PARAMETRICALLY EXCITED DAMPED INVERTED PENDULUM G. ERDOS AND T. SINGH Department of Mechanica and Aerospace Engineering, SUNY at Buffao,

More information

CHAPTER 2 AN INTRODUCTION TO WAVELET ANALYSIS

CHAPTER 2 AN INTRODUCTION TO WAVELET ANALYSIS CHAPTER 2 AN INTRODUCTION TO WAVELET ANALYSIS [This chapter is based on the ectures of Professor D.V. Pai, Department of Mathematics, Indian Institute of Technoogy Bombay, Powai, Mumbai - 400 076, India.]

More information

Course 2BA1, Section 11: Periodic Functions and Fourier Series

Course 2BA1, Section 11: Periodic Functions and Fourier Series Course BA, 8 9 Section : Periodic Functions and Fourier Series David R. Wikins Copyright c David R. Wikins 9 Contents Periodic Functions and Fourier Series 74. Fourier Series of Even and Odd Functions...........

More information

SEMINAR 2. PENDULUMS. V = mgl cos θ. (2) L = T V = 1 2 ml2 θ2 + mgl cos θ, (3) d dt ml2 θ2 + mgl sin θ = 0, (4) θ + g l

SEMINAR 2. PENDULUMS. V = mgl cos θ. (2) L = T V = 1 2 ml2 θ2 + mgl cos θ, (3) d dt ml2 θ2 + mgl sin θ = 0, (4) θ + g l Probem 7. Simpe Penduum SEMINAR. PENDULUMS A simpe penduum means a mass m suspended by a string weightess rigid rod of ength so that it can swing in a pane. The y-axis is directed down, x-axis is directed

More information

More Scattering: the Partial Wave Expansion

More Scattering: the Partial Wave Expansion More Scattering: the Partia Wave Expansion Michae Fower /7/8 Pane Waves and Partia Waves We are considering the soution to Schrödinger s equation for scattering of an incoming pane wave in the z-direction

More information

Maximizing Sum Rate and Minimizing MSE on Multiuser Downlink: Optimality, Fast Algorithms and Equivalence via Max-min SIR

Maximizing Sum Rate and Minimizing MSE on Multiuser Downlink: Optimality, Fast Algorithms and Equivalence via Max-min SIR 1 Maximizing Sum Rate and Minimizing MSE on Mutiuser Downink: Optimaity, Fast Agorithms and Equivaence via Max-min SIR Chee Wei Tan 1,2, Mung Chiang 2 and R. Srikant 3 1 Caifornia Institute of Technoogy,

More information

Tracking Control of Multiple Mobile Robots

Tracking Control of Multiple Mobile Robots Proceedings of the 2001 IEEE Internationa Conference on Robotics & Automation Seou, Korea May 21-26, 2001 Tracking Contro of Mutipe Mobie Robots A Case Study of Inter-Robot Coision-Free Probem Jurachart

More information

ASummaryofGaussianProcesses Coryn A.L. Bailer-Jones

ASummaryofGaussianProcesses Coryn A.L. Bailer-Jones ASummaryofGaussianProcesses Coryn A.L. Baier-Jones Cavendish Laboratory University of Cambridge caj@mrao.cam.ac.uk Introduction A genera prediction probem can be posed as foows. We consider that the variabe

More information

Research Article The Diagonally Dominant Degree and Disc Separation for the Schur Complement of Ostrowski Matrix

Research Article The Diagonally Dominant Degree and Disc Separation for the Schur Complement of Ostrowski Matrix Hindawi Pubishing Corporation Journa of Appied Mathematics Voume 2013, Artice ID 973152, 10 pages http://dxdoiorg/101155/2013/973152 Research Artice The Diagonay Dominant Degree and Disc Separation for

More information

LECTURE NOTES 9 TRACELESS SYMMETRIC TENSOR APPROACH TO LEGENDRE POLYNOMIALS AND SPHERICAL HARMONICS

LECTURE NOTES 9 TRACELESS SYMMETRIC TENSOR APPROACH TO LEGENDRE POLYNOMIALS AND SPHERICAL HARMONICS MASSACHUSETTS INSTITUTE OF TECHNOLOGY Physics Department Physics 8.07: Eectromagnetism II October 7, 202 Prof. Aan Guth LECTURE NOTES 9 TRACELESS SYMMETRIC TENSOR APPROACH TO LEGENDRE POLYNOMIALS AND SPHERICAL

More information

14 Separation of Variables Method

14 Separation of Variables Method 14 Separation of Variabes Method Consider, for exampe, the Dirichet probem u t = Du xx < x u(x, ) = f(x) < x < u(, t) = = u(, t) t > Let u(x, t) = T (t)φ(x); now substitute into the equation: dt

More information

Stochastic Variational Inference with Gradient Linearization

Stochastic Variational Inference with Gradient Linearization Stochastic Variationa Inference with Gradient Linearization Suppementa Materia Tobias Pötz * Anne S Wannenwetsch Stefan Roth Department of Computer Science, TU Darmstadt Preface In this suppementa materia,

More information

u(x) s.t. px w x 0 Denote the solution to this problem by ˆx(p, x). In order to obtain ˆx we may simply solve the standard problem max x 0

u(x) s.t. px w x 0 Denote the solution to this problem by ˆx(p, x). In order to obtain ˆx we may simply solve the standard problem max x 0 Bocconi University PhD in Economics - Microeconomics I Prof M Messner Probem Set 4 - Soution Probem : If an individua has an endowment instead of a monetary income his weath depends on price eves In particuar,

More information

Partial permutation decoding for MacDonald codes

Partial permutation decoding for MacDonald codes Partia permutation decoding for MacDonad codes J.D. Key Department of Mathematics and Appied Mathematics University of the Western Cape 7535 Bevie, South Africa P. Seneviratne Department of Mathematics

More information

This article appeared in a journal published by Elsevier. The attached copy is furnished to the author for internal non-commercial research and

This article appeared in a journal published by Elsevier. The attached copy is furnished to the author for internal non-commercial research and This artice appeared in a journa pubished by Esevier. The attached copy is furnished to the author for interna non-commercia research and education use, incuding for instruction at the authors institution

More information

Absolute Value Preconditioning for Symmetric Indefinite Linear Systems

Absolute Value Preconditioning for Symmetric Indefinite Linear Systems MITSUBISHI ELECTRIC RESEARCH LABORATORIES http://www.mer.com Absoute Vaue Preconditioning for Symmetric Indefinite Linear Systems Vecharynski, E.; Knyazev, A.V. TR2013-016 March 2013 Abstract We introduce

More information

Multigrid Lecture Notes

Multigrid Lecture Notes Mutigrid Lecture Notes Wenqiang Feng, Steven Wise Abstract Mutigrid MG methods in numerica anaysis are a group of agorithms for soving differentia equations using a hierarchy of discretizations MG method

More information

Assignment 7 Due Tuessday, March 29, 2016

Assignment 7 Due Tuessday, March 29, 2016 Math 45 / AMCS 55 Dr. DeTurck Assignment 7 Due Tuessday, March 9, 6 Topics for this week Convergence of Fourier series; Lapace s equation and harmonic functions: basic properties, compuations on rectanges

More information

Formulas for Angular-Momentum Barrier Factors Version II

Formulas for Angular-Momentum Barrier Factors Version II BNL PREPRINT BNL-QGS-06-101 brfactor1.tex Formuas for Anguar-Momentum Barrier Factors Version II S. U. Chung Physics Department, Brookhaven Nationa Laboratory, Upton, NY 11973 March 19, 2015 abstract A

More information

Research Article Numerical Range of Two Operators in Semi-Inner Product Spaces

Research Article Numerical Range of Two Operators in Semi-Inner Product Spaces Abstract and Appied Anaysis Voume 01, Artice ID 846396, 13 pages doi:10.1155/01/846396 Research Artice Numerica Range of Two Operators in Semi-Inner Product Spaces N. K. Sahu, 1 C. Nahak, 1 and S. Nanda

More information

$, (2.1) n="# #. (2.2)

$, (2.1) n=# #. (2.2) Chapter. Eectrostatic II Notes: Most of the materia presented in this chapter is taken from Jackson, Chap.,, and 4, and Di Bartoo, Chap... Mathematica Considerations.. The Fourier series and the Fourier

More information

Separation of Variables and a Spherical Shell with Surface Charge

Separation of Variables and a Spherical Shell with Surface Charge Separation of Variabes and a Spherica She with Surface Charge In cass we worked out the eectrostatic potentia due to a spherica she of radius R with a surface charge density σθ = σ cos θ. This cacuation

More information

Homogeneity properties of subadditive functions

Homogeneity properties of subadditive functions Annaes Mathematicae et Informaticae 32 2005 pp. 89 20. Homogeneity properties of subadditive functions Pá Burai and Árpád Száz Institute of Mathematics, University of Debrecen e-mai: buraip@math.kte.hu

More information

Indirect Optimal Control of Dynamical Systems

Indirect Optimal Control of Dynamical Systems Computationa Mathematics and Mathematica Physics, Vo. 44, No. 3, 24, pp. 48 439. Transated from Zhurna Vychisite noi Matematiki i Matematicheskoi Fiziki, Vo. 44, No. 3, 24, pp. 444 466. Origina Russian

More information

Unconditional security of differential phase shift quantum key distribution

Unconditional security of differential phase shift quantum key distribution Unconditiona security of differentia phase shift quantum key distribution Kai Wen, Yoshihisa Yamamoto Ginzton Lab and Dept of Eectrica Engineering Stanford University Basic idea of DPS-QKD Protoco. Aice

More information

LECTURE NOTES 8 THE TRACELESS SYMMETRIC TENSOR EXPANSION AND STANDARD SPHERICAL HARMONICS

LECTURE NOTES 8 THE TRACELESS SYMMETRIC TENSOR EXPANSION AND STANDARD SPHERICAL HARMONICS MASSACHUSETTS INSTITUTE OF TECHNOLOGY Physics Department Physics 8.07: Eectromagnetism II October, 202 Prof. Aan Guth LECTURE NOTES 8 THE TRACELESS SYMMETRIC TENSOR EXPANSION AND STANDARD SPHERICAL HARMONICS

More information

Semidefinite relaxation and Branch-and-Bound Algorithm for LPECs

Semidefinite relaxation and Branch-and-Bound Algorithm for LPECs Semidefinite reaxation and Branch-and-Bound Agorithm for LPECs Marcia H. C. Fampa Universidade Federa do Rio de Janeiro Instituto de Matemática e COPPE. Caixa Posta 68530 Rio de Janeiro RJ 21941-590 Brasi

More information

Asynchronous Control for Coupled Markov Decision Systems

Asynchronous Control for Coupled Markov Decision Systems INFORMATION THEORY WORKSHOP (ITW) 22 Asynchronous Contro for Couped Marov Decision Systems Michae J. Neey University of Southern Caifornia Abstract This paper considers optima contro for a coection of

More information

Gauss Law. 2. Gauss s Law: connects charge and field 3. Applications of Gauss s Law

Gauss Law. 2. Gauss s Law: connects charge and field 3. Applications of Gauss s Law Gauss Law 1. Review on 1) Couomb s Law (charge and force) 2) Eectric Fied (fied and force) 2. Gauss s Law: connects charge and fied 3. Appications of Gauss s Law Couomb s Law and Eectric Fied Couomb s

More information

The Group Structure on a Smooth Tropical Cubic

The Group Structure on a Smooth Tropical Cubic The Group Structure on a Smooth Tropica Cubic Ethan Lake Apri 20, 2015 Abstract Just as in in cassica agebraic geometry, it is possibe to define a group aw on a smooth tropica cubic curve. In this note,

More information

CONJUGATE GRADIENT WITH SUBSPACE OPTIMIZATION

CONJUGATE GRADIENT WITH SUBSPACE OPTIMIZATION CONJUGATE GRADIENT WITH SUBSPACE OPTIMIZATION SAHAR KARIMI AND STEPHEN VAVASIS Abstract. In this paper we present a variant of the conjugate gradient (CG) agorithm in which we invoke a subspace minimization

More information

Pattern Frequency Sequences and Internal Zeros

Pattern Frequency Sequences and Internal Zeros Advances in Appied Mathematics 28, 395 420 (2002 doi:10.1006/aama.2001.0789, avaiabe onine at http://www.ideaibrary.com on Pattern Frequency Sequences and Interna Zeros Mikós Bóna Department of Mathematics,

More information

arxiv: v1 [math.ap] 8 Nov 2014

arxiv: v1 [math.ap] 8 Nov 2014 arxiv:1411.116v1 [math.ap] 8 Nov 014 ALL INVARIANT REGIONS AND GLOBAL SOLUTIONS FOR m-component REACTION-DIFFUSION SYSTEMS WITH A TRIDIAGONAL SYMMETRIC TOEPLITZ MATRIX OF DIFFUSION COEFFICIENTS SALEM ABDELMALEK

More information

Model Solutions (week 4)

Model Solutions (week 4) CIV-E16 (17) Engineering Computation and Simuation 1 Home Exercise 6.3 Mode Soutions (week 4) Construct the inear Lagrange basis functions (noda vaues as degrees of freedom) of the ine segment reference

More information

General Decay of Solutions in a Viscoelastic Equation with Nonlinear Localized Damping

General Decay of Solutions in a Viscoelastic Equation with Nonlinear Localized Damping Journa of Mathematica Research with Appications Jan.,, Vo. 3, No., pp. 53 6 DOI:.377/j.issn:95-65...7 Http://jmre.dut.edu.cn Genera Decay of Soutions in a Viscoeastic Equation with Noninear Locaized Damping

More information

Sample Problems for Third Midterm March 18, 2013

Sample Problems for Third Midterm March 18, 2013 Mat 30. Treibergs Sampe Probems for Tird Midterm Name: Marc 8, 03 Questions 4 appeared in my Fa 000 and Fa 00 Mat 30 exams (.)Let f : R n R n be differentiabe at a R n. (a.) Let g : R n R be defined by

More information

Power Control and Transmission Scheduling for Network Utility Maximization in Wireless Networks

Power Control and Transmission Scheduling for Network Utility Maximization in Wireless Networks ower Contro and Transmission Scheduing for Network Utiity Maximization in Wireess Networks Min Cao, Vivek Raghunathan, Stephen Hany, Vinod Sharma and. R. Kumar Abstract We consider a joint power contro

More information

Fitting affine and orthogonal transformations between two sets of points

Fitting affine and orthogonal transformations between two sets of points Mathematica Communications 9(2004), 27-34 27 Fitting affine and orthogona transformations between two sets of points Hemuth Späth Abstract. Let two point sets P and Q be given in R n. We determine a transation

More information

SVM: Terminology 1(6) SVM: Terminology 2(6)

SVM: Terminology 1(6) SVM: Terminology 2(6) Andrew Kusiak Inteigent Systems Laboratory 39 Seamans Center he University of Iowa Iowa City, IA 54-57 SVM he maxima margin cassifier is simiar to the perceptron: It aso assumes that the data points are

More information

Linear Stable Sampling Rate: Optimality of 2D Wavelet Reconstructions from Fourier Measurements

Linear Stable Sampling Rate: Optimality of 2D Wavelet Reconstructions from Fourier Measurements Linear Stabe Samping Rate: Optimaity of D Waveet Reconstructions from Fourier easurements Ben Adcock, Anders C. Hansen, Gitta utyniok, and Jackie a arch, 0 Abstract In this paper we anayze two-dimensiona

More information

BASIC NOTIONS AND RESULTS IN TOPOLOGY. 1. Metric spaces. Sets with finite diameter are called bounded sets. For x X and r > 0 the set

BASIC NOTIONS AND RESULTS IN TOPOLOGY. 1. Metric spaces. Sets with finite diameter are called bounded sets. For x X and r > 0 the set BASIC NOTIONS AND RESULTS IN TOPOLOGY 1. Metric spaces A metric on a set X is a map d : X X R + with the properties: d(x, y) 0 and d(x, y) = 0 x = y, d(x, y) = d(y, x), d(x, y) d(x, z) + d(z, y), for a

More information

Discrete Techniques. Chapter Introduction

Discrete Techniques. Chapter Introduction Chapter 3 Discrete Techniques 3. Introduction In the previous two chapters we introduced Fourier transforms of continuous functions of the periodic and non-periodic (finite energy) type, we as various

More information