TOI processing

From Planck Legacy Archive Wiki
Revision as of 01:15, 3 February 2016 by Dscott (talk | contribs) (Beam-convolved dipole)
Jump to: navigation, search

Overview[edit]

The LFI Level 2 Pipeline analyses data from each horn of the instrument separately, one pointing period at a time, and stores the results in an object the length of an OD. Each diode of the horn is corrected for systematic effects. Next, measurements of the sky and the 4-K load are differenced, then the signals from one diode are combined with signals from the complementary diode in the same radiometer. Finally, photometric calibration is applied for each horn.

Pre-processing[edit]

Before the Level 2 pipeline is run, the Mission information and data sampling divisions are stored in the database, in order to improve the analysis.

The Mission information is a set of objects, one for each Operational Day (OD, as defined in the glossary), in which are stored pointing period data: the DPC pointing ID (where 1 is the first pointing of the nominal mission); PSO pointing ID; start OBT of the pointing manoeuvre; start OBT of the stable pointing period; OBT of the end of the stable pointing period; and spin axis ecliptic longitude and latitude.

The sampling information is a set of objects, one for each LFI frequency, in which are stored for each pointing ID: the start OBT of the pointing manoeuvre; th start OBT of the stable pointing period; the end OBT of the pointing period; the number of samples of the pointing, number of stable samples of the pointing; the starting sample of the stable pointing period; and the sample number from the start of the nominal mission. Valid samples and OBTs are defined to be those where any of the radiometers in a frequency band contain valid data.

ADC correction[edit]

During the analysis of LFI date, a systematic effect was discovered that was common to both white noise and calibration. This turned out to be a nonlinearity in the analogue-to-digital converter (ADC) on board, as discussed further in Planck-2013-II[1], Planck-2013-III[2], Planck-2015-A03[3], and Planck-2015-A04[4].

Evaluation[edit]

The mathematical model represents the digital ADC output as:

[math] X = (V - \Delta) \gamma + x_0 [/math],

where V is the voltage input, γ is the DAE gain, Δ is the DAE offset and x0 is the DAE Tzero.

We can model the non-linearity as a function of the input voltage R(V). So we have the apparent inferred voltage V' and we can link it to the actual input voltage with:

[math] \{(V - \Delta) \gamma + x_0\} R(V) = X' = (V' - \Delta) \gamma + x_0 [/math],

so that

[math] R(V) = (V' - \Delta) \gamma + x_0 \over (V - \Delta) \gamma + x_0 [/math].

Since V >> Δ and V γ >> x0, we can use the much simpler relation

[math] R(V) = \frac{V'}{V} [/math],

and we expect this to be very near to unity for all V.

To find the response curve we have only the apparent voltage to work with, so we had to use the inverse response function R'(V') and replace the real input voltage with Tsys times the time varying gain factor G(t):

[math] V = V'R'(V') = G(t)T_{\rm sys} [/math].

If we introduce a small signal on top of Tsys, which leads to increased detected voltage and corresponding apparent voltage increment, then

[math] V + \delta V = (V' + \delta V')\,R' (V' + \delta V') = G(t) (T_{\rm sys} + \delta T) [/math],

so carrying out the differentiation with respect to V' of the relation between true and apparent signal voltage leads to

[math] \delta V = \left\{ V' {dR'(V') \over dV'} + R'(V') \right\} \delta V' = G(t) \delta T [/math].

We now assume Tsys and δT are fixed and that the variations are due to slow drifts in the gain. Then we can isolate the terms

[math] V' = {G(t) T_{\rm sys} \over R'(V')} [/math],
[math] \delta V' = {G(t) \delta T \over V' {dR'(V') \over dV} + R'(V')} [/math].

Combining the equations to remove the gain factor, we have

[math] {V' R'(V') \over T_{\rm sys}} = {\delta V' \left\{{V'dR'(V') \over dV'} + R'(V')\right\} \over \delta T } [/math].

Rearranging and setting a = δT/Tsys gives

[math] {dR'(V') \over dV' } = \left( {a V'\over \delta V'} - {1 \over V'} \right) R'(V') [/math].

