Exercise 2: Partial Differential Equations

Size: px
Start display at page:

Download "Exercise 2: Partial Differential Equations"

Transcription

1 Exercise : Partial Differential Equations J F Ider Chitham Astrophysics Group, HH Wills Physics Laboratory, University of Bristol, Tyndall Avenue, Bristol BS8 TL Accepted March Received March ; in original form March ABSTRACT Partial differential equations can be implemented to solve a vast range of physical problems abundant in many engineering and scientific fields of study Analytical solutions are often difficult to calculate due to their continuous nature, this makes computational analysis via simulations of continuous physical systems a useful and efficient alternative INTRODUCTION The general form of Poission s equation: Φ(r) = σ(r), is an example of a second order partial differential equation relating a generic potential Φ(r) to a source function σ(r) Poission s equation lies at the foundation of potential theory and is imperative to concepts such as electromagnetism, Newtonian gravity and fluid dynamics due to the accurate representation of the respective potentials When σ(r) = Poission s equation reduces to Laplace s equation If the system under consideration is discrete rather than continuous, it becomes extremely useful to approximate derivatives in partial differential equations as finite differences during numerical analysis For example in electrostatics this concept allows the discretizization of Laplace s equation in two dimensions to be expressed in the form of () This can be solved in the computational plane via projection onto a square (n + ) (n + ) grid with the i,j grid points providing the (x, y) co-ordinates of each point in physical space with respective grid spacings of x and y ( V (x, y) = x + y ) V (x, y) = () By considering the Taylor Series expansion of V (x i, y j) = V i,j about an i,j grid point and evaluating the four adjacent nodes, a first order finite difference approximation for the internal points () can be found providing < i < n and < j < n V i+,j V i,j + V i,j x + Vi,j+ Vi,j + Vi,j y = () For methods of finite difference to be effective well defined boundary conditions must be appropriately imposed on the system Dirichlet and Von Neumann boundary conditions specify the value of V and the normal component ˆn V at the boundary respectively In electrostatics this corresponds to specifying the potential and the normal component of the electric field E = V [] RELAXATION Large linear systems used to model partial differential equations can be solved via iterative methods which implement methods of relaxation This allows the discrete modification of the components of an initially approximated solution to progressively resemble its genuine form with each relaxation step (modification) until convergence is reached The Jacobi method is the simplest of the considered iterative techniques and can be used to solve Laplace s equation in two dimensions by rearranging () to construct a discrete form of the Laplacian operator () [] This effectively averages over neighbouring grid points, allowing iterative alteration to the value at each grid point as the old solution V i,j is continually replaced by a refined estimate V i,j V i,j = [Vi+,j + Vi,j + Vi,j+ + Vi,j )] () An alternative to the Jacobi method is the Gauss-Seidel iteration, the only contrasting feature is that the improved estimate V i,j is returned to the solution immediately after completion, rather than postponing its use until the subsequent iteration This leads to a slight variation in computational performance and efficiency COMPUTATIONAL ANALYSIS Convergence Criterion The process of solution refinement () can continue indefinitely so it is necessary to implement an appropriate convergence criterion X, which specifies the maximum percentage difference a value at a particular grid point can change by between successive iterations When the solution no longer satisfies this condition the iterative process ceases as convergence is deemed sufficient To compare the performance of the iterative algorithms at solving Laplace s equation the initial grid system was set to be symmetrically square ( ) with boundary conditions of V and all other elements at V, X was varied logarithmically and the relative progress compared at each interval as shown in Figure The optimal convergence criterion for iterative techniques emerged as X = %, achieving the maximum degree of convergence in the least time (for this specific system configuration) This was taken as the maximum order of X for adequate convergence hereafter (for the remaining duration of the investigation) as solutions at this level of precision are almost identical regardless of iterative method The contrasting iterative technique of each algorithm is subtly depicted via the isocontours of Figure Jacobi contours are centred as the grid is discretely refined after each iteration over the whole system Gauss-Seidel contours on the other hand become

