You are on page 1of 10

Computational Imaging for VLBI Image Reconstruction

Katherine L. Bouman1 Michael D. Johnson2 Daniel Zoran1 Vincent L. Fish3


Sheperd S. Doeleman2,3 William T. Freeman1,4

1 2 3 4
Massachusetts Institute of Technology, CSAIL Harvard, Center for Astrophysics MIT Haystack Observatory Google

Abstract

Very long baseline interferometry (VLBI) is a technique


for imaging celestial radio emissions by simultaneously ob-
serving a source from telescopes distributed across Earth.
The challenges in reconstructing images from fine angular
resolution VLBI data are immense. The data is extremely
sparse and noisy, thus requiring statistical image models
such as those designed in the computer vision community.
In this paper we present a novel Bayesian approach for
VLBI image reconstruction. While other methods often re- (a) Telescope Locations (b) Spatial Frequency Coverage
quire careful tuning and parameter selection for different Figure 1. Frequency Coverage: (A) A sample of the telescope locations
types of data, our method (CHIRP) produces good results in the EHT. By observing a source over the course of a day, we obtain mea-
under different settings such as low SNR or extended emis- surements corresponding to elliptical tracks in the source image’s spatial
sion. The success of our method is demonstrated on realis- frequency plane (B). These frequencies, (u, v), are the projected baseline
lengths orthogonal to a telescope pair’s light of sight. Points of the same
tic synthetic experiments as well as publicly available real color correspond to measurements from the same telescope pair.
data. We present this problem in a way that is accessible to
members of the community, and provide a dataset website a lack of inverse modeling [36], resulting in sub-optimal im-
(vlbiimaging.csail.mit.edu) that facilitates con- ages. Image processing, restoration, sophisticated inference
trolled comparisons across algorithms. algorithms, and the study of non-standard cameras are all
active areas of computer vision. The computer vision com-
1. Introduction munity’s extensive work in these areas are invaluable to the
High resolution celestial imaging is essential for success of these reconstruction methods and can help push
progress in astronomy and physics. For example, imag- the limits of celestial imaging. [16, 17, 27, 43].
ing the plasma surrounding a black hole’s event horizon at Imaging distant celestial sources with high resolving
high resolution could help answer many important ques- power (i.e. fine angular resolution) requires single-dish
tions; most notably, it may substantiate the existence of telescopes with prohibitively large diameters due to the in-
black holes [10] as well as verify and test the effects of verse relationship between angular resolution and telescope
general relativity [22]. Recently, there has been an inter- diameter [41]. For example, it is predicted that emission
national effort to create an Event Horizon Telescope (EHT) surrounding the black hole at the center of the Milky Way
capable of imaging a black hole’s event horizon for the first subtends ≈ 2.5 × 10−10 radians [15]. Imaging this emis-
time [12, 13]. The angular resolution necessary for this sion with a 10−10 radian resolution at a 1.3 mm wavelength
observation is at least an order of magnitude smaller than would require a telescope with a 13000 km diameter. Al-
has been previously used to image radio sources [24]. As though a single telescope this large is unrealizable, by si-
measurements from the EHT become available, robust al- multaneously collecting data from an array of telescopes
gorithms able to reconstruct images in this fine angular res- located around the Earth, it is possible to emulate samples
olution regime will be necessary. from a single telescope with a diameter equal to the maxi-
Although billions of dollars are spent on astronomical mum distance between telescopes in the array. Using mul-
imaging systems to acquire the best images, current recon- tiple telescopes in this manner is referred to as very long
struction techniques suffer from unsophisticated priors and baseline interferometry (VLBI) [41]. Refer to Figure 1a.

913
VLBI measurements place a sparse set of constraints on ŝ ŝ
the source image’s spatial frequencies. The task of recon- Time Delay:  


structing an image from these constraints is highly ill-posed B · ŝ


τg =
and relies heavily on priors to guide optimization. Cur- c

rent VLBI image reconstruction techniques have been rea-