We see the expected direct proportionality of δV' to V', based on the assumption that the variations in voltage are due to overall gain drift, so that the amplitude of voltage and signal will vary together. Then there is the additional differential term, which will pull the signal amplitude away from the linear relationship. So if we plot measured white noise or dipole gain factor against recovered voltage, we should see a linear curve with variations due to local slope changes at particular voltages. The linear part can be taken out and the differential part fitted. This was numerically integrated to obtain the inverse response curve, which is then used to convert the measured voltages to corrected voltages.

Application[edit]

For each of the 44 LFI diodes there is a corresponding corrected object in the Database. Each object contains four columns: the input voltages coming from the sky channel, plus the corresponding linearized output; and the input voltages coming from the 4-K reference channel, plus the corresponding linearized output.

Data loaded by this module are used to initialize two different interpolators using cubic splines and the functions from GSL (GNU Scientific Libraries) libraries. These interpolators are then used to correct each sample.

Spike removal[edit]

Some of the LFI receivers exhibit a small artefact with exactly 1-s period, that produces effects visible in the power spectra. The effect is a set of spikes at 1 Hz and harmonics. The spurious signal can be well modelled and is removed from the timelines. More information can be found in Planck-2013-II[1], Planck-2013-III[2], Planck-2015-A03[3], and Planck-2015-A04[4].

Modelling[edit]

The cause of the spikes at 1 Hz and harmonics is a tiny 1-s square-wave embedded in signals from the affected channels. The method used to estimate the 1-Hz signal is to build a template in the time domain, synchronized with the spurious signal. The first step is to divide each second of data into time bins using OBT. The number of bins is computed using

[math] N_{\rm bins} = f_{\rm samp} \times template\_resolution[/math]

where fsamp is the sampling frequency and is 136 Hz at 70 GHz, 80 at 44 GHz, and 56 at 30 GHz. Then the vector of bins is initialized with time intervals. To avoid aliasing effects, the template resolution is √3. We can write the process adding indices to the time sample; here a lower index denotes the particular time sample, while the upper index labels the bin into which the sample falls. The linear filter can be written as

[math] s(t_{i}^{j}) = a_j \left\{1- \Delta x (t_{i}^{j}) \right\} + a_{j+1} \Delta x (t_{i}^{j})[/math].

Here Δx(ti) is the filter weight, which is determined by where the sample lies within the bin. If we use tj with only an upper index to denote the start of each bin, then we can write the filter weight as

[math] \Delta x (t_{i}^{j}) = {{{t_i^j - t^j} \over {t^{j+1} - t^j}}} [/math].

In other words, the filter weight is the time sample value minus the start of the bin divided by the width of the bin.

We must estimate the parameters aj from the data. With the assumption that the instrument has stable noise properties, we can use a least squares algorithm to estimate the bin values:

[math] {\partial \over \partial a_k} \sum_{i,j} \left( s(t_i^j) – d_i^j \right)^2 = 0 [/math].

This can be represented in the matrix equation

[math] {\sf M}_{jk}a_k = b_j [/math],

with the following definitions:

[math] {\sf M}_{k,k-1} = \sum_i \left\{1 - \Delta x (t_i^{k-1})\right\} \Delta x (t_i^{k-1}) [/math];
[math] {\sf M}_{k,k} = \sum_i \left\{1 - \Delta x (t_i^k)\right\}^2 \Delta x (t_i^{k-1})^2 [/math];
[math] {\sf M}_{k,k+1} = \sum_i \left\{1 - \Delta x (t_i^k)\right\} \Delta x (t_i^k) [/math];
[math] {\sf M}_{k,k+n} (|n| \gt 1) = 0 [/math];
[math] b_j = \sum_i d_i^k \left\{1- \Delta x (t_k^i)\right\} + d_i^{k-1}\Delta x (t_i^{k-1}) [/math].

With these definitions we have to make use of periodic boundary conditions to obtain the correct results, such that if k = 0, then k-1 = n-1 and if k = n-1, then k+1 = 0. Once this is done, we have a symmetric tridiagonal matrix with additional values at the upper right and lower left corners. The matrix can be solved with LU decomposition. In order to be certain of the numerical accuracy of the result, we can perform a simple iteration. The solving of the linear system and the iterative improvement of the solution are implemented as suggested in Numerical Recipes (Press et al., Cambridge University Press, 2007).

Application[edit]

