The Fourier spectral method (Amath Bretherton)

Size: px
Start display at page:

Download "The Fourier spectral method (Amath Bretherton)"

Transcription

1 The Fourier spectral method (Amath Bretherton) 1 Introduction The Fourier spectral method (or more precisely, pseudospectral method) is a very accurate way to solve BVPs with smooth solutions on periodic domains. It can be extended to handle homogeneous Dirichlet and eumann BCs. It is a function-space method that approximates an arbitrary periodic function on an interval [, L] by a finite sum of (assumed even) complex exponentials: u(x) u () (x) = 1 û m exp(ik m x) (1) with wavenumbers k m = 2πM m /L. (2) The first /2 exponentials correspond to zero and positive harmonics M m, and the remaining /2 exponentials correspond to the negative harmonics: { m 1 1 m /2 M m = m 1 /2 < m (3) The û m are called the (discrete) Fourier coefficients. We need pairs of positive and negative harmonics to make up cosines and sines and create a real-valued function. The apparently unpaired /2 harmonic is exactly equal to the /2 harmonic at all the grid points (an example of aliasing), so with some care we can treat both these harmonics with a single term. With harmonics, we can represent the exact value of the function u(x) at grid points, which we take to be uniformly spaced across the interval, such that. u j = u(x j ), x j = (j 1)h, h = L/, j = 1,...,. (4) The next grid point x +1 = L would be redundant, since it is periodically equivalent to the first grid point x 1 =. 1

2 2 The Discrete Fourier Transform Given the gridpoint values u j, we calculate the corresponding Fourier coefficients û m from the definition (1): u j 1 û m exp(ik m x j ), j = 1,..., By manipulating the exponential, we find that for 1 m /2, while for /2 < m, exp(ik m x j ) = exp 2πi L M m(j 1) L = exp 2πi (j 1)(m 1) exp(ik m x j ) = exp 2πi L M m(j 1) L = exp 2πi (j 1)(m 1) = exp 2πi 2πi (j 1)(m 1) exp (j 1)( ) = exp 2πi (j 1)(m 1) exp[ 2πi(j 1)] = exp 2πi (j 1)(m 1) Thus u j 1 û m exp[2πi(j 1)(m 1)/] j = 1,..., (5) This is a system of equations in the unknowns û m. Luckily, it has an elegant solution in terms of the discrete Fourier transform (DFT). Let u j, j = 1,..., be a sequence of possibly complex values. Its DFT is defined as the sequence û m, m = 1,...,, where û m = u j exp[ 2πi(m 1)(j 1)/] (6) j=1 As this notation implies, these û m can be shown to be exactly the desired coefficients that solve (5). In fact, the transformation (5) from the vector û of Fourier coefficients û m to the vector u of gridpoint values u j is called the inverse DFT or IDFT. 2

3 2.1 Proof that the IDFT is the inverse of the DFT It suffices to show that applying the IDFT to the DFT of a sequence recovers the original sequence. By direct substitution of (6) into (5): u j = 1 exp[2πi(j 1)(m 1)/] u n exp[ 2πi(m 1)(n 1)/] = A jn u n n=1 A jn = 1 exp[2πi(j 1)(m 1)/] exp[ 2πi(m 1)(n 1)/] n=1 = 1 exp[2πi(j n)(m 1)/] (8) If j = n, all the terms in the series are 1, so A jj = 1. If j n, we are summing a geometrical series with ratio exp[2πi(j n)(m 1)/]. This is computed to be We conclude that A jn = exp[2πi(j n)( + 1 1)/] exp[2πi(j n)(1 1)/] exp[2πi(j n)(m 1)/] 1 A jn u n = u j, i. e. that substituting the DFT into the IDFT returns the original sequence, as claimed. 2.2 The FFT - a fast algorithm to compute the DFT if = 2 p n=1 = (7) Direct use of these formulas would require O( 2 ) flops to obtain the sequence û m from the sequence u n, or vice versa. However, when is a power of 2, a very efficient algorithm called the fast Fourier transform (FFT) can calculate the DFT in O( log ) flops. The FFT is what makes the DFT a practical tool for large problems, and is among the most influential of all numerical algorithms. The FFT can be generalized (with a little loss of efficiency) to all which can be factored into products of small primes (e. g. 2, 3, and 5). Because software packages use the FFT algorithm whenever possible, the word FFT is often (loosely) used in place of DFT. In MATLAB, uhat = fft(u) calculates the DFT of the sequence u, and u = ifft(uhat) calculates the inverse DFT of uhat. MATLAB uses the fast FFT algorithm only if is a power of 2. 3

4 2.3 Matrix representation of the DFT and IDFT If u is the vectors of gridpoint values u i, then the DFT and inverse DFT can be written as matrix operators û = DF T (u) = 1/2 F u u = IDF T (y) = 1/2 F û (9) whereû is the DFT of u, and F mj = 1/2 exp[ 2πi(m 1)(j 1)] (1) and F is the conjugate transpose of F. The matrix form of the statement that the IDFT is the inverse of the DFT is F 1 = F This is equivalent to saying that F is a unitary matrix (i. e. F F = F F = I). 3 Use of DFT for differentiation We can approximate du/dx for all x using the DFT interpolating function: In particular, at the grid points u (x) d dx 1 û m exp(ik m x) 1 ik m û m exp(ik m x) u (x j ) 1 ik m û m exp(ik m x j ) (11) The RHS is just the IDFT of the sequence ik m û m. That is, just like with Fourier transforms, differentiation in physical space is just like multiplication by ik in wavenumber space. 3.1 The unbalanced harmonic M m = /2 One minor complication is the unbalanced harmonic M m = /2 corresponding to index m = / Assuming u j is a real-valued function, it is easy to show that û m will also be real for this harmonic. We d 4

5 like to interpret the component of the interpolant u () (x) due to this harmonic as 1 û m (e ix/2 + e ix/2 )/2 At the gridpoints e ixj/2 = e ixj/2 = ( 1) j 1, so there it does not matter whether we interpret the interpolant using the negative or positive harmonic. However, between the gridpoints, it does matter, so this will affect the derivative of the interpolant even at the gridpoints. We can calculate the derivative that we want (with equal weighting of positive and negative harmonics) as At the gridpoints, this equals d dx 1 û m (e ix/2 + e ix/2 )/2 = (i/4)(e ix/2 e ix/2 )û m (i/4)û m (e ixj/2 e ixj/2 ) = Thus, we want to zero the term in the derivative corresponding to this harmonic. On the other hand, the formula we are using so far will give a contribution from this term of d dx 1 û m e ix/2 xj = (i/2)( 1) j 1 û m Since û m is real for this harmonic, the spurious contribution to the derivative will always be imaginary, and can be removed simply by taking the real part of the IDFT. The contributions to the derivative from all the other matched pairs of harmonics will be real, so they won t be affected by this. 3.2 Implementation of the derivative using DFT/IDFT in Matlab Thus, to use the DFT to calculate a derivative of a periodic function sampled on a uniform grid: 1. Calculate the DFT û of the sampled function u 2. Multiply element m of the DFT by ik m 3. Take the real part of the IDFT of the resulting vector to get the derivative at the grid points. The following MATLAB algorithm can be used for this purpose (assuming L and have already been defined); 5

6 uhat = fft(u) M = [:(/2-1) (1-/2):(-1)]; k = 2*pi*M/L; dudx = real(ifft(1i*k.*uhat)) 3.3 Higher derivatives Higher derivatives are easily calculated using the same approach as above; to take a p th derivative, the Fourier coefficients are just multiplied by (ik) p. 4 Relation to complex Fourier analysis The DFT interpolant formula (1) is a truncated version of the complex Fourier series for u(x), which has the form where the coefficients u(x) = c M exp(2πimx/l) c M = 1 L M= L u(x) exp( 2πiM x/l)dx, (12) Indeed, the discrete Fourier coefficients give approximations to the c M that are accurate when M m : c Mm û m /, m = 1,..., (13) In fact, the DFT formula for û m can be obtained by approximating the integral in c Mm as a Riemann sum centered on the gridpoints x j. 5 Accuracy of DFT-based interpolation and differentiation 5.1 Smoothness matters! The accuracy of Fourier interpolation and differentiation depends on the relative size of the Fourier coefficients of harmonics are that must be truncated if only harmonics can be retained. One can show that for an infinitely-differentiable L-periodic function u(x), the Fourier coefficients û m corresponding to high harmonics M m tend to zero faster than any inverse power of M m. This also implies that the error of Fourier 6

7 interpolation and differentiation will decrease faster than any negative power of the smallest neglected harmonic, i..e. faster than any inverse power of. SInce h = L/, this also implies that for C L-periodic functions, the error of Fourier interpolation and differentiation goes to zero faster than any power of the grid spacing h. This is sometimes referred to as spectral accuracy. On the other hand, if u(x) is less smooth, the Fourier coefficients die off less rapidly at large harmonics, and the error of Fourier differentation decreases less rapidly with h. If u(x) is R times differentiable over the entire interval [, L] then its discrete Fourier coefficients are O( M m (R+1) ), and the Fourier coefficients of its p the derivative are O( M m (R p+1) ). Thus a periodic step function (which is not continuous at the steps) has Fourier coefficients which are O( M 1 ), and can t accurately be differentiated with the DFT, while a sawtooth (which is continuous, but whose derivative is not continuous at the teeth) has Fourier coefficients which are O( M 2 ), and its derivative (the periodic step function) has rather slowly convergent Fourier coefficients of O( M 1 ). Hence, for problems with non-smooth terms or solutions, Fourier spectral methods lose most of their accuracy advantages. 5.2 The DFT power spectrum A good approximation to u(x) can be obtained from the DFT interpolant as long as û m 2 is sufficiently small for the highest retained harmonics (in practice, 1 6 of the largest Fourier mode squared amplitude is usually OK). For smooth functions u(x), the required can be small (1 or less). For a less smooth function, the required may be very large. It is useful to make a semilogy plot of the power spectrum of the squared amplitude of the Fourier modes û m 2 / 2 vs. harmonic M m to check whether the highest harmonics do in fact have small amplitude. 5.3 Examples of DFT interpolants of smooth and nonsmooth functions The solid lines in the left panels of Figure 1 shows a step, sawtooth, and C function periodic over [, 1]. In the right panel are plotted the DFT power spectrum and for comparison, the analytically derived squared amplitudes of the exact Fourier coefficients. The analytical form of the Fourier coefficients in the 7

8 Step function, = 16 y(x) y i y (x) Squared amplitude Fourier power spectrum yhat DFT x.5 Sawtooth, = 16 y(x) y i y (x) Squared amplitude M Fourier power spectrum yhat DFT x /(1.6 cos x), = 16 y(x) y i y (x) Squared amplitude M Fourier power spectrum yhat DFT x M Figure 1: Left panels: Function u(x) (solid), grid points u i, and FFT-based interpolating function u () (x). Right panels: Power spectrum of exact complex Fourier components and of the DFT. 8

9 three cases are: Step: u(x) = sgn(x.5) c M = 2i/(πM), M odd, Sawtooth: u(x) = 2x 1.5 c M = 2/(πM) 2, M odd, Swell: u(x) = (1.6 cos(x)) 1 c M = M. For the swell function, the squared amplitudes of all Fourier coefficients for M > 6 are less that 1 6 of the leading Fourier coefficient, so a very accurate representation of the swell can be obtained with only a few Fourier modes. For the small harmonics M, there is extremely good agreement between the squared DFT Fourier coefficient amplitudes and those from the exact full complex Fourier series. For larger M, the agreement is less good, especially when u(x) is not very smooth. The chain-dashed line on the left panel of Figure 1 is the DFT-based approximation u (x) to the original function using = 16 grid points. For the C swell function, it is extremely good. For the step function, ringing near the edges of the step is evident. 5.4 Accuracy of DFT-based differentiation on smooth vs. nonsmooth functions DFT-based differentiation is extremely accurate for smooth functions u(x) well resolved by the grid, but is less accurate for functions with derivative discontinuities. This can be seen in Figure 2. The derivative of a sawtooth function is the periodic step function shown at left. The DFT estimates of its derivative oscillate around the step function. In contrast, for the C swell function at right, the DFT gives an excellent approximation to du/dx at the gridpoints despite the small number of gridpoints used. 6 Fourier spectral interpolation The DFT-based approximation u (x) to the continuous function u(x) can be used for interpolation. The matlab function u =interpft(un,intp) evaluates an interpolating function based on the -vector of values un (assumed equally spaced through a wavelength) at intp grid points (also equally spaced through a wavelength). This is done by taking the DFT of un, filling out the middle of the resulting vector with zeros to bring it to length intp, renormalizing by multiplying by intp/, then taking an inverse DFT. 9

10 3 Sawtooth, = /(1.6 cos(2πx)), = Exact DFT 5 dy/dx dy/dx x 5 Exact DFT x Figure 2: Exact and DFT-computed derivative of [, 1] periodic sawtooth and swell functions. 7 Use of DFT for localized functions on unbounded domains Frequently, the DFT is used for approximating localized functions on the unbounded domain (, ). The method is to restrict u(x) to a finite domain [X 1, X 2 ] which is chosen large enough so that u(x) is very small (1 3 or less of its maximum value) outside this domain. Then u(x) is treated as periodic on this domain. For example, we can use a DFT to numerically differentiate exp( x 2 /2) in this manner (Figure 3). If we restrict the domain to [-4, 4] and take = 16 grid points, du/dx has only small errors at the grid points (left) compared to the exact value x exp( x 2 /2). The maximum error,.13, occurs near x = -4, suggesting that it is primarily due to the domain truncation. The power spectrum of the DFT (right) falls off rapidly with M up through M = 6, then levels off. The leveling is due to the derivative discontinuity in u(x) when interpreted as a periodic function on the truncated domain. In this example, enlarging the domain somewhat would make u(x) so small at the boundary that the domain truncation effects could be made totally negligible. To avoid degrading accuracy by increasing the grid spacing, correspondingly more grid points (and hence a larger FFT) would be required. In this problem, the computational effort is minute, but in other problems, an optimal choice of domain truncation may involve a tradeoff (for a given allowable computational effort) between wanting a large domain and wanting a sufficiently fine grid spacing. 1

11 1 Gaussian over [ 4, 4], = DFT Power spectrum.5 1 dy/dx Y m 2.5 Exact DFT x M m Figure 3: Left: Exact derivative of u(x) = exp( x 2 /2), and DFT-computed derivative with = 16 grid points, truncating domain to [-4, 4]. Right: Power spectrum of the DFT of u(x) 8 Application to 1D BVPs The main application of Fourier spectral methods is to multidimensional elliptic equations in simple rectangularbox geometries, e. g. commonly used in simulation of fluid flows. However, 1D examples illustrates the concepts well. 1D periodic ODE example Consider the ODE u xx u = f(x) = 1/(1.6 cos(x)) (14) with periodic BCs on [, 2π]. The forcing function is C and periodic on [, 2π], so we expect a Fourier method to achieve spectral accuracy. The Fourier spectral method with gridpoints for this problem can be written: ˆf = DFT(f), û m = ˆf m /(k 2 m + 1), u = Re[IDFT(û)] Matlab script FS 1DBVP.m implements this method for = 2 p and a range of p (Fig. 4). The left panel shows f(x); the middle panel shows the solution for various, interpolated between grid points using interpft 11

12 2.5 f(x) -.8 Fourier spectral u(x) 1 Max-norm h/2-h soln diff f u =2 =4 =8 =16 =32 δ x/l x/l h Figure 4: RHS f(x), FS solution u(x) at grid points and between, and error convergence plot..ote h = 2π/. The right panel assesses solution convergence from the max-norm difference δ between the p + 1 and p solutions at their common gridpoints. Spectral accuracy is achieved : δ decreases faster than any power of h. 9 Homogeneous Dirichlet and eumann BCs For an ODE with only even derivatives, the Fourier spectral method is easily extensible to homogeneous Dirichlet and eumann BCs at x =, L/2. The Dirichlet case is handled using odd extension. We assume the RHS and solution are specified as f H (x), u H (x) on the half-interval < x < L/2 and we extend the domain rightward to x = L. We let f(x), u(x) be the odd extension of f H (x), u H (x) to the extended domain, f H (x), < x < L/2 f(x) =, x =, L/2, L f H (L x), L/2 < x < L and similarly for u(x). ote that if f H is nonzero at either domain endpoint, its odd extension will have discontinuities there, and this will greatly degrade the error convergence even if even if f H (x) is smooth in the domain interior. By construction, f and its derivative are the same at x = and x = L, so a periodic solution can be found to the extended problem, allowing application of the Fourier spectral method. One can easily show by substitution that an ODE with only second derivatives holds over the extended domain < x < L, except perhaps at the reflection point L/2. At that point, the ODE is automatically 12

13 f Odd extension of f H (x) x/l u Fourier spectral u(x) -.2 =2 -.4 =4 =8 -.6 =16 = x/l δ 1 Max-norm h/2-h soln diff O(h -2 ) Figure 5: RHS, FS solution, and error convergence plot for odd extension of Dirichlet problem on the half-interval < x < L/2 1 h satisfied, because the RHS and all even derivatives of u are zero, e. g. d 2 u u(l/2 + ɛ) 2u(L/2) + u(l/2 ɛ) (L/2) = lim dx2 ɛ ɛ 2, u H (L/2 ɛ) 2() + u H (L/2 ɛ) = lim ɛ ɛ 2, =. FS 1DBVP.m implements odd extension on the ODE (14) on the half-interval < x < L/2 = π with homogeneous Dirichlet BCs, giving Fig. 5. The odd extension of the RHS (left panel) has discontinuities at and L/2. o solution is plotted for = 2 since in this case the only Fourier grid points are at the half-interval boundaries and L/2, where the solution is zero by construction. With larger, one can see the solution satisfies the Dirichlet BCs at x/l =,.5 and it looks like a periodic odd extension outside this interval. The RHS endpoint discontinuities keep the error convergence slow (O(h 2 )), such that the spectral method has no accuracy advantage over finite differences for this problem. The eumann case is handled using even extension. We extend the domain rightward to x = L. We let f(x) be the even extension of f H (x) to [, L]: { fh (x), x L/2 f(x) = f H (L x), L/2 < x L and similarly for u(x). If this is implemented on the the half-interval < x < L/2 = π for the ODE (14), the 13

14 even extension of f H is exactly the same as the periodic f that we already defined, so the Fourier spectral solution will be identical to the periodic problem. 14

Y m = y n e 2πi(m 1)(n 1)/N (1) Y m e 2πi(m 1)(n 1)/N (2) m=1

Y m = y n e 2πi(m 1)(n 1)/N (1) Y m e 2πi(m 1)(n 1)/N (2) m=1 The Discrete Fourier Transform (Bretherton notes): 1 Definition Let y n, n = 1,..., N be a sequence of N possibly comple values. The discrete Fourier transform () of this sequence is the sequence Y m,

More information

Appendix C: Recapitulation of Numerical schemes

Appendix C: Recapitulation of Numerical schemes Appendix C: Recapitulation of Numerical schemes August 31, 2009) SUMMARY: Certain numerical schemes of general use are regrouped here in order to facilitate implementations of simple models C1 The tridiagonal

More information

Numerical Methods I Orthogonal Polynomials

Numerical Methods I Orthogonal Polynomials Numerical Methods I Orthogonal Polynomials Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 Course G63.2010.001 / G22.2420-001, Fall 2010 Nov. 4th and 11th, 2010 A. Donev (Courant Institute)

More information

Computer Problems for Fourier Series and Transforms

Computer Problems for Fourier Series and Transforms Computer Problems for Fourier Series and Transforms 1. Square waves are frequently used in electronics and signal processing. An example is shown below. 1 π < x < 0 1 0 < x < π y(x) = 1 π < x < 2π... and

More information

Mathematics for Chemists 2 Lecture 14: Fourier analysis. Fourier series, Fourier transform, DFT/FFT

Mathematics for Chemists 2 Lecture 14: Fourier analysis. Fourier series, Fourier transform, DFT/FFT Mathematics for Chemists 2 Lecture 14: Fourier analysis Fourier series, Fourier transform, DFT/FFT Johannes Kepler University Summer semester 2012 Lecturer: David Sevilla Fourier analysis 1/25 Remembering

More information

The discrete and fast Fourier transforms

The discrete and fast Fourier transforms The discrete and fast Fourier transforms Marcel Oliver Revised April 7, 1 1 Fourier series We begin by recalling the familiar definition of the Fourier series. For a periodic function u: [, π] C, we define

More information

Math 56 Homework 5 Michael Downs

Math 56 Homework 5 Michael Downs 1. (a) Since f(x) = cos(6x) = ei6x 2 + e i6x 2, due to the orthogonality of each e inx, n Z, the only nonzero (complex) fourier coefficients are ˆf 6 and ˆf 6 and they re both 1 2 (which is also seen from

More information

Jim Lambers ENERGY 281 Spring Quarter Lecture 5 Notes

Jim Lambers ENERGY 281 Spring Quarter Lecture 5 Notes Jim ambers ENERGY 28 Spring Quarter 27-8 ecture 5 Notes These notes are based on Rosalind Archer s PE28 lecture notes, with some revisions by Jim ambers. Fourier Series Recall that in ecture 2, when we

More information

Polynomial Approximation: The Fourier System

Polynomial Approximation: The Fourier System Polynomial Approximation: The Fourier System Charles B. I. Chilaka CASA Seminar 17th October, 2007 Outline 1 Introduction and problem formulation 2 The continuous Fourier expansion 3 The discrete Fourier

More information

Introduction to the FFT

Introduction to the FFT Introduction to the FFT 1 Introduction Assume that we have a signal fx where x denotes time. We would like to represent fx as a linear combination of functions e πiax or, equivalently, sinπax and cosπax

More information

Examples of the Fourier Theorem (Sect. 10.3). The Fourier Theorem: Continuous case.

Examples of the Fourier Theorem (Sect. 10.3). The Fourier Theorem: Continuous case. s of the Fourier Theorem (Sect. 1.3. The Fourier Theorem: Continuous case. : Using the Fourier Theorem. The Fourier Theorem: Piecewise continuous case. : Using the Fourier Theorem. The Fourier Theorem:

More information

MA3232 Summary 5. d y1 dy1. MATLAB has a number of built-in functions for solving stiff systems of ODEs. There are ode15s, ode23s, ode23t, ode23tb.

MA3232 Summary 5. d y1 dy1. MATLAB has a number of built-in functions for solving stiff systems of ODEs. There are ode15s, ode23s, ode23t, ode23tb. umerical solutions of higher order ODE We can convert a high order ODE into a system of first order ODEs and then apply RK method to solve it. Stiff ODEs Stiffness is a special problem that can arise in

More information

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim.

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim. 56 Summary High order FD Finite-order finite differences: Points per Wavelength: Number of passes: D n f(x j ) = f j+n f j n n x df xj = m α m dx n D n f j j n= α m n = ( ) n (m!) (m n)!(m + n)!. PPW =

More information

Partial differential equations

Partial differential equations Partial differential equations Many problems in science involve the evolution of quantities not only in time but also in space (this is the most common situation)! We will call partial differential equation

More information

THE WAVE EQUATION. F = T (x, t) j + T (x + x, t) j = T (sin(θ(x, t)) + sin(θ(x + x, t)))

THE WAVE EQUATION. F = T (x, t) j + T (x + x, t) j = T (sin(θ(x, t)) + sin(θ(x + x, t))) THE WAVE EQUATION The aim is to derive a mathematical model that describes small vibrations of a tightly stretched flexible string for the one-dimensional case, or of a tightly stretched membrane for the

More information

Strauss PDEs 2e: Section Exercise 4 Page 1 of 6

Strauss PDEs 2e: Section Exercise 4 Page 1 of 6 Strauss PDEs 2e: Section 5.3 - Exercise 4 Page of 6 Exercise 4 Consider the problem u t = ku xx for < x < l, with the boundary conditions u(, t) = U, u x (l, t) =, and the initial condition u(x, ) =, where

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

Physics 250 Green s functions for ordinary differential equations

Physics 250 Green s functions for ordinary differential equations Physics 25 Green s functions for ordinary differential equations Peter Young November 25, 27 Homogeneous Equations We have already discussed second order linear homogeneous differential equations, which

More information

Ch.11 The Discrete-Time Fourier Transform (DTFT)

Ch.11 The Discrete-Time Fourier Transform (DTFT) EE2S11 Signals and Systems, part 2 Ch.11 The Discrete-Time Fourier Transform (DTFT Contents definition of the DTFT relation to the -transform, region of convergence, stability frequency plots convolution

More information

Notes on Fourier Series and Integrals Fourier Series

Notes on Fourier Series and Integrals Fourier Series Notes on Fourier Series and Integrals Fourier Series et f(x) be a piecewise linear function on [, ] (This means that f(x) may possess a finite number of finite discontinuities on the interval). Then f(x)

More information

Preliminary Examination, Numerical Analysis, August 2016

Preliminary Examination, Numerical Analysis, August 2016 Preliminary Examination, Numerical Analysis, August 2016 Instructions: This exam is closed books and notes. The time allowed is three hours and you need to work on any three out of questions 1-4 and any

More information

Differential Equations

Differential Equations Electricity and Magnetism I (P331) M. R. Shepherd October 14, 2008 Differential Equations The purpose of this note is to provide some supplementary background on differential equations. The problems discussed

More information

1 + lim. n n+1. f(x) = x + 1, x 1. and we check that f is increasing, instead. Using the quotient rule, we easily find that. 1 (x + 1) 1 x (x + 1) 2 =

1 + lim. n n+1. f(x) = x + 1, x 1. and we check that f is increasing, instead. Using the quotient rule, we easily find that. 1 (x + 1) 1 x (x + 1) 2 = Chapter 5 Sequences and series 5. Sequences Definition 5. (Sequence). A sequence is a function which is defined on the set N of natural numbers. Since such a function is uniquely determined by its values

More information

DOING PHYSICS WITH MATLAB FOURIER ANALYSIS FOURIER TRANSFORMS

DOING PHYSICS WITH MATLAB FOURIER ANALYSIS FOURIER TRANSFORMS DOING PHYSICS WITH MATLAB FOURIER ANALYSIS FOURIER TRANSFORMS Ian Cooper School of Physics, University of Sydney ian.cooper@sydney.edu.au DOWNLOAD DIRECTORY FOR MATLAB SCRIPTS maths_ft_01.m mscript used

More information

Computational Methods in Plasma Physics

Computational Methods in Plasma Physics Computational Methods in Plasma Physics Richard Fitzpatrick Institute for Fusion Studies University of Texas at Austin Purpose of Talk Describe use of numerical methods to solve simple problem in plasma

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 12 Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002. Reproduction permitted for noncommercial,

More information

Solving Poisson s Equations Using Buffered Fourier Spectral Method

Solving Poisson s Equations Using Buffered Fourier Spectral Method Solving Poisson s Equations Using Buffered Fourier Spectral Method Yinlin Dong Hassan Abd Salman Al-Dujaly Chaoqun Liu Technical Report 2015-12 http://www.uta.edu/math/preprint/ Solving Poisson s Equations

More information

Answers to Problem Set Number MIT (Fall 2005).

Answers to Problem Set Number MIT (Fall 2005). Answers to Problem Set Number 6. 18.305 MIT (Fall 2005). D. Margetis and R. Rosales (MIT, Math. Dept., Cambridge, MA 02139). December 12, 2005. Course TA: Nikos Savva, MIT, Dept. of Mathematics, Cambridge,

More information

Fourier and Partial Differential Equations

Fourier and Partial Differential Equations Chapter 5 Fourier and Partial Differential Equations 5.1 Fourier MATH 294 SPRING 1982 FINAL # 5 5.1.1 Consider the function 2x, 0 x 1. a) Sketch the odd extension of this function on 1 x 1. b) Expand the

More information

The Discrete Fourier Transform (DFT) Properties of the DFT DFT-Specic Properties Power spectrum estimate. Alex Sheremet.

The Discrete Fourier Transform (DFT) Properties of the DFT DFT-Specic Properties Power spectrum estimate. Alex Sheremet. 4. April 2, 27 -order sequences Measurements produce sequences of numbers Measurement purpose: characterize a stochastic process. Example: Process: water surface elevation as a function of time Parameters:

More information

(z 0 ) = lim. = lim. = f. Similarly along a vertical line, we fix x = x 0 and vary y. Setting z = x 0 + iy, we get. = lim. = i f

(z 0 ) = lim. = lim. = f. Similarly along a vertical line, we fix x = x 0 and vary y. Setting z = x 0 + iy, we get. = lim. = i f . Holomorphic Harmonic Functions Basic notation. Considering C as R, with coordinates x y, z = x + iy denotes the stard complex coordinate, in the usual way. Definition.1. Let f : U C be a complex valued

More information

Finite Difference Methods for Boundary Value Problems

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

More information

FILTERING IN THE FREQUENCY DOMAIN

FILTERING IN THE FREQUENCY DOMAIN 1 FILTERING IN THE FREQUENCY DOMAIN Lecture 4 Spatial Vs Frequency domain 2 Spatial Domain (I) Normal image space Changes in pixel positions correspond to changes in the scene Distances in I correspond

More information

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

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 28 PART II Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 29 BOUNDARY VALUE PROBLEMS (I) Solving a TWO

More information

Solving Boundary Value Problems (with Gaussians)

Solving Boundary Value Problems (with Gaussians) What is a boundary value problem? Solving Boundary Value Problems (with Gaussians) Definition A differential equation with constraints on the boundary Michael McCourt Division Argonne National Laboratory

More information

Introduction to the Fourier transform. Computer Vision & Digital Image Processing. The Fourier transform (continued) The Fourier transform (continued)

Introduction to the Fourier transform. Computer Vision & Digital Image Processing. The Fourier transform (continued) The Fourier transform (continued) Introduction to the Fourier transform Computer Vision & Digital Image Processing Fourier Transform Let f(x) be a continuous function of a real variable x The Fourier transform of f(x), denoted by I {f(x)}

More information

Today s lecture. The Fourier transform. Sampling, aliasing, interpolation The Fast Fourier Transform (FFT) algorithm

Today s lecture. The Fourier transform. Sampling, aliasing, interpolation The Fast Fourier Transform (FFT) algorithm Today s lecture The Fourier transform What is it? What is it useful for? What are its properties? Sampling, aliasing, interpolation The Fast Fourier Transform (FFT) algorithm Jean Baptiste Joseph Fourier

More information

LES of Turbulent Flows: Lecture 3

LES of Turbulent Flows: Lecture 3 LES of Turbulent Flows: Lecture 3 Dr. Jeremy A. Gibbs Department of Mechanical Engineering University of Utah Fall 2016 1 / 53 Overview 1 Website for those auditing 2 Turbulence Scales 3 Fourier transforms

More information

Fig. 1: Fourier series Examples

Fig. 1: Fourier series Examples FOURIER SERIES AND ITS SOME APPLICATIONS P. Sathyabama Assistant Professor, Department of Mathematics, Bharath collage of Science and Management, Thanjavur, Tamilnadu Abstract: The Fourier series, the

More information

The moral of the story regarding discontinuities: They affect the rate of convergence of Fourier series

The moral of the story regarding discontinuities: They affect the rate of convergence of Fourier series Lecture 7 Inner product spaces cont d The moral of the story regarding discontinuities: They affect the rate of convergence of Fourier series As suggested by the previous example, discontinuities of a

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

The 1-D Heat Equation

The 1-D Heat Equation The 1-D Heat Equation 18.303 Linear Partial Differential Equations Matthew J. Hancock Fall 004 1 The 1-D Heat Equation 1.1 Physical derivation Reference: Haberman 1.1-1.3 [Sept. 8, 004] In a metal rod

More information

Separation of Variables in Linear PDE: One-Dimensional Problems

Separation of Variables in Linear PDE: One-Dimensional Problems Separation of Variables in Linear PDE: One-Dimensional Problems Now we apply the theory of Hilbert spaces to linear differential equations with partial derivatives (PDE). We start with a particular example,

More information

f xx g dx, (5) The point (i) is straightforward. Let us check the point (ii). Doing the integral by parts, we get 1 f g xx dx = f g x 1 0 f xg x dx =

f xx g dx, (5) The point (i) is straightforward. Let us check the point (ii). Doing the integral by parts, we get 1 f g xx dx = f g x 1 0 f xg x dx = Problem 19. Consider the heat equation u t = u xx, (1) u = u(x, t), x [, 1], with the boundary conditions (note the derivative in the first one) u x (, t) =, u(1, t) = (2) and the initial condition u(x,

More information

6 Non-homogeneous Heat Problems

6 Non-homogeneous Heat Problems 6 Non-homogeneous Heat Problems Up to this point all the problems we have considered for the heat or wave equation we what we call homogeneous problems. This means that for an interval < x < l the problems

More information

1 Separation of Variables

1 Separation of Variables Jim ambers ENERGY 281 Spring Quarter 27-8 ecture 2 Notes 1 Separation of Variables In the previous lecture, we learned how to derive a PDE that describes fluid flow. Now, we will learn a number of analytical

More information

8.1 Concentration inequality for Gaussian random matrix (cont d)

8.1 Concentration inequality for Gaussian random matrix (cont d) MGMT 69: Topics in High-dimensional Data Analysis Falll 26 Lecture 8: Spectral clustering and Laplacian matrices Lecturer: Jiaming Xu Scribe: Hyun-Ju Oh and Taotao He, October 4, 26 Outline Concentration

More information

Lecture 4 Filtering in the Frequency Domain. Lin ZHANG, PhD School of Software Engineering Tongji University Spring 2016

Lecture 4 Filtering in the Frequency Domain. Lin ZHANG, PhD School of Software Engineering Tongji University Spring 2016 Lecture 4 Filtering in the Frequency Domain Lin ZHANG, PhD School of Software Engineering Tongji University Spring 2016 Outline Background From Fourier series to Fourier transform Properties of the Fourier

More information

Waves, the Wave Equation, and Phase Velocity. We ll start with optics. The one-dimensional wave equation. What is a wave? Optional optics texts: f(x)

Waves, the Wave Equation, and Phase Velocity. We ll start with optics. The one-dimensional wave equation. What is a wave? Optional optics texts: f(x) We ll start with optics Optional optics texts: Waves, the Wave Equation, and Phase Velocity What is a wave? f(x) f(x-) f(x-) f(x-3) Eugene Hecht, Optics, 4th ed. J.F. James, A Student's Guide to Fourier

More information

2.3. Quantitative Properties of Finite Difference Schemes. Reading: Tannehill et al. Sections and

2.3. Quantitative Properties of Finite Difference Schemes. Reading: Tannehill et al. Sections and 3 Quantitative Properties of Finite Difference Schemes 31 Consistency, Convergence and Stability of FD schemes Reading: Tannehill et al Sections 333 and 334 Three important properties of FD schemes: Consistency

More information

Applied Mathematics 205. Unit III: Numerical Calculus. Lecturer: Dr. David Knezevic

Applied Mathematics 205. Unit III: Numerical Calculus. Lecturer: Dr. David Knezevic Applied Mathematics 205 Unit III: Numerical Calculus Lecturer: Dr. David Knezevic Unit III: Numerical Calculus Chapter III.3: Boundary Value Problems and PDEs 2 / 96 ODE Boundary Value Problems 3 / 96

More information

The Heat Equation John K. Hunter February 15, The heat equation on a circle

The Heat Equation John K. Hunter February 15, The heat equation on a circle The Heat Equation John K. Hunter February 15, 007 The heat equation on a circle We consider the diffusion of heat in an insulated circular ring. We let t [0, ) denote time and x T a spatial coordinate

More information

Chapter 6 - Ordinary Differential Equations

Chapter 6 - Ordinary Differential Equations Chapter 6 - Ordinary Differential Equations 7.1 Solving Initial-Value Problems In this chapter, we will be interested in the solution of ordinary differential equations. Ordinary differential equations

More information

Introduction to Finite Di erence Methods

Introduction to Finite Di erence Methods Introduction to Finite Di erence Methods ME 448/548 Notes Gerald Recktenwald Portland State University Department of Mechanical Engineering gerry@pdx.edu ME 448/548: Introduction to Finite Di erence Approximation

More information

Math 4263 Homework Set 1

Math 4263 Homework Set 1 Homework Set 1 1. Solve the following PDE/BVP 2. Solve the following PDE/BVP 2u t + 3u x = 0 u (x, 0) = sin (x) u x + e x u y = 0 u (0, y) = y 2 3. (a) Find the curves γ : t (x (t), y (t)) such that that

More information

Spectral Methods and Inverse Problems

Spectral Methods and Inverse Problems Spectral Methods and Inverse Problems Omid Khanmohamadi Department of Mathematics Florida State University Outline Outline 1 Fourier Spectral Methods Fourier Transforms Trigonometric Polynomial Interpolants

More information

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods Introduction In this workshop we will introduce you to the least-squares spectral element method. As you can see from the lecture notes, this method is a combination of the weak formulation derived from

More information

Curve Fitting. 1 Interpolation. 2 Composite Fitting. 1.1 Fitting f(x) 1.2 Hermite interpolation. 2.1 Parabolic and Cubic Splines

Curve Fitting. 1 Interpolation. 2 Composite Fitting. 1.1 Fitting f(x) 1.2 Hermite interpolation. 2.1 Parabolic and Cubic Splines Curve Fitting Why do we want to curve fit? In general, we fit data points to produce a smooth representation of the system whose response generated the data points We do this for a variety of reasons 1

More information

arxiv: v1 [math.cv] 18 Aug 2015

arxiv: v1 [math.cv] 18 Aug 2015 arxiv:508.04376v [math.cv] 8 Aug 205 Saddle-point integration of C bump functions Steven G. Johnson, MIT Applied Mathematics Created November 23, 2006; updated August 9, 205 Abstract This technical note

More information

Computer Vision. Filtering in the Frequency Domain

Computer Vision. Filtering in the Frequency Domain Computer Vision Filtering in the Frequency Domain Filippo Bergamasco (filippo.bergamasco@unive.it) http://www.dais.unive.it/~bergamasco DAIS, Ca Foscari University of Venice Academic year 2016/2017 Introduction

More information

Take Home Exam I Key

Take Home Exam I Key Take Home Exam I Key MA 336 1. (5 points) Read sections 2.1 to 2.6 in the text (which we ve already talked about in class), and the handout on Solving the Nonhomogeneous Heat Equation. Solution: You did

More information

Fourier Series. (Com S 477/577 Notes) Yan-Bin Jia. Nov 29, 2016

Fourier Series. (Com S 477/577 Notes) Yan-Bin Jia. Nov 29, 2016 Fourier Series (Com S 477/577 otes) Yan-Bin Jia ov 9, 016 1 Introduction Many functions in nature are periodic, that is, f(x+τ) = f(x), for some fixed τ, which is called the period of f. Though function

More information

lecture 7: Trigonometric Interpolation

lecture 7: Trigonometric Interpolation lecture : Trigonometric Interpolation 9 Trigonometric interpolation for periodic functions Thus far all our interpolation schemes have been based on polynomials However, if the function f is periodic,

More information

Compensation. June 29, Arizona State University. Edge Detection from Nonuniform Data via. Convolutional Gridding with Density.

Compensation. June 29, Arizona State University. Edge Detection from Nonuniform Data via. Convolutional Gridding with Density. Arizona State University June 29, 2012 Overview gridding with density compensation is a common method for function reconstruction nonuniform Fourier data. It is computationally inexpensive compared with

More information

n 1 f n 1 c 1 n+1 = c 1 n $ c 1 n 1. After taking logs, this becomes

n 1 f n 1 c 1 n+1 = c 1 n $ c 1 n 1. After taking logs, this becomes Root finding: 1 a The points {x n+1, }, {x n, f n }, {x n 1, f n 1 } should be co-linear Say they lie on the line x + y = This gives the relations x n+1 + = x n +f n = x n 1 +f n 1 = Eliminating α and

More information

Math 229: Introduction to Analytic Number Theory The product formula for ξ(s) and ζ(s); vertical distribution of zeros

Math 229: Introduction to Analytic Number Theory The product formula for ξ(s) and ζ(s); vertical distribution of zeros Math 9: Introduction to Analytic Number Theory The product formula for ξs) and ζs); vertical distribution of zeros Behavior on vertical lines. We next show that s s)ξs) is an entire function of order ;

More information

Transforms and Orthogonal Bases

Transforms and Orthogonal Bases Orthogonal Bases Transforms and Orthogonal Bases We now turn back to linear algebra to understand transforms, which map signals between different domains Recall that signals can be interpreted as vectors

More information

Relevant self-assessment exercises: [LIST SELF-ASSESSMENT EXERCISES HERE]

Relevant self-assessment exercises: [LIST SELF-ASSESSMENT EXERCISES HERE] Chapter 5 Fourier Analysis of Finite Difference Methods In this lecture, we determine the stability of PDE discretizations using Fourier analysis. First, we begin with Fourier analysis of PDE s, and then

More information

Fourier Series and Integrals

Fourier Series and Integrals Fourier Series and Integrals Fourier Series et f(x) beapiece-wiselinearfunctionon[, ] (Thismeansthatf(x) maypossessa finite number of finite discontinuities on the interval). Then f(x) canbeexpandedina

More information

A glimpse of Fourier analysis

A glimpse of Fourier analysis Chapter 7 A glimpse of Fourier analysis 7.1 Fourier series In the middle of the 18th century, mathematicians and physicists started to study the motion of a vibrating string (think of the strings of a

More information

Discrete Fourier transform

Discrete Fourier transform Discrete Fourier transform Alejandro Ribeiro Dept. of Electrical and Systems Engineering University of Pennsylvania aribeiro@seas.upenn.edu http://www.seas.upenn.edu/users/~aribeiro/ January 2, 216 Signal

More information

3. Lecture. Fourier Transformation Sampling

3. Lecture. Fourier Transformation Sampling 3. Lecture Fourier Transformation Sampling Some slides taken from Digital Image Processing: An Algorithmic Introduction using Java, Wilhelm Burger and Mark James Burge Separability ² The 2D DFT can be

More information

Fourier Transform Chapter 10 Sampling and Series

Fourier Transform Chapter 10 Sampling and Series Fourier Transform Chapter 0 Sampling and Series Sampling Theorem Sampling Theorem states that, under a certain condition, it is in fact possible to recover with full accuracy the values intervening between

More information

Dispersion relations, stability and linearization

Dispersion relations, stability and linearization Dispersion relations, stability and linearization 1 Dispersion relations Suppose that u(x, t) is a function with domain { < x 0}, and it satisfies a linear, constant coefficient partial differential

More information

University of Connecticut Lecture Notes for ME5507 Fall 2014 Engineering Analysis I Part III: Fourier Analysis

University of Connecticut Lecture Notes for ME5507 Fall 2014 Engineering Analysis I Part III: Fourier Analysis University of Connecticut Lecture Notes for ME557 Fall 24 Engineering Analysis I Part III: Fourier Analysis Xu Chen Assistant Professor United Technologies Engineering Build, Rm. 382 Department of Mechanical

More information

Signal Processing COS 323

Signal Processing COS 323 Signal Processing COS 323 Digital Signals D: functions of space or time e.g., sound 2D: often functions of 2 spatial dimensions e.g. images 3D: functions of 3 spatial dimensions CAT, MRI scans or 2 space,

More information

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs)

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) 13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) A prototypical problem we will discuss in detail is the 1D diffusion equation u t = Du xx < x < l, t > finite-length rod u(x,

More information

Notes on FFT-based differentiation

Notes on FFT-based differentiation Notes on FFT-based differentiation Steven G Johnson, MIT Applied Mathematics Created April, 2011, updated May 4, 2011 Abstract A common numerical technique is to differentiate some sampled function y(x)

More information

Time-dependent variational forms

Time-dependent variational forms Time-dependent variational forms Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Oct 30, 2015 PRELIMINARY VERSION

More information

CS711008Z Algorithm Design and Analysis

CS711008Z Algorithm Design and Analysis CS711008Z Algorithm Design and Analysis Lecture 5 FFT and Divide and Conquer Dongbo Bu Institute of Computing Technology Chinese Academy of Sciences, Beijing, China 1 / 56 Outline DFT: evaluate a polynomial

More information

An Introduction to Numerical Methods for Differential Equations. Janet Peterson

An Introduction to Numerical Methods for Differential Equations. Janet Peterson An Introduction to Numerical Methods for Differential Equations Janet Peterson Fall 2015 2 Chapter 1 Introduction Differential equations arise in many disciplines such as engineering, mathematics, sciences

More information

The Discrete Fourier Transform

The Discrete Fourier Transform The Discrete Fourier Transform / 23 The Fourier Transform Any discrete time series exponentials: can be built up of a sum of complex = X m e i2πmn/, n = 0,, m=0 = [ + + + + ]. X 0 X e i2πn (/) X 2 e i2πn

More information

12.7 Heat Equation: Modeling Very Long Bars.

12.7 Heat Equation: Modeling Very Long Bars. 568 CHAP. Partial Differential Equations (PDEs).7 Heat Equation: Modeling Very Long Bars. Solution by Fourier Integrals and Transforms Our discussion of the heat equation () u t c u x in the last section

More information

Math 251 December 14, 2005 Answer Key to Final Exam. 1 18pt 2 16pt 3 12pt 4 14pt 5 12pt 6 14pt 7 14pt 8 16pt 9 20pt 10 14pt Total 150pt

Math 251 December 14, 2005 Answer Key to Final Exam. 1 18pt 2 16pt 3 12pt 4 14pt 5 12pt 6 14pt 7 14pt 8 16pt 9 20pt 10 14pt Total 150pt Name Section Math 51 December 14, 5 Answer Key to Final Exam There are 1 questions on this exam. Many of them have multiple parts. The point value of each question is indicated either at the beginning

More information

Von Neumann Analysis of Jacobi and Gauss-Seidel Iterations

Von Neumann Analysis of Jacobi and Gauss-Seidel Iterations Von Neumann Analysis of Jacobi and Gauss-Seidel Iterations We consider the FDA to the 1D Poisson equation on a grid x covering [0,1] with uniform spacing h, h (u +1 u + u 1 ) = f whose exact solution (to

More information

Time-Frequency Analysis

Time-Frequency Analysis Time-Frequency Analysis Basics of Fourier Series Philippe B. aval KSU Fall 015 Philippe B. aval (KSU) Fourier Series Fall 015 1 / 0 Introduction We first review how to derive the Fourier series of a function.

More information

The 1-D Heat Equation

The 1-D Heat Equation The 1-D Heat Equation 18.303 Linear Partial Differential Equations Matthew J. Hancock Fall 005 1 The 1-D Heat Equation 1.1 Physical derivation Reference: Haberman 1.1-1.3 [Sept. 7, 005] In a metal rod

More information

1 Distributions (due January 22, 2009)

1 Distributions (due January 22, 2009) Distributions (due January 22, 29). The distribution derivative of the locally integrable function ln( x ) is the principal value distribution /x. We know that, φ = lim φ(x) dx. x ɛ x Show that x, φ =

More information

(Refer Slide Time: 01:30)

(Refer Slide Time: 01:30) Networks and Systems Prof V.G K.Murti Department of Electrical Engineering Indian Institute of Technology, Madras Lecture - 11 Fourier Series (5) Continuing our discussion of Fourier series today, we will

More information

Discrete Fourier Transform

Discrete Fourier Transform Discrete Fourier Transform Virtually all practical signals have finite length (e.g., sensor data, audio records, digital images, stock values, etc). Rather than considering such signals to be zero-padded

More information

Homework Set 4 - SOLUTIONS

Homework Set 4 - SOLUTIONS MATH 55 Scientific Computing II Spring 6 Homework Set 4 - SOLUTIONS. For N even define a discrete grid x h for [, π] by x k = k h where h = π/n and k N. Show e i( N +j)x k = e i( N j)x k for j =,,...,

More information

2.1 The derivative. Rates of change. m sec = y f (a + h) f (a)

2.1 The derivative. Rates of change. m sec = y f (a + h) f (a) 2.1 The derivative Rates of change 1 The slope of a secant line is m sec = y f (b) f (a) = x b a and represents the average rate of change over [a, b]. Letting b = a + h, we can express the slope of the

More information

Fundamentals of the DFT (fft) Algorithms

Fundamentals of the DFT (fft) Algorithms Fundamentals of the DFT (fft) Algorithms D. Sundararajan November 6, 9 Contents 1 The PM DIF DFT Algorithm 1.1 Half-wave symmetry of periodic waveforms.............. 1. The DFT definition and the half-wave

More information

GRE Math Subject Test #5 Solutions.

GRE Math Subject Test #5 Solutions. GRE Math Subject Test #5 Solutions. 1. E (Calculus) Apply L Hôpital s Rule two times: cos(3x) 1 3 sin(3x) 9 cos(3x) lim x 0 = lim x 2 x 0 = lim 2x x 0 = 9. 2 2 2. C (Geometry) Note that a line segment

More information

swapneel/207

swapneel/207 Partial differential equations Swapneel Mahajan www.math.iitb.ac.in/ swapneel/207 1 1 Power series For a real number x 0 and a sequence (a n ) of real numbers, consider the expression a n (x x 0 ) n =

More information

Chapter 2: Differentiation

Chapter 2: Differentiation Chapter 2: Differentiation Spring 2018 Department of Mathematics Hong Kong Baptist University 1 / 82 2.1 Tangent Lines and Their Slopes This section deals with the problem of finding a straight line L

More information

Higher-order ordinary differential equations

Higher-order ordinary differential equations Higher-order ordinary differential equations 1 A linear ODE of general order n has the form a n (x) dn y dx n +a n 1(x) dn 1 y dx n 1 + +a 1(x) dy dx +a 0(x)y = f(x). If f(x) = 0 then the equation is called

More information

A REVIEW OF RESIDUES AND INTEGRATION A PROCEDURAL APPROACH

A REVIEW OF RESIDUES AND INTEGRATION A PROCEDURAL APPROACH A REVIEW OF RESIDUES AND INTEGRATION A PROEDURAL APPROAH ANDREW ARHIBALD 1. Introduction When working with complex functions, it is best to understand exactly how they work. Of course, complex functions

More information

Lattices Part II Dual Lattices, Fourier Transform, Smoothing Parameter, Public Key Encryption

Lattices Part II Dual Lattices, Fourier Transform, Smoothing Parameter, Public Key Encryption Lattices Part II Dual Lattices, Fourier Transform, Smoothing Parameter, Public Key Encryption Boaz Barak May 12, 2008 The first two sections are based on Oded Regev s lecture notes, and the third one on

More information

FOURIER ANALYSIS. (a) Fourier Series

FOURIER ANALYSIS. (a) Fourier Series (a) Fourier Series FOURIER ANAYSIS (b) Fourier Transforms Useful books: 1. Advanced Mathematics for Engineers and Scientists, Schaum s Outline Series, M. R. Spiegel - The course text. We follow their notation

More information