MATH 412: Homework # 5 Tim Ahn July 22, 2016

Size: px
Start display at page:

Download "MATH 412: Homework # 5 Tim Ahn July 22, 2016"

Transcription

1 MATH 412: Homework # 5 Tim Ahn July 22, 2016 Supplementary Exercises Supp #23 Find the Fourier matrices F for = 2 and = 4. set.seed(2) = 2 omega = 2*pi/ F = exp(omega*outer(0:(-1),0:(-1))*(0+1i)) F ## [,1] [,2] ## [1,] 1+0i 1+0i ## [2,] 1+0i -1+0i = 4 omega = 2*pi/ F = exp(omega*outer(0:(-1),0:(-1))*(0+1i)) F ## [,1] [,2] [,3] [,4] ## [1,] 1+0i 1+0i 1+0i 1+0i ## [2,] 1+0i 0+1i -1+0i 0-1i ## [3,] 1+0i -1+0i 1-0i -1+0i ## [4,] 1+0i 0-1i -1+0i 0+1i Supp #24 Given the signal (x 0,..., x 3 ) = (1, 2, 0, 1) for length = 4. a) Write down the even and odd numbered components x, x. Even : x = (1, 0) Odd : x = (2, 1) b) Compute the discrete Fourier transforms c = F 2 x, c = F 2 x using matrix multiplications. 1

2 = 2 x1 = c(1,0) x2 = c(2,1) omega = 2*pi/ F = exp(omega*outer(0:(-1),0:(-1))*(0+1i)) Fstar = Conj(t(F)) c1 = F%*%x1 c2 = F%*%x2 c1 ## [,1] ## [1,] 1+0i ## [2,] 1+0i c2 ## [,1] ## [1,] 3+0i ## [2,] 1+0i c) Find the twiddle factors z j 4 = ( z 4 ) j and use them to compute c. c = F 2 x c = F 2 x ( c ) j = z j 4 (c ) j z j 4 = e j 4 2πi d) Compute the discrete Fourier transform of x from c and c. x 0 = c low1 + c low2 x 1 = c high1 + c high2 x 2 = c low1 c low2 x 3 = c low1 c high2 Supp #26 Make a random signal of length = 1024, compute its DFT and then compute its inverse DFT y with R. The imaginary part of y may be extracted with the command Im(y) and the real part may be extracted with the command Re(y). Verify that the imaginary part is very small in magnitude. Does it look like it is a completely random sequence of independent values? Use a plot. < x <- rnorm() # Random signal of length = 1024 c <- fft(x)/ # DFT 2

3 y <- fft(c*, inverse = T)/ z <- Im(y) plot(z, ylab = "Im(y)") # Inverse DFT # Imaginary part of y Im(y) 1.5e e e Index hist(z, breaks=30, xlab = "Im(y)", main = "Histogram of Im(y)") 3

4 Histogram of Im(y) Frequency e e e e 15 Im(y) The values shown in the two plots are extremely small, and it does appear to have a similar normal distribution as that of the random normal sample that the original vector was selected from. Supp #27 Download orbital data (eccentricity, precession, obliquity only) for the time window from 50 Myr before present to 48 Myr before present from the website and find the power spectra using R. Describe the main frequency components. Are there major differences between those data and the ones from -Myr to +1Myr? library(data.table) orbit <- read.table("c:/users/ahn/desktop/georgetown/2016 Summer/MATH 412/Homework/orbit.txt", quote="\" orbit2 <- read.table("c:/users/ahn/desktop/georgetown/2016 Summer/MATH 412/Homework/orbit2.txt", quote=" colnames(orbit) <- c("years", "eccentricity", "precession", "obliquity") colnames(orbit2) <- c("years", "eccentricity", "precession", "obliquity") # Eccentricity plot(eccentricity ~ years, orbit, type = 'l', xlab = "Years (Kyr)", main = "Eccentricity (-50Myr to -48M 4