B
sonably successful in imaging large celestial sources with
coarse angular resolution. However, as the demand for
V2 = A cos(!(t − τg )) V1 = A cos(!t)
higher resolving power increases, particularly for the EHT, X 
Mul.plica.on 
traditional reconstruction algorithms are quickly approach-
A2
ing their limits [28, 38]. [cos(!τg ) + cos(2!t − !τg )]
2
The difficulty of image reconstruction drastically in-
<>  A2
creases as the angular resolution of a VLBI array im- Rc = cos(!τg )
Time Average  2
proves. To improve angular resolution (i.e., increase resolv-
Figure 2. Simplified Interferometry Diagram: Light is emitted from a
ing power), one must either increase the maximum distance distant source and arrives at the telescopes as a plane wave in the direction
between two telescopes or decrease the observing wave- ŝ. An additional distance of B · ŝ is necessary for the light to travel to
length [41]. Due to the fixed size of Earth, increasing the the farther telescope, introducing a time delay between the received sig-
maximum telescope baseline results in a smaller set of pos- nals that varies depending on the source’s location in the sky. The time-
averaged correlation of these signals is a sinusoidal function related to the
sible telescope sites to choose from. Therefore, algorithms location of the source. This insight is generalized to extended emissions
must be designed to perform well with increasingly fewer in the van Cittert-Zernike Thm. and used to relate the time-averaged cor-
measurements [28]. Extending VLBI to millimeter and sub- relation to a Fourier component of the emission image in the direction ŝ.
mm wavelengths to increase resolution requires overcoming
many challenges, all of which make image reconstruction goal is to provide intuition; for additional details we rec-
more difficult. For instance, at these short wavelengths, ommend [41]. As with cameras, a single-dish telescope
rapidly varying inhomogeneities in the atmosphere intro- is diffraction limited. However, simultaneously collecting
duce additional measurement errors [31, 38]. data from an array of telescopes, called an interferometer,
In this paper, we leverage ideas from computer vision allows us to overcome the single-dish diffraction limit.
to confront these challenges. We present a new algorithm, Figure 2 provides a simplified explanation of a two
CHIRP (Continuous High-resolution Image Reconstruction telescope interferometer. Electromagnetic radiation travels
using Patch priors), which takes a Bayesian approach and from a point source to the telescopes. However, because
novel formulation to solve the ill-posed inverse problem of the telescopes are separated by a distance B, they will not
image reconstruction from VLBI measurements. Specifi- receive the signal concurrently. For spatially incoherent ex-
cally, the contributions of this algorithm are: tended emissions, the time-averaged correlation of the re-
• An improved forward model approximation that more ac- ceived signals is equivalent to the projection of this sinu-
curately models spatial-frequency measurements, soidal variation on the emission’s intensity distribution.
• A simpler problem formulation and optimization strategy This phenomenon is formally described by the van
to model the effects of atmospheric noise on VLBI data. Cittert-Zernike Theorem. The theorem states that, for ideal
Furthermore, current interferometry testing datasets are sensors, the time-averaged correlation of the measured sig-
small and have noise properties unsuitable for radio wave- nals from two telescopes, i and j, for a single wavelength,
lengths [3, 6, 26]. λ, can be approximated as:
Z Z
• We introduce a large, realistic VLBI dataset website to
Γi,j (u, v) ≈ e−i2π(uℓ+vm) Iλ (ℓ, m)dldm (1)
the community (vlbiimaging.csail.mit.edu). ℓ m
This website allows researchers to easily access a large
where Iλ (ℓ, m) is the emission √ of wavelength λ traveling
VLBI dataset, and compare their algorithms to other leading
from the direction ŝ = (ℓ, m, 1 − ℓ2 − m2 ). The dimen-
methods. Its automatic evaluation system facilitates unbi-
sionless coordinates (u, v) (measured in wavelengths) are
ased comparisons between algorithms, which are otherwise
the projected baseline, B, orthogonal to the line of sight.1
difficult to make and are lacking in the literature. Further-
Notice that Eq. 1 is just the Fourier transform of the source
more, we hope to make this computational imaging problem
emission image, Iλ (ℓ, m). Thus, Γi,j (u, v) provides a sin-
accessible to computer vision researchers, cross-fertilizing
gle complex Fourier component of Iλ at position (u, v) on
the astronomy and computer vision communities.
the 2D spatial frequency plane. We refer to these mea-
surements, Γi,j , as visibilities. Since the spatial frequency,
2. A Brief Introduction to VLBI
1 The change in elevation between telescopes can be neglected due to
We briefly describe VLBI to provide the necessary back- corrections made in pre-processing. Additionally, for small FOVs wide-
ground for building an accurate likelihood model. Our field effects are negligible.

914
(u, v), is proportional to the baseline, B, increasing the dis- the (u, v) frequency plane. After many iterations, the final
tance between telescopes increases the resolving power of image of point sources is blurred [18]. Since CLEAN as-
the interferometer, allowing it to distinguish finer details. sumes a distribution of point sources, it often struggles with
Earth Rotation Synthesis At a single time, for an N tele- reconstructing images of extended emissions [38].
For mm/sub-mm wavelength VLBI, reconstruction is
scope array, we obtain N (N2−1) visibility measurements cor-
complicated by corruption of the visibility phases. CLEAN
responding to each pair of telescopes. As the Earth rotates,
is not inherently capable of handling this problem; however,
the direction that the telescopes point towards the source
self-calibration methods have been developed to greedily
(ŝ) changes. Assuming a static source, this yields measure-
recover the phases during imaging. Self-calibration requires
ments of spatial frequency components (visibilities) of the
manual input from a knowledgeable user and often fails
desired image along elliptical paths in the (u, v) frequency
when the SNR is too low or the source is complex [38].
plane (see Fig. 1b).
Optical Interferometry Interferometry at visible wave-
Phase Closure All equations thus far assumed that light
lengths faces the same phase-corruption challenges as
travels from the source to a telescope through a vacuum.
mm/sub-mm VLBI. Although historically the optical and
However, inhomogeneities in the atmosphere cause the
radio interferometry communities have been separate, fun-
light to travel at different velocities towards each telescope.
damentally the resulting measurements and imaging pro-
These delays have a significant effect on the phase of mea-
cess are very similar [31]. We have selected two optical in-
surements, and renders the phase unusable for image recon-
terferometry reconstruction algorithms representative of the
structions at wavelengths less than 3 mm [31].
field to discuss and compare to in this work [28]. Both al-
Although absolute phase measurements cannot be used,
gorithms take a regularized maximum likelihood approach
a clever observation - termed phase closure - allows us to
and can use the bispectrum, rather than visibilities, for re-
still recover some information from the phases. The at-
construction [4, 11]. Recent methods based on compressed
mosphere affects an ideal visibility (spatial frequency mea-
sensing have been proposed, but have yet to demonstrate
surement) by introducing an additional phase term: Γmeas i,j =
i(φi −φj ) ideal
superior results [25, 28].
e Γi,j , where φi and φj are the phase delays intro- BSMEM (BiSpectrum Maximum Entropy Method)
duced in the path to telescopes i and j respectively. By takes a Bayesian approach to image reconstruction [11].
multiplying the visibilities from three different telescopes, Gradient descent optimization [37] using a maximum en-
we obtain an expression that is invariant to the atmosphere, tropy prior is used to find an optimal reconstruction of the
as the unknown phase offsets cancel, see Eq. 2 [14]. image. Under a flat image prior BSMEM is often able to
Γmeas meas meas i(φi −φj ) ideal i(φj −φk ) ideal i(φk −φi ) ideal achieve impressive super-resolution results on simple celes-
i,j Γj,k Γk,i = e Γi,j e Γj,k e Γk,i
tial images. However, in Section 6 we demonstrate how it
= Γideal ideal ideal
i,j Γj,k Γk,i (2) often struggles on complex, extended emissions.
SQUEEZE takes a Markov chain Monte Carlo (MCMC)
We refer to this triple product of visibilities as the bis-
approach to sample images from a posterior distribution [4].
pectrum. The bispectrum is invariant to atmospheric noise;
To obtain a sample image, SQUEEZE moves a set of point
however, in exchange, it reduces the number of constraints
sources around the field of view (FOV). The final image is
that can be used in image reconstruction. Although  the then calculated as the average of a number of sample im-
number of triple pairs in an N telescope array is N3 , the
ages. Contrary to gradient descent methods, SQUEEZE is
number of independent values is only (N −1)(N 2
−2)
. For not limited in its choice of regularizers or constraints [28].
small telescope arrays, such as the EHT, this effect is large. However, this freedom comes at the cost of a large number
For instance, in an eight telescope array, using the bispec- of parameter choices that may be hard for an unknowledge-
trum rather than visibilities results in 25% fewer indepen- able user to select and tune.
dent constraints [14].
3.1. Spectral Image Reconstruction
3. Related Work
VLBI image reconstruction has similarities with other
We summarize a few significant algorithms from the as- spectral image reconstruction problems, such as Syn-
tronomical interferometry imaging literature. thetic Aperture Radar (SAR), Magnetic Resonance Imag-
CLEAN CLEAN is the de-facto standard method used for ing (MRI), and Computed Tomography (CT) [8, 29, 33, 39].
VLBI image reconstruction. It assumes that the image is However, VLBI faces a number of challenges that are typ-
made up of a number of bright point sources. From an ini- ically not relevant in these other fields. For instance, SAR,
tialization image, CLEAN iteratively looks for the brightest MRI, and CT are generally not plagued by large corruption
point in the image and “deconvolves” around that location of the signal’s phase, as is the case due to atmospheric dif-
by removing side lobes that occur due to sparse sampling in ferences in mm/sub-mm VLBI. In SAR the Fourier samples

