Practical in Numerical Astronomy, SS 2012 LECTURE 9

Size: px
Start display at page:

Download "Practical in Numerical Astronomy, SS 2012 LECTURE 9"

Transcription

1 Practical in Numerical Astronomy, SS 01 Elliptic partial differential equations. Poisson solvers. LECTURE 9 1. Gravity force and the equations of hydrodynamics. Poisson equation versus Poisson integral. Numerical solution of the Poisson equation 4. Numerical integration of the Poisson integral Lecturer Eduard Vorobyov. eduard.vorobiev@univie.ac.at 1

2 GRAVITY FORCE and THE EQUATIONS OF HYDRODYNAMICS

3 External gravity vs. self-gravity Although gravity is omnipresent in the Universe, its effect is often simplified or even neglected. However, there are situations when an accurate calculation of gravity is a necessity. In this context, two conceptually distinct descriptions of gravity are often used: external gravity and internal self-gravity. 1 External gravity is an additional external force acting onto the object under consideration. At the same time, the back reaction of the object onto the external perturber is neglected. The typical examples are the motion of gas and stars in the gravitational potential of the dark matter halo or the motion of a planet in the gravitational potential of a star. Internal self-gravity or, simply, self-gravity acts as an intrinsic force, like that of the gas pressure, arising due to gravitational interaction of particles constituting the object under consideration. The typical examples are the gravitational collapse of pre-stellar cores, formation of protostars and planets in protostellar disks or the growth of spiral structures in disk galaxies Myr 0. Myr 0.5 Myr Myr -1 Radial distance (kpc Gyr Gyr Gyr Gyr Radial distance (AU Radial distance (AU Radial distance (kpc Radial distance (kpc Gyr. Gyr.4 Gyr.0 Gyr. Gyr.7 Gyr Gyr 4.1 Gyr

4 If gravity cannot be neglected, the equations of hydrodynamics need to be modified to include the effect of gravitational acceleration g Equations of hydrodynamics in Cartesian coordinates (i,j = x,y,z ( ρu pressure force per unit volume viscous force per unit volume ρ + i = 0 t xi P π ρ ui + ρ ui u j + ρ gi = t x x x ( ij 0 j i j gravity force per unit volume E + E + P u j ui ji uigi = t x j ( π ρ 0 work per unit volume per unit time due to gravity force See Nigel s lecture for more details 4

5 DERIVING THE POISSON EQUATION and POISSON INTEGRAL FROM NEWTON S LAW OF GRAVITY 5

6 Newton s law of gravity for two-body interaction F GMm r = -- scalar form of Newton s law for two-body interaction F GMm = r r vector form of Newton s law for two-body interaction, where r is the position vector of a particle with mass m, and F is the gravity force acting on that object from a particle with mass M. Note the minus sign appearing due to the fact that r and F are pointed in opposite directions. M r F m Applying nd Newton s law, one gets the gravitational acceleration g GMm GM F = mg = r g = r r r In the following slides, boldfaced values are vectors or tensors 6

7 Newton s law of gravity for many interacting bodies j=1 g( r i N = GM ( r - r r - r j= 1 i j i j total acceleration acting on particle i from particles j=(1 N. r i g j=1 i r i -r j rj g j= g j=n j=n j= g( r = G V ρ ( r ( r - r d r - r r acceleration acting at position vector r within a continuous body with density ρ and volume V r = d dx dy dz in Cartesian coordinates r d = dz dr r dϕ in cylindrical coordinates d r = dr r dθ r sin θ dϕ in spherical coordinates r r 7

8 Gravitational potential Gravity is the so-called central force whose magnitude only depends on the distance r between the interacting objects and is directed along the line joining them. Work done by the gravity force has a nice property such that it does not depend on the path but only on the starting and finishing points. This allows us to define the gravitational potential Φ as follows r r r Φ A = Fdr = mgdr = m dr = m Φ( r Φ( r1 r r r r [ ] The minus sign is due to the fact that Φ is negative ρ ( r ( r - r g( r = Φ ( r = G d r, = r - r r V where is the Nabla operator Gravitational potential is a scalar field in the sense that it takes scalar values but, at the same time, is a function of the position vector. It has dimensions of energy per unit mass and is always negative (due to attraction nature of the gravity force. 8

9 Deriving Poisson equation and Poisson integral Φ ( r = G V ρ ( r ( r - r d r - r r Let us use the following two vector identities 1 r r r = ; = 4 πδ ( r r r r r r proof can be done expanding these identities in Cartesian coordinates applying the first identity ρ( r ( r - r d Φ ( r = r = r - r V ρ( r ρ( r = G d r = G d r r r r r V G V applying the second identity ρ( r ( r - r Φ ( r = Φ ( r = G d r = r - r V = = 4 πg ρ( r δ ( r - r d r 4 πgρ( r we arrive at the Poisson integral we arrive at the Poisson equation Φ ( r = G V ρ ( r d r r r where Φ ( r = 4 πgρ( r, = r r is the Laplace operator 9

10 POISSON EQUATION - a prototype elliptic partial differential equation 10

11 Expansion of the Poisson equation in orthogonal coordinates Φ ( r = 4 πgρ( r where the Laplace operator has the following form in three main orthogonal coordinate systems = + + Cartesian (x,y,z x y z 1 1 = + r + z r r r r ϕ Cylindrical (z,r, ϕ = r sin + θ + r r r r sinθ θ θ r sin θ ϕ Spherical (r, θ, ϕ 11

12 Classification of the Poisson equation The general second-order PDE in two independent variables x and y has the form f f f f f x x y y x y A + B + C + D + E + F f + G = 0, (1 where f (x,y is the unknown function and coefficients A, B, C, D, E, F, and G may be constant or may also depend on x and y A B B C > 0 If, equation (1 is said to be a linear elliptic PDE. The Poisson equation is the prototype example. In the example below, the determinant is equal to unity Φ Φ + = 4π Gρ x y 1

13 Elliptical PDEs are different from parabolic PDEs (e.g., diffusion equation or hyperbolic PDEs (wave equation, transport equation in the sense that the latter are the initial value problems while the former is the boundary value problem. = + t x y f f f Φ Φ Φ + + = 4π Gρ x y z t=t 1 t=t 0 x y z Φ is known x y Φ is known at the cube faces but is unknown inside the cube Solving for the diffusion equation means advancing the solution in time starting from the initial layer of known values of f at t=t 0. That is why this sort of problems is called the initial value problem. Boundary values also need to be known but only one layer at a time. Solving for the Poisson equation means finding all the values of the potential Φ inside the cube at once using precalculated boundary values. Usually, one cannot march from the outer boundary towards the center in the same sense as the initial value problem can be integrated forward in time.

14 NUMERICAL SOLUTION of the POISSON EQUATION 14

15 dy dx Discretization of the Poisson equation Suppose we need to find the gravitational potential on a mesh with x grid zones of equal size in each direction. The grid zone size is dx and dy in the x- and y-directions. The first step would be to discretize the D Poisson equation. Φ 1, j= j= Φ Φ Φ = + = 4π Gρ x y Discretizing the first derivative Φ x i+ 1/ = Φ i+ 1, j i, j dx Φ boundary value, Φ 0, i=0 i=1 i= i= boundary layer Φ x 1+ 1/, j=1 Discretizing the second derivative Φ x Φ x Φ i+ 1/, j i 1/, j = x dx For a simple case of D Cartesian equidistant mesh we obtain a five-zone molecule Φi+ 1, j Φ i, j + Φi 1, j Φi, j+ 1 Φ i, j + Φi, j 1 Φ = + = dx dy 4π Gρ i, j 15

16 The discretized Poisson equation on equidistant Cartesian mesh It is convenient to express the discretized Poisson equation as follows a Φ + a Φ + a Φ + a Φ + a Φ = S 1 i+ 1, j i, j+ 1 i, j 4 i 1, j 5 i, j 1 i, j (1 dy dx dx dy dy dx a1 =, a =, a =, a4, a5, Si, j 4π Gρij dx dy dx dy + dy dx = = = dx dy Expanding equation (1 for each grid zone (i =1,, and j =1,,, we obtain ( a Φ + a Φ + a Φ + a Φ + a Φ = S, for i = 1, j = 1 1,1 1, 1,1 4 0,1 5 1,0 11 a1φ, + aφ 1, + aφ 1, + a4φ 0, + a5φ 1,1 = S1, for i = 1, j = a1φ, + aφ 1,4 + aφ 1, + a4φ 0, + a5φ 1, = S1, for i = 1, j =. a1φ 4, + aφ,4 + aφ, + a4φ, + a5φ, = S, for i =, j =

17 ( Rearranging system (, we obtain nine equations for nine unknown Φ i,j a Φ + a Φ + 0Φ + a Φ + 0Φ + 0Φ + 0Φ + 0Φ + 0Φ = S a Φ a Φ 1,1 1, 1, 1,1,,,1,, ,1 5 1,0 a Φ + a Φ + a Φ + 0Φ + a Φ + 0Φ + 0Φ + 0Φ + 0Φ = S a Φ 5 1,1 1, 1,,1 1,,,1,, 1, 4 0, 0Φ + a Φ + a Φ + 0Φ + 0Φ + a Φ + 0Φ + 0Φ + 0Φ = S a Φ a Φ 1,1 5 1, 1,,1, 1,,1,, 1, 1,4 4 0,. 0Φ + 0Φ + 0Φ + 0Φ + 0Φ + a Φ + 0Φ + a Φ + a Φ = S a Φ a Φ 1,1 1, 1,,1, 4,,1 5,,, 1 4,,4 Discretized Poisson equation turns into a system of equations which can be expressed in the matrix form A Φ S a,b a 0 a b 0 0 a 5 a,b a 0 a b 0 Φ 11 Φ 1 S 11,b S 1,b 0 a 5 a,b 0 0 a b a a,b a 0 a a 4 0 a 5 a a 0 a 1 0 Φ 1 Φ 1 Φ S 1,b S 1,b S,b 0 0 a 4 0 a 5 a,b 0 0 a 1 0 b 0 0 a a,b a 0 Φ Φ 1 S,b S 1,b 0 0 b 0 0 a 4 0 a 5 a,b a Φ S,b b 0 0 a 4 0 a 5 a,b Φ S,b 17

18 Boundary conditions The subscript b indicates that these values can be affected by the boundary conditions a,b a 0 a b 0 0 a 5 a,b a 0 a b 0 0 a 5 a,b 0 0 a b a a,b a 0 a a 4 0 a 5 a a 0 a a 4 0 a 5 a,b 0 0 a 1 0 b 0 0 a a,b a b 0 0 a 4 0 a 5 a,b a b 0 0 a 4 0 a 5 a,b Φ 11 Φ 1 Φ 1 Φ 1 Φ Φ Φ 1 Φ Φ S 11,b S 1,b S 1,b S 1,b S,b S,b S 1,b S,b S,b Consider the second equation of system ( a Φ + a Φ + a Φ + 0Φ + a Φ + 0Φ + 0Φ + 0Φ + 0Φ = S a Φ 5 1,1 1, 1,,1 1,,,1,, 1, 4 0, The value Φ 0, needs to be specified a priori because we have 9 equation for 9 unknowns and Φ 0, is already the 10 th unknown value.

19 Periodic boundary conditions Φ 0, = Φ, j= j= Φ 0, Φ, j=1 i=0 i=1 i= i= boundary layer With periodic boundary conditions, you wrap around the computational mesh and need not to invoke any special technique to find Φ 0,. Example: phi-angle in polar and cylindrical coordinates a Φ + a Φ + a Φ + 0Φ + a Φ + 0Φ + 0Φ + 0Φ + 0Φ = S a Φ 5 1,1 1, 1,,1 1,,,1,, 1, 4 0, a Φ + a Φ + a Φ + 0Φ + a Φ + 0Φ + 0Φ + a Φ + 0Φ = S 5 1,1 1, 1,,1 1,,,1 4,, 1, 19

20 Neumann boundary conditions Axis of symmetry j= The gradient of Φ across the boundary is zero Φ 0, Φ 1, j= Φ + r 0 1/, = 0 Φ = Φ 0, 1, j=1 i=0 i=1 i= i= boundary layer With Neumann boundary conditions, you reflect the computational mesh off the boundary and need not to invoke any special technique to find Φ 0,. Example: axis of symmetry, equatorial symmetry. a Φ + a Φ + a Φ + 0Φ + a Φ + 0Φ + 0Φ + 0Φ + 0Φ = S a Φ 5 1,1 1, 1,,1 1,,,1,, 1, 4 0, ( a Φ + a + a Φ + a Φ + 0Φ + a Φ + 0Φ + 0Φ + a Φ + 0Φ = S 5 1,1 4 1, 1,,1 1,,,1 4,, 1, 0

21 Dirichlet boundary conditions boundary layer j= j= Φ B Φ 4, j=1 r B θ Β i=1 i= i= i=4 In the case that the boundary is neither periodic or reflective, multipole expansion is often used to find the potential at the boundary. Example: outer boundaries of the computational domain (away from reflection surfaces or axes of symmetry. 1

22 The multipole expansion formulae (Jackson, Classical Electrodynamics Laplace equation in spherical coordinates (r, θ assuming axial symmetry, i.e. = 0 ϕ 1 1 ( r sinθ Φ Φ = Φ + 0 = r r r sinθ θ θ Seeking solution at the boundary in the form U( r Φ B = P ( θ r l ( l 1 B ( rb, θb + Al rb BlrB Pl (cos θb l= 0 Φ Φ = + P (cos θ The general solution is where l B are the Legendre polynomials, and r B and θ B are the spherical coordinates of boundary grid zones The Legendre polynomials can be calculated using the following recurrent formula

23 To find values of A l and B l, we note that A l must go to zero for r B inf (i.e. for outer boundaries and B l must go to zero for r B 0 (i.e. for boundaries near the coordinate origin l ( l 1 B ( rb, θb + Al rb BlrB Pl (cos θb l= 0 Φ Φ = + (4 This requirement splits equation (4 into the following two equations ( l+ 1 l ( rb r, θb Bl rb Pl (cos θb, ( rb r, θb Al rb Pl (cos θb l= 0 l= 0 Φ > = Φ < = where B l and A l are the so-called interior and exterior multipole moments B = ρ( r, θ r P (cos θ d r, A = ρ( r, θ r P (cos θ d l ( l+ 1 l l l l r In the case of B l, the integration (summation is performed over ALL grid zones with r < r B and in the case of A l over all grid zones with r > r B

24 z j= j= j=1 θ θ B r boundary layer r B Φ B For all grid zones INSIDE the circle, the following equations are to be used ( l+ 1 ( rb r, θb Bl rb Pl (cos θb l= 0 Φ > = B = ρ( r, θ r P (cos θ dv, l l l ij i, j For all grid zones OUTSIDE the circle, the following equations are to be used l B θb l B l θb l= 0 Φ ( r < r, = A r P (cos A = ρ r θ r P θ dv ( l+ 1 l = ρ (, θ l (cos θ ij i. j i=1 i= i= i=4 If we do not take into account the input from grid zones with r > r B, the series may diverge in the case when a substantial mass is located at those zones! In practice, one continues adding higher-order terms in the sum over l until the desired relative accuracy (~ is reached. Note that the accuracy with which you calculate the boundary values will directly affect the accuracy of the potential in the rest of your computational mesh due to the boundary-value nature of the Poisson equation. 4

25 General strategy for solving the Poisson equation Once the Poisson equation is properly discretized, the boundary conditions are specified, and the boundary values of the potential are found, one needs to choose the fastest method for solving the following matrix equation (i.e., a large system of linear equations A Φ = S Discretization and boundary conditions Equidistant grid with periodic boundary conditions Fast Fourier Transform Non-equidistant grid with any boundary conditions Alternative direction implicit method (best in D with axial symmetry Successive overrelaxation (best in D, slow in full D Multigrid methods (fast only on Cartesian geometry, slow on cylindrical and spherical geometries For details on each method see: 1. Press, Teukolsky, Vitterling, Flannery: Numerical Recipes in Fortran.. Bodenheimer, Laughlin, Rozyczka, Yorke: Numerical Methods in Astrophysics. 5

26 The Poisson Integral 6

27 Finding the gravitational potential using the Poisson integral Φ ( r = G V ρ ( r d r - r Let us consider a D Cartesian grid. Substituting the integral with a double sum, we obtain r Φ ( x, y l m = G N 1 N 1 l = 0 m = 0 M ( x, y l m ( x x + ( y y l l m m y m=n-1 Where M ( xl, ym is the mass contained in a grid zone ( l, m m= m=1 m=0 Note that no boundary values of Φ are involved in the summation. This is the fundamental advantage of the Poisson Integral over the Poisson equation. You need not to find the boundary values! l=0 l=1 l= l=n-1 x 7

28 Now let s assume that our computational grid is equidistant. ( x x = x ( l l l l then M Φ = = x ( l l + y ( m m N 1 N 1 N 1 N 1 l m l, m G G l l, m m M l m l = 0 m = 0 l = 0 m = 0 Gl l, m m = G g where 1 ( ( x l l + y m m is the gravitational potential in zone (l,m created by unit mass located in zone is often called the Green function. G l l, m m ( l, m Direct evaluation of the sum in equation (1 takes N operations, where N is the total number of grid zones A much faster way for evaluating the double sum is to use the convolution theorem 8

29 The convolution theorem Suppose, we need to calculate the following double sum N 1 N 1 A B C = l, m l, m l l, m m l ' = N m = N where B and C are periodic discrete functions with a period of N This sum can be calculated using the following three steps B k, n N 1 N 1 = l= N m= N B 1. Take direct Fourier transform of B and C lm e πikl πimn N N e. calculate the product of Fourier transforms B and C A ( N A =B C C kn kn kn. take the inverse Fourier Transform of A N 1 N 1 1 l, m = A k, n k= N n= N e N 1 N 1 = k, n k, n l= N m= N πikl πimn N N e C e πikl πimn N N e 9

30 Note the conceptual similarity between the two sums! The convolution sum N 1 N 1 A B C = l, m l, m l l, m m l ' = N m = N Doubling the computational domain N-1 Φ Our gravitational potential N 1 N 1 = M G l, m l m l l, m m l = 0 m = 0 The problem is that M and G are in general non-periodic and we have to make them periodic in order to use the convolution theorem We double the computational domain and fill zones,, and 4 with Ml m = 0 Φ N 1 N 1 = M G l, m l m l l, m m l = N m = N N Now M is periodic with a period of N. Because M = 0 in zones,,4, the gravitational potential in zone 1 is unaffected by the doubling. 0

31 Re-arranging the computational domain to make periodic G l l, m m l=-n l=- l=- l=1 l=0 l=1 l= l=n-1 m=n-1 m= m=1 1 m= m=-1 m=- m=- m=-n 4 We cannot simply set G to zero in zones,,4 because it is the inverse distance. Gl l, m m = G g 1 ( ( x l l + y m m 1

32 Singularity of the Green function At l = l, m = m, Φ is not defined! l, m M ( xl, ym Φ ( xl, ym = Gg = ( x x + ( y y l l m m However, it is possible to calculate the contribution of the material in the (l,m th cell to the potential in the same cell by assuming constant density within the cell and integrating over the cell area x within an individual cell (l,m and vary in the following limits y l m x x xl xl xl + y y ym ym ym + y y ( xl, ym y m x Σ = const x l x

33 defining x x = x and y y = y l l m m Φ ( x, y = G l m g M ( x, y l m ( x x + ( y y l l m m M ( x, y = Σ( x, y dx dy and noticing that, we obstain l m l m Φ ( x, y = G Σ( x, y l m g l m y x y x dx dy x + y after a few pages of algebra y Φ ( xl, ym = Gg Σ( xl, ym x sinh + y sinh x if l = l and m = m 1 1 x y

34 The extension to D Cartesian coordinates is straightforward, though the integral has to be taken numerically (I couldn t find an analytic solution Φ ( x, y, z = G ρ( x, y, z l m k g l m k z y x z y x dx dy dz x + y + z Problem with large memory requirements: the convolution method takes a lot of memory in D due to doubling of the computational grid. Some remedy: see Hockney and Eastwood: Computer simulations using particles and Bodenheimer, Laughlin, Rozyczka, Yorke: Numerical Methods in Astrophysics. The Fourier transform of the Green function has to be taken only once if the grid is not arbitrarily varying during simulations. This leaves us with FFTs each taking N log N operations where N is the total number of grid zones. On the other hand, the direct summation takes N operations and the Fourier transform technique is faster than the direct summation starting from N > 16. 4

35 Practicum Take a sphere with radius R and density profile of the form: where r is the radial distance from the center of the sphere ρ c =1 and r c =0. R Find the gravitational potential at r > R (outside the sphere using the multipole expansion formula. Split the sphere into N x N zones in spherical coordinates (r, θ. Compare the numerical solution with the analytic one: 5

Expansion of 1/r potential in Legendre polynomials

Expansion of 1/r potential in Legendre polynomials Expansion of 1/r potential in Legendre polynomials In electrostatics and gravitation, we see scalar potentials of the form V = K d Take d = R r = R 2 2Rr cos θ + r 2 = R 1 2 r R cos θ + r R )2 Use h =

More information

Notes: Most of the material presented in this chapter is taken from Jackson, Chap. 2, 3, and 4, and Di Bartolo, Chap. 2. 2π nx i a. ( ) = G n.

Notes: Most of the material presented in this chapter is taken from Jackson, Chap. 2, 3, and 4, and Di Bartolo, Chap. 2. 2π nx i a. ( ) = G n. Chapter. Electrostatic II Notes: Most of the material presented in this chapter is taken from Jackson, Chap.,, and 4, and Di Bartolo, Chap... Mathematical Considerations.. The Fourier series and the Fourier

More information

lim = F F = F x x + F y y + F z

lim = F F = F x x + F y y + F z Physics 361 Summary of Results from Lecture Physics 361 Derivatives of Scalar and Vector Fields The gradient of a scalar field f( r) is given by g = f. coordinates f g = ê x x + ê f y y + ê f z z Expressed

More information

Classical Field Theory: Electrostatics-Magnetostatics

Classical Field Theory: Electrostatics-Magnetostatics Classical Field Theory: Electrostatics-Magnetostatics April 27, 2010 1 1 J.D.Jackson, Classical Electrodynamics, 2nd Edition, Section 1-5 Electrostatics The behavior of an electrostatic field can be described

More information

NUMERICAL METHODS IN ASTROPHYSICS An Introduction

NUMERICAL METHODS IN ASTROPHYSICS An Introduction -1 Series in Astronomy and Astrophysics NUMERICAL METHODS IN ASTROPHYSICS An Introduction Peter Bodenheimer University of California Santa Cruz, USA Gregory P. Laughlin University of California Santa Cruz,

More information

AY202a Galaxies & Dynamics Lecture 7: Jeans Law, Virial Theorem Structure of E Galaxies

AY202a Galaxies & Dynamics Lecture 7: Jeans Law, Virial Theorem Structure of E Galaxies AY202a Galaxies & Dynamics Lecture 7: Jeans Law, Virial Theorem Structure of E Galaxies Jean s Law Star/Galaxy Formation is most simply defined as the process of going from hydrostatic equilibrium to gravitational

More information

Connection to Laplacian in spherical coordinates (Chapter 13)

Connection to Laplacian in spherical coordinates (Chapter 13) Connection to Laplacian in spherical coordinates (Chapter 13) We might often encounter the Laplace equation and spherical coordinates might be the most convenient 2 u(r, θ, φ) = 0 We already saw in Chapter

More information

Potential/density pairs and Gauss s law

Potential/density pairs and Gauss s law Potential/density pairs and Gauss s law We showed last time that the motion of a particle in a cluster will evolve gradually, on the relaxation time scale. This time, however, is much longer than the typical

More information

Electromagnetism HW 1 math review

Electromagnetism HW 1 math review Electromagnetism HW math review Problems -5 due Mon 7th Sep, 6- due Mon 4th Sep Exercise. The Levi-Civita symbol, ɛ ijk, also known as the completely antisymmetric rank-3 tensor, has the following properties:

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

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

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

Spherical Coordinates and Legendre Functions

Spherical Coordinates and Legendre Functions Spherical Coordinates and Legendre Functions Spherical coordinates Let s adopt the notation for spherical coordinates that is standard in physics: φ = longitude or azimuth, θ = colatitude ( π 2 latitude)

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

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

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

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

More information

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN INTROUCTION TO FINITE ELEMENT METHOS ON ELLIPTIC EQUATIONS LONG CHEN CONTENTS 1. Poisson Equation 1 2. Outline of Topics 3 2.1. Finite ifference Method 3 2.2. Finite Element Method 3 2.3. Finite Volume

More information

Physics 6303 Lecture 11 September 24, LAST TIME: Cylindrical coordinates, spherical coordinates, and Legendre s equation

Physics 6303 Lecture 11 September 24, LAST TIME: Cylindrical coordinates, spherical coordinates, and Legendre s equation Physics 6303 Lecture September 24, 208 LAST TIME: Cylindrical coordinates, spherical coordinates, and Legendre s equation, l l l l l l. Consider problems that are no axisymmetric; i.e., the potential depends

More information

l=0 The expansion coefficients can be determined, for example, by finding the potential on the z-axis and expanding that result in z.

l=0 The expansion coefficients can be determined, for example, by finding the potential on the z-axis and expanding that result in z. Electrodynamics I Exam - Part A - Closed Book KSU 15/11/6 Name Electrodynamic Score = 14 / 14 points Instructions: Use SI units. Where appropriate, define all variables or symbols you use, in words. Try

More information

d 1 µ 2 Θ = 0. (4.1) consider first the case of m = 0 where there is no azimuthal dependence on the angle φ.

d 1 µ 2 Θ = 0. (4.1) consider first the case of m = 0 where there is no azimuthal dependence on the angle φ. 4 Legendre Functions In order to investigate the solutions of Legendre s differential equation d ( µ ) dθ ] ] + l(l + ) m dµ dµ µ Θ = 0. (4.) consider first the case of m = 0 where there is no azimuthal

More information

Electrodynamics PHY712. Lecture 4 Electrostatic potentials and fields. Reference: Chap. 1 & 2 in J. D. Jackson s textbook.

Electrodynamics PHY712. Lecture 4 Electrostatic potentials and fields. Reference: Chap. 1 & 2 in J. D. Jackson s textbook. Electrodynamics PHY712 Lecture 4 Electrostatic potentials and fields Reference: Chap. 1 & 2 in J. D. Jackson s textbook. 1. Complete proof of Green s Theorem 2. Proof of mean value theorem for electrostatic

More information

Summary: Curvilinear Coordinates

Summary: Curvilinear Coordinates Physics 2460 Electricity and Magnetism I, Fall 2007, Lecture 10 1 Summary: Curvilinear Coordinates 1. Summary of Integral Theorems 2. Generalized Coordinates 3. Cartesian Coordinates: Surfaces of Constant

More information

The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and engineering.

The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and engineering. Lecture 16 Applications of Conformal Mapping MATH-GA 451.001 Complex Variables The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and

More information

Lecture 21 Gravitational and Central Forces

Lecture 21 Gravitational and Central Forces Lecture 21 Gravitational and Central Forces 21.1 Newton s Law of Universal Gravitation According to Newton s Law of Universal Graviation, the force on a particle i of mass m i exerted by a particle j of

More information

PRACTICE PROBLEMS. Please let me know if you find any mistakes in the text so that i can fix them. 1. Mixed partial derivatives.

PRACTICE PROBLEMS. Please let me know if you find any mistakes in the text so that i can fix them. 1. Mixed partial derivatives. PRACTICE PROBLEMS Please let me know if you find any mistakes in the text so that i can fix them. 1.1. Let Show that f is C 1 and yet How is that possible? 1. Mixed partial derivatives f(x, y) = {xy x

More information

1. (3) Write Gauss Law in differential form. Explain the physical meaning.

1. (3) Write Gauss Law in differential form. Explain the physical meaning. Electrodynamics I Midterm Exam - Part A - Closed Book KSU 204/0/23 Name Electro Dynamic Instructions: Use SI units. Where appropriate, define all variables or symbols you use, in words. Try to tell about

More information

Equations of linear stellar oscillations

Equations of linear stellar oscillations Chapter 4 Equations of linear stellar oscillations In the present chapter the equations governing small oscillations around a spherical equilibrium state are derived. The general equations were presented

More information

Solutions to Laplace s Equation in Cylindrical Coordinates and Numerical solutions. ρ + (1/ρ) 2 V

Solutions to Laplace s Equation in Cylindrical Coordinates and Numerical solutions. ρ + (1/ρ) 2 V Solutions to Laplace s Equation in Cylindrical Coordinates and Numerical solutions Lecture 8 1 Introduction Solutions to Laplace s equation can be obtained using separation of variables in Cartesian and

More information

Homework 1. Astronomy 202a. Fall 2009

Homework 1. Astronomy 202a. Fall 2009 Homework 1 Astronomy 0a Fall 009 Solutions Problems: 1. A galaxy has an integrated blue magnitude of 6.5, a rotation velocity (essentially flat) of 107 km s 1, and is ellptical in overall shape with major

More information

MULTIVARIABLE INTEGRATION

MULTIVARIABLE INTEGRATION MULTIVARIABLE INTEGRATION (SPHERICAL POLAR COORDINATES) Question 1 a) Determine with the aid of a diagram an expression for the volume element in r, θ, ϕ. spherical polar coordinates, ( ) [You may not

More information

5.1 Circular Velocities and Rotation Curves

5.1 Circular Velocities and Rotation Curves Chapter 5 otation Curves 5.1 Circular Velocities and otation Curves The circular velocity v circ is the velocity that a star in a galaxy must have to maintain a circular orbit at a specified distance from

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

Curvilinear coordinates

Curvilinear coordinates C Curvilinear coordinates The distance between two points Euclidean space takes the simplest form (2-4) in Cartesian coordinates. The geometry of concrete physical problems may make non-cartesian coordinates

More information

SOLUTIONS TO THE FINAL EXAM. December 14, 2010, 9:00am-12:00 (3 hours)

SOLUTIONS TO THE FINAL EXAM. December 14, 2010, 9:00am-12:00 (3 hours) SOLUTIONS TO THE 18.02 FINAL EXAM BJORN POONEN December 14, 2010, 9:00am-12:00 (3 hours) 1) For each of (a)-(e) below: If the statement is true, write TRUE. If the statement is false, write FALSE. (Please

More information

Chapter 7. Kinematics. 7.1 Tensor fields

Chapter 7. Kinematics. 7.1 Tensor fields Chapter 7 Kinematics 7.1 Tensor fields In fluid mechanics, the fluid flow is described in terms of vector fields or tensor fields such as velocity, stress, pressure, etc. It is important, at the outset,

More information

Galactic Astronomy 2016

Galactic Astronomy 2016 10 Potential theory The study of dynamics is fundamental to any understanding of galaxies. The following few chapters provide a brief summary of the most important results. More details can be found in

More information

5. FVM discretization and Solution Procedure

5. FVM discretization and Solution Procedure 5. FVM discretization and Solution Procedure 1. The fluid domain is divided into a finite number of control volumes (cells of a computational grid). 2. Integral form of the conservation equations are discretized

More information

Cosmology ASTR 2120 Sarazin. Hubble Ultra-Deep Field

Cosmology ASTR 2120 Sarazin. Hubble Ultra-Deep Field Cosmology ASTR 2120 Sarazin Hubble Ultra-Deep Field Cosmology - Da Facts! 1) Big Universe of Galaxies 2) Sky is Dark at Night 3) Isotropy of Universe Cosmological Principle = Universe Homogeneous 4) Hubble

More information

Note: Each problem is worth 14 points except numbers 5 and 6 which are 15 points. = 3 2

Note: Each problem is worth 14 points except numbers 5 and 6 which are 15 points. = 3 2 Math Prelim II Solutions Spring Note: Each problem is worth points except numbers 5 and 6 which are 5 points. x. Compute x da where is the region in the second quadrant between the + y circles x + y and

More information

is any such piece, suppose we choose a in this piece and use σ ( xk, yk, zk) . If B

is any such piece, suppose we choose a in this piece and use σ ( xk, yk, zk) . If B Multivariable Calculus Lecture # Notes In this lecture we look at integration over regions in space, ie triple integrals, using Cartesian coordinates, cylindrical coordinates, and spherical coordinates

More information

Tutorial Exercises: Geometric Connections

Tutorial Exercises: Geometric Connections Tutorial Exercises: Geometric Connections 1. Geodesics in the Isotropic Mercator Projection When the surface of the globe is projected onto a flat map some aspects of the map are inevitably distorted.

More information

CHAPTER 4. Basics of Fluid Dynamics

CHAPTER 4. Basics of Fluid Dynamics CHAPTER 4 Basics of Fluid Dynamics What is a fluid? A fluid is a substance that can flow, has no fixed shape, and offers little resistance to an external stress In a fluid the constituent particles (atoms,

More information

Final Exam May 4, 2016

Final Exam May 4, 2016 1 Math 425 / AMCS 525 Dr. DeTurck Final Exam May 4, 2016 You may use your book and notes on this exam. Show your work in the exam book. Work only the problems that correspond to the section that you prepared.

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

Stellar Winds. Star. v w

Stellar Winds. Star. v w Stellar Winds Star v w Stellar Winds Geoffrey V. Bicknell 1 Characteristics of stellar winds Solar wind Velocity at earth s orbit: Density: Temperature: Speed of sound: v 400 km/s n 10 7 m 3 c s T 10 5

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

Week 7: Integration: Special Coordinates

Week 7: Integration: Special Coordinates Week 7: Integration: Special Coordinates Introduction Many problems naturally involve symmetry. One should exploit it where possible and this often means using coordinate systems other than Cartesian coordinates.

More information

The Distribution Function

The Distribution Function The Distribution Function As we have seen before the distribution function (or phase-space density) f( x, v, t) d 3 x d 3 v gives a full description of the state of any collisionless system. Here f( x,

More information

Multiple Integrals and Vector Calculus: Synopsis

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

More information

FORMULA SHEET FOR QUIZ 2 Exam Date: November 8, 2017

FORMULA SHEET FOR QUIZ 2 Exam Date: November 8, 2017 MASSACHUSETTS INSTITUTE OF TECHNOLOGY Physics Department Physics 8.07: Electromagnetism II November 5, 207 Prof. Alan Guth FORMULA SHEET FOR QUIZ 2 Exam Date: November 8, 207 A few items below are marked

More information

Kerr black hole and rotating wormhole

Kerr black hole and rotating wormhole Kerr Fest (Christchurch, August 26-28, 2004) Kerr black hole and rotating wormhole Sung-Won Kim(Ewha Womans Univ.) August 27, 2004 INTRODUCTION STATIC WORMHOLE ROTATING WORMHOLE KERR METRIC SUMMARY AND

More information

Poisson Solvers. William McLean. April 21, Return to Math3301/Math5315 Common Material.

Poisson Solvers. William McLean. April 21, Return to Math3301/Math5315 Common Material. Poisson Solvers William McLean April 21, 2004 Return to Math3301/Math5315 Common Material 1 Introduction Many problems in applied mathematics lead to a partial differential equation of the form a 2 u +

More information

Separation of Variables in Polar and Spherical Coordinates

Separation of Variables in Polar and Spherical Coordinates Separation of Variables in Polar and Spherical Coordinates Polar Coordinates Suppose we are given the potential on the inside surface of an infinitely long cylindrical cavity, and we want to find the potential

More information

Control Volume. Dynamics and Kinematics. Basic Conservation Laws. Lecture 1: Introduction and Review 1/24/2017

Control Volume. Dynamics and Kinematics. Basic Conservation Laws. Lecture 1: Introduction and Review 1/24/2017 Lecture 1: Introduction and Review Dynamics and Kinematics Kinematics: The term kinematics means motion. Kinematics is the study of motion without regard for the cause. Dynamics: On the other hand, dynamics

More information

Lecture 1: Introduction and Review

Lecture 1: Introduction and Review Lecture 1: Introduction and Review Review of fundamental mathematical tools Fundamental and apparent forces Dynamics and Kinematics Kinematics: The term kinematics means motion. Kinematics is the study

More information

Introduction to Partial Differential Equations

Introduction to Partial Differential Equations Introduction to Partial Differential Equations Philippe B. Laval KSU Current Semester Philippe B. Laval (KSU) Key Concepts Current Semester 1 / 25 Introduction The purpose of this section is to define

More information

In this chapter we study elliptical PDEs. That is, PDEs of the form. 2 u = lots,

In this chapter we study elliptical PDEs. That is, PDEs of the form. 2 u = lots, Chapter 8 Elliptic PDEs In this chapter we study elliptical PDEs. That is, PDEs of the form 2 u = lots, where lots means lower-order terms (u x, u y,..., u, f). Here are some ways to think about the physical

More information

( ) by D n ( y) 1.1 Mathematical Considerations. π e nx Dirac s delta function (distribution) a) Dirac s delta function is defined such that

( ) by D n ( y) 1.1 Mathematical Considerations. π e nx Dirac s delta function (distribution) a) Dirac s delta function is defined such that Chapter 1. Electrostatics I Notes: Most of the material presented in this chapter is taken from Jackson, Chap. 1. Units from the ystème International (I) will be used in this chapter. 1.1 Mathematical

More information

AST1100 Lecture Notes

AST1100 Lecture Notes AST1100 Lecture Notes 5 The virial theorem 1 The virial theorem We have seen that we can solve the equation of motion for the two-body problem analytically and thus obtain expressions describing the future

More information

MATH 0350 PRACTICE FINAL FALL 2017 SAMUEL S. WATSON. a c. b c.

MATH 0350 PRACTICE FINAL FALL 2017 SAMUEL S. WATSON. a c. b c. MATH 35 PRACTICE FINAL FALL 17 SAMUEL S. WATSON Problem 1 Verify that if a and b are nonzero vectors, the vector c = a b + b a bisects the angle between a and b. The cosine of the angle between a and c

More information

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

More information

Solution of Differential Equation by Finite Difference Method

Solution of Differential Equation by Finite Difference Method NUMERICAL ANALYSIS University of Babylon/ College of Engineering/ Mechanical Engineering Dep. Lecturer : Dr. Rafel Hekmat Class : 3 rd B.Sc Solution of Differential Equation by Finite Difference Method

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

Review problems for the final exam Calculus III Fall 2003

Review problems for the final exam Calculus III Fall 2003 Review problems for the final exam alculus III Fall 2003 1. Perform the operations indicated with F (t) = 2t ı 5 j + t 2 k, G(t) = (1 t) ı + 1 t k, H(t) = sin(t) ı + e t j a) F (t) G(t) b) F (t) [ H(t)

More information

NEWTONIAN COSMOLOGY. Figure 2.1: All observers see galaxies expanding with the same Hubble law. v A = H 0 r A (2.1)

NEWTONIAN COSMOLOGY. Figure 2.1: All observers see galaxies expanding with the same Hubble law. v A = H 0 r A (2.1) M. Pettini: Introduction to Cosmology Lecture 2 NEWTONIAN COSMOLOGY The equations that describe the time evolution of an expanding universe which is homogeneous and isotropic can be deduced from Newtonian

More information

Lecture Notes 3

Lecture Notes 3 12.005 Lecture Notes 3 Tensors Most physical quantities that are important in continuum mechanics like temperature, force, and stress can be represented by a tensor. Temperature can be specified by stating

More information

ENGI Multiple Integration Page 8-01

ENGI Multiple Integration Page 8-01 ENGI 345 8. Multiple Integration Page 8-01 8. Multiple Integration This chapter provides only a very brief introduction to the major topic of multiple integration. Uses of multiple integration include

More information

xy 2 e 2z dx dy dz = 8 3 (1 e 4 ) = 2.62 mc. 12 x2 y 3 e 2z 2 m 2 m 2 m Figure P4.1: Cube of Problem 4.1.

xy 2 e 2z dx dy dz = 8 3 (1 e 4 ) = 2.62 mc. 12 x2 y 3 e 2z 2 m 2 m 2 m Figure P4.1: Cube of Problem 4.1. Problem 4.1 A cube m on a side is located in the first octant in a Cartesian coordinate system, with one of its corners at the origin. Find the total charge contained in the cube if the charge density

More information

Practice Problems for Exam 3 (Solutions) 1. Let F(x, y) = xyi+(y 3x)j, and let C be the curve r(t) = ti+(3t t 2 )j for 0 t 2. Compute F dr.

Practice Problems for Exam 3 (Solutions) 1. Let F(x, y) = xyi+(y 3x)j, and let C be the curve r(t) = ti+(3t t 2 )j for 0 t 2. Compute F dr. 1. Let F(x, y) xyi+(y 3x)j, and let be the curve r(t) ti+(3t t 2 )j for t 2. ompute F dr. Solution. F dr b a 2 2 F(r(t)) r (t) dt t(3t t 2 ), 3t t 2 3t 1, 3 2t dt t 3 dt 1 2 4 t4 4. 2. Evaluate the line

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Xu Chen Assistant Professor United Technologies Engineering Build, Rm. 382 Department of Mechanical Engineering University of Connecticut xchen@engr.uconn.edu Contents 1

More information

Research Institute of Geodesy, Topography and Cartography Zdiby, Prague-East, Czech Republic

Research Institute of Geodesy, Topography and Cartography Zdiby, Prague-East, Czech Republic Leibniz Society of Science at Berlin, Scientific Colloquium Geodesy - Mathematic - Physics - Geophysics in honour of Erik W. Grafarend on the occasion of his 75th birthday Berlin, Germany, 3 February 05

More information

Electromagnetic Field Theory (EMT)

Electromagnetic Field Theory (EMT) Electromagnetic Field Theory (EMT) Lecture # 9 1) Coulomb s Law and Field Intensity 2) Electric Fields Due to Continuous Charge Distributions Line Charge Surface Charge Volume Charge Coulomb's Law Coulomb's

More information

Practice problems ********************************************************** 1. Divergence, curl

Practice problems ********************************************************** 1. Divergence, curl Practice problems 1. Set up the integral without evaluation. The volume inside (x 1) 2 + y 2 + z 2 = 1, below z = 3r but above z = r. This problem is very tricky in cylindrical or Cartesian since we must

More information

A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere

A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere Michael Levy University of Colorado at Boulder Department of Applied Mathematics August 10, 2007 Outline 1 Background

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 11 Partial Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002.

More information

Practice problems. m zδdv. In our case, we can cancel δ and have z =

Practice problems. m zδdv. In our case, we can cancel δ and have z = Practice problems 1. Consider a right circular cone of uniform density. The height is H. Let s say the distance of the centroid to the base is d. What is the value d/h? We can create a coordinate system

More information

ASTR 200 : Lecture 21. Stellar mass Black Holes

ASTR 200 : Lecture 21. Stellar mass Black Holes 1 ASTR 200 : Lecture 21 Stellar mass Black Holes High-mass core collapse Just as there is an upper limit to the mass of a white dwarf (the Chandrasekhar limit), there is an upper limit to the mass of a

More information

7 Curvilinear coordinates

7 Curvilinear coordinates 7 Curvilinear coordinates Read: Boas sec. 5.4, 0.8, 0.9. 7. Review of spherical and cylindrical coords. First I ll review spherical and cylindrical coordinate systems so you can have them in mind when

More information

A A + B. ra + A + 1. We now want to solve the Einstein equations in the following cases:

A A + B. ra + A + 1. We now want to solve the Einstein equations in the following cases: Lecture 29: Cosmology Cosmology Reading: Weinberg, Ch A metric tensor appropriate to infalling matter In general (see, eg, Weinberg, Ch ) we may write a spherically symmetric, time-dependent metric in

More information

ASP2062 Introduction to Astrophysics

ASP2062 Introduction to Astrophysics School of Physics and Astronomy ASP2062 2015 ASP2062 Introduction to Astrophysics Star formation II Daniel Price Key revision points 1. Star formation is a competition between gravity and pressure 2. Timescale

More information

A Simple Compact Fourth-Order Poisson Solver on Polar Geometry

A Simple Compact Fourth-Order Poisson Solver on Polar Geometry Journal of Computational Physics 182, 337 345 (2002) doi:10.1006/jcph.2002.7172 A Simple Compact Fourth-Order Poisson Solver on Polar Geometry Ming-Chih Lai Department of Applied Mathematics, National

More information

SUMMARY PHYSICS 707 Electrostatics. E(x) = 4πρ(x) and E(x) = 0 (1)

SUMMARY PHYSICS 707 Electrostatics. E(x) = 4πρ(x) and E(x) = 0 (1) SUMMARY PHYSICS 707 Electrostatics The basic differential equations of electrostatics are E(x) = 4πρ(x) and E(x) = 0 (1) where E(x) is the electric field and ρ(x) is the electric charge density. The field

More information

Exercises for Multivariable Differential Calculus XM521

Exercises for Multivariable Differential Calculus XM521 This document lists all the exercises for XM521. The Type I (True/False) exercises will be given, and should be answered, online immediately following each lecture. The Type III exercises are to be done

More information

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 Math Problem a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 3 6 Solve the initial value problem u ( t) = Au( t) with u (0) =. 3 1 u 1 =, u 1 3 = b- True or false and why 1. if A is

More information

The Virial Theorem, MHD Equilibria, and Force-Free Fields

The Virial Theorem, MHD Equilibria, and Force-Free Fields The Virial Theorem, MHD Equilibria, and Force-Free Fields Nick Murphy Harvard-Smithsonian Center for Astrophysics Astronomy 253: Plasma Astrophysics February 10 12, 2014 These lecture notes are largely

More information

Classification of algebraic surfaces up to fourth degree. Vinogradova Anna

Classification of algebraic surfaces up to fourth degree. Vinogradova Anna Classification of algebraic surfaces up to fourth degree Vinogradova Anna Bases of algebraic surfaces Degree of the algebraic equation Quantity of factors The algebraic surfaces are described by algebraic

More information

%#, for x = a & ' 0, for x $ a. but with the restriction that the area it encloses equals 1. Therefore, whenever it is used it is implied that

%#, for x = a & ' 0, for x $ a. but with the restriction that the area it encloses equals 1. Therefore, whenever it is used it is implied that Chapter 1. Electrostatics I Notes: Most of the material presented in this chapter is taken from Jackson, Chap. 1. Units from the ystème International (I will be used in this chapter. 1.1 Mathematical Considerations

More information

Basic Physics. Isaac Newton ( ) Topics. Newton s Laws of Motion (2) Newton s Laws of Motion (1) PHYS 1411 Introduction to Astronomy

Basic Physics. Isaac Newton ( ) Topics. Newton s Laws of Motion (2) Newton s Laws of Motion (1) PHYS 1411 Introduction to Astronomy PHYS 1411 Introduction to Astronomy Basic Physics Chapter 5 Topics Newton s Laws Mass and Weight Work, Energy and Conservation of Energy Rotation, Angular velocity and acceleration Centripetal Force Angular

More information

Math 3435 Homework Set 11 Solutions 10 Points. x= 1,, is in the disk of radius 1 centered at origin

Math 3435 Homework Set 11 Solutions 10 Points. x= 1,, is in the disk of radius 1 centered at origin Math 45 Homework et olutions Points. ( pts) The integral is, x + z y d = x + + z da 8 6 6 where is = x + z 8 x + z = 4 o, is the disk of radius centered on the origin. onverting to polar coordinates then

More information

Finite Difference Method for PDE. Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36

Finite Difference Method for PDE. Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36 Finite Difference Method for PDE Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36 1 Classification of the Partial Differential Equations Consider a scalar second order partial

More information

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 1: Finite Difference Method

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 1: Finite Difference Method file:///d:/chitra/nptel_phase2/mechanical/cfd/lecture1/1_1.htm 1 of 1 6/19/2012 4:29 PM The Lecture deals with: Classification of Partial Differential Equations Boundary and Initial Conditions Finite Differences

More information

Aim: Understand equilibrium of galaxies

Aim: Understand equilibrium of galaxies 8. Galactic Dynamics Aim: Understand equilibrium of galaxies 1. What are the dominant forces? 2. Can we define some kind of equilibrium? 3. What are the relevant timescales? 4. Do galaxies evolve along

More information

MATHS 267 Answers to Stokes Practice Dr. Jones

MATHS 267 Answers to Stokes Practice Dr. Jones MATH 267 Answers to tokes Practice Dr. Jones 1. Calculate the flux F d where is the hemisphere x2 + y 2 + z 2 1, z > and F (xz + e y2, yz, z 2 + 1). Note: the surface is open (doesn t include any of the

More information

Steady and unsteady diffusion

Steady and unsteady diffusion Chapter 5 Steady and unsteady diffusion In this chapter, we solve the diffusion and forced convection equations, in which it is necessary to evaluate the temperature or concentration fields when the velocity

More information

Dynamics of Galaxies: Basics. Frontiers in Numerical Gravitational Astrophysics July 3, 2008

Dynamics of Galaxies: Basics. Frontiers in Numerical Gravitational Astrophysics July 3, 2008 Dynamics of Galaxies: Basics Frontiers in Numerical Gravitational Astrophysics July 3, 2008 c = G = 1 h = 0 Outline (a) Galaxies as physical systems. (b) The Collisionless Boltzmann Equation. (c) N-body

More information

has a lot of good notes on GR and links to other pages. General Relativity Philosophy of general relativity.

has a lot of good notes on GR and links to other pages. General Relativity Philosophy of general relativity. http://preposterousuniverse.com/grnotes/ has a lot of good notes on GR and links to other pages. General Relativity Philosophy of general relativity. As with any major theory in physics, GR has been framed

More information

14.1. Multiple Integration. Iterated Integrals and Area in the Plane. Iterated Integrals. Iterated Integrals. MAC2313 Calculus III - Chapter 14

14.1. Multiple Integration. Iterated Integrals and Area in the Plane. Iterated Integrals. Iterated Integrals. MAC2313 Calculus III - Chapter 14 14 Multiple Integration 14.1 Iterated Integrals and Area in the Plane Objectives Evaluate an iterated integral. Use an iterated integral to find the area of a plane region. Copyright Cengage Learning.

More information

CHAPTER 3 POTENTIALS 10/13/2016. Outlines. 1. Laplace s equation. 2. The Method of Images. 3. Separation of Variables. 4. Multipole Expansion

CHAPTER 3 POTENTIALS 10/13/2016. Outlines. 1. Laplace s equation. 2. The Method of Images. 3. Separation of Variables. 4. Multipole Expansion CHAPTER 3 POTENTIALS Lee Chow Department of Physics University of Central Florida Orlando, FL 32816 Outlines 1. Laplace s equation 2. The Method of Images 3. Separation of Variables 4. Multipole Expansion

More information

Ph1a: Solution to the Final Exam Alejandro Jenkins, Fall 2004

Ph1a: Solution to the Final Exam Alejandro Jenkins, Fall 2004 Ph1a: Solution to the Final Exam Alejandro Jenkins, Fall 2004 Problem 1 (10 points) - The Delivery A crate of mass M, which contains an expensive piece of scientific equipment, is being delivered to Caltech.

More information

Solutions to Laplace s Equations- II

Solutions to Laplace s Equations- II Solutions to Laplace s Equations- II Lecture 15: Electromagnetic Theory Professor D. K. Ghosh, Physics Department, I.I.T., Bombay Laplace s Equation in Spherical Coordinates : In spherical coordinates

More information