Particle In Cell Beam Dynamics Simulations With a Wavelet based Poisson Solver

Size: px
Start display at page:

Download "Particle In Cell Beam Dynamics Simulations With a Wavelet based Poisson Solver"

Transcription

1 Particle In Cell Beam Dynamics Simulations With a Wavelet based Poisson Solver Balša Terzić Beam Physics and Astrophysics Group, Department of Physics Northern Illinois University in collaboration with Ilya Pogorelov (Lawrence Berkeley Lab) Courtlandt Bohn, Daniel Mihalcea, Benjamin Sprague (NIU) University of New Mexico, Department of Mathematics and Statistics November 2, 2006

2 Motivation Gaining insight into the dynamics of multi particle systems (galaxies, charged particle beams, plasma...) heavily relies on N body simulations It is important for N body codes to: account for multiscale dynamics minimize numerical noise due to Nsimulation<< Nphysical be as efficient as possible, without compromising accuracy for some applications: have a compact representation of system's history We present a wavelet based Poisson equation solver which, as a part of an Particle In Cell (PIC) N body code, addresses all of these requirements

3 Outline of the Talk PIC algorithm for N body simulations origin and profile of noise Brief introduction to wavelets and their properties denoising and compression Wavelet based Poisson equation solver Applications to real machines and comparison to existing codes Summary and discussion of further work

4 Algorithms for N body Simulations Main algorithms for N body simulations: direct summation (DS): CPU cost scales as N2 tree: DS nearby and statistical treatment farther away Particle In Cell (PIC): particles binned in cells (grid) system at t=t0 binning particle distribution N particles in box Newton's equations advance particles by t system at t=t0+ t on Nx Ny Nz grid interpolation, F for each particle F = solve the Poisson equation = on Nx Ny Nz grid

5 Noise in PIC Simulations Any numerical simulation will have numerical noise Origin of numerical noise in PIC simulations: graininess of the distribution function: Nsimulation<< Nphysical discreteness of the computational domain: and specified on a finite, discrete grid Each macroparticle is deposited onto a finite grid by either: Nearest Grid Point (NGP) dep. scheme Cloud In Cell (CIC) dep. scheme x location of the macroparticle location of gridpoints

6 Noise in PIC Simulations For NGP, at each gridpoint, particle dist. is Poissonian: n j P= n! 1 n nj e nj is the expected number in jth cell; n integer For CIC, at each gridpoint, particle dist. is contracted Poissonian: D / 2 1 n an P= n! an j e where a= 2 /3 j Measure of error (noise) in depositing macroparticles onto a grid: N grid 2= N grid 1 Var qi i=1 2 NGP = 2 Qtotal N N grid 2 2 CIC = 2 a Qtotal N N grid where qj = q0nj, q0= Qtotal/N, Qtotal is the total charge and Ngrid total the number of gridpoints This error/noise estimate is crucial for optimal wavelet denoising IDEA: Solve the Poisson equation in such a way so as to minimize numerical noise USE WAVELETS

7 Wavelets What are wavelets? orthogonal basis of functions composed of scaled and translated versions of the mother wavelet (x) and the scaling function (x) f(x) =s00 00 (x) + d00 00 (x) + i k dik ik (x) ik(x) = 2k/2 (2kx i) = j gik 2i+jk+1 (x) ik(x) = 2k/2 (2kx i) = j hik 2i+jk+1 (x) family of perfect low and high pass filters hi and gi (enable DWT) Why wavelets? simultaneous time (space) and frequency localization (FFT only frequency) data compression: computational speed up (FBI uses it for storing fingerprints) signal denoising: natural setting in which noise can be partially removed denoised simulation simulation with more macroparticles

8 One Dimensional Wavelets (a) Haar wavelet, (b) Morlet wavelet, (c) Daubechies wavelet. Two Dimensional Daubechies least symmetric N = 10 two dimensional wavelet.

9 Wavelet Denoising and Compression In wavelet space: signal noise few large wavelet coefficients ci,j many small wavelet coefficients ci,j Anscombe transformation Poissonian noise Denoising by wavelet thresholding: Gaussian noise if ci,j < T, set to ci,j =0 (choose threshold T carefully!) A great deal of study has been devoted to estimating optimal T or T = 2 log N grid T =2 log N grid where was estimated earlier w/ Anscombe transformation w/out Anscombe transformation

10 Example: Wavelet Denoising and Compression Whenever the discrete signal is analytically known, one can compute Signal to Noise Ratio (SNR) which measures its quality SNR ~ Nppc ANALYTICAL Nppc: avg. # of particles per cell Nppc= 3 SNR = 2.02 Nppc= 205 SNR = 16.89

11 Example: Wavelet Denoising and Compression Whenever the discrete signal is analytically known, one can compute Signal to Noise Ratio (SNR) which measures its quality SNR ~ Nppc Nppc: avg. # of particles per cell 2D superimposed Gaussians on grid ANALYTICAL Nppc= 3 SNR = 2.02 Nppc= 205 SNR = 16.89

12 Example: Wavelet Denoising and Compression Whenever the discrete signal is analytically known, one can compute Signal to Noise Ratio (SNR) which measures its quality SNR ~ Nppc Nppc: avg. # of particles per cell 2D superimposed Gaussians on grid ANALYTICAL Nppc= 3 SNR = 2.02 Nppc= 205 SNR = 16.89

13 Example: Wavelet Denoising and Compression Whenever the discrete signal is analytically known, one can compute Signal to Noise Ratio (SNR) which measures its quality SNR ~ Nppc Nppc: avg. # of particles per cell 2D superimposed Gaussians on grid ANALYTICAL Nppc= 3 SNR = 2.02 Nppc= 205 SNR = 16.89