2 J F Ider Chitham increasingly off centre as X (see X = {, }) as the algorithm continually refines grid elements starting from the origin resulting in the greater degree of convergence in this vicinity Visual comparisons are consistent with computational time evaluation over a more extensive range of X as shown in Figure The relative degree of convergence is similar for X & however the Gauss-Seidel algorithm is far more efficient when X This can be explained intuitively via algorithm memory requirements; Jacobi iterations bear an additional computational expense of storing Vi,j however this is not necessary for Gauss-Seidel iterations which allows solutions to tend to converge relatively quicker Grid Density Solutions are also sensitive to grid point number density ρn variation, as this determines the effective resolution of the solution due to an increasing resemblance with a continuous system as grid density tends to infinity This was investigated by incrementally changing the number of grid points in the x and y direction n, as the dimensions and spacing of the system and convergence criterion were constrained to ( ), x = y = m, and X = % respectively Grid density scales linearly with the number of grid points n, and the number of iterations N required to reduce the overall error by a factor of P for Laplace s equation in two dimensions is given by ()[] X and therefore P are the same for both methods so the rate of change of iterations as a function of grid density for Jacobi is expected to be approximately twice that of Gauss-Seidel (), this can be seen in Figure with an actual relative gradient ratio of 6 despite the poor goodness of fit This inaccuracy is explained by the breaks down of the relationship at low densities (and very small X), this limiting sensitivity is highlighted by apparent curve at densities P n / for Jacobi N () P n / for Gauss-Seidel The form of computational time differs from the number of iterations because the interaction between grid points must also be considered as well the number of points iterated over, this complicates the rate of variation as shown in Figure via an approximate quadratic form NB All graphical fit analysis is summarised in Table PHYSICS PROBLEMS Parallel Plate Capacitor A one dimensional, finitely extending parallel plate capacitor is located within the structure of the grid and the potential V and electric field, E must be evaluated at every point within and around its proximity The grid dimensions were specified to be much greater than that of the capacitor ( ) >> (a d) to give physical justification to the simplified approximation of the Dirchlet boundary conditions at the edges of the grid, Vbc = (in reality V as the distance from the centre of the capacitor, r ) Potential and field configurations were determined by solving Laplace s equation via relaxation as mentioned in and however due to its superior computational performance the Gauss-Seidel iteration was designated as primary method of solution Electric field vectors E = V can be approximated at each grid point in terms of their x and y components via discrete differentiation () using methods of finite differences analogous to those X = % X = % V (V) 7 7 V (V) X = % 7 7 V (V) 7 7 V (V) V (V) X = % X = % V (V) 7 X = % V (V) 7 X=% X = % 7 V (V) X=% X = % V (V) 7 7 V (V) 7 Figure Converged solutions for a system with initial potential approximations of V and boundary conditions of V for both Jacobi (left) and Gauss-Seidel (right) iterative methods with X = {,,,, }% discussed in, and justified by the relatively small grid spacings x and y Vi+,j Vi,j Vi,j Vi+,j Exij = lim x x x () Vi,j+ Vi,j Vi,j Vi,j+ Eyij = lim y y y Although lacking multi-dimensional sophistication, it is clear the electric field configuration resembles that of reality It is expected that as a : d increases the field configuration should approach 7

