lecture 7: Trigonometric Interpolation

Size: px
Start display at page:

Download "lecture 7: Trigonometric Interpolation"

Transcription

1 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, one might naturally prefer to interpolate f with some set of periodic functions To be concrete, suppose we have a continuous p-periodic function f that we wish to interpolate at the uniformly spaced points k = pk/n for k =,, n with n = We shall build an interpolant as a linear combination of the p-periodic functions p-periodic means that f is continuous throughout IR and f () = f ( + p) for all IR The choice of period p makes the notation a bit simpler, but the idea can be easily adapted for any period b () =, b () =sin(), b () =cos(), b () =sin(), b () =cos() Note that we have si interpolation conditions at k for k =,,, but only five basis functions This is not a problem: since f is periodic, f ( )= f ( ), and the same will be true of our p-periodic interpolant: the last interpolation condition is automatically satisfied We shall construct an interpolant of the form such that t () = Â c k b k () k= t ( j )= f ( j ), j =,, To compute the unknown coefficients c,,c, set up a linear system as usual, b ( ) b ( ) b ( ) b ( ) b ( ) c f ( ) b ( ) b ( ) b ( ) b ( ) b ( ) c f ( ) b ( ) b ( ) b ( ) b ( ) b ( ) c = f ( ), b ( ) b ( ) b ( ) b ( ) b ( ) c f ( ) b ( ) b ( ) b ( ) b ( ) b ( ) f ( ) c which can be readily generalized to accommodate more interpolation points We could solve this system for c,,c n, but we prefer to epress the problem in a more convenient basis for the trigonometric functions Recall Euler s formula, e iq = cos(q)+i sin(q), You would b () = sin(), b () =cos(), etc: one function for each additional interpolation point Generally you would use an odd value of n, to include pairs of sines and cosines which also implies that e iq = cos(q) From these formulas it follows that i sin(q) To prove this, write the Taylor epansion of e iq, then separate the real and imaginary components to give Taylor epansions for cos(q) and sin(q) span{e iq,e iq } = {cos(q), sin(q)}

2 Note that we can also write b () = e i Putting these pieces together, we arrive at an alternative basis for the trigonometric interpolation space: span{, sin(), cos(), sin(), cos()} = span{e i,e i,e i,e i,e i } The interpolant t n can thus be epressed in the form t () = Â g k e ik = Â g k (e i ) k k= k= This last sum is written in a manner that emphasizes that t is a polynomial in the variable e i, and hence t n is a trigonometric polynomial In this basis, the interpolation conditions give the linear system e i e i e i e i e i e i e i e i e i e i e i e i e i e i e i e i e i e i e i e i e i e i e i e i e i g g g g g = f ( ) f ( ) f ( ) f ( ) f ( ) again with the natural generalization to larger odd integers n At first blush this matri looks no simpler than the one we first encountered, but a fascinating structure lurks Notice that a generic entry of this matri has the form e`i k for ` = (n )/,, (n )/ and k =,, n Since k = pk/n, rewrite this entry as, e`i k = e i k ` = e pik/n ` = e pi/n k` = w k`, where w = e pi/n is an nth root of unity In the n = case, the linear system can thus be written as () w w w w w w w w w w w w w w w w w w w w w 8 w w w w 8 g g g g g = f ( ) f ( ) f ( ) f ( ) f ( ) This name comes from the fact that w n = Denote this system by Fg = f Notice that each column of F equals some (entrywise) power of the vector w w w w w In other words, the matri F has Vandermonde structure From our past eperience with polynomial fitting addressed in Section, we

3 might fear that this formulation is ill-suited to numerical computations, ie, solutions g to the system Fg = f could be polluted by large numerical errors In the language of numerical linear algebra, we might fear that the matri F is ill-conditioned, ie, the condition number kfkkf k is large Before jumping to this conclusion, eamine F F To form F note F is the conjugate-transpose of F: that w ` = w`, so F = F T, w w w w w 8 w w w w w so (F ) j,k = F k,j w w w w w w w w w w F F = w w w w w w w w w w w w w w w w w w w w w w w w w 8 w 8 w w w w 8 The (`, k) entry for F F thus takes the form (F F)`,k = w + w (k `) + w (k `) + w (k `) + w (k `) On the diagonal, when ` = k, we simply have (F F) k,k = w + w + w + w + w = n On the off-diagonal, use w n = to see that all the off diagonal entries simplify to (F F)`,k = w + w + w + w + w, ` = k You can think of this last entry as n times the average of w, w, w, w, and w, which are uniformly spaced points on the unit circle, shown in the plot to the right As these points are uniformly positioned about the unit circle, their mean must be zero, and hence We thus must conclude that (F F)`,k =, ` = k F F = ni, thus giving a formula for the inverse: - - w w w w - - w = w F = n F The system Fg = f can be immediately solved without the need for any factorization of F: g = n F f The ready formula for F is reminiscent of a unitary matri In fact, the matrices p F and p F n n Q C n n is unitary if and only if Q = Q, or, equivalently, Q Q = I

4 are indeed unitary, and hence kn / Fk = kn / F k = From this we can compute the condition number of F: kfk kf k = n kfk kf k = kn / Fk kn / F k = This special Vandermonde matri is perfectly conditioned! One can easily solve the system Fg = f to high precision The key distinction between this case and standard polynomial interpolation is that now we have a Vandermonde matri based on points e i k that are equally spaced about the unit circle in the comple plane, whereas before our points were distributed over an interval on the real line This distinction makes all the difference between an unstable matri equation and one that is not only perfectly stable, but also forms the cornerstone of modern signal processing In fact, we have just computed the Discrete Fourier Transform (DFT) of the data vector f ( ) f ( ) f ( n ) The matri -norm is defined as kfk = ma = kfk kk, where the vector norm on the right hand side is the Euclidean norm kyk =  y k / =(y y) / k The -norm of a unitary matri is one: If Q Q = I, then kqk = Q Q = = kk, so kqk = The coefficients g (n )/,,g (n )/ that make up the vector g = n F f are the discrete Fourier coefficients of the data in f From where does this name derive? 9 Connection to Fourier series In a real/functional analysis course, one learns that a p-periodic function f can be written as the Fourier series f () =  c k e ik, k= where the Fourier coefficients c` are defined via c k := Z p f ()e ik p Notice that g k =((/n)f f) k is an approimation to this c k : g k = n = n n  f (`)w `k `= n  f ( k )e (pk/n)i` = n n  f ( k )e i` k k= k= To ensure pointwise convergence of this series for all [, p], f must be a continuous p-periodic function with a continuous first derivative The functions e k () = e ik / p p form an orthonormal basis for the space L [, p] endowed with the inner product Z p ( f, g) = f ()g() d The Fourier series is simply an epansion of f in this basis: f = Â( f, e k ) e k k