5 eccentricity Eccentricity ( 50Myr to 48Myr) Years (Kyr) plot(eccentricity ~ years, orbit2, type = 'l', xlab = "Years (Kyr)", main = "Eccentricity (-Myr to +Myr) Eccentricity ( Myr to +Myr) eccentricity Years (Kyr) mylength = length(orbit$eccentricity) myvara = orbit$eccentricity myvar2 = orbit2$eccentricity myfreq1 = 2:50 plot(mylength/(myfreq1-1),abs(fft(myvara))[myfreq1], type = 'b', lwd = 2, xlab = "period (Kyr)", main = "Eccentricity from -50Myr to -48Mry") 5

6 abs(fft(myvara))[myfreq1] Eccentricity from 50Myr to 48Mry period (Kyr) plot(mylength/(myfreq1-1),abs(fft(myvar2))[myfreq1], type = 'b', lwd = 2, xlab = "period (Kyr)", main = "Eccentricity from -Myr to +Mry") abs(fft(myvar2))[myfreq1] Eccentricity from Myr to +Mry period (Kyr) # Precession myvarb = orbit$precession myvar2 = orbit2$precession myfreq2 = 10:200 plot(precession ~ years, orbit, type = 'l', xlab = "Years (Kyr)", main = "Precession (-50Myr to -48Myr)" 6

7 precession Precession ( 50Myr to 48Myr) Years (Kyr) plot(precession ~ years, orbit2, type = 'l', xlab = "Years (Kyr)", main = "Precession (-Myr to +Myr)") Precession ( Myr to +Myr) precession Years (Kyr) plot(mylength/(myfreq2-1),abs(fft(myvarb))[myfreq2], type = 'b', lwd = 2, xlab = "period (Kyr)", main = "Precession from -50Myr to -48Mry") 7

8 abs(fft(myvarb))[myfreq2] Precession from 50Myr to 48Mry period (Kyr) plot(mylength/(myfreq2-1),abs(fft(myvar2))[myfreq2], type = 'b', lwd = 2, xlab = "period (Kyr)", main = "Precession from -Myr to +Mry") abs(fft(myvar2))[myfreq2] Precession from Myr to +Mry period (Kyr) # Obliquity myvarc = orbit$obliquity myvar2 = orbit2$obliquity myfreq3 = 2:100 plot(obliquity ~ years, orbit, type = 'l', xlab = "Years (Kyr)", main = "Obliquity (-50Myr to -48Myr)") 8

9 Obliquity ( 50Myr to 48Myr) obliquity Years (Kyr) plot(obliquity ~ years, orbit2, type = 'l', xlab = "Years (Kyr)", main = "Obliquity (-Myr to +Myr)") Obliquity ( Myr to +Myr) obliquity Years (Kyr) plot(mylength/(myfreq3-1),abs(fft(myvarc))[myfreq3], type = 'b', lwd = 2, xlab = "period (Kyr)", main = "Obliquity from -50Myr to -48Mry") 9

10 abs(fft(myvarc))[myfreq3] Obliquity from 50Myr to 48Mry period (Kyr) plot(mylength/(myfreq3-1),abs(fft(myvar2))[myfreq3], type = 'b', lwd = 2, xlab = "period (Kyr)", main = "Obliquity from -Myr to +Mry") abs(fft(myvar2))[myfreq3] Obliquity from Myr to +Mry period (Kyr) # Power Spectra plot((myfreq1-1)/mylength,abs(fft(myvara))[myfreq1]^2, type = 'b', lwd = 2, xlab = "frequency (1/Kyr)", main = "Power Spectrum of the Earth's Eccentricity (-50Myr to -48Myr)") 10

11 abs(fft(myvara))[myfreq1]^ Power Spectrum of the Earth's Eccentricity ( 50Myr to 48Myr) frequency (1/Kyr) plot((myfreq2-1)/mylength,abs(fft(myvarb))[myfreq2]^2, type = 'b', lwd = 2, xlab = "frequency (1/Kyr)", main = "Power Spectrum of the Earth's Precession (-50Myr to -48Myr)") abs(fft(myvarb))[myfreq2]^ Power Spectrum of the Earth's Precession ( 50Myr to 48Myr) frequency (1/Kyr) plot((myfreq3-1)/mylength,abs(fft(myvarc))[myfreq3]^2, type = 'b', lwd = 2, xlab = "frequency (1/Kyr)", main = "Power Spectrum of the Earth's Obliquity (-50Myr to -48Myr)") 11

12 abs(fft(myvarc))[myfreq3]^ Power Spectrum of the Earth's Obliquity ( 50Myr to 48Myr) frequency (1/Kyr) There appears to be components for eccentricity at 100k years and also at around 400k years. For precession and obliquity, there are components at nearly 20k and 40k years, respectively. All these trends are reflected in both time periods and show no significant difference. With regard to frequency, peaks appear about every 100k for eccentricity, which indicates a frequency of about 20 during the time period for both periods. For precession, the peaks occur at intervals of slightly more than 20k years indicating a frequency of slightly more than 100. Obliquity peaks occur about at 40k years with a frequency of Chapter 11 Problem #3(i)(ii) Let x = (x 0,..., x ) T be a column vector, and let c = F x be its DFT. Also assume that = rm for some integers r and M with 1 < r <. Find the DFT of the following vectors in terms of c: (i) u = (u 0, u 1,..., u ) T = (x, x 2,..., x 0 ) T (time reversal) If we set u j = x j 1, (j = 0, 1, 2,...), then u = (x, x 2,..., x 1, x 0 ). l = k 1 k = l 1 12

13 (Fu) j = = = = u=0 l=0 l=0 = z j z jk u k = z ( l 1) j z j l=0 k=0 x l z lj zj x l z jk x l 1 z lj zj x l (since z j = 1) l=0 = z j c l z lj x l (ii) v = (v 0, v 1,..., v ) T = (x k, x k+1,..., x, x 0,..., x k 1 ) T for any k {1,..., 1} (shift) c = F x = z jk v = = =...? k=0 k=0 k=0 c z nk z jk x x znk x z k(n j) 13

6.003 Homework #10 Solutions

6.003 Homework #10 Solutions 6.3 Homework # Solutions Problems. DT Fourier Series Determine the Fourier Series coefficients for each of the following DT signals, which are periodic in N = 8. x [n] / n x [n] n x 3 [n] n x 4 [n] / n

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

Math Homework # 4

Math Homework # 4 Math 446 - Homework # 4 1. Are the following statements true or false? (a) 3 5(mod 2) Solution: 3 5 = 2 = 2 ( 1) is divisible by 2. Hence 2 5(mod 2). (b) 11 5(mod 5) Solution: 11 ( 5) = 16 is NOT divisible

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

MATH 271 Summer 2016 Practice problem solutions Week 1

MATH 271 Summer 2016 Practice problem solutions Week 1 Part I MATH 271 Summer 2016 Practice problem solutions Week 1 For each of the following statements, determine whether the statement is true or false. Prove the true statements. For the false statement,

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

WEEK10 Fast Fourier Transform (FFT) (Theory and Implementation)

WEEK10 Fast Fourier Transform (FFT) (Theory and Implementation) WEEK10 Fast Fourier Transform (FFT) (Theory and Implementation) Learning Objectives DFT algorithm. Conversion of DFT to FFT algorithm. Implementation of the FFT algorithm. Chapter 19, Slide 2 DFT Algorithm

More information

1 The Normal approximation

1 The Normal approximation Statistics and Linguistic Applications Hale February 3, 2010 1 The Normal approximation Review of frequency Remember frequency? That s how often a particular level appears in a data set. Take Keith Johnson

More information

Math /29/2014. Richard McGehee, University of Minnesota 1. Math 5490 September 29, Glacial Cycles

Math /29/2014. Richard McGehee, University of Minnesota 1. Math 5490 September 29, Glacial Cycles Math 9 September 29, 21 Topics in Applied Mathematics: Introduction to the Mathematics of Climate Mondays and Wednesdays 2: : http://www.math.umn.edu/~mcgehee/teaching/math9-21-2fall/ Streaming video is

More information

Engineering Geodesy I. Exercise 3: Monitoring of a Bridge Determination of the Eigenfrequencies

Engineering Geodesy I. Exercise 3: Monitoring of a Bridge Determination of the Eigenfrequencies Engineering Geodesy I Exercise 3: Monitoring of a Bridge Determination of the Eigenfrequencies Prof. Dr. H. Ingensand Geodetic Metrology and Engineering Geodesy 29.11.2010 Model Analyses of the Bridge

More information

10.1 Generate n = 100 standard lognormal data points via the R commands

10.1 Generate n = 100 standard lognormal data points via the R commands STAT 675 Statistical Computing Solutions to Homework Exercises Chapter 10 Note that some outputs may differ, depending on machine settings, generating seeds, random variate generation, etc. 10.1 Generate

More information

Conic Sections in Polar Coordinates

Conic Sections in Polar Coordinates Conic Sections in Polar Coordinates MATH 211, Calculus II J. Robert Buchanan Department of Mathematics Spring 2018 Introduction We have develop the familiar formulas for the parabola, ellipse, and hyperbola

More information

The Discrete Fourier Transform. Signal Processing PSYCH 711/712 Lecture 3

The Discrete Fourier Transform. Signal Processing PSYCH 711/712 Lecture 3 The Discrete Fourier Transform Signal Processing PSYCH 711/712 Lecture 3 DFT Properties symmetry linearity shifting scaling Symmetry x(n) -1.0-0.5 0.0 0.5 1.0 X(m) -10-5 0 5 10 0 5 10 15 0 5 10 15 n m

More information

Assignment 2. Signal Processing and Speech Communication Lab. Graz University of Technology

Assignment 2. Signal Processing and Speech Communication Lab. Graz University of Technology Signal Processing and Speech Communication Lab. Graz University of Technology Assignment 2 This homework has to be submitted via e-mail to the address hw1.spsc@tugraz.at not later than 25.5.2016. Let the

More information

Homework 5 Solutions

Homework 5 Solutions Homework 5 Solutions ECS 0 (Fall 17) Patrice Koehl koehl@cs.ucdavis.edu ovember 1, 017 Exercise 1 a) Show that the following statement is true: If there exists a real number x such that x 4 +1 = 0, then