915
are all coherently related and the absolute phase can gener- space into Nℓ × Nm scaled pulse functions, h(l, m), cen-
ally be recovered, even under atmospheric changes [19, 32]. tered around
However, although fully understanding the connection re-
mains an open problem, incorporating ideas of phase clo- ∆ℓ Fℓ
sure, as is done in this work, may open the potential to push l = i∆ℓ + − for i = 0, ..., Nℓ − 1 (7)
2 2
SAR techniques [21] past their current limits. ∆m Fm
m = j∆m + − for j = 0, ..., Nm − 1 (8)
2 2
4. Method Fℓ Fm
for ∆ℓ = Nℓ and ∆m = Nm . Using Eq. 7 and 8 we can
Reconstructing an image using bispectrum measure- represent a continuous image as a discrete sum of shifted
ments is an ill-posed problem, and as such there are an infi- pulse functions scaled by x[i, j]. We refer to this image as
nite number of possible images that explain the data [28]. Iˆλ (x) for vectorized coefficients x.
The challenge is to find an explanation that respects our Due to the shift theorem [34], plugging this image rep-
prior assumptions about the “visual” universe while still sat- resentation into the van Cittert-Zernike theorem (Eq. 1) re-
isfying the observed data. sults in a closed-form solution to the visibilities in terms of
H(u, v), the Fourier transform of h(l, m), as seen in Eq. 6.
4.1. Continuous Image Representation Note that performing a continuous integration has been re-
The image that we wish to recover, Iλ (ℓ, m), is de- duced to a linear matrix operation similar to a Discrete Time
fined over the continuous space of angular coordinates l and Fourier Transform (DTFT).
m. Many algorithms assume a discretized image of point In Figure 3 we show that this representation allows us
sources during reconstruction [38]. This discretization in- to approximates the true frequency components more ac-
troduces errors during the reconstruction optimization, es- curately than a discretized set of point sources, especially
pecially in fitting the higher frequency visibilities. Instead, for high frequencies. Any pulse with a continuous closed-
we parameterize a continuous image using a discrete num- form Fourier transform can be used in this representation
ber of terms. This parameterization not only allows us to (e.g. rectangle, triangle, sinc, Gaussian). The chosen pulse
model our emission with a continuous image, but it also re- places an implicit prior on the reconstruction. For instance,
duces modeling errors during optimization. a sinc pulse with frequency and spacing ∆ can reconstruct
Since each measured complex visibility is approximated any signal with a bandwidth less than ∆ 2 [34]. In this work
as the Fourier transform of Iλ (ℓ, m), a convenient param- we choose to use a triangle pulse with width (2∆ℓ , 2∆m )
eterization of the image is to represent it as a discrete since this is equivalent to linearly interpolating between
number of scaled and shifted continuous pulse functions, pulse centers and also simplifies non-negativity constraints.
such as triangular pulses. For a scene defined in the range Although we developed this image model for VLBI image
ℓ ∈ [− F2ℓ , F2ℓ ] and m ∈ [− F2m , F2m ], we parameterize our reconstruction, it has potential applicability to a much more
general class of imaging problems that rely on frequency
constraints.
4.2. Model Energy
We seek a maximum a posteriori (MAP) estimate of the
image coefficients, x, given M complex bispectrum mea-
surements, y. Following recent success in image restoration
using patch priors [43, 44], we choose to use an expected
patch log likelihood (EPLL) and minimize the energy:
Magnitude

fr (x|y) = −D(y|x) − EPLLr (x) (9)