14 Example: Wavelet Denoising and Compression Whenever the discrete signal is analytically known, one can compute Signal to Noise Ratio (SNR) which measures its quality SNR ~ Nppc Nppc: avg. # of particles per cell 2D superimposed Gaussians on grid DENOISED ANALYTICAL Nppc= 3 SNR = 2.02 Nppc= 205 SNR = denoising by wavelet thresholding: if ci,j < T, set to 0 Nppc= 3 SNR = 16.83

15 Example: Wavelet Denoising and Compression Whenever the discrete signal is analytically known, one can compute Signal to Noise Ratio (SNR) which measures its quality SNR ~ Nppc Nppc: avg. # of particles per cell 2D superimposed Gaussians on grid COMPACT: only 0.12% of coeffs WAVELET THRESHOLDING ANALYTICAL Nppc= 3 SNR = 2.02 Nppc= 205 SNR = DENOISED Nppc= 3 SNR = denoising by wavelet thresholding: if ci,j < T, set to 0 Increase in SNR by b equivalent to running simulation with b2 more particles! Particle distribution is compactly stored in wavelet space (in the example b=8.3 equivalent to 68 times more particles; 79/65536 wavelet coeffs retained)

16 Wavelet based Poisson Solver Poisson equation in physical space u=f BCs: using Green's functions Discretize Poisson equation on the Nx Ny Nz grid LU=F transform discretized Poisson equation to wavelet space WT Lw Uw = Fw ubnd = g PRECONDITIONED Conjugate Gradient (PCG) in wavelet space A X B 2 ε2 B 2 iwt solution U on the Nx Ny Nz grid wavelet threshold source Fw, operator Lw AX=B (PLwP) P 1Uw = PFw A compressed operator PLwP PRECONDITION Laplacian Lw B denoised distribution PFw with diagonal preconditioner X denoised solution P 1Uw k (Lw) ~ O(Nx2) k (PLwP) ~ O(Nx) P

17 Preconditioned Conjugate Gradient (PCG) i convergence rate depends on k u u i 2 k 1 u 2 preconditioning (diagonal in wavelet space): k ~ O(Nx2) k ~ O(Nx ) k 1 good initial approximation: solution at previous time step

18 Preconditioned Conjugate Gradient (PCG) i convergence rate depends on k u u i 2 k 1 u 2 preconditioning (diagonal in wavelet space): k ~ O(Nx2) k ~ O(Nx ) k 1 good initial approximation: solution at previous time step typical realistic beam simulation no preconditioning Ui=0 initial guess average over step run 75.2

19 Preconditioned Conjugate Gradient (PCG) i convergence rate depends on k u u i 2 k 1 u 2 preconditioning (diagonal in wavelet space): k ~ O(Nx2) k ~ O(Nx ) k 1 good initial approximation: solution at previous time step typical realistic beam simulation average over step run no preconditioning Ui=0 initial guess 75.2 preconditioned Ui=0 initial guess 60.7

20 Preconditioned Conjugate Gradient (PCG) i convergence rate depends on k u u i 2 k 1 u 2 preconditioning (diagonal in wavelet space): k ~ O(Nx2) k ~ O(Nx ) k 1 good initial approximation: solution at previous time step typical realistic beam simulation average over step run no preconditioning Ui=0 initial guess 75.2 preconditioned Ui=0 initial guess 60.7 no preconditioning Ui=Ui 1 initial guess 4.8

21 Preconditioned Conjugate Gradient (PCG) i convergence rate depends on k u u i 2 k 1 u 2 preconditioning (diagonal in wavelet space): k ~ O(Nx2) k ~ O(Nx ) k 1 good initial approximation: solution at previous time step typical realistic beam simulation average over step run no preconditioning Ui=0 initial guess 75.2 preconditioned Ui=0 initial guess 60.7 no preconditioning Ui=Ui 1 initial guess 4.8 preconditioned Ui=Ui 1 initial guess 2.4

22 Applications Our goal: develop wavelet based Poisson solver which can easily be integrated into existing PIC codes First: test the PCG as a stand alone Poisson solver on (idealized) examples from beam dynamics (3D 'fuzzy cigar' beam charge distribution) galactic dynamics (mass density of an elliptical galaxy as idealized by the 3D Plummer sphere)