3 Exercise : Partial Differential Equations Log (Time(ms)) - Jacobi Gauss-Seidel Log (X) Figure Logarithmic evaluation of computational time as a function of the convergence criterion, X for both Jacobi (red) and Gauss-Seidel (blue) iterative methods Iterations Jacobi Gauss-Seidel Grid Density (m - ) Figure Number of iterations as a function of the grid density with linear fit for both Jacobi (red) and Gauss-Seidel (blue) iterative methods Computational Time (ms) Jacobi Gauss-Seidel Grid Density (m - ) Figure Computational time as a function of the grid density with quadratic fit for both Jacobi (red) and Gauss-Seidel (blue) iterative methods V (V) V (V) a : d = 7 a : d = 7 Figure Electric potential, V as a function of grid position for capacitor dimension ratios; a: d = {, } the infinite plane solution between parallel plates and zero elsewhere (6) This is first demonstrated in Figure via an increasingly constant rate of change of potential between the plates at larger a:d and supported by the increasing uniformity of the respective vector field configuration of Figure 6 Electric field lines are expected to resemble the perpendicular bisectors of equipotentials, this relation is illustrated via the sample of isocontours and corresponding vector plots in Figures & 6 respectively, further supporting the validity of the solutions lim E a:d { V/d between plates otherwise The deviation from the theoretical infinite plane solution, E = V/d was investigated as a function of the capacitor dimensional ratio a : d in terms of a percentage difference, E/E as shown in Figure 7 NB E represents the difference between the mean electric field magnitude (between parallel plates) and the respective infinite plane value (7) E = E N (6) N E ij (7) The origin of deviation can be explained by a fringing field effect around the periphery (between the sides of the capacitor) The degree of fringing becomes increasingly significant as the distance between the electrodes is no longer negligible relative to the lateral dimensions of the capacitor, resulting in an increased effective capacitance Fringing fields are always present as long as the system is finite and should be accounted for quantitatively when modelling the electrostatic forces via Maxwell s equations The percentage difference between computational and infinite plane solution shown in Figure 7 drops off as (a : d) (see Table for detailed fit analysis) with a deviation of only 6% achievable at a relatively small dimensional ratio of a : d = The asymptotic appearance of Figure 7 suggests an accurate relation over this small range, however extrapolation reveals that the infinite plane solution is reached prematurely (ie at a : d < ) ij

4 J F Ider Chitham a : d = E Magnitude (Vm - ) E / E (%) 6 8 a : d a : d = Figure 6 Electric vector field, E as a function of grid position for capacitor dimension ratios; a: d = {, } as indicated via a small but negative asymptotic intercept, C = ( 68 ± )% Combining this feature with the small reduced χ of implies an overestimated error in the variance, suggesting a more precise fit is only attainable if a larger dataset is compiled with evaluation over a greater range of dimensional ratios Despite the quantity and crudeness of approximations the combination of Figures -7 provide good confirmation of a strong resemblance between expectations and computational solutions Heat Diffusion A m iron rod initially at room temperature is thrust into a C furnace The time evolution of the thermal distribution as a function of position along the rod, T (x, t) must be determined given that the rod can be approximated as one dimensional and heat losses along the length of the poker are assumed to be negligible The diffusion of heat is best described by the heat equation (8) as it models how the temperature distribution evolves with time as heat spreads through space The thermal diffusivity, α characterises the rod s ability to conduct thermal energy relative to storing it and is deduced via its relationship with thermal conductivity, specific heat and mass density, α = κ/cρ Two physical situations were investigated comparatively; (i) There is no heat loss from the far end of the poker (ii) The far end of the rod is immersed in a block of ice ( C) 6 E Magnitude (Vm - ) Figure 7 Percentage difference, E/E between computational and infite plane solutions of mean electric field magnitude (between parrallel plates) as a function of the capacitor dimensional ratio, a : d of the form A (a : d) B + C (red) α T (x, t) = T (x, t) t The heat equation can be solved in a similar way to Poission s equation and minor modifications to the one dimensional equivalent of the finite difference relation () yield a stable implicit relation (9) which can rearranged and manipulated to solve for T (x, t) T i T i t = α [ T x i T i + T i+ ] (9) conveniently reduces to the matrix equation () with γ = α t/ x This was solved via Lower-Upper triangular decomposition by implementing appropriate GNU library functions + γ γ γ + γ γ γ + γ γ γ + γ T i T i T i+ = T i T i T i+ () The time taken for the system to tend toward steady state thermal conduction was the subject of preliminary investigation This describes the time taken for thermal convergence, at which a constant temperature gradient is achieved as the temperature at every discrete point along the rod remains constant, while varying linearly in space along the original direction of heat transfer [] These times were found to be O s and O s for situations (i) and (ii) respectively as shown in Figure 8 The order of magnitude discrepancy can be accounted for by the presence of the ice reducing the mean thermal energy within the rod allowing quicker convergence Despite the similarities at early times, the steady state distribution for (i) is a horizontal line at T (x) = C and a diagonal line of the form T (x) = ( x + ) C for (ii) as the final element is always fixed by the temperature of the ice Alteration of the source code allowed time to be varied incrementally with the approximate steady state times determined from Figure 8 set as maximal values This created near continuous, three dimensional thermal distributions, T (x, t) as shown in Figures 9 & (8) (9)

5 Exercise : Partial Differential Equations Table Summary of graphical fit analysis Figure Fit Form A B C Reduced χ (Jacobi) Bρ n + C ± ± 9668 (Gauss-Seidel) Bρ n + C - ± ± 89 6 (Jacobi) Aρ n + C 69 ± ± 6 7 (Gauss-Seidel) Aρ n + C 7 ± 96-7 ± A (a/d) B + C 6 ± ± ± T(x,t) ( C) t = s t = s t = s t = s t = s t = s t = s t = s t = s t = s Figure 8 Preliminary temperature distribution as a function of position along the rod, T (x, t) at a variety of elapsed times for each physical situation; no heat loss from the far end of the poker (above) and the far end of the poker is immersed in a block of ice at C (below) 7 T(x,t) ( C) Figure 9 Temperature distribution T (x, t) for each physical situation; no heat loss from the far end of the poker (above) and the far end of the poker is immersed in a block of ice at C (below) This paper has been typeset from a TEX/ L A TEX file prepared by the author ACKNOWLEDGEMENTS I thank my collaborators for assistance and C Lucas for guidance throughout the duration of the course This work made extensive use of GNU s GSL library REFERENCES () Trefethen, LN, Bau III, D, Numerical Linear Algebra, Society for Industrial and Applied Mathematics, 997, 8, () Press, WH, et al, Numerical Recipes in C (The Art of Scientific Computing), rd edn Cambridge Univ Press, Cambridge, 7 ()Blundell, S, Blundell, K, Concepts In Thermal Physics, nd edn Oxford Univ Press, Oxford 6

6 6 J F Ider Chitham T(x,t) T(x,t) Figure Three dimensional temperature distribution T (x, t) for each physical situation; no heat loss from the far end of the poker (above) and the far end of the poker is immersed in a block of ice at C (below)

Exercise 3: Random Numbers and Monte Carlo

Exercise 3: Random Numbers and Monte Carlo Exercise : Random Numbers and Monte Carlo J. F. Ider Chitham Astrophysics Group, H.H. Wills Physics Laboratory, University of Bristol, Tyndall Avenue, Bristol BS8 TL Accepted March. Received March ; in

More information

7 Mathematical Methods 7.6 Insulation (10 units)

7 Mathematical Methods 7.6 Insulation (10 units) 7 Mathematical Methods 7.6 Insulation (10 units) There are no prerequisites for this project. 1 Introduction When sheets of plastic and of other insulating materials are used in the construction of building

More information

Non-linear least squares

Non-linear least squares Non-linear least squares Concept of non-linear least squares We have extensively studied linear least squares or linear regression. We see that there is a unique regression line that can be determined

More information

Lecture 7. Capacitors and Electric Field Energy. Last lecture review: Electrostatic potential

Lecture 7. Capacitors and Electric Field Energy. Last lecture review: Electrostatic potential Lecture 7. Capacitors and Electric Field Energy Last lecture review: Electrostatic potential V r = U r q Q Iclicker question The figure shows cross sections through two equipotential surfaces. In both

More information

Introduction to Heat and Mass Transfer. Week 9

Introduction to Heat and Mass Transfer. Week 9 Introduction to Heat and Mass Transfer Week 9 補充! Multidimensional Effects Transient problems with heat transfer in two or three dimensions can be considered using the solutions obtained for one dimensional

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

STA 4273H: Statistical Machine Learning

STA 4273H: Statistical Machine Learning STA 4273H: Statistical Machine Learning Russ Salakhutdinov Department of Statistics! rsalakhu@utstat.toronto.edu! http://www.utstat.utoronto.ca/~rsalakhu/ Sidney Smith Hall, Room 6002 Lecture 3 Linear

More information

DOING PHYSICS WITH MATLAB. ELECTRIC FIELD AND ELECTRIC POTENTIAL: POISSON S and LAPLACES S EQUATIONS

DOING PHYSICS WITH MATLAB. ELECTRIC FIELD AND ELECTRIC POTENTIAL: POISSON S and LAPLACES S EQUATIONS DOING PHYSICS WITH MATLAB ELECTRIC FIELD AND ELECTRIC POTENTIAL: POISSON S and LAPLACES S EQUATIONS Ian Cooper School of Physics, University of Sydney ian.cooper@sydney.edu.au DOWNLOAD DIRECTORY FOR MATLAB

More information

Lecture 13: Electromagnetic Theory Professor D. K. Ghosh, Physics Department, I.I.T., Bombay. Poisson s and Laplace s Equations

Lecture 13: Electromagnetic Theory Professor D. K. Ghosh, Physics Department, I.I.T., Bombay. Poisson s and Laplace s Equations Poisson s and Laplace s Equations Lecture 13: Electromagnetic Theory Professor D. K. Ghosh, Physics Department, I.I.T., Bombay We will spend some time in looking at the mathematical foundations of electrostatics.

More information

Introduction to Computational Fluid Dynamics

Introduction to Computational Fluid Dynamics AML2506 Biomechanics and Flow Simulation Day Introduction to Computational Fluid Dynamics Session Speaker Dr. M. D. Deshpande M.S. Ramaiah School of Advanced Studies - Bangalore 1 Session Objectives At

More information

August 7, 2007 NUMERICAL SOLUTION OF LAPLACE'S EQUATION

August 7, 2007 NUMERICAL SOLUTION OF LAPLACE'S EQUATION August 7, 007 NUMERICAL SOLUTION OF LAPLACE'S EQUATION PURPOSE: This experiment illustrates the numerical solution of Laplace's Equation using a relaxation method. The results of the relaxation method

More information

Solution Methods. Steady convection-diffusion equation. Lecture 05

Solution Methods. Steady convection-diffusion equation. Lecture 05 Solution Methods Steady convection-diffusion equation Lecture 05 1 Navier-Stokes equation Suggested reading: Gauss divergence theorem Integral form The key step of the finite volume method is to integrate

More information

Electrostatics: Electrostatic Devices

Electrostatics: Electrostatic Devices Electrostatics: Electrostatic Devices EE331 Electromagnetic Field Theory Outline Laplace s Equation Derivation Meaning Solving Laplace s equation Resistors Capacitors Electrostatics -- Devices Slide 1

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

More information

CS 542G: The Poisson Problem, Finite Differences

CS 542G: The Poisson Problem, Finite Differences CS 542G: The Poisson Problem, Finite Differences Robert Bridson November 10, 2008 1 The Poisson Problem At the end last time, we noticed that the gravitational potential has a zero Laplacian except at

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

Elements of Vector Calculus : Scalar Field & its Gradient

Elements of Vector Calculus : Scalar Field & its Gradient Elements of Vector Calculus : Scalar Field & its Gradient Lecture 1 : Electromagnetic Theory Professor D. K. Ghosh, Physics Department, I.I.T., Bombay Introduction : In this set of approximately 40 lectures

More information

Computational Techniques Prof. Sreenivas Jayanthi. Department of Chemical Engineering Indian institute of Technology, Madras

Computational Techniques Prof. Sreenivas Jayanthi. Department of Chemical Engineering Indian institute of Technology, Madras Computational Techniques Prof. Sreenivas Jayanthi. Department of Chemical Engineering Indian institute of Technology, Madras Module No. # 05 Lecture No. # 24 Gauss-Jordan method L U decomposition method

More information

Potential from a distribution of charges = 1

Potential from a distribution of charges = 1 Lecture 7 Potential from a distribution of charges V = 1 4 0 X Smooth distribution i q i r i V = 1 4 0 X i q i r i = 1 4 0 Z r dv Calculating the electric potential from a group of point charges is usually

More information

1 Finite difference example: 1D implicit heat equation

1 Finite difference example: 1D implicit heat equation 1 Finite difference example: 1D implicit heat equation 1.1 Boundary conditions Neumann and Dirichlet We solve the transient heat equation ρc p t = ( k ) (1) on the domain L/2 x L/2 subject to the following

More information

Solution of System of Linear Equations & Eigen Values and Eigen Vectors

Solution of System of Linear Equations & Eigen Values and Eigen Vectors Solution of System of Linear Equations & Eigen Values and Eigen Vectors P. Sam Johnson March 30, 2015 P. Sam Johnson (NITK) Solution of System of Linear Equations & Eigen Values and Eigen Vectors March

More information

Introduction to Heat and Mass Transfer. Week 7

Introduction to Heat and Mass Transfer. Week 7 Introduction to Heat and Mass Transfer Week 7 Example Solution Technique Using either finite difference method or finite volume method, we end up with a set of simultaneous algebraic equations in terms

More information

Introduction to Heat and Mass Transfer. Week 8

Introduction to Heat and Mass Transfer. Week 8 Introduction to Heat and Mass Transfer Week 8 Next Topic Transient Conduction» Analytical Method Plane Wall Radial Systems Semi-infinite Solid Multidimensional Effects Analytical Method Lumped system analysis

More information

Open Problems in Mixed Models

Open Problems in Mixed Models xxiii Determining how to deal with a not positive definite covariance matrix of random effects, D during maximum likelihood estimation algorithms. Several strategies are discussed in Section 2.15. For

More information

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS 5.1 Introduction When a physical system depends on more than one variable a general

More information

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

Department of Mathematics California State University, Los Angeles Master s Degree Comprehensive Examination in. NUMERICAL ANALYSIS Spring 2015 Department of Mathematics California State University, Los Angeles Master s Degree Comprehensive Examination in NUMERICAL ANALYSIS Spring 2015 Instructions: Do exactly two problems from Part A AND two

More information

YEAR 10 PROGRAM TERM 1 TERM 2 TERM 3 TERM 4

YEAR 10 PROGRAM TERM 1 TERM 2 TERM 3 TERM 4 YEAR 10 PROGRAM TERM 1 1. Revision of number operations 3 + T wk 2 2. Expansion 3 + T wk 4 3. Factorisation 7 + T wk 6 4. Algebraic Fractions 4 + T wk 7 5. Formulae 5 + T wk 9 6. Linear Equations 10 +T

More information

free space (vacuum) permittivity [ F/m]

free space (vacuum) permittivity [ F/m] Electrostatic Fields Electrostatic fields are static (time-invariant) electric fields produced by static (stationary) charge distributions. The mathematical definition of the electrostatic field is derived

More information

Measurement of electric potential fields

Measurement of electric potential fields Measurement of electric potential fields Matthew Krupcale, Oliver Ernst Department of Physics, Case Western Reserve University, Cleveland Ohio, 44106-7079 18 November 2012 Abstract In electrostatics, Laplace

More information

Discretization of Convection Diffusion type equation

Discretization of Convection Diffusion type equation Discretization of Convection Diffusion type equation 10 th Indo German Winter Academy 2011 By, Rajesh Sridhar, Indian Institute of Technology Madras Guides: Prof. Vivek V. Buwa Prof. Suman Chakraborty

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

Chapter 7. Three Dimensional Modelling of Buoyancy-Driven Displacement Ventilation: Point Source

Chapter 7. Three Dimensional Modelling of Buoyancy-Driven Displacement Ventilation: Point Source Chapter 7 Three Dimensional Modelling of Buoyancy-Driven Displacement Ventilation: Point Source 135 7. Three Dimensional Modelling of Buoyancy- Driven Displacement Ventilation: Point Source 7.1 Preamble

More information

Lab 1: Numerical Solution of Laplace s Equation

Lab 1: Numerical Solution of Laplace s Equation Lab 1: Numerical Solution of Laplace s Equation ELEC 3105 last modified August 27, 2012 1 Before You Start This lab and all relevant files can be found at the course website. You will need to obtain an

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

Course Notes: Week 1

Course Notes: Week 1 Course Notes: Week 1 Math 270C: Applied Numerical Linear Algebra 1 Lecture 1: Introduction (3/28/11) We will focus on iterative methods for solving linear systems of equations (and some discussion of eigenvalues

More information

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

ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices. Numerical Methods and Simulation / Umberto Ravaioli ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices 1 General concepts Numerical Methods and Simulation / Umberto Ravaioli Introduction to the Numerical Solution of Partial Differential

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

Numerical Solution for Two Dimensional Laplace Equation with Dirichlet Boundary Conditions

Numerical Solution for Two Dimensional Laplace Equation with Dirichlet Boundary Conditions IOSR Journal of Mathematics (IOSR-JM) e-issn: 2278-5728,p-ISSN: 2319-765X, Volume 6, Issue 4 (May. - Jun. 2013), PP 66-75 Numerical Solution for Two Dimensional Laplace Equation with Dirichlet Boundary

More information

Classification of partial differential equations and their solution characteristics

Classification of partial differential equations and their solution characteristics 9 TH INDO GERMAN WINTER ACADEMY 2010 Classification of partial differential equations and their solution characteristics By Ankita Bhutani IIT Roorkee Tutors: Prof. V. Buwa Prof. S. V. R. Rao Prof. U.

More information

Gross Motion Planning

Gross Motion Planning Gross Motion Planning...given a moving object, A, initially in an unoccupied region of freespace, s, a set of stationary objects, B i, at known locations, and a legal goal position, g, find a sequence

More information

Unit-1 Electrostatics-1

Unit-1 Electrostatics-1 1. Describe about Co-ordinate Systems. Co-ordinate Systems Unit-1 Electrostatics-1 In order to describe the spatial variations of the quantities, we require using appropriate coordinate system. A point

More information

Computer Aided Design of Thermal Systems (ME648)

Computer Aided Design of Thermal Systems (ME648) Computer Aided Design of Thermal Systems (ME648) PG/Open Elective Credits: 3-0-0-9 Updated Syallabus: Introduction. Basic Considerations in Design. Modelling of Thermal Systems. Numerical Modelling and

More information

ME Computational Fluid Mechanics Lecture 5

ME Computational Fluid Mechanics Lecture 5 ME - 733 Computational Fluid Mechanics Lecture 5 Dr./ Ahmed Nagib Elmekawy Dec. 20, 2018 Elliptic PDEs: Finite Difference Formulation Using central difference formulation, the so called five-point formula

More information

Optimization Tutorial 1. Basic Gradient Descent

Optimization Tutorial 1. Basic Gradient Descent E0 270 Machine Learning Jan 16, 2015 Optimization Tutorial 1 Basic Gradient Descent Lecture by Harikrishna Narasimhan Note: This tutorial shall assume background in elementary calculus and linear algebra.

More information

Technology Computer Aided Design (TCAD) Laboratory. Lecture 2, A simulation primer

Technology Computer Aided Design (TCAD) Laboratory. Lecture 2, A simulation primer Technology Computer Aided Design (TCAD) Laboratory Lecture 2, A simulation primer [Source: Synopsys] Giovanni Betti Beneventi E-mail: gbbeneventi@arces.unibo.it ; giobettibeneventi@gmail.com Office: Engineering

More information

Numerical Linear Algebra Primer. Ryan Tibshirani Convex Optimization

Numerical Linear Algebra Primer. Ryan Tibshirani Convex Optimization Numerical Linear Algebra Primer Ryan Tibshirani Convex Optimization 10-725 Consider Last time: proximal Newton method min x g(x) + h(x) where g, h convex, g twice differentiable, and h simple. Proximal

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

Iterative Solvers. Lab 6. Iterative Methods

Iterative Solvers. Lab 6. Iterative Methods Lab 6 Iterative Solvers Lab Objective: Many real-world problems of the form Ax = b have tens of thousands of parameters Solving such systems with Gaussian elimination or matrix factorizations could require

More information

Partial Differential Equations

Partial Differential Equations Next: Using Matlab Up: Numerical Analysis for Chemical Previous: Ordinary Differential Equations Subsections Finite Difference: Elliptic Equations The Laplace Equations Solution Techniques Boundary Conditions

More information

Experiment 2 Electric Field Mapping

Experiment 2 Electric Field Mapping Experiment 2 Electric Field Mapping I hear and I forget. I see and I remember. I do and I understand Anonymous OBJECTIVE To visualize some electrostatic potentials and fields. THEORY Our goal is to explore

More information

PHYSICS ASSIGNMENT ES/CE/MAG. Class XII

PHYSICS ASSIGNMENT ES/CE/MAG. Class XII PHYSICS ASSIGNMENT ES/CE/MAG Class XII MM : 70 1. What is dielectric strength of a medium? Give its value for vacuum. 1 2. What is the physical importance of the line integral of an electrostatic field?

More information

End-of-Chapter Exercises

End-of-Chapter Exercises End-of-Chapter Exercises Exercises 1 12 are primarily conceptual questions designed to see whether you understand the main concepts of the chapter. 1. (a) If the electric field at a particular point is

More information

7. A capacitor has been charged by a D C source. What are the magnitude of conduction and displacement current, when it is fully charged?

7. A capacitor has been charged by a D C source. What are the magnitude of conduction and displacement current, when it is fully charged? 1. In which Orientation, a dipole placed in uniform electric field is in (a) stable (b) unstable equilibrium. 2. Two point charges having equal charges separated by 1 m in distance experience a force of

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

1.5 Phase Line and Bifurcation Diagrams

1.5 Phase Line and Bifurcation Diagrams 1.5 Phase Line and Bifurcation Diagrams 49 1.5 Phase Line and Bifurcation Diagrams Technical publications may use special diagrams to display qualitative information about the equilibrium points of the

More information

Electric Field Mapping

Electric Field Mapping Electric Field Mapping I hear and I forget. I see and I remember. I do and I understand Anonymous OBJECTIVE To visualize some electrostatic potentials and fields. THEORY Our goal is to explore the electric

More information

A marks are for accuracy and are not given unless the relevant M mark has been given (M0 A1 is impossible!).

A marks are for accuracy and are not given unless the relevant M mark has been given (M0 A1 is impossible!). NOTES 1) In the marking scheme there are three types of marks: M marks are for method A marks are for accuracy and are not given unless the relevant M mark has been given (M0 is impossible!). B marks are

More information

UNIT I ELECTROSTATIC FIELDS

UNIT I ELECTROSTATIC FIELDS UNIT I ELECTROSTATIC FIELDS 1) Define electric potential and potential difference. 2) Name few applications of gauss law in electrostatics. 3) State point form of Ohm s Law. 4) State Divergence Theorem.