Eq. 9 appears similar to the familiar form using a
Bayesian posterior probability; however, since bispectrum
−1.5 −1 −0.5 0 0.5 1 1.5
Frequency (1/radians) 10
x 10 measurements are not independent, the data term D is not
Figure 3. Accurately modeling the frequencies of an image is crucial for a log-likelihood. Additionally, EPLLr is the expected log
fitting VLBI measurements during image reconstruction. Here we show, likelihood of a randomly chosen patch in the image Iˆλ (x),
that with the same number of parameters, we can much more accurately not the log-likelihood of the image itself [43]. Details of the
model the true frequency distribution. A slice of frequencies for the true
image is shown in red. Overlayed we show the effect of using the tra-
data and prior term are discussed below.
ditional discretized imaging model (green), and our improved model for 4.2.1 Data Term −D(y|x)
rectangle (cyan) and triangle (blue) pulses. The dotted lines denote the
frequency range sampled in Fig 1b. Representing an image in this way re- As discussed in Section 2, bispectrum measurements are
duces modeling errors for higher frequencies during image reconstruction. invariant to atmospheric inhomogeneity. Therefore, we

916
Z ∞ Z ∞ Nℓ −1 Nm −1     
X X ∆ℓ F OVℓ ∆m F OVm
Γ(u, v) ≈ e−i2π(uℓ+vm) x[i, j]h ℓ − ∆ℓ i + − , m − ∆m j + − dℓdm
−∞ −∞ i=0 j=0
2 2 2 2
Nℓ −1 Nm −1

   
−i2π u ∆ℓ i+ 2ℓ +aℓ +v (∆m j+ ∆2m +am )
X X  
= x[i, j]e H(u, v) = Ax = Aℜ + iAℑ x (6)
i=0 j=0

choose to express an image’s “likelihood” in terms of the 4.3. Optimization


bispectrum, rather than visibility, measurements. Let yk be
a noisy, complex bispectrum measurement corresponding To optimize Eq. 9 we use “Half Quadratic Splitting” [43].
to visibilities k1,2 , k2,3 , and k3,1 for telescopes 1, 2 and 3. This method introduces a set of auxiliary patches {z i }N
1 ,
Ideal bispectrum values, ξ, can be extracted from Iˆλ (x) us- one for each overlapping patch Pi x in the image. We can
ing the following polynomial equation: then solve this problem using an iterative framework:
(1) Solve for {z n } given x: In order to complete this step
ξk (x) = Ak1,2 xAk2,3 xAk3,1 x = ξkℜ (x) + iξkℑ (x) (10)
we set {z n } to the most likely patch under the prior, given
where complex, row vector Akm,n extracts the 2D fre- the corrupted measurements Pn X and weighting parameter
quency, (u, v), corresponding to the baseline between tele- β (described further in [43]).
scopes m and n from Iˆλ (x). By assuming Gaussian noise
(2) Solve for x given {z n }: If we were able to work with
(Σk ) on the complex bispectrum measurements, we evalu-
visibilities our problem would be quadratic in x, and we
ate −D(y|x) as:
could solve then for x in closed-form. However, since we
M
" #
αk ξkℜ (x) − ykℜ
 T  ℜ ℜ use bispectrum measurements rather than visibilities, our
−1 ξk (x) − yk
X
γ Σk (11) energy is a 6th order polynomial that cannot be solved in
2 ξkℑ (x) − ykℑ ξkℑ (x) − ykℑ
i=1 closed-form. One possibility is to solve for the gradient
To account for the independence of each constraint, we set and then use gradient descent to solve for a local minimum.
αk = (Tk −1)(T k −2)
2(T3k )
= T3k for Tk telescopes observing at However, this method is slow. Alternatively, we perform a
the time corresponding to the k-th bispectrum value. If 2nd order Taylor expansion around our current solution, x0 ,
necessary, effects due to the primary beam and interstellar to obtain an approximation of the local minimum in closed-
scattering [15] can be accounted for in Eq. 11 by weight- form. A detailed derivation of the gradient and local closed-
ing each bispectrum term appropriately. Refer to the supp. form solution can be found in the supp. material [7].
material [7] for further details. The polynomial structure As suggested in [43] we iterate between these two steps
of our “likelihood” formulation is simpler than previously for increasing β values of 1, 4, 8, 16, 32, 64, 128, 256, 512.
proposed formulations using the bispectrum [5, 40]. Multi-scale Framework Since our convexification of the
Noise Although the error due to atmospheric inhomo- energy is only approximate, we slowly build up Iˆλ (x) us-
geneity cancels when using the bispectrum, residual error ing a multi scale framework. This framework also helps
exists due to thermal noise and gain fluctuations [41]. This to avoid local minima in the final solution. We initialize
introduces Gaussian noise on each complex visibility mea- the image x0 with small random noise centered around the
surement. Since the bispectrum is the product of three vis- mean flux density (average image intensity), and iterate be-
ibilities, its noise distribution is not Gaussian; nonetheless, tween solving for {z n } and x. Then, using our discretized
its noise is dominated by a Gaussian bounding its first-order formulation of the image, we increase the number of pulses
noise terms. In the supp. material we show evidence that used to describe the image. This framework allows us to
this is a reasonable approximation [7]. find the best low-resolution solution before optimizing the
4.2.2 Regularizer −EPLLr (x) higher frequency detail in the image. In this paper, we ini-
tialize our optimization using a set of 20 × 20 pulses and
We use a Gaussian mixture model (GMM) patch prior to slowly increase to 64 × 64 pulses over 10 scales.
regularize our solution of Iˆλ (x). Although this is not an
explicit prior on Iˆλ (x), patch priors have been shown to 5. Dataset
work well in the past [43, 44]. Building on ideas from [43],
We introduce a dataset and website (vlbiimaging.
we maximize the EPLL by maximizing the probability of
csail.mit.edu) for evaluating the performance of
each of the N overlapping pulse patches in Iˆλ (x):
VLBI image reconstruction algorithms. By supplying a
PN
EPLLr (x) = n=1 log p(Pn x). (12) large set of easy-to-understand training and testing data, we
hope to make the problem more accessible to those less fa-
Pn is a matrix that extracts the n-th patch from x and miliar with the VLBI field. The website contains a:
p(Pn x) is the probability of that patch learned through the • Standardized data set of real and synthetic data for train-
GMM’s optimization. We use a patch size of 8x8. ing and blind testing of VLBI imaging algorithms

