Practical Course Scientific Computing and Visualization

Size: px
Start display at page:

Download "Practical Course Scientific Computing and Visualization"

Transcription

1 May 3, 24 Page 1 of 18

2 1 gridpoints for pressure p: j i p, p 1, p 2, p 3, p 4, p,1 p 1,1 p 2,1 p 3,1 p 4,1 p,2 p 1,2 p 2,2 p 3,2 p 4,2 p,3 p 1,3 p 2,3 p 3,3 p 4,3 p,4 p 1,4 p 2,4 p 3,4 p 4,4 Page 2 of 18

3 2 j Definitions: A = 1 δy, B = 1 δy, C = 1 δx, D = 1 δx, E = 1 δy 2, F = 1 δx 2, G = 2 δx 2 2 δy 2 discrete Poisson equation for p (n+1) (red points): p i+1,j 2p i 1,j + p i 1,j δx 2 equation (i, j): i + p i,j+1 2p i,j + p i,j 1 δy 2 = RHS i,j E p i,j 1 + F p i 1,j + G p i,j + F p i+1,j + E p i,j+1 = RHS i,j Page 3 of 18

4 j Definitions: A = 1 δy, B = 1 δy, C = 1 δx, D = 1 δx, E = 1 δy 2, F = 1 δx 2, G = 2 δx 2 2 δy 2 boundary conditions (blue points): p 1,j p,j =, δx p i,1 p i, =, δy i p imax+1,j p imax,j = δx for all j = 1,, jmax, p i,jmax+1 p i,jmax = δy for all i = 1,, imax equation (, j): C p,j + D p 1,j =, equation (imax + 1, j): D p imax,j + Cp imax+1,j =, equation (i, ): A p i, + B p i,1 =, equation (i, jmax + 1): B p i,jmax + A p i,jmax+1 = Page 4 of 18

5 j Definitions: A = 1 δy, B = 1 δy, C = 1 δx, D = 1 δx, E = 1 δy 2, F = 1 δx 2, G = 2 δx 2 2 δy 2 unused corner points (green points): equation (, ): p, =, equation (imax + 1, ): p imax+1, =, equation (, jmax + 1): p,jmax+1 =, equation (imax + 1, jmax + 1): p imax+1,jmax+1 = i (as the values of these points are never used, you can replace by any other value) Page 5 of 18

6 3 Resulting System of Linear j A = 1 δy, B = 1 δy, C = 1 δx, D = 1 δx, 1 δy 2, F = E = G = 2 δx 2 2 δy 2 i 1 p, A B p 1, A B p 2, A B p 3, 1 p 4, C D p,1 p 1,1 RHS 1,1 p 2,1 RHS 2,1 p 3,1 RHS 3,1 D C p 4,1 C D p,2 p 1,2 RHS 1,2 p 2,2 = RHS 2,2 p 3,2 RHS 3,2 D C p 4,2 C D p,3 p 1,3 RHS 1,3 p 2,3 RHS 2,3 p 3,3 RHS 3,3 D C p 4,3 1 p,4 B A p 1,4 B A p 2,4 B A p 3,4 1 p 4,4 1 δx 2 Page 6 of 18

7 4 Reduced System of Linear Values to be computed: pressure at red points, thus reduce SLE 1) neglect p,, p imax+1,, p,jmax+1, and p imax+1,jmax+1 (never needed) 2) seperate boundary conditions from the rest of the SLE: p 1, p 1,1 p 2, p 2,1 p 3, p 3,1 p,1 p 1,1 p 4,1 p 3,1 p,2 = p 1,2, p 4,2 p 3,2 p,3 p 1,3 p 1,4 p 3,3 p 2,4 p 1,3 p 3,4 p 3,3 Page 7 of 18

8 3) remaining SLE for inner grid points: p 1, p 2, p 3, p,1 p 1,1 p 2,1 p 3,1 p 4,1 p,2 p 1,2 p 2,2 p 3,2 p 4,2 p,3 p 1,3 p 2,3 p 3,3 p 4,3 p 1,4 p 2,4 p 3,4 RHS 1,1 RHS 2,1 RHS 3,1 RHS 1,2 = RHS 2,2 RHS 3,2 RHS 1,3 RHS 2,3 RHS 3,3 Page 8 of 18

9 5 1) set boundary values (blue points) 2) solve the (quadratic) system of linear equations (for the pressure values at red points): G F E p 1,1 RHS 1,1 Ep 1, F p,1 F G F E p 2,1 RHS 2,1 Ep 2, F G E p 3,1 RHS 3,1 Ep 3, F p 4,1 E G F E p 1,2 RHS 1,2 F p,2 p 2,2 = RHS 2,2 E F G E p 3,2 RHS 3,2 F p 4,2 E G F p 1,3 RHS 1,3 F p,3 Ep 1,4 E F G F p 2,3 RHS 2,3 Ep 2,4 E F G p 3,3 RHS 3,3 F p 4,3 Ep 3,4 Remark: values at boundary (blue) points are transported to the right hand side as their are no longer unknown after step 1)!!! Use an iterative solver! Page 9 of 18

10 6 General Treatment of SLEs starting point: A x = b decomposition of A: A = B + D (B + D) x = b D x = b B x iteration: D x i+1 = b B x i or D x i+1 = D x i + b A x i Page 1 of 18

11 7 a 1,1 x i+1 = x i + D 1 ( b A x i ) with D := a n,n a 1,1 a 1,1 a n,n a n,n x i+1 1 x i+1 n x i 1 x i n ( x i+1 ir = x i ir + 1 b ir a ir,ir = + b 1 b n ) n a ir,ic x i ir ic=1 a 1,1 a 1,n a n,1 a n,n x i 1 x i n Page 11 of 18