For each of the 44 LFI diodes there is a corresponding object in the Database. After studying the amplitude of the spikes at other LFI frequencies, we chose to apply the correction only to the 44 GHz radiometers. Each object contains three columns: the bins start time vector; the sky amplitudes; and the reference amplitudes.

For each sample the value to be subtracted is computed using

[math] V = A^{\rm sky}_k (1 - \Delta x (t_k)) + A^{\rm sky}_{k+1} \Delta x (t_k) [/math],

where k is the index of the bins at a given time.

Filling gaps in the data[edit]

During the mission, a small number of data packets were lost (Planck-2013-II[1], Planck-2015-A03[3]). Moreover, in two different and very peculiar situations, LFI was shut down and restarted, giving inconsistencies in data sampling. None of these data are used for scientific purposes, but to avoid discrepancies in data analysis all of the radiometers at the same frequency must have the same number of samples.

To ensure this, we compare the length of the data stream to be reduced in a specific pointing period to the data stored in the sample information object. If the length is not the same, the OBT vector is filled with missing sample times, the data vector is filled with zeros, and in the flag column the bit for "gap" is entered.

Gain modulation factor[edit]

The pseudo-correlation design of the LFI radiometers allows for a dramatic reduction of 1/f noise when the Vsky and Vload outputs are differenced (see LFI instrument description). The two streams are slightly unbalanced, since one looks at the 2.7-K sky and the other looks at the 4.5-K reference load. To force the mean of the difference to zero, the load signal is multiplied by the gain modulation factor (R). For each pointing period this factor is computed using (see equation (3) in LFI description)

[math] R = { \left\langle V_{\rm sky}\right\rangle \over \left\langle V_{\rm load}\right\rangle} [/math].

Then the data are differenced using

[math] {\rm TOI}_{\rm diff}^i = V_{\rm sky}^i – R V_{\rm load}^i [/math].

This value for R minimizes both the 1/f noise and the white noise in the difference timestream. The i index represents the diode and can be 0 or 1.

At this point, we also set the manoeuvre flag bit to identify those samples that have missing data, using the information stored in the sampling information object. This identifies which data to ignore in the next step of the Pipeline.

The R values are stored in the database. At the same time the mean values of Vsky and Vload are stored, so they can be used in other steps of the analysis.

Diode combination[edit]

The two complementary diodes of each radiometer are combined. The relative weights of the diodes in the combination are chosen for optimal noise. We assign relative weights to the uncalibrated diode streams based on their first-order calibrated noise.

Evaluation[edit]

From first-order calibration we compute an absolute gain G0 and G1, subtract an estimated sky signal and calculate the calibrated white noise σ0 and σ1, for the pair of diodes (see equation 6 in LFI description). The weights for the two diodes (i = 0 or 1) are

[math] W_i = {\sigma_i^2 \over G_{01}} {1 \over {\sigma_0^2 + \sigma_1^2}} [/math],

where the weighted calibration constant is given by

[math] G_{01} = {1 \over {\sigma_0^2 + \sigma_1^2}} \left(G_0 \sigma_1^2 + G_1 \sigma_0^2\right) [/math].

The weights are fixed to a single value per diode for the entire data set. Small variations in the relative noise of the diodes would in principle require that we recalculate the weights on shorter timescales; however, we decided that a time-varying weight could possibly induce more significant (and hard to model) systematics, so we chose a single best estimate for the weights for each diode pair.

LFI weights.jpg

Weights used in combining diodes.

Application[edit]

The weights in the table above are used in the formula

[math] {\rm TOI}_{\rm diff} = w_0 {\rm TOI}_{\rm diff,0} + w_1 {\rm TOI}_{\rm diff,1} [/math].

Planet flagging[edit]

Extraction method[edit]

Measurements of planets have been formed from samples containing flux from the planet, plus a surrounding region, projected onto a grid (microstripes), by assuming an elliptical Gaussian beam using parameters from instrument database.

Microstripes are a way to extract and store relevant samples for planet detection. Here relevant samples are those affected by the planet plus samples in the neighbourhood (to establish a background level). The search radius for selecting samples as relevant is 5° around the planet's position, computed at the pointing period mid-time. For each sample we store SCET (Spacecraft Event Time), pointing directions, and calibrated temperature. Destriping is applied during the application of this procedure.