More information

9.1 Preconditioned Krylov Subspace Methods

9.1 Preconditioned Krylov Subspace Methods Chapter 9 PRECONDITIONING 9.1 Preconditioned Krylov Subspace Methods 9.2 Preconditioned Conjugate Gradient 9.3 Preconditioned Generalized Minimal Residual 9.4 Relaxation Method Preconditioners 9.5 Incomplete

More information

Lightning Phenomenology Notes Note 23 8 Jan Lightning Responses on a Finite Cylindrical Enclosure

Lightning Phenomenology Notes Note 23 8 Jan Lightning Responses on a Finite Cylindrical Enclosure Lightning Phenomenology Notes Note 23 8 Jan 2014 Lightning Responses on a Finite Cylindrical Enclosure Kenneth C. Chen and Larry K. Warne Sandia National Laboratories, P. O. Box 5800, Albuquerque, NM 87185,

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

Additive Manufacturing Module 8

Additive Manufacturing Module 8 Additive Manufacturing Module 8 Spring 2015 Wenchao Zhou zhouw@uark.edu (479) 575-7250 The Department of Mechanical Engineering University of Arkansas, Fayetteville 1 Evaluating design https://www.youtube.com/watch?v=p

More information

The Electric Field of a Finite Line of Charge The Electric Field of a Finite Line of