12 (): for(it=;it<=itmax;it++){ for(ir=1;ir<=n;ir++){ sum=; for(ic=1;ic<=n;ic++) sum = sum + a ir,ic u ic ; v ir = u ir + (b ir sum)/a ir,ir ; } for(ir=1;ir<=n;ir++) u ir = v ir ; } Page 12 of 18

13 8 a 1,1 x i+1 = x i + D 1 ( b A x i ) with D :=, a n,1 a n,n a 1,1 a n,1 a n,n a 1,1 x i+1 1 x i+1 n x i 1 a n,1 a n,n x i n ( x i+1 ir = x i ir + 1 b ir a ir,ir = + ir is=1 b 1 b n a ir,is x i+1 is a 1,1 a 1,n a n,1 a n,n ) n a ir,is x i is is=ir+1 x i 1 x i n Page 13 of 18

14 (): for(it=;it<=itmax;it++) for(ir=1;ir<=n;ir++){ sum=; for(ic=1;ic<=n;ic++) sum = sum + a ir,ic u ic ; u ir = u ir + (b ir sum)/a ir,ir ; } no storage of an intermediate result necessary!!!!! Page 14 of 18

15 9 ion) ( x i+1 ir = x i ir+ω 1 a ir,ir b ir ir is=1 a ir,isx i+1 is ) n is=ir+1 a ir,isx i is (ω [1; 2]) : for(it=;it<=itmax;it++) for(ir=1;ir<=n;ir++){ sum=; for(ic=1;ic<=n;ic++) sum = sum + a ir,ic u ic ; u ir = u ir + ω(b ir sum)/a ir,ir ; } Page 15 of 18

16 1 Remarks: G F E p 1,1 RHS 1,1 Ep 1, F p,1 F G F E p 2,1 RHS 2,1 Ep 2, F G E p 3,1 RHS 3,1 Ep 3, F p 4,1 E G F E p 1,2 RHS 1,2 F p,2 p 2,2 = RHS 2,2 E F G E p 3,2 RHS 3,2 F p 4,2 E G F p 1,3 RHS 1,3 F p,3 Ep 1,4 E F G F p 2,3 RHS 2,3 Ep 2,4 E F G p 3,3 RHS 3,3 F p 4,3 Ep 3,4 Only five entries per line of the discretization matrix matrix is not to be stored completely!!!! (else: storage cost O(n 2 )!!) Use discretization stencil instead : δy 2 δx 2 2(δx 2 + δy 2 ) δx 2 δy 2 The discretization stencil looks the same for all inner (red) points discretization stencil doesn t have to be stored for each grid point, but only once or can even be directly encoded (see the following algorithm) Page 16 of 18

17 11 SOR- for Our Code general algorithm our algorithm for(it=;it<=itmax;it++) for(ir=1;ir<=n;ir++){ } sum = ; for(ic=1;ic<=n;ic++) sum = sum+a ir,ic u ic ; u ir = u ir + ω a ir,ir (b ir sum); for(it=;it<=itmax;it++) for(i=1;i<=imax;i++) for(j=1;j<=jmax;j++){ sum = p i+1,j+p i 1,j } ( p i,j p i,j = p i,j ω δx 2 + p i,j+1 +p i,j 1 δy 2 2 δx ); 2 δx 2 δy 2 δy 2 (b i,j sum); Page 17 of 18

18 12 Termination Criterion Final it = ; res = 1; while(res>=eps && it < itmax){ res = ; it = it + 1; for(i=1;i<=imax;i++) for(j=1;j<=jmax;j++){ } r = b i,j p i+1,j + p i 1,j δx 2 p i,j = p i,j ω 2 2 r; δx 2 δy 2 res = res + r r; } res = res; p i,j+1 + p i,j 1 δy 2 + p i,j ( 2 δx + 2 ) ; 2 δy 2 Page 18 of 18

Fluid flow I: The potential function

Fluid flow I: The potential function 5//0 Miscellaneous Exercises Fluid Flow I Fluid flow I: The potential function One of the equations describing the flow of a fluid is the continuity equation: u 0 t where is the fluid density and u is

More information

Laplace's equation: the potential between parallel plates

Laplace's equation: the potential between parallel plates 4/3/01 Electrostatics Laplace Solver 1 Laplace's equation: the potential between parallel plates Laplace's equation describing the electric potential in two dimensions is: ( x, y) 0 At right is the potential

More information

COURSE Iterative methods for solving linear systems

COURSE Iterative methods for solving linear systems COURSE 0 4.3. Iterative methods for solving linear systems Because of round-off errors, direct methods become less efficient than iterative methods for large systems (>00 000 variables). An iterative scheme

More information

Iterative Methods for Solving A x = b

Iterative Methods for Solving A x = b Iterative Methods for Solving A x = b A good (free) online source for iterative methods for solving A x = b is given in the description of a set of iterative solvers called templates found at netlib: http

More information

Lecture # 3 Orthogonal Matrices and Matrix Norms. We repeat the definition an orthogonal set and orthornormal set.

Lecture # 3 Orthogonal Matrices and Matrix Norms. We repeat the definition an orthogonal set and orthornormal set. Lecture # 3 Orthogonal Matrices and Matrix Norms We repeat the definition an orthogonal set and orthornormal set. Definition A set of k vectors {u, u 2,..., u k }, where each u i R n, is said to be an

More information