Random errors are estimated by taking the variance of samples entering each micromap pixel. This method is fast but not exact, since the variance is larger near a bright source. This can cause the noise to be overestimated by a factor of 2; however, given the large S/N for planetary observations, that is not a major drawback.

The apparent position of a planet as seen from Planck at a given time is derived from JPL Horizons. Positions are tabulated in steps of 15 minutes and then linearly interpolated at the sampling frequency of each detector. JPL Horizons tables allow us also to derive other quantities such as the planet-Planck distance and the planet-Sun distance, as well as the planet angular diameter, which affects the apparent brightness of the planet.

The antenna temperature is a function of the dilution factor, according to

[math] T_{\rm ant,obs} = 4 \log 2\,T_{\rm ant,1} \left( {\theta \over b_{\rm FWHM} } \right) ^2 [/math],

where Tant,obs and Tant,1 are the observed and reduced Tant, θ is the instantaneous angular diameter of the planet, and bFWHM the beam full-width at half-maximum.

With the above definition Tant,1 could be considered as the Tant for a planet with bFWHM = θ, but a more convenient view is to take a reference dilution factor D0, as the dilution factor for a standardized angular diameter for the planet and fiducial FWHM beam bFWHM, θ0, to have

[math] D_0 = \left( {\theta_0 \over b_0 } \right) ^2 [/math],

leading to the following definition of a standardized Tant:

[math] T_{\rm ant,obs} = 4 \log 2\, T_{\rm ant,0} \left( {b_{\rm FWHM,0} \over b_{\rm FWHM}} {\theta \over \theta_0} \right) ^2 [/math].

This has the advantage of removing variations among different detectors and transits, while keeping the value of Tant similar to that seen by the instrument and then allowing a prompt comparison of signals and sensitivities.

Application[edit]

The OBT vectors found by the searches are saved in a set of objects, one for each horn. In the Level 2 pipeline those OBTs are compared with the OBT vector of the data to set the planet bit flag where needed.

Photometric calibration[edit]

Photometric calibration is the procedure used to convert data from volts to kelvins. The source of the calibration is the well understood CMB dipole, caused by the motion of the Solar System with respect to the CMB reference frame. To this signal we add the modulation induced by the orbital motion of Planck around the Sun. The resulting signal is then convoluted with the horn beam to obtain the observed dipole. For details refer to Planck-2015-A06[5].

Beam-convolved dipole[edit]

In computing the beam-convolved dipole we used an elegant algorithm to save time and computing power. In computing the cosmological dipole signal it is common to assume a pencil-like beam acting as a Dirac delta function. In this case a dipole timeline is defined as

[math] \Delta T_{D,\delta}(t) = \mathbf{P}_{\rm E}(t) \cdot \mathbf{D}_{\rm E} [/math]

where PE(t) is the pointing direction in the observer reference frame and DE(t) is the dipole axis scaled by the dipole amplitude, again in the same reference frame (here the label "E" is for "Ecliptic").

In general the true signal would have to be convolved with the beam pattern of the given radiometer, usually described as a fixed map in the beam reference frame or as a time-dependent map in the observer reference frame. In this case it is easiest to describe the convolution in the beam reference frame, since the function to be convolved then can be described by a single vector.

Denoting by [math] {\sf U}(t) [/math] the matrix converting from the observer to the beam reference frame, so that

[math] {\sf U}(t) \mathbf{P}_{\rm E}(t) = \mathbf{e}_z [/math],

the instantaneous dipole direction in the beam reference frame is

[math] \mathbf{D}(t) = {\sf U}(t) \mathbf{D}_{\rm E} [/math].

By denoting with [math] \mathbf{P} [/math] a pointing direction in the beam reference frame, then

[math] \Delta T_D(t) = N \int_{4\pi} B(\mathbf{P})\,\mathbf{P} \cdot \mathbf{D}(t)\, d^3\mathbf{P} [/math],

where N is a normalization constant defined through

[math] N^{-1} = \int_{4\pi} B(\mathbf{P}) d^3\mathbf{P} [/math].

Denoting with Px, Py, and Pz the three Cartesian components of P, the integral of the dot product can be decomposed into three independent integrals:

[math] S_x = N \int_{4\pi} B(\mathbf{P}) P_x d^3\mathbf{P} [/math];
[math] S_y = N \int_{4\pi} B(\mathbf{P}) P_y d^3\mathbf{P} [/math];
[math] S_z = N \int_{4\pi} B(\mathbf{P}) P_z d^3\mathbf{P} [/math].

These integrals define a time independent vector characteristic of each radiometer and constant over the mission.

Detector ID [math] S_x [/math] [math] S_y [/math] [math] S_z [/math]
LFI18S 4.64653×10-3 -1.3271241134658798×10-3 9.9577083251002374×10-1
LFI18M 2.84449×10-3 -8.9511701920330633×10-4 9.9735308499993403×10-1
LFI19S 4.29488×10-3 -1.4037771886936600×10-3 9.9612844031547154×10-1
LFI19M 4.50970×10-3 -1.6255119872940569×10-3 9.9573258887316529×10-1
LFI20S 5.27978×10-3 -1.9479348764780897×10-3 9.9514557074549859×10-1
LFI20M 4.74206×10-3 -1.8462064956921880×10-3 9.9548302435765323×10-1
LFI21S 5.23772×10-3 1.9337533884005056×10-3 9.9517552967578515×10-1
LFI21M 4.37131×10-3 1.7075534076511198×10-3 9.9585142295482576×10-1
LFI22S 3.62730×10-3 1.2030860597901591×10-3 9.9679007501368400×10-1
LFI22M 3.1817723013115090×10-3 1.1383448292256770×10-3 9.9705527860728405×10-1
LFI23S 3.25825×10-3 9.1080217792813213×10-4 9.9706066300815721×10-1
LFI23M 2.63850×10-3 8.0545189089709709×10-4 9.9755224385088148×10-1
LFI24S 1.20077×10-3 -2.9877396130232452×10-7 9.9897924004634964×10-1
LFI24M 1.19670×10-3 -1.3590311231894260×10-6 9.9894545519286426×10-1
LFI25S -2.10060×10-4 4.4287041964311393×10-4 9.9965683952381934×10-1
LFI25M -2.51334×10-4 5.5803053337715499×10-4 9.9954614333864866×10-1
LFI26S -1.97667×10-4 -4.2202164851420096×10-4 9.9966955259454382×10-1
LFI26M -2.54267×10-4 -5.7426678736881309×10-4 9.9952104084618332×10-1
LFI27S 5.85555×10-3 1.8175261751324087×10-3 9.9448302844644199×10-1
LFI27M 4.99628×10-3 1.5766304210447924×10-3 9.9529240281463061×10-1
LFI28S 6.37507×10-3 -1.9617207193203534×10-3 9.9396633709784610×10-1
LFI28M 4.78777×10-3 -1.5442874049905993×10-3 9.9551694709996730×10-1
Characteristic verctors for each LFI detector.


By using this characteristic vector the calculation of the convolved dipole is simply defined by a dot product of the vector [math] \mathbf{S} [/math] and the dipole axis rotated in the beam reference frame:

[math] \Delta T (t) = \mathbf{S}^{\rm T} {\sf U}(t) \mathbf{D}_{\rm E} [/math].

Binning[edit]

In order to simplify the computation and to reduce the amount of data used in the calibration procedure the data are phase binned in map with Nside=256. During phase binning all the data flagged for maneuvers, planets and gaps, as well as the ones flagged in Level 1 analysis as not recoverable, are ignored.

Fit[edit]

The first order calibration values are given by a least squares fit between the signal and the dipole. For each pointing gain ([math] g_k [/math]) and offset ([math] b_k [/math]) values are computed by minimizing

[math] \chi^2 = \sum_{i \in k} {\left\{ \Delta V (t_i) - \Delta V_{\rm model} (t_i|g_k, b_k)\right\}^2 \over {\rm rms}_i^2 } [/math],

where the sum includes only samples outside a Galactic mask.

DaCapo[edit]

The largest source of error in the fit arises from unmodeled sky signal [math] \Delta T_a [/math] from CMB anisotropy.

The procedure adopted to correct this effect is described below.

The uncalibrated toi [math]y_{i}[/math] belonging to a pointing period [math]k[/math] is modeled as

[math]y_{i}=g_{k}*(s_{i}+d_{i})+b_{k}+n[/math]