More information

Lecture 5 : The Poisson Distribution

Lecture 5 : The Poisson Distribution Lecture 5 : The Poisson Distribution Jonathan Marchini November 5, 2004 1 Introduction Many experimental situations occur in which we observe the counts of events within a set unit of time, area, volume,

More information

Class 04 - Statistical Inference

Class 04 - Statistical Inference Class 4 - Statistical Inference Question 1: 1. What parameters control the shape of the normal distribution? Make some histograms of different normal distributions, in each, alter the parameter values

More information

NUMERICAL ANALYSIS WEEKLY OVERVIEW

NUMERICAL ANALYSIS WEEKLY OVERVIEW NUMERICAL ANALYSIS WEEKLY OVERVIEW M. AUTH 1. Monday 28 August Students are encouraged to download Anaconda Python. Anaconda is a version of Python that comes with some numerical packages (numpy and matplotlib)

More information

Math 220A Fall 2007 Homework #7. Will Garner A

Math 220A Fall 2007 Homework #7. Will Garner A Math A Fall 7 Homework #7 Will Garner Pg 74 #13: Find the power series expansion of about ero and determine its radius of convergence Consider f( ) = and let ak f ( ) = k! k = k be its power series expansion

More information

Milankovitch Cycles. Milankovitch Cycles. Milankovitch Cycles. Milankovitch Cycles. Milankovitch Cycles. Milankovitch Cycles.

Milankovitch Cycles. Milankovitch Cycles. Milankovitch Cycles. Milankovitch Cycles. Milankovitch Cycles. Milankovitch Cycles. Richard McGehee Temperatures in the Cenozoic ra Seminar on the Mathematics of Climate Change School of Mathematics March 4, 9 http://www.tqnyc.org/nyc5141/beginningpage.html Hansen, et al, 8, p. 7 Recent