Finite Difference Methods for Boundary Value Problems

Finite Difference Methods for Boundary Value Problems Finite Difference Methods for Boundary Value Problems October 2, 2013 () Finite Differences October 2, 2013 1 / 52 Goals Learn steps to approximate BVPs using the Finite Difference Method Start with two-point

More information

Fluid flow II: The stream function

Fluid flow II: The stream function 5//0 Miscellaneous Exercises Fluid Flow II Fluid flow II: The stream function This exercise is a continuation of the Fluid flow I exercise. Read that exercise an introduction. It is possible to obtain

More information

Finite Difference Methods (FDMs) 1

Finite Difference Methods (FDMs) 1 Finite Difference Methods (FDMs) 1 1 st - order Approxima9on Recall Taylor series expansion: Forward difference: Backward difference: Central difference: 2 nd - order Approxima9on Forward difference: Backward

More information

6. Iterative Methods for Linear Systems. The stepwise approach to the solution...

6. Iterative Methods for Linear Systems. The stepwise approach to the solution... 6 Iterative Methods for Linear Systems The stepwise approach to the solution Miriam Mehl: 6 Iterative Methods for Linear Systems The stepwise approach to the solution, January 18, 2013 1 61 Large Sparse

More information

Review: From problem to parallel algorithm

Review: From problem to parallel algorithm Review: From problem to parallel algorithm Mathematical formulations of interesting problems abound Poisson s equation Sources: Electrostatics, gravity, fluid flow, image processing (!) Numerical solution:

More information

CLASS NOTES Models, Algorithms and Data: Introduction to computing 2018

CLASS NOTES Models, Algorithms and Data: Introduction to computing 2018 CLASS NOTES Models, Algorithms and Data: Introduction to computing 2018 Petros Koumoutsakos, Jens Honore Walther (Last update: April 16, 2018) IMPORTANT DISCLAIMERS 1. REFERENCES: Much of the material

More information

Bindel, Fall 2016 Matrix Computations (CS 6210) Notes for

Bindel, Fall 2016 Matrix Computations (CS 6210) Notes for 1 Iteration basics Notes for 2016-11-07 An iterative solver for Ax = b is produces a sequence of approximations x (k) x. We always stop after finitely many steps, based on some convergence criterion, e.g.

More information

Lecture 18 Classical Iterative Methods

Lecture 18 Classical Iterative Methods Lecture 18 Classical Iterative Methods MIT 18.335J / 6.337J Introduction to Numerical Methods Per-Olof Persson November 14, 2006 1 Iterative Methods for Linear Systems Direct methods for solving Ax = b,

More information

Deterministic Operations Research, ME 366Q and ORI 391 Chapter 2: Homework #2 Solutions

Deterministic Operations Research, ME 366Q and ORI 391 Chapter 2: Homework #2 Solutions Deterministic Operations Research, ME 366Q and ORI 391 Chapter 2: Homework #2 Solutions 11. Consider the following linear program. Maximize z = 6x 1 + 3x 2 subject to x 1 + 2x 2 2x 1 + x 2 20 x 1 x 2 x

More information

SOLVING ELLIPTIC PDES

SOLVING ELLIPTIC PDES university-logo SOLVING ELLIPTIC PDES School of Mathematics Semester 1 2008 OUTLINE 1 REVIEW 2 POISSON S EQUATION Equation and Boundary Conditions Solving the Model Problem 3 THE LINEAR ALGEBRA PROBLEM

More information

Linear Algebra (Review) Volker Tresp 2018