23 3D 'fuzzy cigar' on a 32x32x32 grid BCs: grounded rectangular pipe (V=0 on the sides), open in z direction (Green's function solution)

24 3D Plummer sphere on a 32x32x32 grid BCs: open in all directions (analytically specified)

25 Applications Second: insert the PCG Poisson solver into an existing PIC code (IMPACT T) and run realistic charged particle beam simulations compare (conventional FFT based) IMPACT T Vs. IMPACT T with PCG: rms properties level of detail computational speed

26 IMPACT T Vs. IMPACT T with PCG: rms properties Fermilab/NICADD photoinjector ( grid) 1 nc charge rms beam radius rms normalized transverse emittance rms bunch length rms normalized longitudinal emittance

27 IMPACT T Vs. IMPACT T with PCG: level of detail IMPACT T transverse charge distribution for the Fermilab/NICADD photoinjector simulation very non axisymmetric beam grid, N=200,000 very good agreement in detail IMPACT T w/ PCG initial distribution z = 1.0 m z = 2.0 m z = 4.0 m

28 IMPACT T Vs. IMPACT T with PCG: level of detail IMPACT T transverse charge distribution for the Fermilab/NICADD photoinjector simulation 5 beamlets (masked photocathode) grid, N=200,000 very good agreement in detail IMPACT T w/ PCG initial distribution z = 2.0 m z = 4.0 m z = 6.0 m

29 IMPACT T Vs. IMPACT T with PCG: computational speed IMPACT T w/ PCG ~ 10% faster than the conventional serial IMPACT T Areas of further computational optimization: code parallelization (almost completed) further optimizing boundary conditions computations finding new ways to exploit sparseness of operators and data sets finding a more effective preconditioner for PCG

30 Data Compression: Clear Advantage of PCG IMPACT T w/ PCG provides excellent compression of data sets and operators in wavelet space Fermilab/NICADD photoinjector: Real Simulations particle distribution Laplacian operator grid, N=125000, Nppc=4.58 ~ 3.5% coefficients retained on average grid, N= , Nppc=4.58 ~ 1.75% coefficients retained on average compact storage of beam's distribution history needed for CSR simulations

31 Conclusions Presented an iterative wavelet based Poisson solver (PCG) wavelet compression and denoising achieves computational speedup preconditioning and sparsity of operators in wavelet space reduce CPU load integrated PCG into a PIC code (IMPACT T) for beam dynamics simulations Original contribution: first wavelet based solver for 3D Poisson equation with Dirichlet BCs first application of wavelets to 3D simulation of beams better understanding of noise in PIC simulations and its removal modeled real machines: Fermilab/NICADD photoinjector Future plans: use PCG in N body simulations of self gravitating systems (galaxies, clusters...) apply wavelet formalism to other PDEs: Fokker Planck, Vlasov Poisson, Maxwell explore use of compact representation of charge distribution in CSR simulations

32 On line Resources This paper: Our group's (BPAG) website:

33 Auxiliary Slides

34 Computing Boundary Conditions Green's function corresponding to a grounded rectangular pipe V=0 y computational grid EIGENFUNCTIONS pipe walls sin l x sin m y V=0 V=0 EIGENVALUES l =l / a V=0 lm z = 2 lm z z2 4 ab a x b 0 0 x, y, z sin l x sin m y dx dy 2lm lm z = lm z Nx Ny m=m / b x, y, z = l =1 m=1 lm z sin l x sin m y 2 pipe walls 2 2 l m = l m

35 Preconditioner in Wavelet Space

36 Wavelets (x) What are wavelets? 4th order Daubechies orthogonal basis of functions composed of scaled and translated versions of the mother wavelet (x) and the scaling function (x) f(x) =s00 00 (x) + d00 00 (x) + dik ik (x) ik(x) = 2k/2 (2kx i) ik(x) = 2k/2 (2kx i) family of perfect low and high pass filters hi and gi (enable DWT) Why wavelets? simultaneous time (space) and frequency localization (FFT only frequency) data compression: computational speed up signal denoising: natural setting in which noise can be partially removed denoised simulation simulation with more macroparticles 2(x)

37 Wavelet Decomposition The continuous wavelet transform of a function f (t) is s, = f t s, t dt s, t = 1 s t s t mother wavelet with scale and translation dimensions s and respectively

38 How Do Wavelets Work? Wavelet analysis (wavelet transform): S signal A approximation D detail Approximation apply low pass filter to Signal and down sample Detail apply high pass filter to Signal and down sample Wavelet synthesis (inverse wavelet transform): up sampling & filtering Complexity: 4MN, M the size of the wavelet, N number of cells Recall: FFT complexity 4N log2n

39 2D EXAMPLE: MICROBUNCHED DENSITY DISTRIBUTION (with U=0 starting guess) BCs: open in all directions (analytically specified)

40 IMPACT T Vs. IMPACT T with PCG: rms properties Fermilab/NICADD photoinjector ( grid) 1 nc charge bunch compressor at z=5.65m from cathode rms beam radius rms normalized transverse emittance rms bunch length rms normalized longitudinal emittance

41 IMPACT T Vs. IMPACT T with PCG: level of detail Impact IMPACT T IMPACT Tresidue w/ PCG Impact with CPCG transverse charge distribution for the AES/JLab low charge photoinjector simulation very non axisymmetric beam grid, N= very good agreement in detail initial distribution z = 0.5 m z = 1.9 m z = 2.5 m

Application of Wavelets to N body Particle In Cell Simulations

Application of Wavelets to N body Particle In Cell Simulations Application of Wavelets to N body Particle In Cell Simulations Balša Terzić (NIU) Northern Illinois University, Department of Physics April 7, 2006 Motivation Gaining insight into the dynamics of multi

More information

Orthogonal Basis Function Approximation of Particle Distributions In Numerical Simulations of Beams

Orthogonal Basis Function Approximation of Particle Distributions In Numerical Simulations of Beams Orthogonal Basis Function Approximation of Particle Distributions In Numerical Simulations of Beams Balša Beam Physics and Astrophysics Group Northern Illinois University Jefferson Lab Beam Seminar April

More information

Progress Report: New Particle-In-Cell Code For Numerical Simulations of Coherent Synchrotron Radiation

Progress Report: New Particle-In-Cell Code For Numerical Simulations of Coherent Synchrotron Radiation Progress Report: New Particle-In-Cell Code For Numerical Simulations of Coherent Synchrotron Radiation Balša Terzić and Rui Li CASA, Jefferson Lab CASA Group Meeting May 26, 2010 Notice: Authored by Jefferson

More information

Particle-in-cell beam dynamics simulations with a wavelet-based Poisson solver

Particle-in-cell beam dynamics simulations with a wavelet-based Poisson solver PHYSICAL REVIEW SPECIAL TOPICS - ACCELERATORS AND BEAMS, 3 (7) Particle-in-cell beam dynamics simulations with a wavelet-based Poisson solver Balša Terzić, Ilya V. Pogorelov, and Courtlandt L. Bohn Beam

More information

Particle-in-Cell Beam Dynamics Simulations With A Wavelet-Based Poisson Solver

Particle-in-Cell Beam Dynamics Simulations With A Wavelet-Based Poisson Solver Particle-in-Cell Beam Dynamics Simulations With A Wavelet-Based Poisson Solver Balša Terzić, Ilya V. Pogorelov, Courtlandt L. Bohn Beam Physics and Astrophysics Group, Northern Illinois University, DeKalb,

More information

Wavelet-Based Poisson Solver for Use in Particle-in-Cell Simulations

Wavelet-Based Poisson Solver for Use in Particle-in-Cell Simulations Wavelet-Based Poisson Solver for Use in Particle-in-Cell Simulations Balša Terzić Department of Physics, Northern Illinois University, DeKalb, Illinois 65 Ilya V. Pogorelov Accelerator and Fusion Research

More information

Simulations of the Microbunching Instability in FEL Beam Delivery Systems

Simulations of the Microbunching Instability in FEL Beam Delivery Systems Simulations of the Microbunching Instability in FEL Beam Delivery Systems Ilya Pogorelov Tech-X Corporation Workshop on High Average Power & High Brightness Beams UCLA, January 2009 Outline The setting:

More information

3D Space Charge Routines: The Software Package MOEVE and FFT Compared

3D Space Charge Routines: The Software Package MOEVE and FFT Compared 3D Space Charge Routines: The Software Package MOEVE and FFT Compared Gisela Pöplau DESY, Hamburg, December 4, 2007 Overview Algorithms for 3D space charge calculations Properties of FFT and iterative

More information

Fast Space Charge Calculations with a Multigrid Poisson Solver & Applications

Fast Space Charge Calculations with a Multigrid Poisson Solver & Applications Fast Space Charge Calculations with a Multigrid Poisson Solver & Applications Gisela Pöplau Ursula van Rienen Rostock University DESY, Hamburg, April 26, 2005 Bas van der Geer Marieke de Loos Pulsar Physics

More information

( nonlinear constraints)

( nonlinear constraints) Wavelet Design & Applications Basic requirements: Admissibility (single constraint) Orthogonality ( nonlinear constraints) Sparse Representation Smooth functions well approx. by Fourier High-frequency

More information

Sparse linear models

Sparse linear models Sparse linear models Optimization-Based Data Analysis http://www.cims.nyu.edu/~cfgranda/pages/obda_spring16 Carlos Fernandez-Granda 2/22/2016 Introduction Linear transforms Frequency representation Short-time

More information

PDE Solvers for Fluid Flow

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

More information

Lecture Notes 5: Multiresolution Analysis

Lecture Notes 5: Multiresolution Analysis Optimization-based data analysis Fall 2017 Lecture Notes 5: Multiresolution Analysis 1 Frames A frame is a generalization of an orthonormal basis. The inner products between the vectors in a frame and

More information

EFFICIENT 3D POISSON SOLVERS FOR SPACE-CHARGE SIMULATION

EFFICIENT 3D POISSON SOLVERS FOR SPACE-CHARGE SIMULATION Abstract EFFICIENT 3D POISSON SOLVERS FOR SPACE-CHARGE SIMULATION Three-dimensional Poisson solver plays an important role in the self-consistent space-charge simulation. In this paper, we present several

More information

Beam Physics at SLAC. Yunhai Cai Beam Physics Department Head. July 8, 2008 SLAC Annual Program Review Page 1

Beam Physics at SLAC. Yunhai Cai Beam Physics Department Head. July 8, 2008 SLAC Annual Program Review Page 1 Beam Physics at SLAC Yunhai Cai Beam Physics Department Head July 8, 2008 SLAC Annual Program Review Page 1 Members in the ABP Department * Head: Yunhai Cai * Staff: Gennady Stupakov Karl Bane Zhirong

More information

Multiresolution Analysis

Multiresolution Analysis Multiresolution Analysis DS-GA 1013 / MATH-GA 2824 Optimization-based Data Analysis http://www.cims.nyu.edu/~cfgranda/pages/obda_fall17/index.html Carlos Fernandez-Granda Frames Short-time Fourier transform

More information

ABSTRACT. Title: Wavelet-space solution of the Poisson equation: An algorithm for use in particle-incell simulations

ABSTRACT. Title: Wavelet-space solution of the Poisson equation: An algorithm for use in particle-incell simulations ABSTRACT Name: Benjamin Sprague Department: Physics Title: Wavelet-space solution of the Poisson equation: An algorithm for use in particle-incell simulations Major: Physics Degree: Master of Science Approved

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

Numerical Methods I Non-Square and Sparse Linear Systems

Numerical Methods I Non-Square and Sparse Linear Systems Numerical Methods I Non-Square and Sparse Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 September 25th, 2014 A. Donev (Courant

More information

Wavelets in Scattering Calculations

Wavelets in Scattering Calculations Wavelets in Scattering Calculations W. P., Brian M. Kessler, Gerald L. Payne polyzou@uiowa.edu The University of Iowa Wavelets in Scattering Calculations p.1/43 What are Wavelets? Orthonormal basis functions.

More information

Sparse Matrix Techniques for MCAO

Sparse Matrix Techniques for MCAO Sparse Matrix Techniques for MCAO Luc Gilles lgilles@mtu.edu Michigan Technological University, ECE Department Brent Ellerbroek bellerbroek@gemini.edu Gemini Observatory Curt Vogel vogel@math.montana.edu

More information

1 Introduction to Wavelet Analysis

1 Introduction to Wavelet Analysis Jim Lambers ENERGY 281 Spring Quarter 2007-08 Lecture 9 Notes 1 Introduction to Wavelet Analysis Wavelets were developed in the 80 s and 90 s as an alternative to Fourier analysis of signals. Some of the

More information

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics SPARSE SOLVERS FOR THE POISSON EQUATION Margreet Nool CWI, Multiscale Dynamics November 9, 2015 OUTLINE OF THIS TALK 1 FISHPACK, LAPACK, PARDISO 2 SYSTEM OVERVIEW OF CARTESIUS 3 POISSON EQUATION 4 SOLVERS

More information

An Introduction to Wavelets and some Applications

An Introduction to Wavelets and some Applications An Introduction to Wavelets and some Applications Milan, May 2003 Anestis Antoniadis Laboratoire IMAG-LMC University Joseph Fourier Grenoble, France An Introduction to Wavelets and some Applications p.1/54

More information

Modelling the Microbunching Instability for Bunch Compressor Systems

Modelling the Microbunching Instability for Bunch Compressor Systems Modelling the Microbunching Instability for Bunch Compressor Systems Gabriele Bassi Page Modelling the Microbunching Instability for Bunch Compressor Systems Gabriele Bassi Department of Physics, University

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 24: Preconditioning and Multigrid Solver Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 5 Preconditioning Motivation:

More information

External injection of electron bunches into plasma wakefields

External injection of electron bunches into plasma wakefields External injection of electron bunches into plasma wakefields Studies on emittance growth and bunch compression p x x Timon Mehrling, Julia Grebenyuk and Jens Osterhoff FLA, Plasma Acceleration Group (http://plasma.desy.de)

More information

Machine Learning: Basis and Wavelet 김화평 (CSE ) Medical Image computing lab 서진근교수연구실 Haar DWT in 2 levels

Machine Learning: Basis and Wavelet 김화평 (CSE ) Medical Image computing lab 서진근교수연구실 Haar DWT in 2 levels Machine Learning: Basis and Wavelet 32 157 146 204 + + + + + - + - 김화평 (CSE ) Medical Image computing lab 서진근교수연구실 7 22 38 191 17 83 188 211 71 167 194 207 135 46 40-17 18 42 20 44 31 7 13-32 + + - - +

More information

Course and Wavelets and Filter Banks

Course and Wavelets and Filter Banks Course 18.327 and 1.130 Wavelets and Filter Bans Numerical solution of PDEs: Galerin approximation; wavelet integrals (projection coefficients, moments and connection coefficients); convergence Numerical

More information

Multiscale Modelling, taking into account Collisions

Multiscale Modelling, taking into account Collisions Multiscale Modelling, taking into account Collisions Andreas Adelmann (Paul Scherrer Institut) October 28, 2017 Multiscale Modelling, taking into account Collisions October 28, 2017 Page 1 / 22 1 Motivation

More information

Computational Astrophysics 1 Particle Mesh methods

Computational Astrophysics 1 Particle Mesh methods Computational Astrophysics 1 Particle Mesh methods Oscar Agertz Outline - The Vlassov-Poisson equation - The Particle-Mesh method in a nut shell - Symplectic Integrators - Mass assignment and force interpolation

More information

Digital Image Processing

Digital Image Processing Digital Image Processing Wavelets and Multiresolution Processing (Wavelet Transforms) Christophoros Nikou cnikou@cs.uoi.gr University of Ioannina - Department of Computer Science 2 Contents Image pyramids

More information

Modeling of Space Charge Effects and Coherent Synchrotron Radiation in Bunch Compression Systems. Martin Dohlus DESY, Hamburg

Modeling of Space Charge Effects and Coherent Synchrotron Radiation in Bunch Compression Systems. Martin Dohlus DESY, Hamburg Modeling of Space Charge Effects and Coherent Synchrotron Radiation in Bunch Compression Systems Martin Dohlus DESY, Hamburg SC and CSR effects are crucial for design & simulation of BC systems CSR and

More information

ORBIT Code Review and Future Directions. S. Cousineau, A. Shishlo, J. Holmes ECloud07

ORBIT Code Review and Future Directions. S. Cousineau, A. Shishlo, J. Holmes ECloud07 ORBIT Code Review and Future Directions S. Cousineau, A. Shishlo, J. Holmes ECloud07 ORBIT Code ORBIT (Objective Ring Beam Injection and Transport code) ORBIT is an object-oriented, open-source code started

More information

Stabilization and Acceleration of Algebraic Multigrid Method

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

More information

Chapter 5. Methods for Solving Elliptic Equations

Chapter 5. Methods for Solving Elliptic Equations Chapter 5. Methods for Solving Elliptic Equations References: Tannehill et al Section 4.3. Fulton et al (1986 MWR). Recommended reading: Chapter 7, Numerical Methods for Engineering Application. J. H.

More information

Digital Image Processing

Digital Image Processing Digital Image Processing, 2nd ed. Digital Image Processing Chapter 7 Wavelets and Multiresolution Processing Dr. Kai Shuang Department of Electronic Engineering China University of Petroleum shuangkai@cup.edu.cn

More information

Linac optimisation for the New Light Source

Linac optimisation for the New Light Source Linac optimisation for the New Light Source NLS source requirements Electron beam requirements for seeded cascade harmonic generation LINAC optimisation (2BC vs 3 BC) CSR issues energy chirp issues jitter

More information

Introduction. Thermoionic gun vs RF photo gun Magnetic compression vs Velocity bunching. Probe beam design options

Introduction. Thermoionic gun vs RF photo gun Magnetic compression vs Velocity bunching. Probe beam design options Introduction Following the 19/05/04 meeting at CERN about the "CTF3 accelerated programme", a possible french contribution has been envisaged to the 200 MeV Probe Beam Linac Two machine options were suggested,

More information

Lecture 18 Classical Iterative Methods

Lecture 18 Classical Iterative Methods Lecture 18 Classical Iterative Methods MIT 18.335J / 6.337J Introduction to Numerical Methods Per-Olof Persson November 14, 2006 1 Iterative Methods for Linear Systems Direct methods for solving Ax = b,

More information

SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS. Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA

SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS. Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA 1 SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA 2 OUTLINE Sparse matrix storage format Basic factorization

More information

A Vlasov-Maxwell Solver to Study Microbunching Instability in the First Bunch Compressor System

A Vlasov-Maxwell Solver to Study Microbunching Instability in the First Bunch Compressor System Microbunching in the FERMI@ELETTRA First Bunch Compressor System / Gabriele Bassi Page 1 A Vlasov-Maxwell Solver to Study Microbunching Instability in the FERMI@ELETTRA First Bunch Compressor System Gabriele

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

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9 Spring 2015 Lecture 9 REVIEW Lecture 8: Direct Methods for solving (linear) algebraic equations Gauss Elimination LU decomposition/factorization Error Analysis for Linear Systems and Condition Numbers

More information

DESY/TEMF Meeting - Status 2011

DESY/TEMF Meeting - Status 2011 Erion Gjonaj Technische Universität Darmstadt, Computational Electromagetics Laboratory (TEMF) Schlossgartenstr. 8 64289 Darmstadt, Germany DESY/TEMF Meeting - Status 211 DESY, Hamburg, 16.12.211 Contents

More information

Representation of inhomogeneous, non-separable covariances by sparse wavelet-transformed matrices

Representation of inhomogeneous, non-separable covariances by sparse wavelet-transformed matrices Representation of inhomogeneous, non-separable covariances by sparse wavelet-transformed matrices Andreas Rhodin, Harald Anlauf German Weather Service (DWD) Workshop on Flow-dependent aspects of data assimilation,

More information

A Comparison of Solving the Poisson Equation Using Several Numerical Methods in Matlab and Octave on the Cluster maya

A Comparison of Solving the Poisson Equation Using Several Numerical Methods in Matlab and Octave on the Cluster maya A Comparison of Solving the Poisson Equation Using Several Numerical Methods in Matlab and Octave on the Cluster maya Sarah Swatski, Samuel Khuvis, and Matthias K. Gobbert (gobbert@umbc.edu) Department

More information

LCLS-II SCRF start-to-end simulations and global optimization as of September Abstract

LCLS-II SCRF start-to-end simulations and global optimization as of September Abstract SLAC National Accelerator Lab LCLS-II TN-17-4 February 217 LCLS-II SCRF start-to-end simulations and global optimization as of September 216 G. Marcus SLAC, Menlo Park, CA 9425 J. Qiang LBNL, Berkeley,

More information

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Introduction to Simulation - Lecture 2 Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Outline Reminder about

More information

Practical in Numerical Astronomy, SS 2012 LECTURE 9

Practical in Numerical Astronomy, SS 2012 LECTURE 9 Practical in Numerical Astronomy, SS 01 Elliptic partial differential equations. Poisson solvers. LECTURE 9 1. Gravity force and the equations of hydrodynamics. Poisson equation versus Poisson integral.

More information

Wavelets and Signal Processing

Wavelets and Signal Processing Wavelets and Signal Processing John E. Gilbert Mathematics in Science Lecture April 30, 2002. Publicity Mathematics In Science* A LECTURE SERIES FOR UNDERGRADUATES Wavelets Professor John Gilbert Mathematics

More information

Moments conservation in adaptive Vlasov solver

Moments conservation in adaptive Vlasov solver 12 Moments conservation in adaptive Vlasov solver M. Gutnic a,c, M. Haefele b,c and E. Sonnendrücker a,c a IRMA, Université Louis Pasteur, Strasbourg, France. b LSIIT, Université Louis Pasteur, Strasbourg,

More information

Wavelets Marialuce Graziadei

Wavelets Marialuce Graziadei Wavelets Marialuce Graziadei 1. A brief summary 2. Vanishing moments 3. 2D-wavelets 4. Compression 5. De-noising 1 1. A brief summary φ(t): scaling function. For φ the 2-scale relation hold φ(t) = p k

More information

Lecture 7 Multiresolution Analysis

Lecture 7 Multiresolution Analysis David Walnut Department of Mathematical Sciences George Mason University Fairfax, VA USA Chapman Lectures, Chapman University, Orange, CA Outline Definition of MRA in one dimension Finding the wavelet

More information

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Classical Iterations We have a problem, We assume that the matrix comes from a discretization of a PDE. The best and most popular model problem is, The matrix will be as large

More information

Wavelet Transform. Figure 1: Non stationary signal f(t) = sin(100 t 2 ).

Wavelet Transform. Figure 1: Non stationary signal f(t) = sin(100 t 2 ). Wavelet Transform Andreas Wichert Department of Informatics INESC-ID / IST - University of Lisboa Portugal andreas.wichert@tecnico.ulisboa.pt September 3, 0 Short Term Fourier Transform Signals whose frequency

More information

Hierarchical Parallel Solution of Stochastic Systems

Hierarchical Parallel Solution of Stochastic Systems Hierarchical Parallel Solution of Stochastic Systems Second M.I.T. Conference on Computational Fluid and Solid Mechanics Contents: Simple Model of Stochastic Flow Stochastic Galerkin Scheme Resulting Equations

More information

Conjugate Gradient Method

Conjugate Gradient Method Conjugate Gradient Method direct and indirect methods positive definite linear systems Krylov sequence spectral analysis of Krylov sequence preconditioning Prof. S. Boyd, EE364b, Stanford University Three

More information

1 The Continuous Wavelet Transform The continuous wavelet transform (CWT) Discretisation of the CWT... 2

1 The Continuous Wavelet Transform The continuous wavelet transform (CWT) Discretisation of the CWT... 2 Contents 1 The Continuous Wavelet Transform 1 1.1 The continuous wavelet transform (CWT)............. 1 1. Discretisation of the CWT...................... Stationary wavelet transform or redundant wavelet

More information

Math 671: Tensor Train decomposition methods II

Math 671: Tensor Train decomposition methods II Math 671: Tensor Train decomposition methods II Eduardo Corona 1 1 University of Michigan at Ann Arbor December 13, 2016 Table of Contents 1 What we ve talked about so far: 2 The Tensor Train decomposition

More information

FFTs in Graphics and Vision. The Laplace Operator

FFTs in Graphics and Vision. The Laplace Operator FFTs in Graphics and Vision The Laplace Operator 1 Outline Math Stuff Symmetric/Hermitian Matrices Lagrange Multipliers Diagonalizing Symmetric Matrices The Laplacian Operator 2 Linear Operators Definition:

More information

Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota

Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota SIAM CSE Boston - March 1, 2013 First: Joint work with Ruipeng Li Work

More information

Spectral Processing. Misha Kazhdan

Spectral Processing. Misha Kazhdan Spectral Processing Misha Kazhdan [Taubin, 1995] A Signal Processing Approach to Fair Surface Design [Desbrun, et al., 1999] Implicit Fairing of Arbitrary Meshes [Vallet and Levy, 2008] Spectral Geometry

More information

CSR calculation by paraxial approximation

CSR calculation by paraxial approximation CSR calculation by paraxial approximation Tomonori Agoh (KEK) Seminar at Stanford Linear Accelerator Center, March 3, 2006 Short Bunch Introduction Colliders for high luminosity ERL for short duration

More information

Dictionary Learning for photo-z estimation

Dictionary Learning for photo-z estimation Dictionary Learning for photo-z estimation Joana Frontera-Pons, Florent Sureau, Jérôme Bobin 5th September 2017 - Workshop Dictionary Learning on Manifolds MOTIVATION! Goal : Measure the radial positions

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

Beam-Beam Simulations for e + e Colliders

Beam-Beam Simulations for e + e Colliders Beam-Beam Simulations for e + e Colliders J. Rogers, Cornell University Motivation for simulations from observed effects Methods algorithms, simulation codes, and some results. Conclusions Brown Bag Seminar,

More information

Multiresolution schemes

Multiresolution schemes Multiresolution schemes Fondamenti di elaborazione del segnale multi-dimensionale Multi-dimensional signal processing Stefano Ferrari Università degli Studi di Milano stefano.ferrari@unimi.it Elaborazione

More information

INTRODUCTION TO. Adapted from CS474/674 Prof. George Bebis Department of Computer Science & Engineering University of Nevada (UNR)

INTRODUCTION TO. Adapted from CS474/674 Prof. George Bebis Department of Computer Science & Engineering University of Nevada (UNR) INTRODUCTION TO WAVELETS Adapted from CS474/674 Prof. George Bebis Department of Computer Science & Engineering University of Nevada (UNR) CRITICISM OF FOURIER SPECTRUM It gives us the spectrum of the

More information

Toward a Realization of Marr s Theory of Primal Sketches via Autocorrelation Wavelets: Image Representation using Multiscale Edge Information

Toward a Realization of Marr s Theory of Primal Sketches via Autocorrelation Wavelets: Image Representation using Multiscale Edge Information Toward a Realization of Marr s Theory of Primal Sketches via Autocorrelation Wavelets: Image Representation using Multiscale Edge Information Naoki Saito 1 Department of Mathematics University of California,

More information

Speeding up simulations of relativistic systems using an optimal boosted frame

Speeding up simulations of relativistic systems using an optimal boosted frame Speeding up simulations of relativistic systems using an optimal boosted frame J.-L. Vay1,3, W.M. Fawley1, C. G. R. Geddes1, E. Cormier-Michel1, D. P. Grote2,3 1Lawrence Berkeley National Laboratory, CA

More information

Multiresolution schemes

Multiresolution schemes Multiresolution schemes Fondamenti di elaborazione del segnale multi-dimensionale Stefano Ferrari Università degli Studi di Milano stefano.ferrari@unimi.it Elaborazione dei Segnali Multi-dimensionali e

More information

RESEARCH ARTICLE. A strategy of finding an initial active set for inequality constrained quadratic programming problems

RESEARCH ARTICLE. A strategy of finding an initial active set for inequality constrained quadratic programming problems Optimization Methods and Software Vol. 00, No. 00, July 200, 8 RESEARCH ARTICLE A strategy of finding an initial active set for inequality constrained quadratic programming problems Jungho Lee Computer

More information

modeling of space charge effects and CSR in bunch compression systems

modeling of space charge effects and CSR in bunch compression systems modeling of space charge effects and CSR in bunch compression systems SC and CSR effects are crucial for the simulation of BC systems CSR and related effects are challenging for EM field calculation non-csr

More information

A Bunch Compressor for the CLIC Main Beam

A Bunch Compressor for the CLIC Main Beam A Bunch Compressor for the CLIC Main Beam F.Stulle, A. Adelmann, M. Pedrozzi March 14, 2007 Abstract The last bunch compressor chicane in front of the main linac of the multi TeV linear collider CLIC is

More information

Solving Large Nonlinear Sparse Systems

Solving Large Nonlinear Sparse Systems Solving Large Nonlinear Sparse Systems Fred W. Wubs and Jonas Thies Computational Mechanics & Numerical Mathematics University of Groningen, the Netherlands f.w.wubs@rug.nl Centre for Interdisciplinary

More information

Solution to Laplace Equation using Preconditioned Conjugate Gradient Method with Compressed Row Storage using MPI

Solution to Laplace Equation using Preconditioned Conjugate Gradient Method with Compressed Row Storage using MPI Solution to Laplace Equation using Preconditioned Conjugate Gradient Method with Compressed Row Storage using MPI Sagar Bhatt Person Number: 50170651 Department of Mechanical and Aerospace Engineering,

More information

Numerical tensor methods and their applications

Numerical tensor methods and their applications Numerical tensor methods and their applications 8 May 2013 All lectures 4 lectures, 2 May, 08:00-10:00: Introduction: ideas, matrix results, history. 7 May, 08:00-10:00: Novel tensor formats (TT, HT, QTT).

More information

Linear Solvers. Andrew Hazel

Linear Solvers. Andrew Hazel Linear Solvers Andrew Hazel Introduction Thus far we have talked about the formulation and discretisation of physical problems...... and stopped when we got to a discrete linear system of equations. Introduction

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences)

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) Lecture 19: Computing the SVD; Sparse Linear Systems Xiangmin Jiao Stony Brook University Xiangmin Jiao Numerical

More information

Numerical Analysis Comprehensive Exam Questions

Numerical Analysis Comprehensive Exam Questions Numerical Analysis Comprehensive Exam Questions 1. Let f(x) = (x α) m g(x) where m is an integer and g(x) C (R), g(α). Write down the Newton s method for finding the root α of f(x), and study the order

More information

Fast Simulation of FEL Linacs with Collective Effects. M. Dohlus FLS 2018

Fast Simulation of FEL Linacs with Collective Effects. M. Dohlus FLS 2018 Fast Simulation of FEL Linacs with Collective Effects M. Dohlus FLS 2018 A typical X-FEL gun environment photo cathode cavity, solenoid, drift straight cavity, quadrupole, drift dispersive bend, quadrupole,

More information

Chapter 7 Iterative Techniques in Matrix Algebra

Chapter 7 Iterative Techniques in Matrix Algebra Chapter 7 Iterative Techniques in Matrix Algebra Per-Olof Persson persson@berkeley.edu Department of Mathematics University of California, Berkeley Math 128B Numerical Analysis Vector Norms Definition

More information

Digital Image Processing Lectures 15 & 16

Digital Image Processing Lectures 15 & 16 Lectures 15 & 16, Professor Department of Electrical and Computer Engineering Colorado State University CWT and Multi-Resolution Signal Analysis Wavelet transform offers multi-resolution by allowing for

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

Medical Image Processing

Medical Image Processing Medical Image Processing Federica Caselli Department of Civil Engineering University of Rome Tor Vergata Medical Imaging X-Ray CT Ultrasound MRI PET/SPECT Digital Imaging! Medical Image Processing What

More information

Motivation: Sparse matrices and numerical PDE's

Motivation: Sparse matrices and numerical PDE's Lecture 20: Numerical Linear Algebra #4 Iterative methods and Eigenproblems Outline 1) Motivation: beyond LU for Ax=b A little PDE's and sparse matrices A) Temperature Equation B) Poisson Equation 2) Splitting