The Electric Field of a Finite Line of Charge The Electric Field of a Finite Line of The Electric Field of a Finite Line of Charge The Electric Field of a Finite Line of Charge Example 26.3 in the text uses integration to find the electric field strength at a radial distance r in the plane

More information

9/10/2018. An Infinite Line of Charge. The electric field of a thin, uniformly charged rod may be written:

9/10/2018. An Infinite Line of Charge. The electric field of a thin, uniformly charged rod may be written: The Electric Field of a Finite Line of Charge The Electric Field of a Finite Line of Charge Example 26.3 in the text uses integration to find the electric field strength at a radial distance r in the plane

More information

Cambridge International Advanced Level 9231 Further Mathematics November 2010 Principal Examiner Report for Teachers

Cambridge International Advanced Level 9231 Further Mathematics November 2010 Principal Examiner Report for Teachers FURTHER MATHEMATICS Paper 9/0 Paper General comments The scripts for this paper were of a generally good quality There were a number of outstanding scripts and many showing evidence of sound learning Work

More information

The Solution of Linear Systems AX = B

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

More information

Chapter 24. Electric Potential

Chapter 24. Electric Potential Chapter 24 Chapter 24 Electric Potential Electric Potential Energy When an electrostatic force acts between two or more charged particles within a system of particles, we can assign an electric potential