More information

Discrete Fourier Transform

Discrete Fourier Transform Discrete Fourier Transform Valentina Hubeika, Jan Černocký DCGM FIT BUT Brno, {ihubeika,cernocky}@fit.vutbr.cz Diskrete Fourier transform (DFT) We have just one problem with DFS that needs to be solved.

More information

DISCRETE FOURIER TRANSFORM

DISCRETE FOURIER TRANSFORM DISCRETE FOURIER TRANSFORM 1. Introduction The sampled discrete-time fourier transform (DTFT) of a finite length, discrete-time signal is known as the discrete Fourier transform (DFT). The DFT contains

More information

MATH CSE20 Homework 5 Due Monday November 4

MATH CSE20 Homework 5 Due Monday November 4 MATH CSE20 Homework 5 Due Monday November 4 Assigned reading: NT Section 1 (1) Prove the statement if true, otherwise find a counterexample. (a) For all natural numbers x and y, x + y is odd if one of

More information

Fourier Series : Dr. Mohammed Saheb Khesbak Page 34

Fourier Series : Dr. Mohammed Saheb Khesbak Page 34 Fourier Series : Dr. Mohammed Saheb Khesbak Page 34 Dr. Mohammed Saheb Khesbak Page 35 Example 1: Dr. Mohammed Saheb Khesbak Page 36 Dr. Mohammed Saheb Khesbak Page 37 Dr. Mohammed Saheb Khesbak Page 38

More information

Lecture 10, Multirate Signal Processing Transforms as Filter Banks. Equivalent Analysis Filters of a DFT

Lecture 10, Multirate Signal Processing Transforms as Filter Banks. Equivalent Analysis Filters of a DFT Lecture 10, Multirate Signal Processing Transforms as Filter Banks Equivalent Analysis Filters of a DFT From the definitions in lecture 2 we know that a DFT of a block of signal x is defined as X (k)=

More information

Sequential Fast Fourier Transform (PSC ) Sequential FFT

Sequential Fast Fourier Transform (PSC ) Sequential FFT Sequential Fast Fourier Transform (PSC 3.1 3.2) 1 / 18 Applications of Fourier analysis Fourier analysis studies the decomposition of functions into their frequency components. Piano Concerto no. 9 by

More information

MATH 56A: STOCHASTIC PROCESSES CHAPTER 1

MATH 56A: STOCHASTIC PROCESSES CHAPTER 1 MATH 56A: STOCHASTIC PROCESSES CHAPTER. Finite Markov chains For the sake of completeness of these notes I decided to write a summary of the basic concepts of finite Markov chains. The topics in this chapter

More information

MATH 412: Homework # 1 Tim Ahn June 15, 2016

MATH 412: Homework # 1 Tim Ahn June 15, 2016 MATH 412: Homework # 1 Tim Ahn June 15, 2016 Chapter 1 Problem 1 (# 2 & 3) (a) Arctic sea ice extent averaged over January 2011 was 13.55 million square km. This was the lowest January ice extent recorded

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

EXERCISES IN MODULAR FORMS I (MATH 726) (2) Prove that a lattice L is integral if and only if its Gram matrix has integer coefficients.

EXERCISES IN MODULAR FORMS I (MATH 726) (2) Prove that a lattice L is integral if and only if its Gram matrix has integer coefficients. EXERCISES IN MODULAR FORMS I (MATH 726) EYAL GOREN, MCGILL UNIVERSITY, FALL 2007 (1) We define a (full) lattice L in R n to be a discrete subgroup of R n that contains a basis for R n. Prove that L is

More information

Relationship between the Fourier Transform of a Time Series and the Fourier Transforms of its Right and Left Halves Bill Menke, July 25, 2015

Relationship between the Fourier Transform of a Time Series and the Fourier Transforms of its Right and Left Halves Bill Menke, July 25, 2015 Relationship between the Fourier Transform of a Time Series and the Fourier Transforms of its Right and Left Halves Bill Menke, July 25, 215 Statement if the problem: We consider a time series of length

More information

Evaluating Determinants by Row Reduction

Evaluating Determinants by Row Reduction Evaluating Determinants by Row Reduction MATH 322, Linear Algebra I J. Robert Buchanan Department of Mathematics Spring 2015 Objectives Reduce a matrix to row echelon form and evaluate its determinant.

More information

Using Properties of Exponents

Using Properties of Exponents 6.1 Using Properties of Exponents Goals p Use properties of exponents to evaluate and simplify expressions involving powers. p Use exponents and scientific notation to solve real-life problems. VOCABULARY

More information

MARN 5898 Fourier Analysis.

MARN 5898 Fourier Analysis. MAR 5898 Fourier Analysis. Dmitriy Leykekhman Spring 2010 Goals Fourier Series. Discrete Fourier Transforms. D. Leykekhman - MAR 5898 Parameter estimation in marine sciences Linear Least Squares 1 Complex

More information

HFCC Math Lab Beginning Algebra 2 MULTIPLICATION AND DIVISION OF SIGNED NUMBERS

HFCC Math Lab Beginning Algebra 2 MULTIPLICATION AND DIVISION OF SIGNED NUMBERS HFCC Math Lab Beginning Algebra 2 MULTIPLICATION AND DIVISION OF SIGNED NUMBERS PART I: Multiplication of Signed Numbers Rules for Multiplication of Signed Numbers: (These Rules must be memorized.) Rule