5 Now use the fact that f ( )e i` = f ( n )e i` n to view the last sum as a composite trapezoid rule approimation of an integral: pg` = p n Z p = pc` f ( )e i` n + Â f ( k )e i` k + f ( n)e i` n k= f ()e i` d The composite trapezoid rule will be discussed in Chapter The coefficient g` that premultiplies e i` in the trigonometric interpolating polynomial is actually an approimation of the Fourier coefficient c` Let us go one step further Notice that the trigonometric interpolant t n () = (n )/ Â g k e ik k= (n )/ is an approimation to the Fourier series f () = Â c k e ik k= obtained by () truncating the series, and () replacing c k with g k To assess the quality of the approimation, we need to understand the magnitude of the terms dropped from the sum, as well as the accuracy of the composite trapezoid rule approimation g k to c k We will thus postpone discussion of f () t n () until we develop a few more analytical tools in the net two chapters 9 Computing the discrete Fourier coefficients Normally we would require O(n ) operations to compute these coefficients using matri-vector multiplication with F, but Cooley and Tukey discovered in 9 that given the amazing structure in F, one can arrange operations so as to compute g = n F f in only O(n log n) operations: a procedure that we now famously call the Fast Fourier Transform (FFT) We can summarize this section as follows The FFT of a vector of uniform samples of a p-periodic function f gives the coefficients for the trigonometric interpolant to f at those sample points These coefficients approimate the function s Fourier coefficients Apparently the FFT was discovered earlier by Gauss, but it was forgotten, given its limited utility before the advent of automatic computation Jack Good (Bletchley Park codebreaker and, later, a Virginia Tech statistician) published a similar idea in 98 Good recalls: John Tukey (December 9) and Richard L Garwin (September 9) visited Cheltenham and I had them round to steaks and fries on separate occasions I told Tukey briefly about my FFT (with little detail) and, in Cooley and Tukey s well known paper of 9, my 98 paper is the only citation See D L Banks, A conversation with I J Good, Stat Sci (99) 9

6 Eample 8 (Trig interpolation of a smooth periodic function) Figure shows the degree n =,, 9 and trigonometric interpolants to the p-periodic function f () =e cos()+sin() Notice that although all the interpolation points are all drawn from the interval [, p) (indicated by the gray region on the plot), the interpolants are just as accurate outside this region In contrast, a standard polynomial fit through the same points will behave very differently: (nonconstant) polynomials must satisfy p n ()! as! Figure shows this behavior for n = : for [, p], the polynomial fit to f is about as accurate as the n = trigonometric polynomial in Figure Outside of [, p],the polynomial is much worse Eample 9 (Trig interpolation of non-smooth function) Figure shows that a standard (non-perioidic) polynomial fit to a periodic function can yield a good approimation, at least over the interval from which the interpolation points are drawn Now turn the tables: how well does a (periodic) trigonometric polynomial fit a smooth but non-periodic function? Simply take f () = on [, p], and construct the trigonometric interpolant as described above for n = The top plot in Figure shows that t gives a very poor approimation to f, constrained by design to be periodic even though f is not The fact that f (p) = f () acts like a discontinuity, vastly impairing the quality of the approimation The bottom plot in Figure repeats this eercise for f () =( p) Since in this case f () = f (p) we might epect better results; indeed, the approimation looks quite reasonable Note, however, that f () = f (p), and this lack of smoothness severely slows convergence of t n to f as n! Figure contrasts this slow rate of convergence with the much faster convergence observed for f () =e cos()+sin() used in Figure Clearly the periodic interpolant is much better suited to smooth f 9 Fast MATLAB implementation MATLAB organizes its Fast Fourier Transform is a slightly different fashion than we have described above To fit with MATLAB, reorder the unknowns in the system () to obtain () w w w w w w w w w w w w w w w w w w w w w w w 8 w 8 w g g g g g = f ( ) f ( ) f ( ) f ( ) f ( ),

7 f () t () Figure : Trigonometric interpolant to p-periodic function f () =e cos()+sin(), using n =,, 9 and points uniformly spaced over [, p) ({ k } n k= for k = pk/n) Since both f and the interpolant are periodic, the function fits well throughout IR, not just on the interval for which the interpolant was designed - -: : : : f () t () - -: : : : - -: : : : t 9 () f () f () t () - -: : : :

8 8 p () f () Figure : Polynomial fit of degree n = through uniformly spaced grid points,, n for j = pj/n, for the same function f () =e cos()+sin() used in Figure In contrast to the trigonometric fits in the earlier figure, the polynomial grows very rapidly outside the interval [, p] Moral: if your function is periodic, fit it with a trigonometric polynomial - -: : : : f () = t () - -: : : : f () = ( p) Figure : Trigonometric polynomial fit of degree n = through uniformly spaced grid points,, n for j = pj/n, for the non-periodic function f () = (top) and for f () =( p) (bottom) By restricting the latter function to the domain [, p], one can view it as a continuous periodic function with a jump discontinuity in the first derivative The interpolant t seems to give a good approimation to f, but the discontinuity in the derivative slows the convergence of t n to f as n! 8 t () - -: : : : which amounts to reordering the columns of the matri in () You can obtain this matri by the command ifft(eye(n)) For n =, ifft(eye()) = w w w w w w w w w w w w w w w w w w w w w w w 8 w 8 w

9 9 ma f () t n() [,p] f () =( p) f () =e cos()+sin() Figure : Convergence of the trigonometric polynomial interpolants to f () =e cos()+sin() and f () =( p) For the first function, convergence is etremely rapid as n! The second function, restricted to [, p], can be viewed as a continuous but not continuously differentiable function Though the approimation in Figure looks good over [, p], the convergence of t n to f is slow as n! - - n Similarly, the inverse of this matri can be computed from fft(eye(n)) command: w w w w w fft(eye())/ = w w w w w w w w w w 8 w w w w w 8 w w w w w We could construct this matri and multiply it against f to obtain g, but that would require O(n ) operations Instead, we can compute g directly using the fft command: g = fft(f)/n Recall that this reordered vector gives g = g g g g g, which must be taken into account when constructing t n Eample (MATLAB code for trigonometric interpolation) We close with a sample of MATLAB code one could use to construct the interpolant t n for the function f () = e cos()+sin() First we present a generic code that will work for any (real- or complevalued) p-periodic f Take special note of the simple one line command to find the coefficients g

10 f ep(cos()+sin(*)); n = ; k = [:n-] **pi/n; = linspace(,*pi,) ; tn = zeros(size()); % define the function % # terms in trig polynomial (must be odd) % interpolation points % fine grid on which to plot f, t_n % initialize t_n gamma = fft(f(k))/n; % solve for coefficients, gamma for k=:(n+)/ tn = tn + gamma(k)*ep(i*(k-)*); end for k=(n+)/+:n tn = tn + gamma(k)*ep(i*(-n+k-)*); end plot(,f(), b- ), hold on plot(, tn, r- ) % add in gamma_, gamma_, gamma_{(n-)/} % add in gamma_{-(n-)/},, gamma_{-} % plot f % plot t_n In the case that f is real-valued (as with all the eamples shown in this section), one can further show that g k = g k, indicating that the imaginary terms will not make any contribution to t n Since for k =,, (n )/, g k e ik + g k e ik = Re(g k ) cos(k) Im(g k ) sin(k), the code can be simplified slightly to construct t n as follows gamma = fft(f(k))/n; tn = gamma()*ep(i**); for k=:(n+)/ end tn = tn + *real(gamma(k))*cos((k-)*) % solve for coefficients, gamma % initialize t_n() = gamma_ - *imag(gamma(k))*sin((k-)*); % eploit gamma_{-k} = conj(gamma_k)

Lecture 4.2 Finite Difference Approximation

Lecture 4.2 Finite Difference Approximation Lecture 4. Finite Difference Approimation 1 Discretization As stated in Lecture 1.0, there are three steps in numerically solving the differential equations. They are: 1. Discretization of the domain by

More information

Interpolation on the unit circle

Interpolation on the unit circle Lecture 2: The Fast Discrete Fourier Transform Interpolation on the unit circle So far, we have considered interpolation of functions at nodes on the real line. When we model periodic phenomena, it is

More information

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

AP Calculus BC Chapter 8: Integration Techniques, L Hopital s Rule and Improper Integrals

AP Calculus BC Chapter 8: Integration Techniques, L Hopital s Rule and Improper Integrals AP Calculus BC Chapter 8: Integration Techniques, L Hopital s Rule and Improper Integrals 8. Basic Integration Rules In this section we will review various integration strategies. Strategies: I. Separate

More information

Review of Linear Systems Theory

Review of Linear Systems Theory Review of Linear Systems Theory The following is a (very) brief review of linear systems theory, convolution, and Fourier analysis. I work primarily with discrete signals, but each result developed in

More information

AP Calculus AB Summer Assignment

AP Calculus AB Summer Assignment AP Calculus AB Summer Assignment Name: When you come back to school, it is my epectation that you will have this packet completed. You will be way behind at the beginning of the year if you haven t attempted

More information

4.3 The Discrete Fourier Transform (DFT) and the Fast Fourier Transform (FFT)

4.3 The Discrete Fourier Transform (DFT) and the Fast Fourier Transform (FFT) CHAPTER. TIME-FREQUECY AALYSIS: FOURIER TRASFORMS AD WAVELETS.3 The Discrete Fourier Transform (DFT and the Fast Fourier Transform (FFT.3.1 Introduction In this section, we discuss some of the mathematics

More information

The Fast Fourier Transform: A Brief Overview. with Applications. Petros Kondylis. Petros Kondylis. December 4, 2014

The Fast Fourier Transform: A Brief Overview. with Applications. Petros Kondylis. Petros Kondylis. December 4, 2014 December 4, 2014 Timeline Researcher Date Length of Sequence Application CF Gauss 1805 Any Composite Integer Interpolation of orbits of celestial bodies F Carlini 1828 12 Harmonic Analysis of Barometric

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

Lecture 4b. Bessel functions. Introduction. Generalized factorial function. 4b.1. Using integration by parts it is easy to show that

Lecture 4b. Bessel functions. Introduction. Generalized factorial function. 4b.1. Using integration by parts it is easy to show that 4b. Lecture 4b Using integration by parts it is easy to show that Bessel functions Introduction In the previous lecture the separation of variables method led to Bessel's equation y' ' y ' 2 y= () 2 Here

More information

Solve Wave Equation from Scratch [2013 HSSP]

Solve Wave Equation from Scratch [2013 HSSP] 1 Solve Wave Equation from Scratch [2013 HSSP] Yuqi Zhu MIT Department of Physics, 77 Massachusetts Ave., Cambridge, MA 02139 (Dated: August 18, 2013) I. COURSE INFO Topics Date 07/07 Comple number, Cauchy-Riemann

More information

CS S Lecture 5 January 29, 2019

CS S Lecture 5 January 29, 2019 CS 6363.005.19S Lecture 5 January 29, 2019 Main topics are #divide-and-conquer with #fast_fourier_transforms. Prelude Homework 1 is due Tuesday, February 5th. I hope you ve at least looked at it by now!

More information

Algebraic Functions, Equations and Inequalities

Algebraic Functions, Equations and Inequalities Algebraic Functions, Equations and Inequalities Assessment statements.1 Odd and even functions (also see Chapter 7)..4 The rational function a c + b and its graph. + d.5 Polynomial functions. The factor

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

SYLLABUS FOR ENTRANCE EXAMINATION NANYANG TECHNOLOGICAL UNIVERSITY FOR INTERNATIONAL STUDENTS A-LEVEL MATHEMATICS

SYLLABUS FOR ENTRANCE EXAMINATION NANYANG TECHNOLOGICAL UNIVERSITY FOR INTERNATIONAL STUDENTS A-LEVEL MATHEMATICS SYLLABUS FOR ENTRANCE EXAMINATION NANYANG TECHNOLOGICAL UNIVERSITY FOR INTERNATIONAL STUDENTS A-LEVEL MATHEMATICS STRUCTURE OF EXAMINATION PAPER. There will be one -hour paper consisting of 4 questions..

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

Fourier Analysis Fourier Series C H A P T E R 1 1

Fourier Analysis Fourier Series C H A P T E R 1 1 C H A P T E R Fourier Analysis 474 This chapter on Fourier analysis covers three broad areas: Fourier series in Secs...4, more general orthonormal series called Sturm iouville epansions in Secs..5 and.6

More information

Math 365 Homework 5 Due April 6, 2018 Grady Wright

Math 365 Homework 5 Due April 6, 2018 Grady Wright Math 365 Homework 5 Due April 6, 018 Grady Wright 1. (Polynomial interpolation, 10pts) Consider the following three samples of some function f(x): x f(x) -1/ -1 1 1 1/ (a) Determine the unique second degree

More information

AP Calculus AB Summer Assignment

AP Calculus AB Summer Assignment AP Calculus AB Summer Assignment Name: When you come back to school, you will be epected to have attempted every problem. These skills are all different tools that you will pull out of your toolbo this

More information

Fall 2011, EE123 Digital Signal Processing

Fall 2011, EE123 Digital Signal Processing Lecture 6 Miki Lustig, UCB September 11, 2012 Miki Lustig, UCB DFT and Sampling the DTFT X (e jω ) = e j4ω sin2 (5ω/2) sin 2 (ω/2) 5 x[n] 25 X(e jω ) 4 20 3 15 2 1 0 10 5 1 0 5 10 15 n 0 0 2 4 6 ω 5 reconstructed

More information

FOURIER SERIES, HAAR WAVELETS AND FAST FOURIER TRANSFORM

FOURIER SERIES, HAAR WAVELETS AND FAST FOURIER TRANSFORM FOURIER SERIES, HAAR WAVELETS AD FAST FOURIER TRASFORM VESA KAARIOJA, JESSE RAILO AD SAMULI SILTAE Abstract. This handout is for the course Applications of matrix computations at the University of Helsinki

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

Exact and Approximate Numbers:

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

More information

Linear Algebra: Matrix Eigenvalue Problems

Linear Algebra: Matrix Eigenvalue Problems CHAPTER8 Linear Algebra: Matrix Eigenvalue Problems Chapter 8 p1 A matrix eigenvalue problem considers the vector equation (1) Ax = λx. 8.0 Linear Algebra: Matrix Eigenvalue Problems Here A is a given

More information

Computational Methods CMSC/AMSC/MAPL 460

Computational Methods CMSC/AMSC/MAPL 460 Computational Methods CMSC/AMSC/MAPL 460 Fourier transform Balaji Vasan Srinivasan Dept of Computer Science Several slides from Prof Healy s course at UMD Last time: Fourier analysis F(t) = A 0 /2 + A

More information

9.8 APPLICATIONS OF TAYLOR SERIES EXPLORATORY EXERCISES. Using Taylor Polynomials to Approximate a Sine Value EXAMPLE 8.1

9.8 APPLICATIONS OF TAYLOR SERIES EXPLORATORY EXERCISES. Using Taylor Polynomials to Approximate a Sine Value EXAMPLE 8.1 9-75 SECTION 9.8.. Applications of Taylor Series 677 and f 0) miles/min 3. Predict the location of the plane at time t min. 5. Suppose that an astronaut is at 0, 0) and the moon is represented by a circle

More information

which arises when we compute the orthogonal projection of a vector y in a subspace with an orthogonal basis. Hence assume that P y = A ij = x j, x i

which arises when we compute the orthogonal projection of a vector y in a subspace with an orthogonal basis. Hence assume that P y = A ij = x j, x i MODULE 6 Topics: Gram-Schmidt orthogonalization process We begin by observing that if the vectors {x j } N are mutually orthogonal in an inner product space V then they are necessarily linearly independent.

More information

x y x 2 2 x y x x y x U x y x y

x y x 2 2 x y x x y x U x y x y Lecture 7 Appendi B: Some sample problems from Boas Here are some solutions to the sample problems assigned for hapter 4 4: 8 Solution: We want to learn about the analyticity properties of the function

More information

Design and Analysis of Algorithms

Design and Analysis of Algorithms Design and Analysis of Algorithms CSE 5311 Lecture 5 Divide and Conquer: Fast Fourier Transform Junzhou Huang, Ph.D. Department of Computer Science and Engineering CSE5311 Design and Analysis of Algorithms

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

Vectors in Function Spaces

Vectors in Function Spaces Jim Lambers MAT 66 Spring Semester 15-16 Lecture 18 Notes These notes correspond to Section 6.3 in the text. Vectors in Function Spaces We begin with some necessary terminology. A vector space V, also

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

Lectures 9-10: Polynomial and piecewise polynomial interpolation

Lectures 9-10: Polynomial and piecewise polynomial interpolation Lectures 9-1: Polynomial and piecewise polynomial interpolation Let f be a function, which is only known at the nodes x 1, x,, x n, ie, all we know about the function f are its values y j = f(x j ), j

More information

CE 601: Numerical Methods Lecture 7. Course Coordinator: Dr. Suresh A. Kartha, Associate Professor, Department of Civil Engineering, IIT Guwahati.

CE 601: Numerical Methods Lecture 7. Course Coordinator: Dr. Suresh A. Kartha, Associate Professor, Department of Civil Engineering, IIT Guwahati. CE 60: Numerical Methods Lecture 7 Course Coordinator: Dr. Suresh A. Kartha, Associate Professor, Department of Civil Engineering, IIT Guwahati. Drawback in Elimination Methods There are various drawbacks

More information

A BRIEF REVIEW OF ALGEBRA AND TRIGONOMETRY

A BRIEF REVIEW OF ALGEBRA AND TRIGONOMETRY A BRIEF REVIEW OF ALGEBRA AND TRIGONOMETR Some Key Concepts:. The slope and the equation of a straight line. Functions and functional notation. The average rate of change of a function and the DIFFERENCE-

More information

VII. Techniques of Integration

VII. Techniques of Integration VII. Techniques of Integration Integration, unlike differentiation, is more of an art-form than a collection of algorithms. Many problems in applied mathematics involve the integration of functions given

More information

EC5555 Economics Masters Refresher Course in Mathematics September 2014

EC5555 Economics Masters Refresher Course in Mathematics September 2014 EC5555 Economics Masters Refresher Course in Mathematics September 4 Lecture Matri Inversion and Linear Equations Ramakanta Patra Learning objectives. Matri inversion Matri inversion and linear equations

More information

ARTICLE IN PRESS Journal of Computational and Applied Mathematics ( )

ARTICLE IN PRESS Journal of Computational and Applied Mathematics ( ) Journal of Computational and Applied Mathematics ( ) Contents lists available at ScienceDirect Journal of Computational and Applied Mathematics journal homepage: www.elsevier.com/locate/cam The polynomial

More information

MA3232 Numerical Analysis Week 9. James Cooley (1926-)

MA3232 Numerical Analysis Week 9. James Cooley (1926-) MA umerical Analysis Week 9 James Cooley (96-) James Cooley is an American mathematician. His most significant contribution to the world of mathematics and digital signal processing is the Fast Fourier

More information

LECTURE NOTES ON QUANTUM COMPUTATION. Cornell University, Physics , CS 483; Spring, 2005 c 2006, N. David Mermin

LECTURE NOTES ON QUANTUM COMPUTATION. Cornell University, Physics , CS 483; Spring, 2005 c 2006, N. David Mermin LECTURE NOTES ON QUANTUM COMPUTATION Cornell University, Physics 481-681, CS 483; Spring, 2005 c 2006, N. David Mermin IV. Searching with a Quantum Computer Last revised 3/30/06 Suppose you know that eactly

More information

A Fourier Transform Model in Excel #1

A Fourier Transform Model in Excel #1 A Fourier Transorm Model in Ecel # -This is a tutorial about the implementation o a Fourier transorm in Ecel. This irst part goes over adjustments in the general Fourier transorm ormula to be applicable

More information

Trigonometric integrals by basic methods

Trigonometric integrals by basic methods Roberto s Notes on Integral Calculus Chapter : Integration methods Section 7 Trigonometric integrals by basic methods What you need to know already: Integrals of basic trigonometric functions. Basic trigonometric

More information

Section 1.2 A Catalog of Essential Functions

Section 1.2 A Catalog of Essential Functions Chapter 1 Section Page 1 of 6 Section 1 A Catalog of Essential Functions Linear Models: All linear equations have the form rise change in horizontal The letter m is the of the line, or It can be positive,

More information

Optimization Methods: Optimization using Calculus - Equality constraints 1. Module 2 Lecture Notes 4

Optimization Methods: Optimization using Calculus - Equality constraints 1. Module 2 Lecture Notes 4 Optimization Methods: Optimization using Calculus - Equality constraints Module Lecture Notes 4 Optimization of Functions of Multiple Variables subect to Equality Constraints Introduction In the previous

More information

Chapter 6. Nonlinear Equations. 6.1 The Problem of Nonlinear Root-finding. 6.2 Rate of Convergence

Chapter 6. Nonlinear Equations. 6.1 The Problem of Nonlinear Root-finding. 6.2 Rate of Convergence Chapter 6 Nonlinear Equations 6. The Problem of Nonlinear Root-finding In this module we consider the problem of using numerical techniques to find the roots of nonlinear equations, f () =. Initially we

More information

Pre-Calculus and Trigonometry Capacity Matrix

Pre-Calculus and Trigonometry Capacity Matrix Pre-Calculus and Capacity Matri Review Polynomials A1.1.4 A1.2.5 Add, subtract, multiply and simplify polynomials and rational epressions Solve polynomial equations and equations involving rational epressions

More information

Module 2, Section 2 Solving Equations

Module 2, Section 2 Solving Equations Principles of Mathematics Section, Introduction 03 Introduction Module, Section Solving Equations In this section, you will learn to solve quadratic equations graphically, by factoring, and by applying

More information

The Fast Fourier Transform

The Fast Fourier Transform The Fast Fourier Transform 1 Motivation: digital signal processing The fast Fourier transform (FFT) is the workhorse of digital signal processing To understand how it is used, consider any signal: any

More information

Polynomial Functions of Higher Degree

Polynomial Functions of Higher Degree SAMPLE CHAPTER. NOT FOR DISTRIBUTION. 4 Polynomial Functions of Higher Degree Polynomial functions of degree greater than 2 can be used to model data such as the annual temperature fluctuations in Daytona

More information

Section 1.2 A Catalog of Essential Functions

Section 1.2 A Catalog of Essential Functions Page 1 of 6 Section 1. A Catalog of Essential Functions Linear Models: All linear equations have the form y = m + b. rise change in horizontal The letter m is the slope of the line, or. It can be positive,

More information

Real Analysis Math 125A, Fall 2012 Final Solutions

Real Analysis Math 125A, Fall 2012 Final Solutions Real Analysis Math 25A, Fall 202 Final Solutions. (a) Suppose that f : [0, ] R is continuous on the closed, bounded interval [0, ] and f() > 0 for every 0. Prove that the reciprocal function /f : [0, ]

More information

Course. Print and use this sheet in conjunction with MathinSite s Maclaurin Series applet and worksheet.

Course. Print and use this sheet in conjunction with MathinSite s Maclaurin Series applet and worksheet. Maclaurin Series Learning Outcomes After reading this theory sheet, you should recognise the difference between a function and its polynomial epansion (if it eists!) understand what is meant by a series

More information

Application of modified Leja sequences to polynomial interpolation

Application of modified Leja sequences to polynomial interpolation Special Issue for the years of the Padua points, Volume 8 5 Pages 66 74 Application of modified Leja sequences to polynomial interpolation L. P. Bos a M. Caliari a Abstract We discuss several applications

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

Fast Polynomial Multiplication

Fast Polynomial Multiplication Fast Polynomial Multiplication Marc Moreno Maza CS 9652, October 4, 2017 Plan Primitive roots of unity The discrete Fourier transform Convolution of polynomials The fast Fourier transform Fast convolution

More information

6.5 Trigonometric Equations

6.5 Trigonometric Equations 6. Trigonometric Equations In this section, we discuss conditional trigonometric equations, that is, equations involving trigonometric functions that are satisfied only by some values of the variable (or

More information

x 2e e 3x 1. Find the equation of the line that passes through the two points 3,7 and 5, 2 slope-intercept form. . Write your final answer in

x 2e e 3x 1. Find the equation of the line that passes through the two points 3,7 and 5, 2 slope-intercept form. . Write your final answer in Algebra / Trigonometry Review (Notes for MAT0) NOTE: For more review on any of these topics just navigate to my MAT187 Precalculus page and check in the Help section for the topic(s) you wish to review!

More information

Lecture 9: Elementary Matrices

Lecture 9: Elementary Matrices Lecture 9: Elementary Matrices Review of Row Reduced Echelon Form Consider the matrix A and the vector b defined as follows: 1 2 1 A b 3 8 5 A common technique to solve linear equations of the form Ax

More information

B Elements of Complex Analysis

B Elements of Complex Analysis Fourier Transform Methods in Finance By Umberto Cherubini Giovanni Della Lunga Sabrina Mulinacci Pietro Rossi Copyright 21 John Wiley & Sons Ltd B Elements of Complex Analysis B.1 COMPLEX NUMBERS The purpose

More information

FOURIER INVERSION. an additive character in each of its arguments. The Fourier transform of f is

FOURIER INVERSION. an additive character in each of its arguments. The Fourier transform of f is FOURIER INVERSION 1. The Fourier Transform and the Inverse Fourier Transform Consider functions f, g : R n C, and consider the bilinear, symmetric function ψ : R n R n C, ψ(, ) = ep(2πi ), an additive

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

Review of elements of Calculus (functions in one variable)

Review of elements of Calculus (functions in one variable) Review of elements of Calculus (functions in one variable) Mainly adapted from the lectures of prof Greg Kelly Hanford High School, Richland Washington http://online.math.uh.edu/houstonact/ https://sites.google.com/site/gkellymath/home/calculuspowerpoints

More information

MATH 1010E University Mathematics Lecture Notes (week 8) Martin Li

MATH 1010E University Mathematics Lecture Notes (week 8) Martin Li MATH 1010E University Mathematics Lecture Notes (week 8) Martin Li 1 L Hospital s Rule Another useful application of mean value theorems is L Hospital s Rule. It helps us to evaluate its of indeterminate

More information

Quantum Computing Lecture 2. Review of Linear Algebra

Quantum Computing Lecture 2. Review of Linear Algebra Quantum Computing Lecture 2 Review of Linear Algebra Maris Ozols Linear algebra States of a quantum system form a vector space and their transformations are described by linear operators Vector spaces

More information

Numerical Integration (Quadrature) Another application for our interpolation tools!

Numerical Integration (Quadrature) Another application for our interpolation tools! Numerical Integration (Quadrature) Another application for our interpolation tools! Integration: Area under a curve Curve = data or function Integrating data Finite number of data points spacing specified

More information

Advanced Computational Fluid Dynamics AA215A Lecture 2 Approximation Theory. Antony Jameson

Advanced Computational Fluid Dynamics AA215A Lecture 2 Approximation Theory. Antony Jameson Advanced Computational Fluid Dynamics AA5A Lecture Approximation Theory Antony Jameson Winter Quarter, 6, Stanford, CA Last revised on January 7, 6 Contents Approximation Theory. Least Squares Approximation

More information

Lesson 10: Polynomials

Lesson 10: Polynomials Lesson 10: Polynomials restart; When Newton is slow We saw that when the equation has a solution p with, Newton's method converges very quickly (for an appropriate starting point), because. When, on the

More information

3.3.1 Linear functions yet again and dot product In 2D, a homogenous linear scalar function takes the general form:

3.3.1 Linear functions yet again and dot product In 2D, a homogenous linear scalar function takes the general form: 3.3 Gradient Vector and Jacobian Matri 3 3.3 Gradient Vector and Jacobian Matri Overview: Differentiable functions have a local linear approimation. Near a given point, local changes are determined by

More information

West Essex Regional School District. AP Calculus AB. Summer Packet

West Essex Regional School District. AP Calculus AB. Summer Packet West Esse Regional School District AP Calculus AB Summer Packet 05-06 Calculus AB Calculus AB covers the equivalent of a one semester college calculus course. Our focus will be on differential and integral

More information

Time-Frequency Analysis: Fourier Transforms and Wavelets

Time-Frequency Analysis: Fourier Transforms and Wavelets Chapter 4 Time-Frequenc Analsis: Fourier Transforms and Wavelets 4. Basics of Fourier Series 4.. Introduction Joseph Fourier (768-83) who gave his name to Fourier series, was not the first to use Fourier

More information

Convergence for periodic Fourier series

Convergence for periodic Fourier series Chapter 8 Convergence for periodic Fourier series We are now in a position to address the Fourier series hypothesis that functions can realized as the infinite sum of trigonometric functions discussed

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

Falls Church High School

Falls Church High School Summer AP Assignment Coversheet Falls Church High School Course: AP Calculus BC Teacher Name/s: Marla Schnall Assignment Title: AP Calculus BC Summer Packet Assignment Summary/Purpose: The material in

More information

CS168: The Modern Algorithmic Toolbox Lecture #11: The Fourier Transform and Convolution

CS168: The Modern Algorithmic Toolbox Lecture #11: The Fourier Transform and Convolution CS168: The Modern Algorithmic Toolbox Lecture #11: The Fourier Transform and Convolution Tim Roughgarden & Gregory Valiant May 8, 2015 1 Intro Thus far, we have seen a number of different approaches to

More information

TEACHER NOTES MATH NSPIRED

TEACHER NOTES MATH NSPIRED Math Objectives Students will produce various graphs of Taylor polynomials. Students will discover how the accuracy of a Taylor polynomial is associated with the degree of the Taylor polynomial. Students

More information

Lecture 7 January 26, 2016

Lecture 7 January 26, 2016 MATH 262/CME 372: Applied Fourier Analysis and Winter 26 Elements of Modern Signal Processing Lecture 7 January 26, 26 Prof Emmanuel Candes Scribe: Carlos A Sing-Long, Edited by E Bates Outline Agenda:

More information

5. Orthogonal matrices

5. Orthogonal matrices L Vandenberghe EE133A (Spring 2017) 5 Orthogonal matrices matrices with orthonormal columns orthogonal matrices tall matrices with orthonormal columns complex matrices with orthonormal columns 5-1 Orthonormal

More information

1 Rational Exponents and Radicals

1 Rational Exponents and Radicals Introductory Algebra Page 1 of 11 1 Rational Eponents and Radicals 1.1 Rules of Eponents The rules for eponents are the same as what you saw earlier. Memorize these rules if you haven t already done so.

More information

Ammonia molecule, from Chapter 9 of the Feynman Lectures, Vol 3. Example of a 2-state system, with a small energy difference between the symmetric

Ammonia molecule, from Chapter 9 of the Feynman Lectures, Vol 3. Example of a 2-state system, with a small energy difference between the symmetric Ammonia molecule, from Chapter 9 of the Feynman Lectures, Vol 3. Eample of a -state system, with a small energy difference between the symmetric and antisymmetric combinations of states and. This energy

More information

The Harvard Calculus Program in a Computer Classroom

The Harvard Calculus Program in a Computer Classroom The Harvard Calculus Program in a Computer Classroom Carmen Q. Artino Department of Mathematics The College of Saint Rose Albany, NY 103 Office: (518) 454-516 Fa: (518) 458-5446 e-mail: artinoc@rosnet.strose.edu

More information

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018 Numerical Analysis Preliminary Exam 1 am to 1 pm, August 2, 218 Instructions. You have three hours to complete this exam. Submit solutions to four (and no more) of the following six problems. Please start

More information

Approximation theory

Approximation theory Approximation theory Xiaojing Ye, Math & Stat, Georgia State University Spring 2019 Numerical Analysis II Xiaojing Ye, Math & Stat, Georgia State University 1 1 1.3 6 8.8 2 3.5 7 10.1 Least 3squares 4.2

More information

The Fourier spectral method (Amath Bretherton)

The Fourier spectral method (Amath Bretherton) The Fourier spectral method (Amath 585 - Bretherton) 1 Introduction The Fourier spectral method (or more precisely, pseudospectral method) is a very accurate way to solve BVPs with smooth solutions on

More information

Approximation Theory

Approximation Theory Approximation Theory Function approximation is the task of constructing, for a given function, a simpler function so that the difference between the two functions is small and to then provide a quantifiable

More information

Statistical Geometry Processing Winter Semester 2011/2012

Statistical Geometry Processing Winter Semester 2011/2012 Statistical Geometry Processing Winter Semester 2011/2012 Linear Algebra, Function Spaces & Inverse Problems Vector and Function Spaces 3 Vectors vectors are arrows in space classically: 2 or 3 dim. Euclidian

More information

Chapter 5 Symbolic Increments

Chapter 5 Symbolic Increments Chapter 5 Symbolic Increments The main idea of di erential calculus is that small changes in smooth functions are approimately linear. In Chapter 3, we saw that most microscopic views of graphs appear

More information

THE FAST FOURIER TRANSFORM III 10.3

THE FAST FOURIER TRANSFORM III 10.3 10.3 The Fast Fourier Transform 439 THE FAST FOURIER TRANSFORM III 10.3 Many applications of linear algebra take time to develop. It is not easy to explain them in an hour. The teacher and the author must

More information

CSE 548: Analysis of Algorithms. Lecture 4 ( Divide-and-Conquer Algorithms: Polynomial Multiplication )

CSE 548: Analysis of Algorithms. Lecture 4 ( Divide-and-Conquer Algorithms: Polynomial Multiplication ) CSE 548: Analysis of Algorithms Lecture 4 ( Divide-and-Conquer Algorithms: Polynomial Multiplication ) Rezaul A. Chowdhury Department of Computer Science SUNY Stony Brook Spring 2015 Coefficient Representation

More information

23. The Finite Fourier Transform and the Fast Fourier Transform Algorithm

23. The Finite Fourier Transform and the Fast Fourier Transform Algorithm 23. The Finite Fourier Transform and the Fast Fourier Transform Algorithm 23.1 Introduction: Fourier Series Early in the Nineteenth Century, Fourier studied sound and oscillatory motion and conceived of

More information

Chapter 4 Discrete Fourier Transform (DFT) And Signal Spectrum

Chapter 4 Discrete Fourier Transform (DFT) And Signal Spectrum Chapter 4 Discrete Fourier Transform (DFT) And Signal Spectrum CEN352, DR. Nassim Ammour, King Saud University 1 Fourier Transform History Born 21 March 1768 ( Auxerre ). Died 16 May 1830 ( Paris ) French

More information

Introduction - Motivation. Many phenomena (physical, chemical, biological, etc.) are model by differential equations. f f(x + h) f(x) (x) = lim

Introduction - Motivation. Many phenomena (physical, chemical, biological, etc.) are model by differential equations. f f(x + h) f(x) (x) = lim Introduction - Motivation Many phenomena (physical, chemical, biological, etc.) are model by differential equations. Recall the definition of the derivative of f(x) f f(x + h) f(x) (x) = lim. h 0 h Its

More information

Lecture 5: Finding limits analytically Simple indeterminate forms

Lecture 5: Finding limits analytically Simple indeterminate forms Lecture 5: Finding its analytically Simple indeterminate forms Objectives: (5.) Use algebraic techniques to resolve 0/0 indeterminate forms. (5.) Use the squeeze theorem to evaluate its. (5.3) Use trigonometric

More information

Howard Mark and Jerome Workman Jr.

Howard Mark and Jerome Workman Jr. Linearity in Calibration: How to Test for Non-linearity Previous methods for linearity testing discussed in this series contain certain shortcomings. In this installment, the authors describe a method

More information

sin cos 1 1 tan sec 1 cot csc Pre-Calculus Mathematics Trigonometric Identities and Equations

sin cos 1 1 tan sec 1 cot csc Pre-Calculus Mathematics Trigonometric Identities and Equations Pre-Calculus Mathematics 12 6.1 Trigonometric Identities and Equations Goal: 1. Identify the Fundamental Trigonometric Identities 2. Simplify a Trigonometric Expression 3. Determine the restrictions on

More information

CONTINUITY AND DIFFERENTIABILITY

CONTINUITY AND DIFFERENTIABILITY 5. Introduction The whole of science is nothing more than a refinement of everyday thinking. ALBERT EINSTEIN This chapter is essentially a continuation of our stu of differentiation of functions in Class

More information

+ y = 1 : the polynomial

+ y = 1 : the polynomial Notes on Basic Ideas of Spherical Harmonics In the representation of wavefields (solutions of the wave equation) one of the natural considerations that arise along the lines of Huygens Principle is the

More information

Lecture 10: Fourier Sine Series

Lecture 10: Fourier Sine Series Introductory lecture notes on Partial Differential Equations - c Anthony Peirce. Not to be copied, used, or revised without eplicit written permission from the copyright owner. ecture : Fourier Sine Series

More information

Tutorial 2 - Learning about the Discrete Fourier Transform

Tutorial 2 - Learning about the Discrete Fourier Transform Tutorial - Learning about the Discrete Fourier Transform This tutorial will be about the Discrete Fourier Transform basis, or the DFT basis in short. What is a basis? If we google define basis, we get:

More information

Linear Algebra Notes. Lecture Notes, University of Toronto, Fall 2016

Linear Algebra Notes. Lecture Notes, University of Toronto, Fall 2016 Linear Algebra Notes Lecture Notes, University of Toronto, Fall 2016 (Ctd ) 11 Isomorphisms 1 Linear maps Definition 11 An invertible linear map T : V W is called a linear isomorphism from V to W Etymology:

More information

3 QR factorization revisited

3 QR factorization revisited LINEAR ALGEBRA: NUMERICAL METHODS. Version: August 2, 2000 30 3 QR factorization revisited Now we can explain why A = QR factorization is much better when using it to solve Ax = b than the A = LU factorization

More information