An IDL Based Image Deconvolution Software Package

Size: px
Start display at page:

Download "An IDL Based Image Deconvolution Software Package"

Transcription

1 An IDL Based Image Deconvolution Software Package F. Városi and W. B. Landsman Hughes STX Co., Code 685, NASA/GSFC, Greenbelt, MD Abstract. Using the Interactive Data Language (IDL), we have implemented some of the basic iterative algorithms for deconvolution of blurred images in a unified environment called DeConv Tool. Most algorithms have as their goal the optimization of some goodness of fit statistic, possibly combined with a smoothing criterion. All the statistics for all the implemented algorithms are computed by DeConv Tool for the purpose of determining the performance and convergence of any particular algorithm and comparing the different methods. DeConv Tool allows interactive monitoring of the statistics and the deconvolved image during computation. Results are stored in a structure convenient for making comparisons between methods and reviewing the deconvolution process. The DeConv Tool package can be acquired by anonymous FTP from the IDL Astronomy User s Library (Landsman 1993). 1. Introduction The standard model of image formation involves first knowing or estimating the point spread function (PSF), which is the response of the instrument to a point source of photons (e.g., a star). Effects such as atmospheric seeing and optical abberations are then presumably described by the PSF, and for convenience, assume that the PSF is spatially invariant over the imaging detector. Observed images are the result of convolution of the photon signal I with H, the PSF : D = I H + N, (1) where D is the observed image (the data), and N is the noise added during data aquisition, which we assume to follow either a Gaussian or Poisson distribution. Convolution is defined as (I H)(i, j) = k,l I(k, l)h(i k, j l), (2) where (i, j) are image pixel indices and H is assumed to be centered at (0, 0). Similarly, the correlation operator, used below, is defined as (I H)(i, j) = k,l I(k + i, l + j)h(k, l), (3) where now (i, j) are referred to as the lag indices. The objective of deconvolution is to reconstruct the image I given the data D, the PSF = H, and 1

2 knowledge of the noise N. The eq.(??) is part of what is referred to as the imaging model M. In reality the deconvolution problem has more unknown than known quantities because of noise and instrument limitations. For this reason a unique solution does not exist, so it is more realistic to consider the probabilities of solutions. The statistical formulation of the deconvolution problem involves the use of Bayes theorem to derive (see, e.g., Weir 1991, Piña and Puetter 1992) p(i D, M) = p(d I, M)p(I M) p(d M) (4) where p(i D, M) = probability of the restored image given the data and model, p(d I, M) = probability of the data for a given restored image and model. Assuming the model is fixed, the term p(d M) is independent of I so it is constant, and p(i M) is the prior probability of the image given the model. A solution to the deconvolution problem is obtained by maximizing the probability of the restored image, and this can be accomplished by maximizing p(d I, M), the goodness of fit, leading to maximum likelihood methods. Also, the product p(d I, M)p(I M) could be maximized, with p(i M) = e S and S entropy of I, then leading to maximum entropy methods. Hence the Bayesian formulation leads to a variety of algorithms for deconvolution, each having its own statistic to be optimized in order to reconstruct the image. 2. Algorithms Implemented The deconvolution algorithms implemented in DeConv Tool are: the Maximum Likelihood method for Poisson or Gaussian noise (MLP and MLG resp.), and the Maximum Residual Likelihood (MRL) method for Gaussian noise. An implementation of the Maximum Entropy (MEM) method is in progress, and other algorithms which are iterative in nature can be integrated into DeConv Tool. The convolution and correlation operations are computed via the Fast Fourier Transform (FFT) by default, and this assumes periodic boundary conditions. Convolutions can be performed directly if desired, but in any case the edge regions of observed image should not contain significant data. The Maximum Likelihood algorithms are derived by noting that when p(d I, M) is at a maximum I [ln p(d I, M)] = I j [ln p(d I, M)] = 0. (5) Applying this condition leads to iterative algorithms which converge toward a fixed point of the iteration (see, e.g., Meinel 1986, Shepp and Vardi 1982). For the case of Poisson noise in the imaging model n D (I H) k p(d I, M) = k D k! k=1 exp[ (I H) k ] (6) where the product is over all pixel indices k. Applying the condition (??) and 2