Linear Algebra (Review) Volker Tresp 2018 Linear Algebra (Review) Volker Tresp 2018 1 Vectors k, M, N are scalars A one-dimensional array c is a column vector. Thus in two dimensions, ( ) c1 c = c 2 c i is the i-th component of c c T = (c 1, c

More information

Linear Algebra Section 2.6 : LU Decomposition Section 2.7 : Permutations and transposes Wednesday, February 13th Math 301 Week #4

Linear Algebra Section 2.6 : LU Decomposition Section 2.7 : Permutations and transposes Wednesday, February 13th Math 301 Week #4 Linear Algebra Section. : LU Decomposition Section. : Permutations and transposes Wednesday, February 1th Math 01 Week # 1 The LU Decomposition We learned last time that we can factor a invertible matrix

More information

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

More information

CKY & Earley Parsing. Ling 571 Deep Processing Techniques for NLP January 13, 2016

CKY & Earley Parsing. Ling 571 Deep Processing Techniques for NLP January 13, 2016 CKY & Earley Parsing Ling 571 Deep Processing Techniques for NLP January 13, 2016 No Class Monday: Martin Luther King Jr. Day CKY Parsing: Finish the parse Recognizer à Parser Roadmap Earley parsing Motivation:

More information

Optimal Interface Conditions for an Arbitrary Decomposition into Subdomains

Optimal Interface Conditions for an Arbitrary Decomposition into Subdomains Optimal Interface Conditions for an Arbitrary Decomposition into Subdomains Martin J. Gander and Felix Kwok Section de mathématiques, Université de Genève, Geneva CH-1211, Switzerland, Martin.Gander@unige.ch;

More information

Lecture Note 7: Iterative methods for solving linear systems. Xiaoqun Zhang Shanghai Jiao Tong University

Lecture Note 7: Iterative methods for solving linear systems. Xiaoqun Zhang Shanghai Jiao Tong University Lecture Note 7: Iterative methods for solving linear systems Xiaoqun Zhang Shanghai Jiao Tong University Last updated: December 24, 2014 1.1 Review on linear algebra Norms of vectors and matrices vector

More information

CLASSICAL ITERATIVE METHODS

CLASSICAL ITERATIVE METHODS CLASSICAL ITERATIVE METHODS LONG CHEN In this notes we discuss classic iterative methods on solving the linear operator equation (1) Au = f, posed on a finite dimensional Hilbert space V = R N equipped

More information

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Jason E. Hicken Aerospace Design Lab Department of Aeronautics & Astronautics Stanford University 14 July 2011 Lecture Objectives describe when CG can be used to solve Ax

More information

Numerical Solution Techniques in Mechanical and Aerospace Engineering

Numerical Solution Techniques in Mechanical and Aerospace Engineering Numerical Solution Techniques in Mechanical and Aerospace Engineering Chunlei Liang LECTURE 3 Solvers of linear algebraic equations 3.1. Outline of Lecture Finite-difference method for a 2D elliptic PDE

More information

PHYS 410/555 Computational Physics Solution of Non Linear Equations (a.k.a. Root Finding) (Reference Numerical Recipes, 9.0, 9.1, 9.

PHYS 410/555 Computational Physics Solution of Non Linear Equations (a.k.a. Root Finding) (Reference Numerical Recipes, 9.0, 9.1, 9. PHYS 410/555 Computational Physics Solution of Non Linear Equations (a.k.a. Root Finding) (Reference Numerical Recipes, 9.0, 9.1, 9.4) We will consider two cases 1. f(x) = 0 1-dimensional 2. f(x) = 0 d-dimensional

More information

Implementation of Implicit Solution Techniques for Non-equilibrium Hypersonic Flows

Implementation of Implicit Solution Techniques for Non-equilibrium Hypersonic Flows Short Training Program Report Implementation of Implicit Solution Techniques for Non-equilibrium Hypersonic Flows Julian Koellermeier RWTH Aachen University Supervisor: Advisor: Prof. Thierry Magin von

More information

Algebra C Numerical Linear Algebra Sample Exam Problems

Algebra C Numerical Linear Algebra Sample Exam Problems Algebra C Numerical Linear Algebra Sample Exam Problems Notation. Denote by V a finite-dimensional Hilbert space with inner product (, ) and corresponding norm. The abbreviation SPD is used for symmetric

More information

12 CHAPTER 1. PRELIMINARIES Lemma 1.3 (Cauchy-Schwarz inequality) Let (; ) be an inner product in < n. Then for all x; y 2 < n we have j(x; y)j (x; x)

12 CHAPTER 1. PRELIMINARIES Lemma 1.3 (Cauchy-Schwarz inequality) Let (; ) be an inner product in < n. Then for all x; y 2 < n we have j(x; y)j (x; x) 1.4. INNER PRODUCTS,VECTOR NORMS, AND MATRIX NORMS 11 The estimate ^ is unbiased, but E(^ 2 ) = n?1 n 2 and is thus biased. An unbiased estimate is ^ 2 = 1 (x i? ^) 2 : n? 1 In x?? we show that the linear

More information

Handout 8 MATLAB Code for the Projection Method and BC Details for the Lid-Driven Cavity Problem

Handout 8 MATLAB Code for the Projection Method and BC Details for the Lid-Driven Cavity Problem Handout 8 MATLAB Code for the Projection Method and BC Details for the Lid-Driven Cavity Problem Let s simplify the equations of the last page of Handout 7 for the case h = Δx = Δy because the code given

More information

CME342 Parallel Methods in Numerical Analysis. Matrix Computation: Iterative Methods II. Sparse Matrix-vector Multiplication.

CME342 Parallel Methods in Numerical Analysis. Matrix Computation: Iterative Methods II. Sparse Matrix-vector Multiplication. CME342 Parallel Methods in Numerical Analysis Matrix Computation: Iterative Methods II Outline: CG & its parallelization. Sparse Matrix-vector Multiplication. 1 Basic iterative methods: Ax = b r = b Ax

More information

A simple FEM solver and its data parallelism

A simple FEM solver and its data parallelism A simple FEM solver and its data parallelism Gundolf Haase Institute for Mathematics and Scientific Computing University of Graz, Austria Chile, Jan. 2015 Partial differential equation Considered Problem

More information

Modelling and implementation of algorithms in applied mathematics using MPI

Modelling and implementation of algorithms in applied mathematics using MPI Modelling and implementation of algorithms in applied mathematics using MPI Lecture 3: Linear Systems: Simple Iterative Methods and their parallelization, Programming MPI G. Rapin Brazil March 2011 Outline

More information

Background. Background. C. T. Kelley NC State University tim C. T. Kelley Background NCSU, Spring / 58

Background. Background. C. T. Kelley NC State University tim C. T. Kelley Background NCSU, Spring / 58 Background C. T. Kelley NC State University tim kelley@ncsu.edu C. T. Kelley Background NCSU, Spring 2012 1 / 58 Notation vectors, matrices, norms l 1 : max col sum... spectral radius scaled integral norms

More information

1. Fast Iterative Solvers of SLE

1. Fast Iterative Solvers of SLE 1. Fast Iterative Solvers of crucial drawback of solvers discussed so far: they become slower if we discretize more accurate! now: look for possible remedies relaxation: explicit application of the multigrid

More information

Scientific Computing II

Scientific Computing II Technische Universität München ST 008 Institut für Informatik Dr. Miriam Mehl Scientific Computing II Final Exam, July, 008 Iterative Solvers (3 pts + 4 extra pts, 60 min) a) Steepest Descent and Conjugate

More information

9. Iterative Methods for Large Linear Systems

9. Iterative Methods for Large Linear Systems EE507 - Computational Techniques for EE Jitkomut Songsiri 9. Iterative Methods for Large Linear Systems introduction splitting method Jacobi method Gauss-Seidel method successive overrelaxation (SOR) 9-1

More information

Review of matrices. Let m, n IN. A rectangle of numbers written like A =

Review of matrices. Let m, n IN. A rectangle of numbers written like A = Review of matrices Let m, n IN. A rectangle of numbers written like a 11 a 12... a 1n a 21 a 22... a 2n A =...... a m1 a m2... a mn where each a ij IR is called a matrix with m rows and n columns or an

More information

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Classical Iterations We have a problem, We assume that the matrix comes from a discretization of a PDE. The best and most popular model problem is, The matrix will be as large

More information

MATH 3511 Lecture 1. Solving Linear Systems 1

MATH 3511 Lecture 1. Solving Linear Systems 1 MATH 3511 Lecture 1 Solving Linear Systems 1 Dmitriy Leykekhman Spring 2012 Goals Review of basic linear algebra Solution of simple linear systems Gaussian elimination D Leykekhman - MATH 3511 Introduction

More information

A discrete magnetostatic solver in Matlab/Octave

A discrete magnetostatic solver in Matlab/Octave discrete magnetostatic solver in Matlab/Octave Tobias Schäfer 1st March 01 Contents 1 Introduction 1 Theory 1 Boundary conditions 5 3 Solution 5 31 Iterative solution 5 311 Hint 5 3 FEM Solution 6 4 Matlab/Octave

More information

Sparse Matrices and Iterative Methods

Sparse Matrices and Iterative Methods Sparse Matrices and Iterative Methods K. 1 1 Department of Mathematics 2018 Iterative Methods Consider the problem of solving Ax = b, where A is n n. Why would we use an iterative method? Avoid direct

More information

6. Multigrid & Krylov Methods. June 1, 2010

6. Multigrid & Krylov Methods. June 1, 2010 June 1, 2010 Scientific Computing II, Tobias Weinzierl page 1 of 27 Outline of This Session A recapitulation of iterative schemes Lots of advertisement Multigrid Ingredients Multigrid Analysis Scientific

More information

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations Sparse Linear Systems Iterative Methods for Sparse Linear Systems Matrix Computations and Applications, Lecture C11 Fredrik Bengzon, Robert Söderlund We consider the problem of solving the linear system

More information

Spring 2014: Computational and Variational Methods for Inverse Problems CSE 397/GEO 391/ME 397/ORI 397 Assignment 4 (due 14 April 2014)

Spring 2014: Computational and Variational Methods for Inverse Problems CSE 397/GEO 391/ME 397/ORI 397 Assignment 4 (due 14 April 2014) Spring 2014: Computational and Variational Methods for Inverse Problems CSE 397/GEO 391/ME 397/ORI 397 Assignment 4 (due 14 April 2014) The first problem in this assignment is a paper-and-pencil exercise

More information

Numerical Programming I (for CSE)

Numerical Programming I (for CSE) Technische Universität München WT 1/13 Fakultät für Mathematik Prof. Dr. M. Mehl B. Gatzhammer January 1, 13 Numerical Programming I (for CSE) Tutorial 1: Iterative Methods 1) Relaxation Methods a) Let