More information

PDE Solvers for Fluid Flow

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

More information

Lecture 13: Solution to Poission Equation, Numerical Integration, and Wave Equation 1. REVIEW: Poisson s Equation Solution

Lecture 13: Solution to Poission Equation, Numerical Integration, and Wave Equation 1. REVIEW: Poisson s Equation Solution Lecture 13: Solution to Poission Equation, Numerical Integration, and Wave Equation 1 Poisson s Equation REVIEW: Poisson s Equation Solution Poisson s equation relates the potential function V (x, y, z)

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

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

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

Numerical Linear Algebra Primer. Ryan Tibshirani Convex Optimization /36-725

Numerical Linear Algebra Primer. Ryan Tibshirani Convex Optimization /36-725 Numerical Linear Algebra Primer Ryan Tibshirani Convex Optimization 10-725/36-725 Last time: proximal gradient descent Consider the problem min g(x) + h(x) with g, h convex, g differentiable, and h simple

More information

Today s class. Linear Algebraic Equations LU Decomposition. Numerical Methods, Fall 2011 Lecture 8. Prof. Jinbo Bi CSE, UConn

Today s class. Linear Algebraic Equations LU Decomposition. Numerical Methods, Fall 2011 Lecture 8. Prof. Jinbo Bi CSE, UConn Today s class Linear Algebraic Equations LU Decomposition 1 Linear Algebraic Equations Gaussian Elimination works well for solving linear systems of the form: AX = B What if you have to solve the linear