where the unknowns [math]s_{i}[/math],[math]g_{k}[/math] and [math]b_{k}[/math] are respectively the signal per OBT, the gain per PID and the offset per PID, and [math]d_{i}[/math] is the total dipole.

This is a non linear [math]\chi^{2}[/math] minimization problem. It can be linearized with an iterative procedure: for each iteration step a linearized model toi is built as

[math]y_{i,model}=g_{k}(-1)*(s_{i}-s_{i}(-1))+g_{k}*(d_{i}+a_{i}(-1))+b_{k}[/math]

where [math]g_{k}(-1)[/math] and [math]s_{i}(-1)[/math] are the gain and sky signal computed at the previous step of iteration.

A linear fit is performed between [math]y_{i}[/math] and [math]y_{i,model}[/math] to get the new [math]g_{k}[/math] and [math]s_{i}[/math] . The procedure is iterated until convergence.

To reduce the impact of the noise during the iterative procedure the sky estimation is built using data from both radiometers of the same horn.

Smoothing[edit]

To improve accuracy given by the iterative algorithm and remove noise from the solution a smoothing algorithm must be performed.

OSGTV[edit]

OSGTV is a 3 step smoothing algorithm, implemented with a C++ code.

The gain reconstructed with DaCapo can be expressed as

[math]G_{raw}(t,T(t))=G_{true}(t,T(t))+G_{noise}(t)[/math]

where the [math]T(t)[/math] function represents temperature fluctuations of the Focal Plane. The time dependence of the “real” gain [math]G_{true}[/math] is modeled as the superposition of a “slow” component, with a time scale of ~3 months, and a “fast” component with a time scale of few PIDs:

[math]G_{true}=G_{slow}+G_{fast}[/math].

The slow component takes into account the seasonal variations of the thermal structure of the spacecraft due to the orbital motion, while the “fast” component describes the thermal effects of the electronics and compressors, as well as single events like the sorption cooler switchover.

To disentangle the components of [math]G_{true}[/math], we need a parametric “hybrid” approach in three steps.

Step 1. For each PID [math]i[/math], we used the 4K total-power [math]V_{load}(i)[/math] and the signal from temperature detectors in the focal plane [math]T_{i}[/math], subsampled at 1 sample/PID, to track gain changes. This is implemented through a linear fit between [math]V_{load}(i) * G_{raw}[/math] and [math]T_{i}[/math]:

[math]V_{load}(i)*G_{raw}=K_{0}+K_{1}*(T_{i}-\langle T_{MW}\rangle)[/math]

where the window length [math]MW[/math] of the moving average is proportional to the variance of the dipole in the considered PID. The resulting gain is:

[math] G_{i} = \frac{ K_{0} + K_{1} * (T_{i} - \langle T_{MW} \rangle ) }{ V_{load}(i) } [/math]

Step 2. The "fast" component [math]G_{fast}[/math] is recovered as follows: we define a maximum moving average window length [math]WL_{max}[/math],and for each PID we compute the variance [math]\sigma_{i}^2[/math] of [math]G_{i}[/math] in this window. We define a percentile on the ordered variance array and we compute the corresponding value of the variance [math]\sigma_{p}^2[/math]. The window length for each PID is then computed as

[math]WL_{i}=\frac{\sigma_{p}^2*WL_{max}}{\sigma_{i}^2}[/math].

If [math]WL_{i}\gt WL_{max}[/math] we impose [math]WL_{i}=WL_{max}[/math]. With these window lengths a moving window average is performed on [math]G_{i}[/math]. The averaged gain vector is subtracted from the raw hybrid gain to get [math]G_{fast}[/math].

Step 3. We perform a moving window average on [math]G_{i}[/math] and we compute the variances of the smoothed array. The window length is computed with a linear interpolation between a minimum length [math]WL_{min}[/math] defined in the dipole minima and a maximum [math]WL_{max}[/math] defined in the dipole maxima. The array of gain variances is weighted with the variance of the dipole. We set a percentile on the variance array and we find the corresponding variance value [math]\sigma_{p}^2[/math]. Around this value we search for local maxima of the variance array, and we split the domain of the gain in subsets between consecutive maxima. For each subset we perform a moving average with the corresponding window length. The "slow" component [math]G_{slow}[/math] is given by the union of these subsets.

Gain Application[edit]