More information

An Heuristic Finite Difference Scheme on Irregular Plane Regions

An Heuristic Finite Difference Scheme on Irregular Plane Regions Applied Mathematical Sciences, Vol 8, 2014, no 14, 671-683 HIKARI Ltd, wwwm-hikaricom http://dxdoiorg/1012988/ams2014312684 An Heuristic Finite Difference Scheme on Irregular Plane Regions Francisco J

More information

Lecture 1: Introduction to Sublinear Algorithms

Lecture 1: Introduction to Sublinear Algorithms CSE 522: Sublinear (and Streaming) Algorithms Spring 2014 Lecture 1: Introduction to Sublinear Algorithms March 31, 2014 Lecturer: Paul Beame Scribe: Paul Beame Too much data, too little time, space for

More information

RESEARCH ARTICLE. A strategy of finding an initial active set for inequality constrained quadratic programming problems

RESEARCH ARTICLE. A strategy of finding an initial active set for inequality constrained quadratic programming problems Optimization Methods and Software Vol. 00, No. 00, July 200, 8 RESEARCH ARTICLE A strategy of finding an initial active set for inequality constrained quadratic programming problems Jungho Lee Computer

More information

Solving the Convection Diffusion Equation on Distributed Systems

Solving the Convection Diffusion Equation on Distributed Systems Solving the Convection Diffusion Equation on Distributed Systems N. Missirlis, F. Tzaferis, G. Karagiorgos, A. Theodorakos, A. Kontarinis, A. Konsta Department of Informatics and Telecommunications University

More information

Finite Math - J-term Section Systems of Linear Equations in Two Variables Example 1. Solve the system

Finite Math - J-term Section Systems of Linear Equations in Two Variables Example 1. Solve the system Finite Math - J-term 07 Lecture Notes - //07 Homework Section 4. - 9, 0, 5, 6, 9, 0,, 4, 6, 0, 50, 5, 54, 55, 56, 6, 65 Section 4. - Systems of Linear Equations in Two Variables Example. Solve the system

More information

FEM and Sparse Linear System Solving

FEM and Sparse Linear System Solving FEM & sparse system solving, Lecture 7, Nov 3, 2017 1/46 Lecture 7, Nov 3, 2015: Introduction to Iterative Solvers: Stationary Methods http://people.inf.ethz.ch/arbenz/fem16 Peter Arbenz Computer Science

