Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems

Similar documents
NUMERICAL METHODS FOR ENGINEERING APPLICATION

Applied Numerical Analysis

Numerical Mathematics

Preface. 2 Linear Equations and Eigenvalue Problem 22

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2

Preface to the Second Edition. Preface to the First Edition

A THEORETICAL INTRODUCTION TO NUMERICAL ANALYSIS

OT98_LevequeFM2.qxp 6/4/ :20 AM Page 1. Finite Difference Methods for Ordinary and Partial Differential Equations

7 Hyperbolic Differential Equations

Numerical Solution of partial differential equations

Chapter 10 Exercises

Partial Differential Equations

Math 7824 Spring 2010 Numerical solution of partial differential equations Classroom notes and homework

Numerical Methods for Engineers and Scientists

Numerical Methods in Matrix Computations

Numerical Analysis. A Comprehensive Introduction. H. R. Schwarz University of Zürich Switzerland. with a contribution by

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9

MATHEMATICS. Course Syllabus. Section A: Linear Algebra. Subject Code: MA. Course Structure. Ordinary Differential Equations

FDM for parabolic equations

Review for Exam 2 Ben Wang and Mark Styczynski

ME Computational Fluid Mechanics Lecture 5

PDE Solvers for Fluid Flow

NUMERICAL MATHEMATICS AND COMPUTING

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations

Math 411 Preliminaries

Applied Linear Algebra

ITERATIVE METHODS FOR SPARSE LINEAR SYSTEMS

Scientific Computing: An Introductory Survey

Numerical Methods for Engineers. and Scientists. Applications using MATLAB. An Introduction with. Vish- Subramaniam. Third Edition. Amos Gilat.

Computation Fluid Dynamics

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA

Ordinary Differential Equations

MATHEMATICAL METHODS INTERPOLATION

BASIC EXAM ADVANCED CALCULUS/LINEAR ALGEBRA

Part 1. The diffusion equation

Computational Methods

Numerical Methods for Engineers

arxiv: v1 [physics.comp-ph] 30 Sep 2015

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics

Contents. Preface to the Third Edition (2007) Preface to the Second Edition (1992) Preface to the First Edition (1985) License and Legal Information

NUMERICAL COMPUTATION IN SCIENCE AND ENGINEERING

The Conjugate Gradient Method

Numerical Methods for PDEs

PARTIAL DIFFERENTIAL EQUATIONS

Time stepping methods

NUMERICAL SOLUTION OF ODE IVPs. Overview

CAM Ph.D. Qualifying Exam in Numerical Analysis CONTENTS

Chapter 5 Exercises. (a) Determine the best possible Lipschitz constant for this function over 2 u <. u (t) = log(u(t)), u(0) = 2.

Solutions to ODEs and PDEs: Numerical analysis using R (Cambridge University Press, ISBN: )

ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices. Numerical Methods and Simulation / Umberto Ravaioli

PDEs, part 3: Hyperbolic PDEs

Name of the Student: Unit I (Solution of Equations and Eigenvalue Problems)

Numerical Analysis of Differential Equations Numerical Solution of Parabolic Equations

Partial differential equations

APPLIED NUMERICAL LINEAR ALGEBRA

Part IB Numerical Analysis

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement

Introduction to Numerical Analysis

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning

Numerical Methods for Partial Differential Equations CAAM 452. Spring 2005

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

Computer Simulation Using Particles

Preconditioning for Nonsymmetry and Time-dependence

Review. Numerical Methods Lecture 22. Prof. Jinbo Bi CSE, UConn

NUMERICAL METHODS. lor CHEMICAL ENGINEERS. Using Excel', VBA, and MATLAB* VICTOR J. LAW. CRC Press. Taylor & Francis Group

Notes on Numerical Analysis

NUMERICAL METHODS USING MATLAB

The Initial Value Problem for Ordinary Differential Equations

Numerical Methods. Scientists. Engineers

Multigrid solvers for equations arising in implicit MHD simulations

SOLUTION OF EQUATION AND EIGENVALUE PROBLEMS PART A( 2 MARKS)

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK

Butcher tableau Can summarize an s + 1 stage Runge Kutta method using a triangular grid of coefficients

Computational Fluid Dynamics-1(CFDI)

Index. for generalized eigenvalue problem, butterfly form, 211

Contents. Preface... xi. Introduction...

The family of Runge Kutta methods with two intermediate evaluations is defined by

Department of Mathematics California State University, Los Angeles Master s Degree Comprehensive Examination in. NUMERICAL ANALYSIS Spring 2015

Finite difference methods for the diffusion equation

MATH 102 Calculus II (4-0-4)

TABLE OF CONTENTS INTRODUCTION, APPROXIMATION & ERRORS 1. Chapter Introduction to numerical methods 1 Multiple-choice test 7 Problem set 9

M.A. Botchev. September 5, 2014

Finite Differences: Consistency, Stability and Convergence

METHODS FOR SOLVING MATHEMATICAL PHYSICS PROBLEMS

AMS526: Numerical Analysis I (Numerical Linear Algebra)

Solving PDEs with PGI CUDA Fortran Part 4: Initial value problems for ordinary differential equations