The last step in TOI processing is the creation of the calibrated stream. For each sample we have:

[math] TOI_{cal}(t) = (TOI_{diff}(t) – offset(k)) \cdot g(k) \, - \, convDip(t)\, - \, T_{stray}(t)[/math]

where t is the time and k is the pointing period, [math] convDip [/math] is the CMB dipole convolved with the beam, and [math]T_{stray}[/math] is the straylight.

Noise[edit]

This pipeline step aims at the reconstruction of the noise parameters from calibrated flight TOI. The goal is two-fold. On the one hand we need to know the actual noise properties of our instrument in order to properly take them into account, especially during later processing and analysis steps like map-making and power spectrum estimation. On the other hand evaluation of noise properties during the instrument life-time is a way to track down possible variations, anomalies and general deviations from the expected behaviour.

Operations[edit]

Noise estimation is performed on calibrated data; since we would like to track possible noise variations during the mission life-time, we select data in chunks of 5 ODs (Operational Days). These data are processed by the ROMA Iterative Generalized Least Square (IGLS) map-making algorithm which includes a noise estimation tool. In general IGLS map-making is a quite costly in terms of time and resources required. However the length of the data is such that it can run on the DPC cluster in very short time (~1-2 minutes).

The method implemented can be summerized as follows. We model the calibrated TOI as

[math] \mathbf{\Delta T} = \mathbf{P} \mathbf{m} + \mathbf{n} [/math]

where [math] \mathbf{n} [/math] is the noise vector and [math] \mathbf{P} [/math] is the pointing matrix that links a pixel in the map [math] \mathbf{m} [/math] with a sample in the TOI [math] \mathbf{d} [/math]. The zero-th order estimation of the signal is obtained by simply rebinning TOI into a map. Then an iterative approach follows in which both signal and noise are estimated according to

[math] \mathbf{\hat{n}_i} = \mathbf{\Delta T} - \mathbf{P\hat{m}_i} [/math]
[math] \mathbf{\hat{m}_{i+1}} = \mathbf{(P^T\hat{N}_i^{-1}P)^{-1}P^T\hat{N}_i^{-1}\Delta T} [/math]

where [math] \mathbf{\hat{N}_i} [/math] is the noise covariance matrix in the time domain resulting from iteration [math]i [/math]. After three iterations, convergence is achieved.

We then perform an FFT (Fast Fourier Transform) on the noise time stream from the iterative approach and fit the resulting spectrum.

Fitting Pipeline[edit]

As already done in the 2013 release, we estimate the parameters of the noise properties (i.e. white noise level, knee-frequency and slope of the low-frequency noise component) by means of a MCMC approach. Therefore on the spectra just described we first compute the white noise level taking the mean of the last 10% of data (at 30 GHz due to the higher value of the knee-frequency this quantity is reduced to 5%). Once the white noise level has been determined we proceed with the actual fitting of knee-frequency and slope. The resulting values reported are the medians of the fitted values for our 5 ODs chunk along the whole mission lifetime.