More information

Image Reconstruction And Poisson s equation

Image Reconstruction And Poisson s equation Chapter 1, p. 1/58 Image Reconstruction And Poisson s equation School of Engineering Sciences Parallel s for Large-Scale Problems I Chapter 1, p. 2/58 Outline 1 2 3 4 Chapter 1, p. 3/58 Question What have

More information

Math 304 (Spring 2010) - Lecture 2

Math 304 (Spring 2010) - Lecture 2 Math 304 (Spring 010) - Lecture Emre Mengi Department of Mathematics Koç University emengi@ku.edu.tr Lecture - Floating Point Operation Count p.1/10 Efficiency of an algorithm is determined by the total

More information

Next topics: Solving systems of linear equations

Next topics: Solving systems of linear equations Next topics: Solving systems of linear equations 1 Gaussian elimination (today) 2 Gaussian elimination with partial pivoting (Week 9) 3 The method of LU-decomposition (Week 10) 4 Iterative techniques:

More information

Linear Systems of Equations. ChEn 2450

Linear Systems of Equations. ChEn 2450 Linear Systems of Equations ChEn 450 LinearSystems-directkey - August 5, 04 Example Circuit analysis (also used in heat transfer) + v _ R R4 I I I3 R R5 R3 Kirchoff s Laws give the following equations

More information

Module 2: Reflecting on One s Problems

Module 2: Reflecting on One s Problems MATH55 Module : Reflecting on One s Problems Main Math concepts: Translations, Reflections, Graphs of Equations, Symmetry Auxiliary ideas: Working with quadratics, Mobius maps, Calculus, Inverses I. Transformations

More information

Design and Modeling of Fluid Power Systems ME 597/ABE Lecture 7

Design and Modeling of Fluid Power Systems ME 597/ABE Lecture 7 Systems ME 597/ABE 591 - Lecture 7 Dr. Monika Ivantysynova MAHA Professor Fluid Power Systems MAHA Fluid Power Research Center Purdue University Content of 6th lecture The lubricating gap as a basic design

More information

The embedded finite difference method for the Poisson equation in a domain with an irregular boundary and Dirichlet boundary conditions

The embedded finite difference method for the Poisson equation in a domain with an irregular boundary and Dirichlet boundary conditions The embedded finite difference method for the Poisson equation in a domain with an irregular boundary and Dirichlet boundary conditions Z. Jomaa and C. Macaskill School of Mathematics & Statistics University

More information

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Jingwei Zhu May 14, 2014 Instructor: Surya Pratap Vanka 1 Project Description The objective of

More information

Chapter 4 No. 4.0 Answer True or False to the following. Give reasons for your answers.

Chapter 4 No. 4.0 Answer True or False to the following. Give reasons for your answers. MATH 434/534 Theoretical Assignment 3 Solution Chapter 4 No 40 Answer True or False to the following Give reasons for your answers If a backward stable algorithm is applied to a computational problem,

More information

Chapter 5. Methods for Solving Elliptic Equations

Chapter 5. Methods for Solving Elliptic Equations Chapter 5. Methods for Solving Elliptic Equations References: Tannehill et al Section 4.3. Fulton et al (1986 MWR). Recommended reading: Chapter 7, Numerical Methods for Engineering Application. J. H.

More information

1 Non-negative Matrix Factorization (NMF)

1 Non-negative Matrix Factorization (NMF) 2018-06-21 1 Non-negative Matrix Factorization NMF) In the last lecture, we considered low rank approximations to data matrices. We started with the optimal rank k approximation to A R m n via the SVD,

More information

Properties of Matrices and Operations on Matrices

Properties of Matrices and Operations on Matrices Properties of Matrices and Operations on Matrices A common data structure for statistical analysis is a rectangular array or matris. Rows represent individual observational units, or just observations,

More information

RBF-FD Approximation to Solve Poisson Equation in 3D

RBF-FD Approximation to Solve Poisson Equation in 3D RBF-FD Approximation to Solve Poisson Equation in 3D Jagadeeswaran.R March 14, 2014 1 / 28 Overview Problem Setup Generalized finite difference method. Uses numerical differentiations generated by Gaussian

More information

Gaussian Elimination for Linear Systems

Gaussian Elimination for Linear Systems Gaussian Elimination for Linear Systems Tsung-Ming Huang Department of Mathematics National Taiwan Normal University October 3, 2011 1/56 Outline 1 Elementary matrices 2 LR-factorization 3 Gaussian elimination

More information

Indefinite and physics-based preconditioning

Indefinite and physics-based preconditioning Indefinite and physics-based preconditioning Jed Brown VAW, ETH Zürich 2009-01-29 Newton iteration Standard form of a nonlinear system F (u) 0 Iteration Solve: Update: J(ũ)u F (ũ) ũ + ũ + u Example (p-bratu)

More information

Poisson Equation in 2D

Poisson Equation in 2D A Parallel Strategy Department of Mathematics and Statistics McMaster University March 31, 2010 Outline Introduction 1 Introduction Motivation Discretization Iterative Methods 2 Additive Schwarz Method

More information

Iterative Methods. Splitting Methods

Iterative Methods. Splitting Methods Iterative Methods Splitting Methods 1 Direct Methods Solving Ax = b using direct methods. Gaussian elimination (using LU decomposition) Variants of LU, including Crout and Doolittle Other decomposition

More information

Rotated Outer-Inner Iterative Schemes for The Solution of Burgers Equation