Some notes about PDEs. -Bill Green Nov. 2015

Chapter 7 Iterative Techniques in Matrix Algebra

Partial Differential Equations

Iterative Methods and Multigrid

ADVANCED ENGINEERING MATHEMATICS

Implicit-explicit exponential integrators

x n+1 = x n f(x n) f (x n ), n 0.

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

Tutorial 2. Introduction to numerical schemes

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Krylov Implicit Integration Factor Methods for Semilinear Fourth-Order Equations

Iterative methods for Linear System of Equations. Joint Advanced Student School (JASS-2009)

Syllabus for Applied Mathematics Graduate Student Qualifying Exams, Dartmouth Mathematics Department

CS520: numerical ODEs (Ch.2)

Transcription:

Index A-conjugate directions, 83 A-stability, 171 A( )-stability, 171 absolute error, 243 absolute stability, 149 for systems of equations, 154 absorbing boundary conditions, 228 Adams Bashforth methods, 131 Adams Moulton methods, 131 adaptive meshes, 51 advection equation, 201, 311, 312, 316 advection-diffusion equation, 234 advection-diffusion-reaction equation, 234, 239 alternating direction implicit (ADI) method, 198 amplification factor, 193, 212 Arnoldi process, 96 artificial boundary condition, 227 backward differentiation formula (BDF) method, 121, 173 backward Euler method, 120 backward heat equation, 197, 320 Beam Warming method, 212 Bi-CGSTAB (bi-conjugate gradient stabilized) algorithm, 100 big-oh notation, 245 boundary conditions, 14 at outflow boundaries, 227 Dirichlet, 14 for fractional step methods, 239 for LOD method, 197 Neumann, 29 boundary layers, 43 boundary locus method, 161 boundary value problems (BVPs), 13, 59 higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems Cauchy integral formula, 284 Cauchy problem, 313 centered approximations, 4 CFL (Courant Friedrich Lewy) condition, 215 CG, see conjugate-gradient algorithm,characteristic polynomial, 133, 267, 289 characteristic tracing, 214 characteristic variables, 224 Chebyshev extreme points, 263 polynomials, 262 roots, 264 spectral method, 56 chemical kinetics, 155, 167 circulant matrix, 273 CLAWPACK, 201 collocation method, 55 compact methods, 230 companion matrix, 288, 294 condition number, 248 and preconditioners, 93 of discrete Laplacian, 64 of eigenvector matrix, 285 conjugate-gradient (CG) algorithm, 86 conservation laws, 234, 312 consistency of LMMs, 133 for boundary value problem, 19 for PDEs, 184 335

336 Index continuation method, 51 convergence, 189 for boundary value problem, 19 for initial value problem, 137 for PDEs, 184 Crank Nicolson method, 182 Dahlquist theorem, 148 Dahlquist s second barrier, 171 defective matrix, 268 deferred corrections, 54, 65, 239 delta function, 23 descent methods, 77 diagonalizable matrix, 269 diffusion, 314 diffusion equation, 181 Dirichlet boundary conditions, 14, 60 dispersion relation, 221, 323 for leapfrog, 223 dispersive waves, 221, 321 Duhamel s principle, 115, 138, 240 discrete form, 139 eigendecomposition, 269 eigenfunctions, 21 eigengridfunction, 191 eigenvalues, 267 of discrete Laplacian, 63 of Toeplitz matrix, 273 of tridiagonal system, 21 elliptic equations, 59, 309, 310 elliptic operator, 310 ETD, see exponential time differencing method Euler s method, 120 convergence, 138 existence and uniqueness, 116 for boundary value problem, 32 for nonlinear problem, 40 exponential time differencing method (ETD), 199, 231, 240 extrapolation methods, 53 fast Fourier transform (FFT), 58, 264 fast Poisson solvers, 68 fdcoefff, 11, 55 fdcoeffv, 11, 52, 230 FFT, see fast fourier transform field of values, 298 Fourier analysis of PDEs, 315 Fourier transform, 316 of Gaussian, 318 fractional step methods, 237 function space norms, 248 fundamental theorem, 20 Gauss Seidel iteration, 71 Gaussian elimination, 66 Gershgorin theorem, 275 global error, 17, 18, 28 GMRES algorithm, 96 Green s function for advection equation, 317 for boundary value problem, 22, 27 for heat equation, 319 grid functions, errors in 249 group velocity, 221, 228, 325 hat function, 23 heat equation, 13, 24, 181, 314, 318 with Gaussian data, 318 Hermitian matrix, 271 homotopy method, 51 hyperbolic equations, 201, 309, 311 hyperbolic systems, 223, 311 ill-posed problem, 29, 320 ILU (incomplete LU) preconditioner, 95 implicit-explicit (IMEX) methods, 239 incomplete Cholesky, 95 initial boundary value problems, 226 initial value problem, 113 inner-product norms, 277, 279 interior layers, 45 internal stability, 179 interpolation, 257 Newton form, 258 irreducible matrix, 277 iterative methods, 66, 69 IVP, see initial value problem Jacobi iteration, 69, 103 underrelaxed, 105