More information

Lecture 6: Vector Spaces II - Matrix Representations

Lecture 6: Vector Spaces II - Matrix Representations 1 Key points Lecture 6: Vector Spaces II - Matrix Representations Linear Operators Matrix representation of vectors and operators Hermite conjugate (adjoint) operator Hermitian operator (self-adjoint)

More information

Technische Universität Kaiserslautern WS 2016/17 Fachbereich Mathematik Prof. Dr. J. Franke 19. January 2017

Technische Universität Kaiserslautern WS 2016/17 Fachbereich Mathematik Prof. Dr. J. Franke 19. January 2017 Technische Universität Kaiserslautern WS 2016/17 Fachbereich Mathematik Prof. Dr. J. Franke 19. January 2017 Exercises for Computational Modelling with Statistics IV This exercise is about the spectral

More information

Two-Dimensional Signal Processing and Image De-noising

Two-Dimensional Signal Processing and Image De-noising Two-Dimensional Signal Processing and Image De-noising Alec Koppel, Mark Eisen, Alejandro Ribeiro March 12, 2018 Until now, we considered (one-dimensional) discrete signals of the form x : [0, N 1] C of

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

LAB 6: FIR Filter Design Summer 2011

LAB 6: FIR Filter Design Summer 2011 University of Illinois at Urbana-Champaign Department of Electrical and Computer Engineering ECE 311: Digital Signal Processing Lab Chandra Radhakrishnan Peter Kairouz LAB 6: FIR Filter Design Summer 011

More information

A. Graph the parabola. B. Where are the solutions to the equation, 0= x + 1? C. What does the Fundamental Theorem of Algebra say?