Rotated Outer-Inner Iterative Schemes for The Solution of Burgers Equation MATEMATIKA, 2005, Jilid 21, Bil. 1, hlm. 61 77 c Jabatan Matematik, UTM. Rotated Outer-Inner Iterative Schemes for The Solution of Burgers Equation 1 Norhashidah Hj. Mohd. Ali & 2 Abdul Rahman Abdullah

More information

Signatures of GL n Multiplicity Spaces

Signatures of GL n Multiplicity Spaces Signatures of GL n Multiplicity Spaces UROP+ Final Paper, Summer 2016 Mrudul Thatte Mentor: Siddharth Venkatesh Project suggested by Pavel Etingof September 1, 2016 Abstract A stable sequence of GL n representations

More information

Non-Equidistant Particle-In-Cell for Ion Thruster Plumes

Non-Equidistant Particle-In-Cell for Ion Thruster Plumes Non-Equidistant Particle-In-Cell for Ion Thruster Plumes IEPC-213-67 Presented at the 33 rd International Electric Propulsion Conference, The George Washington University, Washington, D.C., USA October

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences)

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) Lecture 19: Computing the SVD; Sparse Linear Systems Xiangmin Jiao Stony Brook University Xiangmin Jiao Numerical

More information

Computational Linear Algebra

Computational Linear Algebra Computational Linear Algebra PD Dr. rer. nat. habil. Ralf-Peter Mundani Computation in Engineering / BGU Scientific Computing in Computer Science / INF Winter Term 2018/19 Part 4: Iterative Methods PD

More information

LECTURES IN BASIC COMPUTATIONAL NUMERICAL ANALYSIS

LECTURES IN BASIC COMPUTATIONAL NUMERICAL ANALYSIS Ax = b Z b a " 1 f(x) dx = h 2 (f X 1 + f n )+ f i #+ O(h 2 ) n 1 i=2 LECTURES IN BASIC COMPUTATIONAL NUMERICAL ANALYSIS x (m+1) = x (m) J(x (m) ) 1 F (x (m) ) p n (x) = X n+1 i=1 " n+1 Y j=1 j6=i # (x

More information

Introduction. Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods. Example: First Order Richardson. Strategy

Introduction. Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods. Example: First Order Richardson. Strategy Introduction Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods M. M. Sussman sussmanm@math.pitt.edu Office Hours: MW 1:45PM-2:45PM, Thack 622 Solve system Ax = b by repeatedly computing

More information

Lecture 3. 1 Polynomial-time algorithms for the maximum flow problem

Lecture 3. 1 Polynomial-time algorithms for the maximum flow problem ORIE 633 Network Flows August 30, 2007 Lecturer: David P. Williamson Lecture 3 Scribe: Gema Plaza-Martínez 1 Polynomial-time algorithms for the maximum flow problem 1.1 Introduction Let s turn now to considering

More information

Numerical Linear Algebra

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

More information

Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods

Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods M. M. Sussman sussmanm@math.pitt.edu Office Hours: MW 1:45PM-2:45PM, Thack 622 March 2015 1 / 70 Topics Introduction to Iterative Methods

More information

Review Solutions, Exam 2, Operations Research

Review Solutions, Exam 2, Operations Research Review Solutions, Exam 2, Operations Research 1. Prove the weak duality theorem: For any x feasible for the primal and y feasible for the dual, then... HINT: Consider the quantity y T Ax. SOLUTION: To

More information

Consider the following example of a linear system:

Consider the following example of a linear system: LINEAR SYSTEMS Consider the following example of a linear system: Its unique solution is x + 2x 2 + 3x 3 = 5 x + x 3 = 3 3x + x 2 + 3x 3 = 3 x =, x 2 = 0, x 3 = 2 In general we want to solve n equations

More information

Proximal Gradient Descent and Acceleration. Ryan Tibshirani Convex Optimization /36-725

Proximal Gradient Descent and Acceleration. Ryan Tibshirani Convex Optimization /36-725 Proximal Gradient Descent and Acceleration Ryan Tibshirani Convex Optimization 10-725/36-725 Last time: subgradient method Consider the problem min f(x) with f convex, and dom(f) = R n. Subgradient method:

More information

Linear Algebra (Review) Volker Tresp 2017

Linear Algebra (Review) Volker Tresp 2017 Linear Algebra (Review) Volker Tresp 2017 1 Vectors k is a scalar (a number) c is a column vector. Thus in two dimensions, c = ( c1 c 2 ) (Advanced: More precisely, a vector is defined in a vector space.

More information

Numerical Methods I: Numerical linear algebra

Numerical Methods I: Numerical linear algebra 1/3 Numerical Methods I: Numerical linear algebra Georg Stadler Courant Institute, NYU stadler@cimsnyuedu September 1, 017 /3 We study the solution of linear systems of the form Ax = b with A R n n, x,

More information

Linear Algebra. Brigitte Bidégaray-Fesquet. MSIAM, September Univ. Grenoble Alpes, Laboratoire Jean Kuntzmann, Grenoble.

Linear Algebra. Brigitte Bidégaray-Fesquet. MSIAM, September Univ. Grenoble Alpes, Laboratoire Jean Kuntzmann, Grenoble. Brigitte Bidégaray-Fesquet Univ. Grenoble Alpes, Laboratoire Jean Kuntzmann, Grenoble MSIAM, 23 24 September 215 Overview 1 Elementary operations Gram Schmidt orthonormalization Matrix norm Conditioning

More information

Motivation: Sparse matrices and numerical PDE's

Motivation: Sparse matrices and numerical PDE's Lecture 20: Numerical Linear Algebra #4 Iterative methods and Eigenproblems Outline 1) Motivation: beyond LU for Ax=b A little PDE's and sparse matrices A) Temperature Equation B) Poisson Equation 2) Splitting