Horn White Noise M [[math]\mu[/math]K s[math]^{1/2}[/math]] White Noise S [[math]\mu[/math]K s[math]^{1/2}[/math]] Knee-frequency M [mHz] Knee-frequency S [mHz] Slope M Slope S
18 513.0[math]\pm[/math]2.1 467.2[math]\pm[/math]2.3 14.8[math]\pm[/math]2.5 17.8[math]\pm[/math]1.5 -1.06[math]\pm[/math]0.10 -1.18[math]\pm[/math]0.13
19 579.6[math]\pm[/math]2.2 555.0[math]\pm[/math]2.2 11.7[math]\pm[/math]1.2 13.7[math]\pm[/math]1.3 -1.21[math]\pm[/math]0.26 -1.11[math]\pm[/math]0.14
20 587.3[math]\pm[/math]2.1 620.5[math]\pm[/math]2.7 8.0[math]\pm[/math]1.9 5.7[math]\pm[/math]1.5 -1.20[math]\pm[/math]0.36 -1.30[math]\pm[/math]0.41
21 451.0[math]\pm[/math]1.7 560.1[math]\pm[/math]2.0 37.9[math]\pm[/math]5.2 13.3[math]\pm[/math]1.5 -1.25[math]\pm[/math]0.09 -1.21[math]\pm[/math]0.09
22 490.8[math]\pm[/math]1.5 531.3[math]\pm[/math]2.3 9.7[math]\pm[/math]2.3 14.8[math]\pm[/math]6.7 -1.42[math]\pm[/math]0.23 -1.24[math]\pm[/math]0.30
23 504.3[math]\pm[/math]1.8 539.7[math]\pm[/math]1.8 29.7[math]\pm[/math]1.1 59.0[math]\pm[/math]1.4 -1.07[math]\pm[/math]0.03 -1.21[math]\pm[/math]0.02
24 463.0[math]\pm[/math]1.4 400.7[math]\pm[/math]1.3 26.8[math]\pm[/math]1.3 88.3[math]\pm[/math]8.9 -0.94[math]\pm[/math]0.01 -0.91[math]\pm[/math]0.01
25 415.3[math]\pm[/math]1.5 395.4[math]\pm[/math]2.9 20.1[math]\pm[/math]0.7 46.4[math]\pm[/math]1.8 -0.85[math]\pm[/math]0.01 -0.90[math]\pm[/math]0.01
26 483.0[math]\pm[/math]1.9 423.2[math]\pm[/math]2.5 64.4[math]\pm[/math]1.9 68.2[math]\pm[/math]9.5 -0.92[math]\pm[/math]0.01 -0.76[math]\pm[/math]0.01
27 281.5[math]\pm[/math]2.1 303.2[math]\pm[/math]1.8 174.5[math]\pm[/math]2.9 108.8[math]\pm[/math]2.5 -0.93[math]\pm[/math]0.01 -0.91[math]\pm[/math]0.01
28 317.1[math]\pm[/math]2.4 286.5[math]\pm[/math]2.3 130.1[math]\pm[/math]4.4 43.1[math]\pm[/math]2.4 -0.93[math]\pm[/math]0.01 -0.90[math]\pm[/math]0.02

Time variations of noise parameters are a good tracer of possible modifications in the instrument behaviour and we know that some events capable of affecting instrument behaviour had happened during the mission. Both variations of the physical temperature of the instrument due to the transition in the operations from the first sorption cooler to the second one, as well as the observed degradation in the performances of the first cooler are events that clearly show their fingerprints in the variation of the noise spectra.

In the following figure we report a representative sample of noise spectra, one for each frequency channel (from left to right LFi 18M, LFI 25S and LFI 27M), covering the whole mission lifetime. The white noise is extremely stable at the level of 0.3%. As already noted in the 2013 release, knee-frequencies and slopes are stable until OD 326 and show clear variations and deviations from the simple one knee-frequency one slope model. This is a sign of the degradation of the first cooler inducing thermal variations with a characteristic knee-frequency (different from the radiometric one) and with a steeper slope. Once the second cooler became operational and performed as expected, the noise spectra gradually returned to the original shape at the beginning of the mission. This behaviour is visible, although not identical at each frequency for several reasons e.g. intrinsic thermal susceptibility and position on the focal plane that determines the actual thermal transfer function.


'"'LFI 18M.'"' '"'LFI 25S.'"' '"'LFI 27M.'"'

References[edit]

  1. 1.01.11.2 Planck 2013 results. II. Low Frequency Instrument data processing, Planck Collaboration, 2014, A&A, 571, A2.
  2. 2.02.1 Planck 2013 results. III. Low Frequency Instrument systematic uncertainties, Planck Collaboration, 2014, A&A, 571, A3.
  3. 3.03.13.2 Planck 2015 results. II. LFI processing, Planck Collaboration, 2016, A&A, 594, A2.
  4. 4.04.1 Planck 2015 results. III. LFI systematics, Planck Collaboration, 2016, A&A, 594, A3.
  5. Planck 2015 results. V. LFI calibration, Planck Collaboration, 2016, A&A, 594, A5.

(Planck) Low Frequency Instrument

Operation Day definition is geometric visibility driven as it runs from the start of a DTCP (satellite Acquisition Of Signal) to the start of the next DTCP. Given the different ground stations and spacecraft will takes which station for how long, the OD duration varies but it is basically once a day.

Data Processing Center

Planck Science Office

On-Board Time

analog to digital converter

LFI Data Acquisition Electronics

Full-Width-at-Half-Maximum

Cosmic Microwave background