917
• Automatic quantitative evaluation of algorithm perfor- and SSIM on the normalized, aligned images. Although we
mance on realistic synthetic test data consider MSE and SSIM a good first step towards quanti-
• Qualitative comparison of algorithm performance tative analysis, we believe a better metric of evaluation is
• Online form to easily simulate realistic data using user- subject for future research.
specified image and telescope parameters 6. Results and Discussion
Current interferometry dataset challenges are both small Measurements from the EHT have yet to become avail-
and assume noise characteristics unsuitable for radio wave- able. Therefore, we demonstrate the success of our algo-
lengths [3, 26]. The introduction of this new radio VLBI rithm, CHIRP, on a sample of synthetic examples obtained
dataset will help to reveal shortcomings of current methods from our online dataset and real VLBI measurements col-
as well as encourage the development of new algorithms. lected by the VLBA-BU-BLAZAR Program.
Synthetic Measurements We provide a standardized for- Synthetic Measurements For image results presented in
mat [35] dataset of over 5000 synthetic VLBI measurements the paper we generated synthetic data using realistic param-
corresponding to a variety of array configuration, source im- eters for the EHT array pointed towards the black hole in
ages, and noise levels. Measurements are simulated using M87. Corresponding (u, v) frequency coverage is shown
the MIT Array Performance Simulator (MAPS) software in Figure 1b. The geometry of an array imposes an intrinsic
package [28]. This software has been developed to accu- maximum resolution on the image you can reconstruct from
rately model the visibilities and noise expected from a user- its measurements. Figure 4 shows the effect of filtering out
specified array and source. Visibilities from the MAPS are spatial frequencies higher than the minimum fringe spac-
not generated in the same manner as our forward model. ing. These images set expectations on what is possible to
We generate data using a collection of black hole [9], reliably reconstruct from the measurements. Additional re-
celestial [1, 2], and natural images. We have deliberately sults and details about the telescopes, noise properties, and
included a diversity of images in the imaging database, parameter settings can be found in the supp. material [7].
since imaging algorithms for black holes must be suf- Method Comparison We compare results from our algo-
ficiently non-committal that they can identify departures rithm, CHIRP, with the three state-of-the-art algorithms de-
from canonical expectations. Natural images test robust- scribed in Section 3: CLEAN, SQUEEZE, and BSMEM.
ness to complex scenes with varied image statistics. Images were obtained by asking authors of the compet-
Real Measurements We provide 33 sets of measure- ing algorithms or knowledgeable users for a suggested set
ments from the VLBA-BU-BLAZAR Program [23] in the of reconstruction parameter (provided in the supp. mate-
same standardized format [35]. This program has been col- rial [7]). The website submission system allows the results
lecting data on a number of gamma-ray blazars every month from other parameter settings and algorithms to be com-
since 2007. Measurements are taken using the Very Long pared, both qualitatively and quantitatively.
Baseline Array (VLBA) at 43 GHz. Although both the an- As with our algorithm, SQUEEZE [4] and BSMEM [11]
gular resolution and wavelength of these measurements are use the bispectrum as input. CLEAN cannot automatically
very different from those taken by the EHT (which collects handle large phase errors, so CLEAN results were obtained
at ≈ 230 GHz) [15], they provide a means to test algorithms using calibrated (eg. no atmospheric phase error) visibil-
on measured, experimental data. ities in CASA [20]. In reality, these ideal calibrated visi-
Test Set and Error Metrics We introduce a blind test bilities would not be available, and the phase would need to
set of challenging synthetic data. Measurements with re- be recovered through highly user-dependent self-calibration
alistic errors are generated using a variety of target sources
Source

and telescope parameters and provided in the OIFITS for-


mat [35]. This test set introduces a means for fair quan-
titative comparisons between competing algorithms. Re-
Max Res

searchers are encouraged to run their algorithms on this data


and submit results to the website for evaluation.
Traditional point-by-point error metrics, such as MSE
and PSNR, are sometimes uninformative in the context of
Figure 4. Intrinsic Maximum Resolution: The geometry of a telescope
highly degraded VLBI reconstructions. Therefore, we sup- array imposes an intrinsic maximum resolution on the image you can re-
plement the MSE metric with the perceptually motivated construct from the measurements. Recovering spatial frequencies higher
structural similarity (SSIM) index [42]. Since the abso- than this resolution is equivalent to superresolution. For results presented,
the minimum recoverable fringe spacing (corresponding to the maximum
lute position of the emission is lost when using the bispec-
frequency) is 24.72 µ-arcseconds. The original ‘Source’ images (183.82
trum, we first align the reconstruction to the ground truth µ-arcsecond FOV) are used to synthetically generate realistic VLBI mea-
image using cross-correlation. We then evaluate the MSE surements. We show the effect of filtering out spatial frequencies higher
than the minimum fringe spacing for these source images in ‘Max Res’.

918
BLACK HOLE CELESTIAL NATURAL

TARGET
CLEAN
SQUEEZE
BSMEM
CHIRP