Index 337 Jacobian matrix, 38 Jordan block, 270, 302 Jordan canonical form, 269 KdV (korteweg devries) equation, 235 Kreiss constant, 290 for matrix exponential, 297 Kreiss matrix theorem, 191, 291, 302 Krylov space algorithms, 96 Kuramoto Sivashinsky equation, 235, 322 L-stability, 171, 199 Lanczos iteration, 99 Laplace s equation, 60 Laplacian, 311 5-point stencil, 60 9-point stencil, 64 Lax equivalence theorem, 184, 190 Lax Friedrichs method, 206 Lax Richtmyer stability, 190, 205 Lax Wendroff method, 207 in two dimensions, 236 leapfrog method, 121, 205 Legendre polynomials, 262 linear difference equations, 144, 288 linear multistep methods (LMMs), 130, 173 Lipschitz constant, 118 Lipschitz continuity, 115 LMM, see linear multistep methods local truncation error (LTE), 5, 17, 63 for advection equation, 206 for Crank Nicolson, 183 for initial value problem, 121 for LMMs, 132 for nonlinear problem, 41 locally one-dimensional (LOD) method, 196, 237 LOD, see locally one-dimensional logarithmic norm, 300 LTE, see local truncation error matrix exponential, 101, 291 matrix norms, 248 matrix powers, 283, 295 maximum principle, 36 method of lines, 184 for advection equation, 203 for heat equation, 184 for mixed equations, 235 method of undetermined coefficients, 7 midpoint method, 121 mixed equations, 233 modified equations, 218 MOL, see method of linesmultidimensional problems, 233 heat equation, 194 multigrid algorithm, 102 algebraic multigrid, 109 nested dissection, 67 Neumann boundary conditions, 29 Newton s method, 38 Newton Krylov methods, 101 nonnormal matrix, 170, 294 nonuniform grids, 49 norm equivalence, 247, 250 normal matrix, 272 norms, 16 numerical boundary condition, 227 numerical range, 298 numerical solutions, errors in, 252 Nyström methods, 132 ODEs see ordinary differential equations one-sided approximations, 210 one-step error, 121 one-step methods, 120, 138 versus multistep methods, 129 order of accuracy, 4 order stars, 164, 171 ordering equations in linear system, 33, 61 ordinary differential equations (ODEs) initial value problem, 113 linear, 114 orthogonal matrix, 272 orthogonal polynomials, 260 parabolic equations, 181, 309, 311, 320 multidimensional, 194 Parseval s relation, 192, 316 partial differential equations (PDEs), 309

338 Index pendulum problem, 37 periodic boundary conditions, 203 phase velocity, 321 Poisson problem, 60, 310 polynomial interpolation, 8, 258 power bounded, 296 preconditioners, 93 principal root, 148 pseudoeigenvalues, 300 pseudospectral methods, 55 reacting flow, 234 reaction-diffusion equations, 234, 315 red-black ordering, 62 region of absolute stability, see stability region relative error, 244 relative stability, 164 resolvent, 284, 289 root condition, 147, 152, 289 rowwise ordering, 61 Runge phenomenon, 56 Runge Kutta methods, 123 Runge Kutta Chebyshev methods, 174, 199 Schrödinger equation, 235, 322 self-adjoint problems, 36, 271 semidiscrete method, 184 similarity transformation, 268 Simpson s rule, 125, 132 singular perturbation problems, 43 skew symmetric matrix, 272 SOR, see successive overrelaxtion source terms, 314 SPD, see symmetric positive definite matrix spectral abscissa, 292 spectral deferred correction method, 58, 239 spectral methods for hyperbolic problems, 230 for parabolic equations, 199 for the boundary value problem, 55 Fourier, 258 splitting methods, 237 stability for advection equation, 203, 212 for boundary value problem, 18, 19 for PDEs versus ODEs, 190 for Poisson problem, 63 of Crank Nicolson, 186 stability polynomial, 152 stability regions, 151 for Adams methods, 153 for BDF methods, 174 for LMMs, 152 for Runge Kutta Chebyshev methods, 176 plotting, 161 starting values for multistep methods, 134 steady-state problems, 13, 59, 310 steady-state heat conduction, 13, 14, 35, 59 steepest descent algorithm, 79 stencils, 61, 182 step size selection, 161 stiffness of ODEs, 167 of the heat equation, 187 stiffness ratio, 169 Strang splitting, 238 strong stability, 190 successive overrelaxtion (SOR), 69 symmetric matrix, 271 symmetric positive definite matrix (SPD), 271 T-norm, 279 Taylor series methods, 122, 236 test problem, 151 Toeplitz matrix, 273 TR-BDF2 method, 127, 174 trapezoidal method, 120 tridiagonal systems, 16, 274 inverse, 22, 27 symmetric, 36 truncation error, see local truncation error underrelaxed Jacobi, 105

Index 339 unitary matrix, 272 upwind methods, 210 V-cycle, 108 variable coefficients, 305 vector norms, 246 viscosity, 234 von Neumann analysis, 191, 212, 315 W-cycle, 108 wave packets, 326 zero-stability, 137, 153 of LMMs, 143, 147 of one-step methods, 148