More information

General Exam Part II, Fall 1998 Quantum Mechanics Solutions

General Exam Part II, Fall 1998 Quantum Mechanics Solutions General Exam Part II, Fall 1998 Quantum Mechanics Solutions Leo C. Stein Problem 1 Consider a particle of charge q and mass m confined to the x-y plane and subject to a harmonic oscillator potential V

More information

Chapter 7 Iterative Techniques in Matrix Algebra

Chapter 7 Iterative Techniques in Matrix Algebra Chapter 7 Iterative Techniques in Matrix Algebra Per-Olof Persson persson@berkeley.edu Department of Mathematics University of California, Berkeley Math 128B Numerical Analysis Vector Norms Definition

More information

Iterative methods for Linear System

Iterative methods for Linear System Iterative methods for Linear System JASS 2009 Student: Rishi Patil Advisor: Prof. Thomas Huckle Outline Basics: Matrices and their properties Eigenvalues, Condition Number Iterative Methods Direct and

More information

Lecture 4 Orthonormal vectors and QR factorization

Lecture 4 Orthonormal vectors and QR factorization Orthonormal vectors and QR factorization 4 1 Lecture 4 Orthonormal vectors and QR factorization EE263 Autumn 2004 orthonormal vectors Gram-Schmidt procedure, QR factorization orthogonal decomposition induced

More information

Algorithm-Hardware Co-Optimization of Memristor-Based Framework for Solving SOCP and Homogeneous QCQP Problems

Algorithm-Hardware Co-Optimization of Memristor-Based Framework for Solving SOCP and Homogeneous QCQP Problems L.C.Smith College of Engineering and Computer Science Algorithm-Hardware Co-Optimization of Memristor-Based Framework for Solving SOCP and Homogeneous QCQP Problems Ao Ren Sijia Liu Ruizhe Cai Wujie Wen

More information

Final Exam. 1 True or False (15 Points)

Final Exam. 1 True or False (15 Points) 10-606 Final Exam Submit by Oct. 16, 2017 11:59pm EST Please submit early, and update your submission if you want to make changes. Do not wait to the last minute to submit: we reserve the right not to

More information

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011 MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS 02139 2.29 NUMERICAL FLUID MECHANICS FALL 2011 QUIZ 2 The goals of this quiz 2 are to: (i) ask some general

More information

Matrices handling in PDEs resolution with MATLAB R

Matrices handling in PDEs resolution with MATLAB R Matrices handling in PDEs resolution with MATLAB R Riccardo Zamolo riccardo.zamolo@phd.units.it Dipartimento di Ingegneria Meccanica e Navale Università degli Studi Trieste, 34127 TRIESTE April 6, 2016

More information

Iterative Methods and Multigrid

Iterative Methods and Multigrid Iterative Methods and Multigrid Part 3: Preconditioning 2 Eric de Sturler Preconditioning The general idea behind preconditioning is that convergence of some method for the linear system Ax = b can be

More information

First example, moments of inertia. I m,n = m i r 2 i m,n. m i r i,m r i,n. Symmetric second rank tensor x. i =1

First example, moments of inertia. I m,n = m i r 2 i m,n. m i r i,m r i,n. Symmetric second rank tensor x. i =1 Eigenvalue Problems Eigenvalue problems arise in many contexts in physics. In matrix form, Ax = x This is somewhat different from our previous SLE, which had the form Ax = b where A, b were assumed known.

More information

Numerical solution of the 2-D Poisson equation on an irregular domain with Robin boundary conditions

Numerical solution of the 2-D Poisson equation on an irregular domain with Robin boundary conditions Numerical solution of the 2-D Poisson equation on an irregular domain with Robin boundary conditions Z. Jomaa C. Macaskill August 8, 28 Abstract We describe a 2-D finite difference algorithm for inverting

More information

Sparsity. The implication is that we would like to find ways to increase efficiency of LU decomposition.

Sparsity. The implication is that we would like to find ways to increase efficiency of LU decomposition. Sparsity. Introduction We saw in previous notes that the very common problem, to solve for the n vector in A b ( when n is very large, is done without inverting the n n matri A, using LU decomposition.

More information

K.S. Kang. The multigrid method for an elliptic problem on a rectangular domain with an internal conductiong structure and an inner empty space

K.S. Kang. The multigrid method for an elliptic problem on a rectangular domain with an internal conductiong structure and an inner empty space K.S. Kang The multigrid method for an elliptic problem on a rectangular domain with an internal conductiong structure and an inner empty space IPP 5/128 September, 2011 The multigrid method for an elliptic

More information

Matrix Assembly in FEA

Matrix Assembly in FEA Matrix Assembly in FEA 1 In Chapter 2, we spoke about how the global matrix equations are assembled in the finite element method. We now want to revisit that discussion and add some details. For example,

More information

CHAPTER 2 EXTRACTION OF THE QUADRATICS FROM REAL ALGEBRAIC POLYNOMIAL

CHAPTER 2 EXTRACTION OF THE QUADRATICS FROM REAL ALGEBRAIC POLYNOMIAL 24 CHAPTER 2 EXTRACTION OF THE QUADRATICS FROM REAL ALGEBRAIC POLYNOMIAL 2.1 INTRODUCTION Polynomial factorization is a mathematical problem, which is often encountered in applied sciences and many of

More information