More information

Image restoration: numerical optimisation

Image restoration: numerical optimisation Image restoration: numerical optimisation Short and partial presentation Jean-François Giovannelli Groupe Signal Image Laboratoire de l Intégration du Matériau au Système Univ. Bordeaux CNRS BINP / 6 Context

More information

Physics 342 Lecture 4. Probability Density. Lecture 4. Physics 342 Quantum Mechanics I

Physics 342 Lecture 4. Probability Density. Lecture 4. Physics 342 Quantum Mechanics I Physics 342 Lecture 4 Probability Density Lecture 4 Physics 342 Quantum Mechanics I Monday, February 4th, 28 We review the basic notions of probability, in particular the role of probability density in

More information

Machine Learning Applied to 3-D Reservoir Simulation

Machine Learning Applied to 3-D Reservoir Simulation Machine Learning Applied to 3-D Reservoir Simulation Marco A. Cardoso 1 Introduction The optimization of subsurface flow processes is important for many applications including oil field operations and

More information

COMPLEX WAVELET TRANSFORM IN SIGNAL AND IMAGE ANALYSIS

COMPLEX WAVELET TRANSFORM IN SIGNAL AND IMAGE ANALYSIS COMPLEX WAVELET TRANSFORM IN SIGNAL AND IMAGE ANALYSIS MUSOKO VICTOR, PROCHÁZKA ALEŠ Institute of Chemical Technology, Department of Computing and Control Engineering Technická 905, 66 8 Prague 6, Cech