A B C D E F G
Figure 5. Method Comparison: Comparison of our algorithm, ‘CHIRP’ to three state-of-the-art methods: ‘CLEAN’, ‘SQUEEZE’, and ‘BSMEM’.
We show the normalized reconstruction of a variety of black hole (a-b), celestial (c-f), and natural (g) source images with a total flux density (sum of pixel
intensities) of 1 jansky and a 183.82 µ-arcsecond FOV. Since absolute position is lost when using the bispectrum, shifts in the reconstructed source location
are expected. The ‘TARGET’ image shows the ground truth emission filtered to the maximum resolution intrinsic to this telescope array.

CLEAN SQUEEZE BSMEM CHIRP CLEAN SQUEEZE BSMEM CHIRP


3.0 Flux

3.0 Flux
2.0 Flux

2.0 Flux
0.5 Flux

0.5 Flux

Figure 6. Noise Sensitivity: The effect of varying total flux density (in janskys), and thus noise, on each method’s recovered reconstructions. Decreasing
flux results in higher noise. Notice how our method is fairly robust to the noise, while the results from other methods often vary substantially across the
noise levels. The ground truth target images along with the results for a total flux density of 1 jansky can been seen in column A and C of Figure 5.

methods. However, in the interest of a fair comparison, we BSMEM tend towards sparser images. This strategy works
show the results of CLEAN in a “best-case” scenario. well for superresolution. However, it comes at the cost of
Figure 5 shows a sample of results comparing our recon- often making extended sources overly sparse and introduc-
structions to those of the current state-of-the-art methods. ing spurious detail. Although algorithms such as BSMEM
Our algorithm is able to handle a wide variety of sources, and SQUEEZE may perform better on these images with
ranging from very simple celestial to complex natural im- specific hand-tuned parameters, these tests demonstrate that
ages, without any additional parameter tuning. CLEAN the performance of CHIRP requires less user expertise and
produces consistently blurrier results. Both SQUEEZE and provides images that may be less sensitive to user bias.

919
Mean Squared Error (MSE) Structural Similarity Index (SSIM) 3C279 OJ287 BL Lacertae
0.16 1

BU Results
0.14 0.98
0.12
0.96
0.1
0.94
0.08
0.06 0.92

0.04 0.9
0.02
0.88
0

CHIRP
CHIRP SQUEEZE BSMEM CHIRP SQUEEZE BSMEM

Figure 7. Quantitative Analysis on Blind Test Set: Box plots of MSE