More information

IYGB Mathematical Methods 1

IYGB Mathematical Methods 1 IYGB Mathematical Methods Practice Paper B Time: 3 hours Candidates may use any non programmable, non graphical calculator which does not have the capability of storing data or manipulating algebraic expressions

More information

Chapter 3 Three Dimensional Finite Difference Modeling

Chapter 3 Three Dimensional Finite Difference Modeling Chapter 3 Three Dimensional Finite Difference Modeling As has been shown in previous chapters, the thermal impedance of microbolometers is an important property affecting device performance. In chapter

More information

Basic Aspects of Discretization

Basic Aspects of Discretization Basic Aspects of Discretization Solution Methods Singularity Methods Panel method and VLM Simple, very powerful, can be used on PC Nonlinear flow effects were excluded Direct numerical Methods (Field Methods)

More information

Physics (

Physics ( Question 2.12: A charge of 8 mc is located at the origin. Calculate the work done in taking a small charge of 2 10 9 C from a point P (0, 0, 3 cm) to a point Q (0, 4 cm, 0), via a point R (0, 6 cm, 9 cm).

More information

IYGB Mathematical Methods 1

IYGB Mathematical Methods 1 IYGB Mathematical Methods Practice Paper A Time: 3 hours Candidates may use any non programmable, non graphical calculator which does not have the capability of storing data or manipulating algebraic expressions

More information

Electric fields in matter

Electric fields in matter Electric fields in matter November 2, 25 Suppose we apply a constant electric field to a block of material. Then the charges that make up the matter are no longer in equilibrium: the electrons tend to

More information

Solving a non-linear partial differential equation for the simulation of tumour oxygenation

Solving a non-linear partial differential equation for the simulation of tumour oxygenation Solving a non-linear partial differential equation for the simulation of tumour oxygenation Julian Köllermeier, Lisa Kusch, Thorsten Lajewski MathCCES, RWTH Aachen Lunch Talk, 26.05.2011 J. Köllermeier,

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

FINITE VOLUME METHOD: BASIC PRINCIPLES AND EXAMPLES

FINITE VOLUME METHOD: BASIC PRINCIPLES AND EXAMPLES FINITE VOLUME METHOD: BASIC PRINCIPLES AND EXAMPLES SHRUTI JAIN B.Tech III Year, Electronics and Communication IIT Roorkee Tutors: Professor G. Biswas Professor S. Chakraborty ACKNOWLEDGMENTS I would like

More information

Consider a point P on the line joining the two charges, as shown in the given figure.

Consider a point P on the line joining the two charges, as shown in the given figure. Question 2.1: Two charges 5 10 8 C and 3 10 8 C are located 16 cm apart. At what point(s) on the line joining the two charges is the electric potential zero? Take the potential at infinity to be zero.

More information

Computation Fluid Dynamics

Computation Fluid Dynamics Computation Fluid Dynamics CFD I Jitesh Gajjar Maths Dept Manchester University Computation Fluid Dynamics p.1/189 Garbage In, Garbage Out We will begin with a discussion of errors. Useful to understand

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

Solution Methods. Steady State Diffusion Equation. Lecture 04

Solution Methods. Steady State Diffusion Equation. Lecture 04 Solution Methods Steady State Diffusion Equation Lecture 04 1 Solution methods Focus on finite volume method. Background of finite volume method. Discretization example. General solution method. Convergence.

More information

Physics 2019 v1.2. IA1 sample assessment instrument. Data test (10%) August Assessment objectives

Physics 2019 v1.2. IA1 sample assessment instrument. Data test (10%) August Assessment objectives Data test (10%) This sample has been compiled by the QCAA to assist and support teachers in planning and developing assessment instruments for individual school settings. Assessment objectives This assessment

More information

Second Order Iterative Techniques for Boundary Value Problems and Fredholm Integral Equations

Second Order Iterative Techniques for Boundary Value Problems and Fredholm Integral Equations Computational and Applied Mathematics Journal 2017; 3(3): 13-21 http://www.aascit.org/journal/camj ISSN: 2381-1218 (Print); ISSN: 2381-1226 (Online) Second Order Iterative Techniques for Boundary Value

More information

Exact and Approximate Numbers:

Exact and Approximate Numbers: Eact and Approimate Numbers: The numbers that arise in technical applications are better described as eact numbers because there is not the sort of uncertainty in their values that was described above.

More information

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

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA Introduction to Finite and Spectral Element Methods Using MATLAB Second Edition C. Pozrikidis University of Massachusetts Amherst, USA (g) CRC Press Taylor & Francis Group Boca Raton London New York CRC

More information

Lecture 18 Capacitance and Conductance

Lecture 18 Capacitance and Conductance Lecture 18 Capacitance and Conductance Sections: 6.3, 6.4, 6.5 Homework: See homework file Definition of Capacitance capacitance is a measure of the ability of the physical structure to accumulate electrical

More information

Matrix inversion and linear equations

Matrix inversion and linear equations Learning objectives. Matri inversion and linear equations Know Cramer s rule Understand how linear equations can be represented in matri form Know how to solve linear equations using matrices and Cramer

More information

Iterative Methods for Ax=b

Iterative Methods for Ax=b 1 FUNDAMENTALS 1 Iterative Methods for Ax=b 1 Fundamentals consider the solution of the set of simultaneous equations Ax = b where A is a square matrix, n n and b is a right hand vector. We write the iterative

More information

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

More information

Self-Concordant Barrier Functions for Convex Optimization

Self-Concordant Barrier Functions for Convex Optimization Appendix F Self-Concordant Barrier Functions for Convex Optimization F.1 Introduction In this Appendix we present a framework for developing polynomial-time algorithms for the solution of convex optimization

More information

EAD 115. Numerical Solution of Engineering and Scientific Problems. David M. Rocke Department of Applied Science

EAD 115. Numerical Solution of Engineering and Scientific Problems. David M. Rocke Department of Applied Science EAD 115 Numerical Solution of Engineering and Scientific Problems David M. Rocke Department of Applied Science Taylor s Theorem Can often approximate a function by a polynomial The error in the approximation

More information

Electric Potential. Capacitors (Chapters 28, 29)

Electric Potential. Capacitors (Chapters 28, 29) Electric Potential. Capacitors (Chapters 28, 29) Electric potential energy, U Electric potential energy in a constant field Conservation of energy Electric potential, V Relation to the electric field strength

More information

NUMERICAL COMPUTATION IN SCIENCE AND ENGINEERING

NUMERICAL COMPUTATION IN SCIENCE AND ENGINEERING NUMERICAL COMPUTATION IN SCIENCE AND ENGINEERING C. Pozrikidis University of California, San Diego New York Oxford OXFORD UNIVERSITY PRESS 1998 CONTENTS Preface ix Pseudocode Language Commands xi 1 Numerical

More information