3 manipulating the result gives the following iterative algorithm: [ ( ) ] D I new = I old H, (7) I old H which is the Richardson-Lucy algorithm (Richardson 1972, Lucy 1974). The relevant statistic for the above MLP algorithm is the log-likelihood ln p(d I, M), and note that the restored image is always positive (if D 0). The case of Gaussian noise in the imaging model gives ( n p(d I, M) = exp [D k (I H) k ] 2 ) 2σN 2 (8) k=1 where the product is over all pixel indices k and σn 2 is the constant variance of the noise. Applying the condition (??) results in the iterative algorithm I new = I old + [D (I old H)] H, (9) called MLG, which is similar in concept to MLP, but can result in negative restored image values, and so must be forced positive. Defining the residual image as R = D (I H), (10) the relevant MLG statistic is the ratio of standard deviations, σ R /σ N, which should approach unity ( note that nσr 2 = Variance[ ln p(d I, M) ] ). Gaussian noise is the limit of Poisson noise at high intensities, as in the case of high background imaging. We have found that the MLP algorithm, eq.(??), can also achieve good image restoration results for the case of Gaussian noise. The residual image R should approach the noise N not only in mean and variance but in all properties. If the additive noise is Gaussian white noise, then there should be no correlation between pixels. Recalling the definition of autocorrelation, A N = N N, the white property of the noise gives A N (i, j) = { n σ 2 N if i = j = 0 0 otherwise, where denotes expectation and n equals the total number of pixels in the image. Since there is no spatial information in the white noise there should be no spatial information left in the residual image after deconvolution. This leads to a new figure of merit for the goodness of fit, the Maximum Residual Likelihood (MRL) statistic, which explicitly incorporates spatial information into the deconvolution. The MRL statistic, developed by Piña and Puetter (1992), is defined as ( ) AR A N 2 (11) χ 2 (A R ) = i,j σ(a N ) where the sum is over nonredundant lags (i, j), since A R (i, j) = A R ( i, j). The range of practical lags is determined by the FWHM of the PSF. This MRL 3

4 statistic follows the standard χ 2 distribution with f degrees of freedom, where f is number of terms in the sum of eq.(??). Another likelihood statistic is then defined by setting p(d I, M) = p( χ 2 (A R ) ), which is maximized when χ 2 (A R ) = f 2. Then the autocorrelation of the residuals is consistent with the white noise model and the residuals have minimal spatial structure. However, the assumption of white noise is sometimes unrealistic since detectors can exhibit noise which is slightly correlated. In such a case the correlation usually occurs over adjacent pixels, so the MRL statistic can still be applied by leaving out the single pixel lags from the sum in eq.(??). The goal of maximizing p( χ 2 (A R ) ), or equivalently, minimizing the difference between χ 2 (A R ) and its most probable value f 2, is accomplished by employing the conjugate-gradient method for n-dimensional function minimization. The resulting iterative MRL algorithm is computation intensive, since, at each iteration it requires computing I [χ 2 (A R )]. However, the MRL statistic proves to be a useful measure for the goodness of fit when using other deconvolution algorithms. We find that as iteration of a deconvolution algorithm proceeds, the point at which the MRL statistic reaches a minimum, or when it stops decreasing at a steady rate, indicates a reasonable cutoff point for the deconvolution iterations. 3. Software Features and Options DeConv Tool provides options for the setup of the observed image and PSF, and the user input is via mouse-menu choices and/or direct keyboard entry. A more advanced widget interface for setup and control will be implemented soon. Starting with an image containing the PSF, any subregion of the image can be selected and extracted, and the result is automatically centered and normalized for use in convolutions. Optionally, the observed PSF can be modeled analytically, where model parameters are estimated by fitting x-y profiles. If the PSF is not supplied, an analytic PSF will be used by inquiring the user for model profile parameters. The PSF model is either a Gaussian functional form or a modified Lorentzian form (Diego 1985), defined as H = α = β = C 1 + α P (1+β) (12) ( ) ( ) x x y y0 + r x r y ρ x (x x 0 ) 2 + ρ y (y y 0 ) 2, where (x 0, y 0 ) is the center pixel, (r x, r y ) specifies the radius at half-max of the PSF x-y profiles, and parameters P, ρ x, ρ y control the steepness of the profiles. The standard deviation, σ N, of Gaussian noise in the observed image is determined automatically by examining histograms of the local image variances around each pixel and finding the most probable variance. Background (mean sky) level is then determined by fitting a Gaussian having the determined σ N to the histogram of image data values. The user can adjust the sky level, and specify an alternate value for σ N if desired. Any subregion of the observed 4

5 image can be extracted and/or a larger region can be defined for the subsequent computations, to make, for example, the size a power of two for optimal FFT convolutions. Empty pixels can then be substituted with appropriate Gaussian noise or a constant value. Progress of the deconvolution is monitored automatically at every b m iterations (m = 1, 2, 3,...), where the base b can be specified to give more or less frequent monitoring, and default base b = 2 (setting b = 1 causes every iteration to be monitored). In addition, the user can press a key at any time to get the current status, or press P to pause with options to save results, adjust colors, or create a zoom window. During the monitoring events DeConv Tool displays: the current deconvolution result (I) alongside the data (D), the residual image (R = D I H), and the residual autocorrelation (A R = R R). Also plotted is the histogram of the residual image, with comparison to a Gaussian curve of same variance. For the case of Poisson noise distribution, since the variance equals the mean, the residuals are first divided by I H so that all variances are normalized. Each monitoring event also prints a line of statistics giving: the mean and standard deviation of residuals (Gaussian noise case), the log-likelihood and RMS difference (Poisson noise case), and the ratio of the residual autocorrelation MRL statistic to the most probable value: χ 2 (A R )/χ 2 (A N ). These statistics can be monitored to determine convergence and stopping iterations. Also printed are the total flux conservation ratio I/ D, the current maximum of the restored image, and FWHM of x-y profiles. All deconvolution statistics are stored in IDL structures and are automatically saved every b m iterations (m = 1, 2, 3,...). The observed image, PSF, and deconvolved images can also be saved, if requested. By save we mean using the IDL save procedure which writes to a file, using External Data Representation (XDR), the designated variables with IDL descriptors so that they can later be easily and completely restored into memory. Thus at a later time, the computations can be restored and replayed using the procedure DeConv Review, giving the same output as DeConv Tool, and further, the statistics for all iterations are then concatenated to form a structured array for convenient examination and graphical display. In summary, DeConv Tool is a modular IDL software package which provides a convenient and powerful environment for applying deconvolution algorithms. The modules (procedures and functions) comprising it can also be utilized separately for special image analysis tasks, and of course, any stage of the computations can be manipulated and examined using IDL. References Diego, F. 1985, PASP, 97, 1209 Landsman, W. B. 1993, this volume Lucy, L. B. 1974, AJ, 79, 745 Meinel, E. S. 1986, J. Opt. Soc. Am. A, 3, 787 Piña, R. K. and Puetter, R. C. 1992, PASP, 104, 1096 Richardson, B. H. 1972, J. Opt. Soc. Am., 62, 55 Shepp, L. A. and Vardi, Y. 1982, IEEE Trans. Med. Imag., MI-1, 113 Weir, N. 1991, in Proceedings of the 3rd ESO/ST-ECF Data Analysis Workshop 5

1. Abstract. 2. Introduction/Problem Statement

1. Abstract. 2. Introduction/Problem Statement Advances in polarimetric deconvolution Capt. Kurtis G. Engelson Air Force Institute of Technology, Student Dr. Stephen C. Cain Air Force Institute of Technology, Professor 1. Abstract One of the realities

More information

Numerical Methods in TEM Convolution and Deconvolution

Numerical Methods in TEM Convolution and Deconvolution Numerical Methods in TEM Convolution and Deconvolution Christoph T. Koch Max Planck Institut für Metallforschung http://hrem.mpi-stuttgart.mpg.de/koch/vorlesung Applications of Convolution in TEM Smoothing

More information

IMPROVING THE DECONVOLUTION METHOD FOR ASTEROID IMAGES: OBSERVING 511 DAVIDA, 52 EUROPA, AND 12 VICTORIA

IMPROVING THE DECONVOLUTION METHOD FOR ASTEROID IMAGES: OBSERVING 511 DAVIDA, 52 EUROPA, AND 12 VICTORIA IMPROVING THE DECONVOLUTION METHOD FOR ASTEROID IMAGES: OBSERVING 511 DAVIDA, 52 EUROPA, AND 12 VICTORIA Z Robert Knight Department of Physics and Astronomy University of Hawai`i at Hilo ABSTRACT Deconvolution

More information

Testing the MCS Deconvolution Algorithm on Infrared Data. Michael P. Egan National Geospatial-Intelligence Agency Basic and Applied Research Office

Testing the MCS Deconvolution Algorithm on Infrared Data. Michael P. Egan National Geospatial-Intelligence Agency Basic and Applied Research Office Testing the MCS Deconvolution Algorithm on Infrared Data Michael P. Egan ational Geospatial-Intelligence Agency Basic and Applied Research Office ABSTRACT Magain, Courbin, and Sohy (MCS, 1998) [1] proposed

More information

Iterations

Iterations 50 40 30 20 10 0 10 20 30 40 Iterations 1.2 1 0.8 0.6 0.4 0.2 0 0 5 10 15 20 Iterations -210-220 -230-240 0 0.2 0.4 0.6 0.8 1 Probability 100 0-100 -200-300 0 10 20 30 40 50 Channel 0.3 0.2 0.1 0 0 10

More information

Lab 1 Uniform Motion - Graphing and Analyzing Motion

Lab 1 Uniform Motion - Graphing and Analyzing Motion Lab 1 Uniform Motion - Graphing and Analyzing Motion Objectives: < To observe the distance-time relation for motion at constant velocity. < To make a straight line fit to the distance-time data. < To interpret

More information

Astronomical Imaging with Maximum Entropy. Retrospective and Outlook. Andy Strong MPE

Astronomical Imaging with Maximum Entropy. Retrospective and Outlook. Andy Strong MPE Astronomical Imaging with Maximum Entropy Retrospective and Outlook Andy Strong MPE Interdisciplinary Cluster Workshop on Statistics Garching, 17-18 Feb 2014 Nature, 272, 688 (1978) Imaging with Maximum

More information

OPTICAL PHOTOMETRY. Observational Astronomy (2011) 1

OPTICAL PHOTOMETRY. Observational Astronomy (2011) 1 OPTICAL PHOTOMETRY Observational Astronomy (2011) 1 The optical photons coming from an astronomical object (star, galaxy, quasar, etc) can be registered in the pixels of a frame (or image). Using a ground-based

More information

HOW TO ANALYZE SYNCHROTRON DATA

HOW TO ANALYZE SYNCHROTRON DATA HOW TO ANALYZE SYNCHROTRON DATA 1 SYNCHROTRON APPLICATIONS - WHAT Diffraction data are collected on diffractometer lines at the world s synchrotron sources. Most synchrotrons have one or more user facilities

More information

Noise, Image Reconstruction with Noise!

Noise, Image Reconstruction with Noise! Noise, Image Reconstruction with Noise! EE367/CS448I: Computational Imaging and Display! stanford.edu/class/ee367! Lecture 10! Gordon Wetzstein! Stanford University! What s a Pixel?! photon to electron

More information

Satellite image deconvolution using complex wavelet packets

Satellite image deconvolution using complex wavelet packets Satellite image deconvolution using complex wavelet packets André Jalobeanu, Laure Blanc-Féraud, Josiane Zerubia ARIANA research group INRIA Sophia Antipolis, France CNRS / INRIA / UNSA www.inria.fr/ariana

More information

Response of DIMM turbulence sensor

Response of DIMM turbulence sensor Response of DIMM turbulence sensor A. Tokovinin Version 1. December 20, 2006 [tdimm/doc/dimmsensor.tex] 1 Introduction Differential Image Motion Monitor (DIMM) is an instrument destined to measure optical

More information

Supplementary Figures Supplementary Figure 1: Estimation of the error of the number and brightness of molecules in a single cluster; Simulation

Supplementary Figures Supplementary Figure 1: Estimation of the error of the number and brightness of molecules in a single cluster; Simulation Supplementary Figures Supplementary Figure 1: Estimation of the error of the number and brightness of molecules in a single cluster; Simulation (a,c) Relative estimated numbers of molecules ; (b,d) relative

More information

SPATIALLY-VARIANT LUCYRICHARDSON DECONVOLUTION FOR MULTIVIEW FUSION OF MICROSCOPICAL 3D IMAGES. Maja Temerinac-Ott. University of Freiburg, Germany

SPATIALLY-VARIANT LUCYRICHARDSON DECONVOLUTION FOR MULTIVIEW FUSION OF MICROSCOPICAL 3D IMAGES. Maja Temerinac-Ott. University of Freiburg, Germany SPATIALLY-VARIANT LUCYRICHARDSON DECONVOLUTION FOR MULTIVIEW FUSION OF MICROSCOPICAL 3D IMAGES Maja Temerinac-Ott Olaf Ronneberger, Roland Nitschke, Wolfgang Driever and Hans Burkhardt University of Freiburg,

More information

Application of Image Restoration Technique in Flow Scalar Imaging Experiments Guanghua Wang

Application of Image Restoration Technique in Flow Scalar Imaging Experiments Guanghua Wang Application of Image Restoration Technique in Flow Scalar Imaging Experiments Guanghua Wang Center for Aeromechanics Research Department of Aerospace Engineering and Engineering Mechanics The University

More information

Designing a Space Telescope to Image Earth-like Planets

Designing a Space Telescope to Image Earth-like Planets Designing a Space Telescope to Image Earth-like Planets Robert J. Vanderbei Rutgers University December 4, 2002 Page 1 of 28 Member: Princeton University/Ball Aerospace TPF Team http://www.princeton.edu/

More information

Discrete Simulation of Power Law Noise

Discrete Simulation of Power Law Noise Discrete Simulation of Power Law Noise Neil Ashby 1,2 1 University of Colorado, Boulder, CO 80309-0390 USA 2 National Institute of Standards and Technology, Boulder, CO 80305 USA ashby@boulder.nist.gov

More information

Abel Inversion using the Maximum Entropy Method

Abel Inversion using the Maximum Entropy Method Abel Inversion using the Maximum Entropy Method Danilo R. Neuber Wolfgang von der Linden 3rd October 2003 Inst. für Theoretische Physik, Tel.: +43/3 16/8 73-81 88; neuber@itp.tu-graz.ac.at Inst. für Theoretische

More information

Maximum-Likelihood Deconvolution in the Spatial and Spatial-Energy Domain for Events With Any Number of Interactions

Maximum-Likelihood Deconvolution in the Spatial and Spatial-Energy Domain for Events With Any Number of Interactions IEEE TRANSACTIONS ON NUCLEAR SCIENCE, VOL. 59, NO. 2, APRIL 2012 469 Maximum-Likelihood Deconvolution in the Spatial and Spatial-Energy Domain for Events With Any Number of Interactions Weiyi Wang, Member,

More information

FARADAY ROTATION MEASURE SYNTHESIS OF UGC 10288, NGC 4845, NGC 3044

FARADAY ROTATION MEASURE SYNTHESIS OF UGC 10288, NGC 4845, NGC 3044 FARADAY ROTATION MEASURE SYNTHESIS OF UGC 10288, NGC 4845, NGC 3044 PATRICK KAMIENESKI DYLAN PARÉ KENDALL SULLIVAN PI: DANIEL WANG July 21, 2016 Madison, WI OUTLINE Overview of RM Synthesis: Benefits Basic

More information

Mimir NIR Spectroscopy Data Processing Cookbook V2.0 DPC

Mimir NIR Spectroscopy Data Processing Cookbook V2.0 DPC Mimir NIR Spectroscopy Data Processing Cookbook V2.0 DPC - 20111130 1. Fetch and install the software packages needed a. Get the MSP_WCT, MSP_CCS, MSP_SXC packages from the Mimir/Software web site: http://people.bu.edu/clemens/mimir/software.html

More information

Covariance Matrix Simplification For Efficient Uncertainty Management

Covariance Matrix Simplification For Efficient Uncertainty Management PASEO MaxEnt 2007 Covariance Matrix Simplification For Efficient Uncertainty Management André Jalobeanu, Jorge A. Gutiérrez PASEO Research Group LSIIT (CNRS/ Univ. Strasbourg) - Illkirch, France *part

More information

OPSIAL Manual. v Xiaofeng Tan. All Rights Reserved

OPSIAL Manual. v Xiaofeng Tan. All Rights Reserved OPSIAL Manual v1.0 2016 Xiaofeng Tan. All Rights Reserved 1. Introduction... 3 1.1 Spectral Calculator & Fitter (SCF)... 3 1.2 Automated Analyzer (AA)... 3 2. Working Principles and Workflows of OPSIAL...

More information

Basics of Photometry

Basics of Photometry Basics of Photometry Photometry: Basic Questions How do you identify objects in your image? How do you measure the flux from an object? What are the potential challenges? Does it matter what type of object

More information

An Overview of the Maximum Entropy Method of Image Deconvolution

An Overview of the Maximum Entropy Method of Image Deconvolution An Overview of the Maximum Entropy Method of Image Deconvolution Michael Gary Grotenhuis A University of Minnesota Twin Cities Plan B Master s paper Introduction Long before entering the consumer home,

More information

Extraction of Point Source Spectra from STIS Long Slit Data

Extraction of Point Source Spectra from STIS Long Slit Data 1997 HST Calibration Workshop Space Telescope Science Institute, 1997 S. Casertano, et al., eds. Extraction of Point Source Spectra from STIS Long Slit Data J. R. Walsh Spect Telescope European Coordinating

More information

SYMBOLIC AND NUMERICAL COMPUTING FOR CHEMICAL KINETIC REACTION SCHEMES

SYMBOLIC AND NUMERICAL COMPUTING FOR CHEMICAL KINETIC REACTION SCHEMES SYMBOLIC AND NUMERICAL COMPUTING FOR CHEMICAL KINETIC REACTION SCHEMES by Mark H. Holmes Yuklun Au J. W. Stayman Department of Mathematical Sciences Rensselaer Polytechnic Institute, Troy, NY, 12180 Abstract

More information

A Limited Memory, Quasi-Newton Preconditioner. for Nonnegatively Constrained Image. Reconstruction

A Limited Memory, Quasi-Newton Preconditioner. for Nonnegatively Constrained Image. Reconstruction A Limited Memory, Quasi-Newton Preconditioner for Nonnegatively Constrained Image Reconstruction Johnathan M. Bardsley Department of Mathematical Sciences, The University of Montana, Missoula, MT 59812-864

More information

StarFinder: code description and operation

StarFinder: code description and operation StarFinder: code description and operation 1 Purpose StarFinder is an IDL program for stellar fields analysis. It is able to detect stars and determine their position and relative flux. It has been designed

More information

EE 367 / CS 448I Computational Imaging and Display Notes: Image Deconvolution (lecture 6)

EE 367 / CS 448I Computational Imaging and Display Notes: Image Deconvolution (lecture 6) EE 367 / CS 448I Computational Imaging and Display Notes: Image Deconvolution (lecture 6) Gordon Wetzstein gordon.wetzstein@stanford.edu This document serves as a supplement to the material discussed in

More information

Updated flux calibration and fringe modelling for the ACS/WFC G800L grism

Updated flux calibration and fringe modelling for the ACS/WFC G800L grism Updated flux calibration and fringe modelling for the ACS/WFC G800L grism H. Kuntschner, M. Kümmel, J. R. Walsh January 25, 2008 ABSTRACT A revised flux calibration is presented for the G800L grism with

More information

Application of deconvolution to images from the EGRET gamma-ray telescope

Application of deconvolution to images from the EGRET gamma-ray telescope Application of deconvolution to images from the EGRET gamma-ray telescope Symeon Charalabides, Andy Shearer, Ray Butler (National University of Ireland, Galway, Ireland) ABSTRACT The EGRET gamma-ray telescope

More information

8 The SVD Applied to Signal and Image Deblurring

8 The SVD Applied to Signal and Image Deblurring 8 The SVD Applied to Signal and Image Deblurring We will discuss the restoration of one-dimensional signals and two-dimensional gray-scale images that have been contaminated by blur and noise. After an

More information

Mixture Models and EM

Mixture Models and EM Mixture Models and EM Goal: Introduction to probabilistic mixture models and the expectationmaximization (EM) algorithm. Motivation: simultaneous fitting of multiple model instances unsupervised clustering

More information

SPATIAL-TEMPORAL TECHNIQUES FOR PREDICTION AND COMPRESSION OF SOIL FERTILITY DATA

SPATIAL-TEMPORAL TECHNIQUES FOR PREDICTION AND COMPRESSION OF SOIL FERTILITY DATA SPATIAL-TEMPORAL TECHNIQUES FOR PREDICTION AND COMPRESSION OF SOIL FERTILITY DATA D. Pokrajac Center for Information Science and Technology Temple University Philadelphia, Pennsylvania A. Lazarevic Computer

More information

AS750 Observational Astronomy

AS750 Observational Astronomy Lecture 9 0) Poisson! (quantum limitation) 1) Diffraction limit 2) Detection (aperture) limit a)simple case b)more realistic case 3) Atmosphere 2) Aperture limit (More realistic case) Aperture has m pixels

More information

Inverse problem and optimization

Inverse problem and optimization Inverse problem and optimization Laurent Condat, Nelly Pustelnik CNRS, Gipsa-lab CNRS, Laboratoire de Physique de l ENS de Lyon Decembre, 15th 2016 Inverse problem and optimization 2/36 Plan 1. Examples

More information

Mnova Software for Analyzing Reaction Monitoring NMR Spectra

Mnova Software for Analyzing Reaction Monitoring NMR Spectra Mnova Software for Analyzing Reaction Monitoring NMR Spectra Version 10 Chen Peng, PhD, VP of Business Development, US & China Mestrelab Research SL San Diego, CA, USA chen.peng@mestrelab.com 858.736.4563

More information

AN NONNEGATIVELY CONSTRAINED ITERATIVE METHOD FOR POSITRON EMISSION TOMOGRAPHY. Johnathan M. Bardsley

AN NONNEGATIVELY CONSTRAINED ITERATIVE METHOD FOR POSITRON EMISSION TOMOGRAPHY. Johnathan M. Bardsley Volume X, No. 0X, 0X, X XX Web site: http://www.aimsciences.org AN NONNEGATIVELY CONSTRAINED ITERATIVE METHOD FOR POSITRON EMISSION TOMOGRAPHY Johnathan M. Bardsley Department of Mathematical Sciences

More information

Vector Autoregression

Vector Autoregression Vector Autoregression Jamie Monogan University of Georgia February 27, 2018 Jamie Monogan (UGA) Vector Autoregression February 27, 2018 1 / 17 Objectives By the end of these meetings, participants should

More information

6 The SVD Applied to Signal and Image Deblurring

6 The SVD Applied to Signal and Image Deblurring 6 The SVD Applied to Signal and Image Deblurring We will discuss the restoration of one-dimensional signals and two-dimensional gray-scale images that have been contaminated by blur and noise. After an

More information

Time-Delay Estimation *

Time-Delay Estimation * OpenStax-CNX module: m1143 1 Time-Delay stimation * Don Johnson This work is produced by OpenStax-CNX and licensed under the Creative Commons Attribution License 1. An important signal parameter estimation

More information

Photometric Techniques II Data analysis, errors, completeness

Photometric Techniques II Data analysis, errors, completeness Photometric Techniques II Data analysis, errors, completeness Sergio Ortolani Dipartimento di Astronomia Universita di Padova, Italy. The fitting technique assumes the linearity of the intensity values

More information

Image Characteristics

Image Characteristics 1 Image Characteristics Image Mean I I av = i i j I( i, j 1 j) I I NEW (x,y)=i(x,y)-b x x Changing the image mean Image Contrast The contrast definition of the entire image is ambiguous In general it is

More information

Computer Vision & Digital Image Processing

Computer Vision & Digital Image Processing Computer Vision & Digital Image Processing Image Restoration and Reconstruction I Dr. D. J. Jackson Lecture 11-1 Image restoration Restoration is an objective process that attempts to recover an image

More information

Automatic Forecasting

Automatic Forecasting Automatic Forecasting Summary The Automatic Forecasting procedure is designed to forecast future values of time series data. A time series consists of a set of sequential numeric data taken at equally

More information

Detection of Artificial Satellites in Images Acquired in Track Rate Mode.

Detection of Artificial Satellites in Images Acquired in Track Rate Mode. Detection of Artificial Satellites in Images Acquired in Track Rate Mode. Martin P. Lévesque Defence R&D Canada- Valcartier, 2459 Boul. Pie-XI North, Québec, QC, G3J 1X5 Canada, martin.levesque@drdc-rddc.gc.ca

More information

8 The SVD Applied to Signal and Image Deblurring

8 The SVD Applied to Signal and Image Deblurring 8 The SVD Applied to Signal and Image Deblurring We will discuss the restoration of one-dimensional signals and two-dimensional gray-scale images that have been contaminated by blur and noise. After an

More information

On the FPA infrared camera transfer function calculation

On the FPA infrared camera transfer function calculation On the FPA infrared camera transfer function calculation (1) CERTES, Université Paris XII Val de Marne, Créteil, France (2) LTM, Université de Bourgogne, Le Creusot, France by S. Datcu 1, L. Ibos 1,Y.

More information

Image Filtering. Slides, adapted from. Steve Seitz and Rick Szeliski, U.Washington

Image Filtering. Slides, adapted from. Steve Seitz and Rick Szeliski, U.Washington Image Filtering Slides, adapted from Steve Seitz and Rick Szeliski, U.Washington The power of blur All is Vanity by Charles Allen Gillbert (1873-1929) Harmon LD & JuleszB (1973) The recognition of faces.

More information

Chapter 11. Output Analysis for a Single Model Prof. Dr. Mesut Güneş Ch. 11 Output Analysis for a Single Model

Chapter 11. Output Analysis for a Single Model Prof. Dr. Mesut Güneş Ch. 11 Output Analysis for a Single Model Chapter Output Analysis for a Single Model. Contents Types of Simulation Stochastic Nature of Output Data Measures of Performance Output Analysis for Terminating Simulations Output Analysis for Steady-state

More information

A quantative comparison of two restoration methods as applied to confocal microscopy

A quantative comparison of two restoration methods as applied to confocal microscopy A quantative comparison of two restoration methods as applied to confocal microscopy Geert M.P. van Kempen 1, Hans T.M. van der Voort, Lucas J. van Vliet 1 1 Pattern Recognition Group, Delft University

More information

A NEW METHOD FOR ADAPTIVE OPTICS POINT SPREAD FUNCTION RECONSTRUCTION

A NEW METHOD FOR ADAPTIVE OPTICS POINT SPREAD FUNCTION RECONSTRUCTION Florence, Italy. May 2013 ISBN: 978-88-908876-0-4 DOI: 10.12839/AO4ELT3.13328 A NEW METHOD FOR ADAPTIVE OPTICS POINT SPREAD FUNCTION RECONSTRUCTION J. Exposito 1a, D. Gratadour 1, G. Rousset 1, Y. Clénet

More information

Variational Methods in Bayesian Deconvolution

Variational Methods in Bayesian Deconvolution PHYSTAT, SLAC, Stanford, California, September 8-, Variational Methods in Bayesian Deconvolution K. Zarb Adami Cavendish Laboratory, University of Cambridge, UK This paper gives an introduction to the

More information

Machine Learning. A Bayesian and Optimization Perspective. Academic Press, Sergios Theodoridis 1. of Athens, Athens, Greece.

Machine Learning. A Bayesian and Optimization Perspective. Academic Press, Sergios Theodoridis 1. of Athens, Athens, Greece. Machine Learning A Bayesian and Optimization Perspective Academic Press, 2015 Sergios Theodoridis 1 1 Dept. of Informatics and Telecommunications, National and Kapodistrian University of Athens, Athens,

More information

1 Statistics Aneta Siemiginowska a chapter for X-ray Astronomy Handbook October 2008

1 Statistics Aneta Siemiginowska a chapter for X-ray Astronomy Handbook October 2008 1 Statistics Aneta Siemiginowska a chapter for X-ray Astronomy Handbook October 2008 1.1 Introduction Why do we need statistic? Wall and Jenkins (2003) give a good description of the scientific analysis

More information

PySaxs A Python module and GUI for SAXS data treatment

PySaxs A Python module and GUI for SAXS data treatment DIRECTION DES SCIENCES DE LA MATIERE IRAMIS Laboratoire Interdisciplinaire sur l Organisation Nanométrique et Supramoléculaire PySaxs A Python module and GUI for SAXS data treatment Olivier Taché Collaborative

More information

Designing Information Devices and Systems I Spring 2018 Lecture Notes Note Introduction to Linear Algebra the EECS Way

Designing Information Devices and Systems I Spring 2018 Lecture Notes Note Introduction to Linear Algebra the EECS Way EECS 16A Designing Information Devices and Systems I Spring 018 Lecture Notes Note 1 1.1 Introduction to Linear Algebra the EECS Way In this note, we will teach the basics of linear algebra and relate

More information

Reading Group on Deep Learning Session 1

Reading Group on Deep Learning Session 1 Reading Group on Deep Learning Session 1 Stephane Lathuiliere & Pablo Mesejo 2 June 2016 1/31 Contents Introduction to Artificial Neural Networks to understand, and to be able to efficiently use, the popular

More information

Detection of point sources

Detection of point sources A&A manuscript no. (will be inserted by hand later) Your thesaurus codes are: 23(03.13.2; 03.13.5; 03.20.1; 08.09.1) ASTRONOMY AND ASTROPHYSICS 15.1.1998 Detection of point sources R. C. Snel, P. Linde

More information

Basics on 2-D 2 D Random Signal

Basics on 2-D 2 D Random Signal Basics on -D D Random Signal Spring 06 Instructor: K. J. Ray Liu ECE Department, Univ. of Maryland, College Park Overview Last Time: Fourier Analysis for -D signals Image enhancement via spatial filtering

More information

Principles of Interferometry. Hans-Rainer Klöckner IMPRS Black Board Lectures 2014

Principles of Interferometry. Hans-Rainer Klöckner IMPRS Black Board Lectures 2014 Principles of Interferometry Hans-Rainer Klöckner IMPRS Black Board Lectures 2014 acknowledgement Mike Garrett lectures James Di Francesco crash course lectures NAASC Lecture 5 calibration image reconstruction

More information

Computer Science, Informatik 4 Communication and Distributed Systems. Simulation. Discrete-Event System Simulation. Dr.

Computer Science, Informatik 4 Communication and Distributed Systems. Simulation. Discrete-Event System Simulation. Dr. Simulation Discrete-Event System Simulation Chapter 0 Output Analysis for a Single Model Purpose Objective: Estimate system performance via simulation If θ is the system performance, the precision of the

More information

FRAM V5.2. Plutonium and Uranium Isotopic Analysis Software

FRAM V5.2. Plutonium and Uranium Isotopic Analysis Software V5.2 Plutonium and Uranium Isotopic Analysis Software Advanced Isotopic Ratio Analysis Software for HPGe Gamma-Ray Spectra Analyzes Pu, and a wide variety of heterogeneous samples containing Pu, Am, U,

More information

1 General Considerations: Point Source Sensitivity, Surface Brightness Sensitivity, and Photometry

1 General Considerations: Point Source Sensitivity, Surface Brightness Sensitivity, and Photometry MUSTANG Sensitivities and MUSTANG-1.5 and - Sensitivity Projections Brian S. Mason (NRAO) - 6sep1 This technical note explains the current MUSTANG sensitivity and how it is calculated. The MUSTANG-1.5

More information

Encoding or decoding

Encoding or decoding Encoding or decoding Decoding How well can we learn what the stimulus is by looking at the neural responses? We will discuss two approaches: devise and evaluate explicit algorithms for extracting a stimulus

More information

Practical Statistics

Practical Statistics Practical Statistics Lecture 1 (Nov. 9): - Correlation - Hypothesis Testing Lecture 2 (Nov. 16): - Error Estimation - Bayesian Analysis - Rejecting Outliers Lecture 3 (Nov. 18) - Monte Carlo Modeling -

More information

SAMSI Astrostatistics Tutorial. More Markov chain Monte Carlo & Demo of Mathematica software

SAMSI Astrostatistics Tutorial. More Markov chain Monte Carlo & Demo of Mathematica software SAMSI Astrostatistics Tutorial More Markov chain Monte Carlo & Demo of Mathematica software Phil Gregory University of British Columbia 26 Bayesian Logical Data Analysis for the Physical Sciences Contents:

More information

Curve Fitting Re-visited, Bishop1.2.5

Curve Fitting Re-visited, Bishop1.2.5 Curve Fitting Re-visited, Bishop1.2.5 Maximum Likelihood Bishop 1.2.5 Model Likelihood differentiation p(t x, w, β) = Maximum Likelihood N N ( t n y(x n, w), β 1). (1.61) n=1 As we did in the case of the

More information

Lecture 9: Speckle Interferometry. Full-Aperture Interferometry. Labeyrie Technique. Knox-Thompson Technique. Bispectrum Technique

Lecture 9: Speckle Interferometry. Full-Aperture Interferometry. Labeyrie Technique. Knox-Thompson Technique. Bispectrum Technique Lecture 9: Speckle Interferometry Outline 1 Full-Aperture Interferometry 2 Labeyrie Technique 3 Knox-Thompson Technique 4 Bispectrum Technique 5 Differential Speckle Imaging 6 Phase-Diverse Speckle Imaging

More information

Generalized Laplacian as Focus Measure

Generalized Laplacian as Focus Measure Generalized Laplacian as Focus Measure Muhammad Riaz 1, Seungjin Park, Muhammad Bilal Ahmad 1, Waqas Rasheed 1, and Jongan Park 1 1 School of Information & Communications Engineering, Chosun University,

More information

REAL-TIME TIME-FREQUENCY BASED BLIND SOURCE SEPARATION. Scott Rickard, Radu Balan, Justinian Rosca. Siemens Corporate Research Princeton, NJ 08540

REAL-TIME TIME-FREQUENCY BASED BLIND SOURCE SEPARATION. Scott Rickard, Radu Balan, Justinian Rosca. Siemens Corporate Research Princeton, NJ 08540 REAL-TIME TIME-FREQUENCY BASED BLIND SOURCE SEPARATION Scott Rickard, Radu Balan, Justinian Rosca Siemens Corporate Research Princeton, NJ 84 fscott.rickard,radu.balan,justinian.roscag@scr.siemens.com

More information

Pysynphot: A Python Re Implementation of a Legacy App in Astronomy

Pysynphot: A Python Re Implementation of a Legacy App in Astronomy Pysynphot: A Python Re Implementation of a Legacy App in Astronomy Vicki Laidler 1, Perry Greenfield, Ivo Busko, Robert Jedrzejewski Science Software Branch Space Telescope Science Institute Baltimore,

More information

Designing Information Devices and Systems I Fall 2018 Lecture Notes Note Introduction to Linear Algebra the EECS Way

Designing Information Devices and Systems I Fall 2018 Lecture Notes Note Introduction to Linear Algebra the EECS Way EECS 16A Designing Information Devices and Systems I Fall 018 Lecture Notes Note 1 1.1 Introduction to Linear Algebra the EECS Way In this note, we will teach the basics of linear algebra and relate it

More information

National Technical University of Athens (NTUA) Department of Civil Engineering Institute of Structural Analysis and Aseismic Research

National Technical University of Athens (NTUA) Department of Civil Engineering Institute of Structural Analysis and Aseismic Research National Technical University of Athens (NTUA) Department of Civil Engineering Institute of Structural Analysis and Aseismic Research mybwid version 1.0 March 2008 Contents CONTENTS...2 1. INTRODUCTION...3

More information

Restoration of interferometric images. IV. An algorithm for super-resolution of stellar systems

Restoration of interferometric images. IV. An algorithm for super-resolution of stellar systems A&A 431, 747 755 (2005) DOI: 10.1051/0004-6361:20040366 c ESO 2005 Astronomy & Astrophysics Restoration of interferometric images IV. An algorithm for super-resolution of stellar systems B. Anconelli 1,

More information

Deblurring Jupiter (sampling in GLIP faster than regularized inversion) Colin Fox Richard A. Norton, J.

Deblurring Jupiter (sampling in GLIP faster than regularized inversion) Colin Fox Richard A. Norton, J. Deblurring Jupiter (sampling in GLIP faster than regularized inversion) Colin Fox fox@physics.otago.ac.nz Richard A. Norton, J. Andrés Christen Topics... Backstory (?) Sampling in linear-gaussian hierarchical

More information

Laplacian Filters. Sobel Filters. Laplacian Filters. Laplacian Filters. Laplacian Filters. Laplacian Filters

Laplacian Filters. Sobel Filters. Laplacian Filters. Laplacian Filters. Laplacian Filters. Laplacian Filters Sobel Filters Note that smoothing the image before applying a Sobel filter typically gives better results. Even thresholding the Sobel filtered image cannot usually create precise, i.e., -pixel wide, edges.

More information

August 7, 2007 NUMERICAL SOLUTION OF LAPLACE'S EQUATION

August 7, 2007 NUMERICAL SOLUTION OF LAPLACE'S EQUATION August 7, 007 NUMERICAL SOLUTION OF LAPLACE'S EQUATION PURPOSE: This experiment illustrates the numerical solution of Laplace's Equation using a relaxation method. The results of the relaxation method

More information

THE ECAT SOFTWARE PACKAGE TO ANALYZE EARTHQUAKE CATALOGUES

THE ECAT SOFTWARE PACKAGE TO ANALYZE EARTHQUAKE CATALOGUES THE ECAT SOFTWARE PACKAGE TO ANALYZE EARTHQUAKE CATALOGUES Tuba Eroğlu Azak Akdeniz University, Department of Civil Engineering, Antalya Turkey tubaeroglu@akdeniz.edu.tr Abstract: Earthquakes are one of

More information

Celeste: Scalable variational inference for a generative model of astronomical images

Celeste: Scalable variational inference for a generative model of astronomical images Celeste: Scalable variational inference for a generative model of astronomical images Jeffrey Regier 1, Brenton Partridge 2, Jon McAuliffe 1, Ryan Adams 2, Matt Hoffman 3, Dustin Lang 4, David Schlegel

More information

Slides 12: Output Analysis for a Single Model

Slides 12: Output Analysis for a Single Model Slides 12: Output Analysis for a Single Model Objective: Estimate system performance via simulation. If θ is the system performance, the precision of the estimator ˆθ can be measured by: The standard error

More information

The deconvolution of lunar brightness temperature based on maximum entropy method using Chang E-2 microwave data

The deconvolution of lunar brightness temperature based on maximum entropy method using Chang E-2 microwave data Research in Astron. Astrophys. 201x Vol. X No. XX, 000 000 http://www.raa-journal.org http://www.iop.org/journals/raa Research in Astronomy and Astrophysics The deconvolution of lunar brightness temperature

More information

Fully Bayesian Analysis of Low-Count Astronomical Images

Fully Bayesian Analysis of Low-Count Astronomical Images Fully Bayesian Analysis of Low-Count Astronomical Images 1 Alanna Connors 2 1 Department of Statistics University of California, Irvine 2 Eurika Scientific Thanks to James Chiang, Adam Roy, and The California

More information

Tutorial 11. Use of User-Defined Scalars and User-Defined Memories for Modeling Ohmic Heating

Tutorial 11. Use of User-Defined Scalars and User-Defined Memories for Modeling Ohmic Heating Tutorial 11. Use of User-Defined Scalars and User-Defined Memories for Modeling Ohmic Heating Introduction The purpose of this tutorial is to illustrate the use of user-defined scalars (UDS) and user defined

More information

Image Deconvolution. Xiang Hao. Scientific Computing and Imaging Institute, University of Utah, UT,

Image Deconvolution. Xiang Hao. Scientific Computing and Imaging Institute, University of Utah, UT, Image Deconvolution Xiang Hao Scientific Computing and Imaging Institute, University of Utah, UT, hao@cs.utah.edu Abstract. This is a assignment report of Mathematics of Imaging course. The topic is image

More information

DETERMINATION OF THE DECOMPOSITION PRODUCTS OF CALCIUM OXALATE USING THERMAL GRAVIMETRY AND INFRARED SPECTROMETRY

DETERMINATION OF THE DECOMPOSITION PRODUCTS OF CALCIUM OXALATE USING THERMAL GRAVIMETRY AND INFRARED SPECTROMETRY DETERMINATION OF THE DECOMPOSITION PRODUCTS OF CALCIUM OXALATE USING THERMAL GRAVIMETRY AND INFRARED SPECTROMETRY Objective: The objectives of this experiment are: (1) to determine the stability of various

More information

StarFinder: an IDL GUI based code to analyze crowded fields with isoplanatic correcting PSF fitting

StarFinder: an IDL GUI based code to analyze crowded fields with isoplanatic correcting PSF fitting Header for SPIE use StarFinder: an IDL GUI based code to analyze crowded fields with isoplanatic correcting PSF fitting E.Diolaiti a, O.Bendinelli a, D.Bonaccini b, L.M.Close b, D.G.Currie b and G.Parmeggiani

More information

Deconvolution of astronomical images using the multiscale maximum entropy method

Deconvolution of astronomical images using the multiscale maximum entropy method ASTRONOMY & ASTROPHYSICS SEPTEMBER 1996, PAGE 575 SUPPLEMENT SERIES Astron. Astrophys. Suppl. Ser. 118, 575-585 (1996) Deconvolution of astronomical images using the multiscale maximum entropy method E.

More information

Understanding Your Spectra Module. Agilent OpenLAB CDS ChemStation Edition

Understanding Your Spectra Module. Agilent OpenLAB CDS ChemStation Edition Understanding Your Spectra Module Agilent OpenLAB CDS ChemStation Edition Notices Agilent Technologies, Inc. 1994-2012, 2013 No part of this manual may be reproduced in any form or by any means (including

More information

Space-Based Imaging Astrometry: Life with an Undersampled PSF. Jay Anderson STScI Feb 15, 2012

Space-Based Imaging Astrometry: Life with an Undersampled PSF. Jay Anderson STScI Feb 15, 2012 Space-Based Imaging Astrometry: Life with an Undersampled PSF Jay Anderson STScI Feb 15, 2012 Overview of the Talk Astrometry with HST 3 critical issues Science General Microlensing Extensions to WFIRST

More information

Simultaneous Multi-frame MAP Super-Resolution Video Enhancement using Spatio-temporal Priors

Simultaneous Multi-frame MAP Super-Resolution Video Enhancement using Spatio-temporal Priors Simultaneous Multi-frame MAP Super-Resolution Video Enhancement using Spatio-temporal Priors Sean Borman and Robert L. Stevenson Department of Electrical Engineering, University of Notre Dame Notre Dame,

More information

Astronomy 101 Lab: Stellarium Tutorial

Astronomy 101 Lab: Stellarium Tutorial Name: Astronomy 101 Lab: Stellarium Tutorial Please install the Stellarium software on your computer using the instructions in the procedure. If you own a laptop, please bring it to class. You will submit

More information

Sampling versus optimization in very high dimensional parameter spaces

Sampling versus optimization in very high dimensional parameter spaces Sampling versus optimization in very high dimensional parameter spaces Grigor Aslanyan Berkeley Center for Cosmological Physics UC Berkeley Statistical Challenges in Modern Astronomy VI Carnegie Mellon

More information

Need for Deep Networks Perceptron. Can only model linear functions. Kernel Machines. Non-linearity provided by kernels

Need for Deep Networks Perceptron. Can only model linear functions. Kernel Machines. Non-linearity provided by kernels Need for Deep Networks Perceptron Can only model linear functions Kernel Machines Non-linearity provided by kernels Need to design appropriate kernels (possibly selecting from a set, i.e. kernel learning)

More information

Deconvolving Primary Beam Patterns from SKA Images

Deconvolving Primary Beam Patterns from SKA Images SKA memo 103, 14 aug 2008 Deconvolving Primary Beam Patterns from SKA Images Melvyn Wright & Stuartt Corder University of California, Berkeley, & Caltech, Pasadena, CA. ABSTRACT In this memo we present

More information

Data analysis for neutron spectrometry with liquid scintillators: applications to fusion diagnostics

Data analysis for neutron spectrometry with liquid scintillators: applications to fusion diagnostics Data analysis for neutron spectrometry with liquid scintillators: applications to fusion diagnostics Bayes Forum Garching, January 25, 2013 Marcel Reginatto Physikalisch-Technische Bundesanstalt (PTB)

More information

Multiphysics Modeling

Multiphysics Modeling 11 Multiphysics Modeling This chapter covers the use of FEMLAB for multiphysics modeling and coupled-field analyses. It first describes the various ways of building multiphysics models. Then a step-by-step

More information

CSC321 Lecture 18: Learning Probabilistic Models

CSC321 Lecture 18: Learning Probabilistic Models CSC321 Lecture 18: Learning Probabilistic Models Roger Grosse Roger Grosse CSC321 Lecture 18: Learning Probabilistic Models 1 / 25 Overview So far in this course: mainly supervised learning Language modeling

More information