and SSIM for reconstruction methods on the blind dataset presented in
Section 5. In SSIM a score of 1 implies perceptual indistinguishability
between the ground truth and recovered image. Scores are calculated using Figure 9. Real Measurements: A comparison of our reconstructed im-
the original ‘Source’ image (Refer to Fig. 4). ages to [23]’s results using CLEAN self-calibration. Note that we are able
to reconstruct less blurry images, and are even able to resolve 2 separate,
Figure 7 shows a quantitative comparison of our method previously unresolved, bright emissions in blazar OJ287. Measurements
to SQUEEZE and BSMEM for the challenging, blind test were taken using the VLBA telescope array. The FOV for each image is
set presented in Section 5. Since CLEAN cannot automat- 1.5, 1, and 1 milli-arcsecond respectively.
ically handle large phase errors, we were unable to fairly
suggests that the prior guides optimization, but does not im-
compare its results on this test set.
pose strong assumptions that may greatly bias results.
Noise Sensitivity The standard deviation of thermal noise Real Measurements We demonstrate the performance
introduced in each measured visibility is fixed based on of our algorithm on the reconstruction of three different
measurement choices and the corresponding telescopes’ sources using real VLBI data from [23] in Figure 9. Al-
1
p
properties. Specifically, σ = 0.88 ρ1 ρ2 /νT for band- though we do not have ground truth images corresponding
width ν, integration time T , and each telescope’s System to these measurements, we compare our reconstructions to
Equivalent Flux Density (ρ). Consequently, an emission those generated by the BU group, reconstructed using an
with a lower total flux will result in a lower SNR signal. interactive calibration procedure described in [23]. Alterna-
Previous measurements predict that the total flux densi- tively, we are able to use bispectrum measurements to auto-
ties of the black holes M87 and SgA* will be in the range matically produce image reconstructions with minimal user
0.5 to 3.0 janskys [12, 13]. Figure 6 shows the effect of input. Notice that we are able to recover sharper images,
varying total flux density, and thus noise, on each method’s and even resolve two potentially distinct sources that were
recovered reconstructions. Notice how our method is fairly previously unresolved in blazar OJ287.
robust to the noise, while the results from other methods
often vary substantially across noise levels. 7. Conclusion
Astronomical imaging will benefit from the cross-
Effect of Patch Prior Flexibility of the patch prior frame- fertilization of ideas with the computer vision community.
work allows us to easily incorporate a variety of differ- In this paper, we have presented an algorithm, CHIRP, for
ent “visual” assumptions in our reconstructed image. For reconstructing an image using a very sparse number of
instance, in the case of the EHT, simulations of a black VLBI frequency constraints. We have demonstrated im-
hole for different inclinations and spins can be used to train proved performance compared to current state-of-the-art
a patch model that can be subsequently used for recon- methods on both synthetic and real data. Furthermore, we
struction. In Figure 8 we show results using a patch prior have introduced a new dataset for the testing and develop-
trained on natural [30], celestial, and synthetic black hole ment of new reconstruction algorithms. With this paper,
images [9]. Only small variations can be observed among the dataset, and algorithm comparison website, we hope to
the resulting images. Given our selected parameters, this make this problem accessible to researchers in computer vi-
sion, and push the limits of celestial imaging.
Acknowledgments We would like to thank Andrew Chael, Kather-
ine Rosenfeld, and Lindy Blackburn for all of their helpful discus-
sions and feedback. This work was partially supported by NSF CGV-
1111415. Katherine Bouman was partially supported by an NSF
Graduate Fellowship. We also thank the National Science Founda-
tion (AST-1310896, AST-1211539, and AST-1440254) and the Gor-
don and Betty Moore Foundation (GBMF-3561) for financial sup-
port of this work. This study makes use of 43 GHz VLBA data
Natural Celestial Black Hole ℓ2 Norm ℓ0.8 Norm from the VLBA-BU Blazar Monitoring Program (VLBA-BU-BLAZAR;
http://www.bu.edu/blazars/VLBAproject.html), funded by NASA through
Figure 8. Effect of Patch Prior: Reconstructions using patch priors
the Fermi Guest Investigator Program. The VLBA is an instrument of the
trained on natural, celestial, and synthetic black hole images as well as
National Radio Astronomy Observatory. The National Radio Astronomy
ℓ2 and ℓ0.8 norm priors on the residuals. The ground truth target image
Observatory is a facility of the National Science Foundation operated by
are shown in Figure 5 column B and E. The patch priors outperform results
Associated Universities, Inc.
obtained using simpler ℓ-norm priors. Since absolute position is lost during
imaging, shifts in the reconstructed source location are expected.

920
References [13] S. S. Doeleman, J. Weintroub, A. E. Rogers, R. Plam-
beck, R. Freund, R. P. Tilanus, P. Friberg, L. M. Zi-
[1] Jpl image gallery. http://www.jpl.nasa.
urys, J. M. Moran, B. Corey, et al. Event-horizon-scale
gov/spaceimages/. Accessed: 2015-04-01.
structure in the supermassive black hole candidate at
[2] Nrao image gallery. https://public.nrao. the galactic centre. Nature, 2008.
edu/gallery. Accessed: 2015-04-01.
[14] M. Felli and R. E. Spencer. Very Long Baseline Inter-
[3] F. Baron, W. D. Cotton, P. R. Lawson, S. T. Ridgway, ferometry. Springer, 1989.
A. Aarnio, J. D. Monnier, K.-H. Hofmann, D. Schertl,
G. Weigelt, E. Thiébaut, et al. The 2012 interfero- [15] V. L. Fish, M. D. Johnson, R.-S. Lu, S. S. Doeleman,
metric imaging beauty contest. In SPIE Astronomical K. L. Bouman, D. Zoran, W. T. Freeman, D. Psaltis,
Telescopes+ Instrumentation, pages 84451E–84451E. R. Narayan, V. Pankratius, et al. Imaging an event
International Society for Optics and Photonics, 2012. horizon: Mitigation of scattering toward sagittarius
a*. The Astrophysical Journal, 2014.
[4] F. Baron, J. D. Monnier, and B. Kloppenborg. A novel
image reconstruction software for optical/infrared in- [16] W. T. Freeman, T. R. Jones, and E. C. Pasztor.
terferometry. In SPIE Astronomical Telescopes+ Example-based super-resolution. Computer Graphics
Instrumentation, pages 77342I–77342I. International and Applications, IEEE, 2002.
Society for Optics and Photonics, 2010. [17] D. Glasner, S. Bagon, and M. Irani. Super-resolution
[5] F. Baron and J. S. Young. Image reconstruction at from a single image. In Computer Vision, 2009 IEEE
cambridge university. In SPIE Astronomical Tele- 12th International Conference on. IEEE, 2009.
scopes+ Instrumentation, pages 70133X–70133X. In- [18] J. Högbom. Aperture synthesis with a non-regular dis-
ternational Society for Optics and Photonics, 2008. tribution of interferometer baselines. Astron. Astro-
[6] J.-P. Berger, F. Malbet, F. Baron, A. Chiavassa, G. Du- phys. Suppl, 1974.
vert, M. Elitzur, B. Freytag, F. Gueth, S. Hnig, J. Hron, [19] T. Isernia, V. Pascazio, R. Pierri, and G. Schir-
H. Jang-Condell, J.-B. Le Bouquin, J.-L. Monin, inzi. Synthetic aperture radar imaging from phase-
J. Monnier, G. Perrin, B. Plez, T. Ratzka, S. Renard, corrupted data. IEE Proceedings - Radar, Sonar and
S. Stefl, E. Thibaut, K. Tristram, T. Verhoelst, S. Wolf, Navigation, Aug 1996.
and J. Young. Imaging the heart of astrophysical ob-
jects with optical long-baseline interferometry. The [20] S. Jaeger. The common astronomy software applica-
Astronomy and Astrophysics Review, 20(1), 2012. tion (casa). In Astronomical Data Analysis Software
and Systems XVII, 2008.
[7] K. L. Bouman, M. D. Johnson, D. Zoran, V. L. Fish,
S. S. Doeleman, and W. T. Freeman. Computational [21] M. Jehle, D. Perler, D. Small, A. Schubert, and
imaging for vlbi image reconstruction supplemental E. Meier. Estimation of atmospheric path delays in
material. http://vlbiimaging.csail.mit. terrasar-x data using models vs. measurements. Sen-
edu/static/papers/CHIRPsupp.pdf. sors, 2008.
[8] R. Bracewell. Fourier analysis and imaging. Springer [22] T. Johannsen and D. Psaltis. Testing the No-hair The-
Science & Business Media, 2004. orem with Observations in the Electromagnetic Spec-
[9] A. E. Broderick, V. L. Fish, S. S. Doeleman, and trum. II. Black Hole Images. The Astrophysical Jour-
A. Loeb. Evidence for Low Black Hole Spin nal, July 2010.
and Physically Motivated Accretion Models from [23] S. G. Jorstad, A. P. Marscher, M. L. Lister, A. M. Stir-
Millimeter-VLBI Observations of Sagittarius A*. The ling, T. V. Cawthorne, W. K. Gear, J. L. Gómez, J. A.
Astrophysical Journal, July 2011. Stevens, P. S. Smith, J. R. Forster, et al. Polarimetric
[10] A. E. Broderick, A. Loeb, and R. Narayan. The event observations of 15 active galactic nuclei at high fre-
horizon of sagittarius a*. The Astrophysical Journal, quencies: jet kinematics from bimonthly monitoring
2009. with the very long baseline array. The Astronomical
Journal, 2005.
[11] D. Buscher. Direct maximum-entropy image recon-
struction from the bispectrum. In Very High Angular [24] T. Krichbaum, D. Graham, M. Bremer, W. Alef,
Resolution Imaging, pages 91–93. Springer, 1994. A. Witzel, J. Zensus, and A. Eckart. Sub-
[12] S. S. Doeleman, V. L. Fish, D. E. Schenck, C. Beau- milliarcsecond imaging of sgr a* and m 87. In Journal
doin, R. Blundell, G. C. Bower, A. E. Broderick, of Physics: Conference Series. IOP Publishing, 2006.
R. Chamberlin, R. Freund, P. Friberg, et al. Jet- [25] B. G. Kurien, Y. Rachlin, V. N. Shah, J. B. Ash-
launching structure resolved near the supermassive com, and V. Tarokh. Compressed sensing techniques
black hole in m87. Science, 2012. for image reconstruction in optical interferometry. In

921
Imaging and Applied Optics 2014. Optical Society of [39] J.-B. Thibault, K. D. Sauer, C. A. Bouman, and
America, 2014. J. Hsieh. A three-dimensional statistical approach to
[26] P. R. Lawson, W. D. Cotton, C. A. Hummel, J. D. improved image quality for multislice helical ct. Med-
Monnier, M. Zhao, J. S. Young, H. Thorsteinsson, ical physics, 2007.
S. C. Meimon, L. M. Mugnier, G. Le Besnerais, et al. [40] E. Thiebaut and J.-F. Giovannelli. Image reconstruc-
An interferometry imaging beauty contest. In Astro- tion in optical interferometry. Signal Processing Mag-
nomical Telescopes and Instrumentation. International azine, IEEE, Jan 2010.
Society for Optics and Photonics, 2004. [41] A. R. Thompson, J. M. Moran, and G. W. Swenson Jr.
[27] A. Levin, Y. Weiss, F. Durand, and W. T. Freeman. Interferometry and synthesis in radio astronomy. John
Efficient marginal likelihood optimization in blind de- Wiley & Sons, 2008.
convolution. In Computer Vision and Pattern Recog- [42] Z. Wang, E. P. Simoncelli, and A. C. Bovik. Mul-
nition (CVPR). IEEE, 2011. tiscale structural similarity for image quality assess-
[28] R.-S. Lu, A. E. Broderick, F. Baron, J. D. Monnier, ment. In Signals, Systems and Computers, 2004. Con-
V. L. Fish, S. S. Doeleman, and V. Pankratius. Imag- ference Record of the Thirty-Seventh Asilomar Con-
ing the Supermassive Black Hole Shadow and Jet Base ference on. Ieee, 2003.
of M87 with the Event Horizon Telescope. The Astro- [43] D. Zoran and Y. Weiss. From learning models of natu-
physical Journal, June 2014. ral image patches to whole image restoration. In Com-
[29] M. Lustig, D. Donoho, and J. M. Pauly. Sparse mri: puter Vision (ICCV), 2011 IEEE International Confer-
The application of compressed sensing for rapid mr ence on. IEEE, 2011.
imaging. Magnetic resonance in medicine, 2007.
[44] D. Zoran and Y. Weiss. Natural images, gaussian mix-
[30] D. Martin, C. Fowlkes, D. Tal, and J. Malik. A tures and dead leaves. In Advances in Neural Informa-
database of human segmented natural images and its tion Processing Systems, 2012.
application to evaluating segmentation algorithms and
measuring ecological statistics. In Computer Vision,
2001. ICCV 2001. Proceedings. Eighth IEEE Interna-
tional Conference on. IEEE, 2001.
[31] J. D. Monnier and R. J. Allen. Radio and optical inter-
ferometry: Basic observing techniques and data anal-
ysis. In Planets, Stars and Stellar Systems. Springer,
2013.
[32] A. Moreira, P. Prats-Iraola, M. Younis, G. Krieger,
I. Hajnsek, and K. P. Papathanassiou. A tutorial on
synthetic aperture radar. IEEE Geoscience and Re-
mote Sensing Magazine, March 2013.
[33] D. C. Munson, J. D. O’Brien, and W. K. Jenkins. A
tomographic formulation of spotlight-mode synthetic
aperture radar. Proceedings of the IEEE, Aug 1983.
[34] A. V. Oppenheim and A. S. Willsky. Signals and sys-
tems. Prentice-Hall, 1997.
[35] T. A. Pauls, J. S. Young, W. Cotton, and J. Monnier.
A data exchange standard for optical (visible/ir) inter-
ferometry. Publications of the Astronomical Society of
the Pacific, 2005.
[36] S. Renard, E. Thiébaut, and F. Malbet. Image recon-
struction in optical interferometry: benchmarking the
regularization. Astronomy & Astrophysics, 2011.
[37] J. Skilling. Quantified maximum entropy. In Maxi-
mum Entropy and Bayesian Methods. Springer, 1990.
[38] G. B. Taylor, C. L. Carilli, and R. A. Perley. Synthesis
imaging in radio astronomy ii. In Synthesis Imaging
in Radio Astronomy II, 1999.

922

You might also like