A. Graph the parabola. B. Where are the solutions to the equation, 0= x + 1? C. What does the Fundamental Theorem of Algebra say? Hart Interactive Honors Algebra 1 Lesson 6 M4+ Opening Exercises 1. Watch the YouTube video Imaginary Numbers Are Real [Part1: Introduction] by Welch Labs (https://www.youtube.com/watch?v=t647cgsuovu).

More information

Section 3 Isomorphic Binary Structures

Section 3 Isomorphic Binary Structures Section 3 Isomorphic Binary Structures Instructor: Yifan Yang Fall 2006 Outline Isomorphic binary structure An illustrative example Definition Examples Structural properties Definition and examples Identity

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

Two-Dimensional Signal Processing and Image De-noising

Two-Dimensional Signal Processing and Image De-noising Two-Dimensional Signal Processing and Image De-noising Alec Koppel, Mark Eisen, Alejandro Ribeiro March 14, 2016 Before we considered (one-dimensional) discrete signals of the form x : [0, N 1] C where

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

Sets and Functions. MATH 464/506, Real Analysis. J. Robert Buchanan. Summer Department of Mathematics. J. Robert Buchanan Sets and Functions

Sets and Functions. MATH 464/506, Real Analysis. J. Robert Buchanan. Summer Department of Mathematics. J. Robert Buchanan Sets and Functions Sets and Functions MATH 464/506, Real Analysis J. Robert Buchanan Department of Mathematics Summer 2007 Notation x A means that element x is a member of set A. x / A means that x is not a member of A.

More information

Use the Rational Zero Theorem to list all the possible rational zeros of the following polynomials. (1-2) 4 3 2

Use the Rational Zero Theorem to list all the possible rational zeros of the following polynomials. (1-2) 4 3 2 Name: Math 114 Activity 1(Due by EOC Apr. 17) Dear Instructor or Tutor, These problems are designed to let my students show me what they have learned and what they are capable of doing on their own. Please

More information

Signals and Systems Laboratory with MATLAB

Signals and Systems Laboratory with MATLAB Signals and Systems Laboratory with MATLAB Alex Palamides Anastasia Veloni @ CRC Press Taylor &. Francis Group Boca Raton London NewYork CRC Press is an imprint of the Taylor & Francis Group, an informa

More information

L. Vandenberghe ECE236B Spring Homework 1. ((u i u c ) 2 +(v i v c ) 2 R 2 ) 2 i=1

L. Vandenberghe ECE236B Spring Homework 1. ((u i u c ) 2 +(v i v c ) 2 R 2 ) 2 i=1 L. Vandenberghe ECE6B Spring 8 Homework. Least squares fit of a circle to points. In this problem we use least squares to fit a circle to given points (u i,v i ) in a plane, as shown in the figure. The

More information

MATLAB and Mathematical Introduction Will be discussed in class on 1/24/11

MATLAB and Mathematical Introduction Will be discussed in class on 1/24/11 MATLAB and Mathematical Introduction Will be discussed in class on 1/24/11 GEOP 523; Theoretical Seismology January 17, 2011 Much of our work in this class will be done using MATLAB. The goal of this exercise

More information

MATH115. Sequences and Infinite Series. Paolo Lorenzo Bautista. June 29, De La Salle University. PLBautista (DLSU) MATH115 June 29, / 16

MATH115. Sequences and Infinite Series. Paolo Lorenzo Bautista. June 29, De La Salle University. PLBautista (DLSU) MATH115 June 29, / 16 MATH115 Sequences and Infinite Series Paolo Lorenzo Bautista De La Salle University June 29, 2014 PLBautista (DLSU) MATH115 June 29, 2014 1 / 16 Definition A sequence function is a function whose domain

More information

Vector Spaces and SubSpaces

Vector Spaces and SubSpaces Vector Spaces and SubSpaces Linear Algebra MATH 2076 Linear Algebra Vector Spaces & SubSpaces Chapter 4, Section 1b 1 / 10 What is a Vector Space? A vector space is a bunch of objects that we call vectors

More information

Fourier Transform with Rotations on Circles and Ellipses in Signal and Image Processing

Fourier Transform with Rotations on Circles and Ellipses in Signal and Image Processing Fourier Transform with Rotations on Circles and Ellipses in Signal and Image Processing Artyom M. Grigoryan Department of Electrical and Computer Engineering University of Texas at San Antonio One UTSA

More information

Introduction to Fourier Analysis Part 2. CS 510 Lecture #7 January 31, 2018

Introduction to Fourier Analysis Part 2. CS 510 Lecture #7 January 31, 2018 Introduction to Fourier Analysis Part 2 CS 510 Lecture #7 January 31, 2018 OpenCV on CS Dept. Machines 2/4/18 CSU CS 510, Ross Beveridge & Bruce Draper 2 In the extreme, a square wave Graphic from http://www.mechatronics.colostate.edu/figures/4-4.jpg

More information

Chapter 2 Polynomial and Rational Functions

Chapter 2 Polynomial and Rational Functions Chapter 2 Polynomial and Rational Functions Overview: 2.2 Polynomial Functions of Higher Degree 2.3 Real Zeros of Polynomial Functions 2.4 Complex Numbers 2.5 The Fundamental Theorem of Algebra 2.6 Rational

More information

STAT 675 Statistical Computing

STAT 675 Statistical Computing STAT 675 Statistical Computing Solutions to Homework Exercises Chapter 3 Note that some outputs may differ, depending on machine settings, generating seeds, random variate generation, etc. 3.1. Sample

More information

MATH10040: Numbers and Functions Homework 1: Solutions

MATH10040: Numbers and Functions Homework 1: Solutions MATH10040: Numbers and Functions Homework 1: Solutions 1. Prove that a Z and if 3 divides into a then 3 divides a. Solution: The statement to be proved is equivalent to the statement: For any a N, if 3

More information

1 Determinants. 1.1 Determinant

1 Determinants. 1.1 Determinant 1 Determinants [SB], Chapter 9, p.188-196. [SB], Chapter 26, p.719-739. Bellow w ll study the central question: which additional conditions must satisfy a quadratic matrix A to be invertible, that is to

More information

Properties of Linear Transformations from R n to R m

Properties of Linear Transformations from R n to R m Properties of Linear Transformations from R n to R m MATH 322, Linear Algebra I J. Robert Buchanan Department of Mathematics Spring 2015 Topic Overview Relationship between the properties of a matrix transformation

More information

Chapter 1 Divide and Conquer Polynomial Multiplication Algorithm Theory WS 2015/16 Fabian Kuhn

Chapter 1 Divide and Conquer Polynomial Multiplication Algorithm Theory WS 2015/16 Fabian Kuhn Chapter 1 Divide and Conquer Polynomial Multiplication Algorithm Theory WS 2015/16 Fabian Kuhn Formulation of the D&C principle Divide-and-conquer method for solving a problem instance of size n: 1. Divide

More information

Parallel Numerical Algorithms

Parallel Numerical Algorithms Parallel Numerical Algorithms Chapter 13 Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign CS 554 / CSE 512 Michael T. Heath Parallel Numerical Algorithms

More information

Fourier analysis of discrete-time signals. (Lathi Chapt. 10 and these slides)

Fourier analysis of discrete-time signals. (Lathi Chapt. 10 and these slides) Fourier analysis of discrete-time signals (Lathi Chapt. 10 and these slides) Towards the discrete-time Fourier transform How we will get there? Periodic discrete-time signal representation by Discrete-time

More information

Explore the data. Anja Bråthen Kristoffersen

Explore the data. Anja Bråthen Kristoffersen Explore the data Anja Bråthen Kristoffersen density 0.2 0.4 0.6 0.8 Probability distributions Can be either discrete or continuous (uniform, bernoulli, normal, etc) Defined by a density function, p(x)

More information

Homework 1 Solutions

Homework 1 Solutions 18-9 Signals and Systems Profs. Byron Yu and Pulkit Grover Fall 18 Homework 1 Solutions Part One 1. (8 points) Consider the DT signal given by the algorithm: x[] = 1 x[1] = x[n] = x[n 1] x[n ] (a) Plot

More information

MATH4427 Notebook 4 Fall Semester 2017/2018

MATH4427 Notebook 4 Fall Semester 2017/2018 MATH4427 Notebook 4 Fall Semester 2017/2018 prepared by Professor Jenny Baglivo c Copyright 2009-2018 by Jenny A. Baglivo. All Rights Reserved. 4 MATH4427 Notebook 4 3 4.1 K th Order Statistics and Their

More information

SOLUTIONS Math 345 Homework 6 10/11/2017. Exercise 23. (a) Solve the following congruences: (i) x (mod 12) Answer. We have

SOLUTIONS Math 345 Homework 6 10/11/2017. Exercise 23. (a) Solve the following congruences: (i) x (mod 12) Answer. We have Exercise 23. (a) Solve the following congruences: (i) x 101 7 (mod 12) Answer. We have φ(12) = #{1, 5, 7, 11}. Since gcd(7, 12) = 1, we must have gcd(x, 12) = 1. So 1 12 x φ(12) = x 4. Therefore 7 12 x

More information

Discrete Fourier transform (DFT)

Discrete Fourier transform (DFT) Discrete Fourier transform (DFT) Alejandro Ribeiro January 19, 2018 Let x : [0, N 1] C be a discrete signal of duration N and having elements x(n) for n [0, N 1]. The discrete Fourier transform (DFT) of

More information

Energy Balance Models

Energy Balance Models Richard McGehee School of Mathematics University of Minnesota NCAR - MSRI July, 2010 Earth s Energy Balance Gary Stix, Scientific American September 2006, pp.46-49 Earth s Energy Balance Historical Overview

More information

Math Computer Lab 4 : Fourier Series

Math Computer Lab 4 : Fourier Series Math 227 - Computer Lab 4 : Fourier Series Dylan Zwick Fall 212 This lab should be a pretty quick lab. It s goal is to introduce you to one of the coolest ideas in mathematics, the Fourier series, and

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

Homework #2 solutions Due: June 15, 2012

Homework #2 solutions Due: June 15, 2012 All of the following exercises are based on the material in the handout on integers found on the class website. 1. Find d = gcd(475, 385) and express it as a linear combination of 475 and 385. That is

More information

Practice Test - Chapter 2

Practice Test - Chapter 2 Graph and analyze each function. Describe the domain, range, intercepts, end behavior, continuity, and where the function is increasing or decreasing. 1. f (x) = 0.25x 3 Evaluate the function for several

More information

MATH 433 Applied Algebra Lecture 4: Modular arithmetic (continued). Linear congruences.

MATH 433 Applied Algebra Lecture 4: Modular arithmetic (continued). Linear congruences. MATH 433 Applied Algebra Lecture 4: Modular arithmetic (continued). Linear congruences. Congruences Let n be a postive integer. The integers a and b are called congruent modulo n if they have the same

More information

IMA. Celestial Influences on Glacial Cycles. Math and Climate Seminar

IMA. Celestial Influences on Glacial Cycles. Math and Climate Seminar Math and Climate Seminar IMA Celestial Influences on Richard McGehee Joint MCRN/IMA Math and Climate Seminar Tuesdays 11:15 1:5 streaming video available at www.ima.umn.edu Seminar on the Mathematics of

More information

Hence, (f(x) f(x 0 )) 2 + (g(x) g(x 0 )) 2 < ɛ

Hence, (f(x) f(x 0 )) 2 + (g(x) g(x 0 )) 2 < ɛ Matthew Straughn Math 402 Homework 5 Homework 5 (p. 429) 13.3.5, 13.3.6 (p. 432) 13.4.1, 13.4.2, 13.4.7*, 13.4.9 (p. 448-449) 14.2.1, 14.2.2 Exercise 13.3.5. Let (X, d X ) be a metric space, and let f

More information

The Fourier transform allows an arbitrary function to be represented in terms of simple sinusoids. The Fourier transform (FT) of a function f(t) is

The Fourier transform allows an arbitrary function to be represented in terms of simple sinusoids. The Fourier transform (FT) of a function f(t) is 1 Introduction Here is something I wrote many years ago while working on the design of anemometers for measuring shear stresses. Part of this work required modelling and compensating for the transfer function

More information

Discrete-Time Gaussian Fourier Transform Pair, and Generating a Random Process with Gaussian PDF and Power Spectrum Mark A.

Discrete-Time Gaussian Fourier Transform Pair, and Generating a Random Process with Gaussian PDF and Power Spectrum Mark A. Discrete-Time Gaussian Fourier Transform Pair, and Generating a Random Process with Gaussian PDF and Power Spectrum Mark A. Richards October 3, 6 Updated April 5, Gaussian Transform Pair in Continuous

More information

SECTION 7: CURVE FITTING. MAE 4020/5020 Numerical Methods with MATLAB

SECTION 7: CURVE FITTING. MAE 4020/5020 Numerical Methods with MATLAB SECTION 7: CURVE FITTING MAE 4020/5020 Numerical Methods with MATLAB 2 Introduction Curve Fitting 3 Often have data,, that is a function of some independent variable,, but the underlying relationship is

More information

Algebra 2 Summer Assignment - Non Regents

Algebra 2 Summer Assignment - Non Regents Name: Date: This assignment is to be completed over the summer. It must be turned in the first day of classes. It will be counted as a quiz. You MUST SHOW all work for each question in the space provided

More information

Differential equations

Differential equations Differential equations Math 7 Spring Practice problems for April Exam Problem Use the method of elimination to find the x-component of the general solution of x y = 6x 9x + y = x 6y 9y Soln: The system

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

STAT 753 Homework 3 SOLUTIONS

STAT 753 Homework 3 SOLUTIONS STAT 753 Homework 3 SOLUTIONS. Y Weibull distribution W (α, ). The survival function is given by S Y (y) = P r(y y) = e ( y α), y 0, α, > 0. (a) Cumulative distribution and its inverse functions. The cumulative

More information

Natural Numbers: Also called the counting numbers The set of natural numbers is represented by the symbol,.

Natural Numbers: Also called the counting numbers The set of natural numbers is represented by the symbol,. Name Period Date: Topic: Real Numbers and Their Graphs Standard: 9-12.A.1.3 Objective: Essential Question: What is the significance of a point on a number line? Determine the relative position on the number

More information

Instructor Notes for Chapters 3 & 4

Instructor Notes for Chapters 3 & 4 Algebra for Calculus Fall 0 Section 3. Complex Numbers Goal for students: Instructor Notes for Chapters 3 & 4 perform computations involving complex numbers You might want to review the quadratic formula

More information

Solving Systems of Linear and Quadratic Equations

Solving Systems of Linear and Quadratic Equations 9.5 Solving Systems of Linear and Quadratic Equations How can you solve a system of two equations when one is linear and the other is quadratic? ACTIVITY: Solving a System of Equations Work with a partner.

More information

Row Space, Column Space, and Nullspace

Row Space, Column Space, and Nullspace Row Space, Column Space, and Nullspace MATH 322, Linear Algebra I J. Robert Buchanan Department of Mathematics Spring 2015 Introduction Every matrix has associated with it three vector spaces: row space

More information

Digital Image Processing

Digital Image Processing Digital Image Processing Image Transforms Unitary Transforms and the 2D Discrete Fourier Transform DR TANIA STATHAKI READER (ASSOCIATE PROFFESOR) IN SIGNAL PROCESSING IMPERIAL COLLEGE LONDON What is this

More information

Math 460: Complex Analysis MWF 11am, Fulton Hall 425 Homework 8 Solutions Please write neatly, and in complete sentences when possible.

Math 460: Complex Analysis MWF 11am, Fulton Hall 425 Homework 8 Solutions Please write neatly, and in complete sentences when possible. Math 460: Complex Analysis MWF am, Fulton Hall 45 Homework 8 Solutions Please write neatly, and in complete sentences when possible. Do the following problems from the book:.4.,.4.0,.4.-.4.6, 4.., 4..,

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

LAB 2: DTFT, DFT, and DFT Spectral Analysis Summer 2011

LAB 2: DTFT, DFT, and DFT Spectral Analysis Summer 2011 University of Illinois at Urbana-Champaign Department of Electrical and Computer Engineering ECE 311: Digital Signal Processing Lab Chandra Radhakrishnan Peter Kairouz LAB 2: DTFT, DFT, and DFT Spectral

More information

m We can similarly replace any pair of complex conjugate eigenvalues with 2 2 real blocks. = R

m We can similarly replace any pair of complex conjugate eigenvalues with 2 2 real blocks. = R 1 RODICA D. COSTIN Suppose that some eigenvalues are not real. Then the matrices S and are not real either, and the diagonalization of M must be done in C n. Suppose that we want to work in R n only. Recall

More information

Chapter 2 Algorithms for Periodic Functions

Chapter 2 Algorithms for Periodic Functions Chapter 2 Algorithms for Periodic Functions In this chapter we show how to compute the Discrete Fourier Transform using a Fast Fourier Transform (FFT) algorithm, including not-so special case situations

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

Fourier Bases on the Skewed Sierpinski Gasket

Fourier Bases on the Skewed Sierpinski Gasket Fourier Bases on the Skewed Sierpinski Gasket Calvin Hotchkiss University Nebraska-Iowa Functional Analysis Seminar November 5, 2016 Part 1: A Fast Fourier Transform for Fractal Approximations The Fractal

More information

DOWNLOAD OR READ : GET SOLUTIONS FROM QUADRATIC EQUATION PDF EBOOK EPUB MOBI

DOWNLOAD OR READ : GET SOLUTIONS FROM QUADRATIC EQUATION PDF EBOOK EPUB MOBI DOWNLOAD OR READ : GET SOLUTIONS FROM QUADRATIC EQUATION PDF EBOOK EPUB MOBI Page 1 Page 2 get solutions from quadratic equation get solutions from quadratic pdf get solutions from quadratic equation Free

More information

Powers, Roots and Radicals. (11) Page #23 47 Column, #51, 54, #57 73 Column, #77, 80

Powers, Roots and Radicals. (11) Page #23 47 Column, #51, 54, #57 73 Column, #77, 80 Algebra 2/Trig Unit Notes Packet Name: Period: # Powers, Roots and Radicals () Homework Packet (2) Homework Packet () Homework Packet () Page 277 # 0 () Page 277 278 #7 6 Odd (6) Page 277 278 #8 60 Even

More information

GENERALIZED ERROR DISTRIBUTION

GENERALIZED ERROR DISTRIBUTION CHAPTER 21 GENERALIZED ERROR DISTRIBUTION 21.1 ASSIGNMENT Write R functions for the Generalized Error Distribution, GED. Nelson [1991] introduced the Generalized Error Distribution for modeling GARCH time

More information

Fractals and Fractal Dimensions

Fractals and Fractal Dimensions Fractals and Fractal Dimensions John A. Rock July 13th, 2009 begin with [0,1] remove 1 of length 1/3 remove 2 of length 1/9 remove 4 of length 1/27 remove 8 of length 1/81...................................

More information

Recent Developments in the Theory of Glacial Cycles

Recent Developments in the Theory of Glacial Cycles Recent Developments in the Theory of Richard McGehee Seminar on the Mathematics of Climate Change School of Mathematics October 6, 010 Hansen, et al, Target atmospheric CO: Where should humanity aim? Open

More information