More information

EXASCALE COMPUTING. Implementation of a 2D Electrostatic Particle in Cell algorithm in UniÞed Parallel C with dynamic load-balancing

EXASCALE COMPUTING. Implementation of a 2D Electrostatic Particle in Cell algorithm in UniÞed Parallel C with dynamic load-balancing ExaScience Lab Intel Labs Europe EXASCALE COMPUTING Implementation of a 2D Electrostatic Particle in Cell algorithm in UniÞed Parallel C with dynamic load-balancing B. Verleye P. Henry R. Wuyts G. Lapenta

More information

These slides follow closely the (English) course textbook Pattern Recognition and Machine Learning by Christopher Bishop

These slides follow closely the (English) course textbook Pattern Recognition and Machine Learning by Christopher Bishop Music and Machine Learning (IFT68 Winter 8) Prof. Douglas Eck, Université de Montréal These slides follow closely the (English) course textbook Pattern Recognition and Machine Learning by Christopher Bishop

More information

High-Brightness Electron Beam Challenges for the Los Alamos MaRIE XFEL

High-Brightness Electron Beam Challenges for the Los Alamos MaRIE XFEL LA-UR-16-6007 High-Brightness Electron Beam Challenges for the Los Alamos MaRIE XFEL Bruce Carlsten October 7, 016 We expect that energy spread constraint will lead to difficult trades DISCUSSION POINTS:

More information

MGA Tutorial, September 08, 2004 Construction of Wavelets. Jan-Olov Strömberg

MGA Tutorial, September 08, 2004 Construction of Wavelets. Jan-Olov Strömberg MGA Tutorial, September 08, 2004 Construction of Wavelets Jan-Olov Strömberg Department of Mathematics Royal Institute of Technology (KTH) Stockholm, Sweden Department of Numerical Analysis and Computer

More information

Wavelets and multiresolution representations. Time meets frequency

Wavelets and multiresolution representations. Time meets frequency Wavelets and multiresolution representations Time meets frequency Time-Frequency resolution Depends on the time-frequency spread of the wavelet atoms Assuming that ψ is centred in t=0 Signal domain + t

More information

Wavelets For Computer Graphics

Wavelets For Computer Graphics {f g} := f(x) g(x) dx A collection of linearly independent functions Ψ j spanning W j are called wavelets. i J(x) := 6 x +2 x + x + x Ψ j (x) := Ψ j (2 j x i) i =,..., 2 j Res. Avge. Detail Coef 4 [9 7

More information

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

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

More information

Multiresolution image processing

Multiresolution image processing Multiresolution image processing Laplacian pyramids Some applications of Laplacian pyramids Discrete Wavelet Transform (DWT) Wavelet theory Wavelet image compression Bernd Girod: EE368 Digital Image Processing

More information

MULTIRATE DIGITAL SIGNAL PROCESSING

MULTIRATE DIGITAL SIGNAL PROCESSING MULTIRATE DIGITAL SIGNAL PROCESSING Signal processing can be enhanced by changing sampling rate: Up-sampling before D/A conversion in order to relax requirements of analog antialiasing filter. Cf. audio

More information