TOI processing

From Planck PLA Wiki
Jump to: navigation, search

Overview[edit]

The LFI Level2 Pipeline analyzes each horn of the instrument separately, one pointing period at time, and store results in object the length of an OD. Each diode of the horn is corrected from systematic, differentiated and then combined with its complementary diode in the same radiometer. The horn is then calibrated and the photometric calibration is applied.

Pre-processing[edit]

Before the run of the Level2 pipeline and to improve the analysis the Mission information and data sampling divisions are stored in the database.

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: DPC pointing ID (where 1 is the first pointing of the nominal mission), PSO pointing ID, start OBT of the pointing maneuver, start OBT of the stable pointing, end OBT of the pointing, 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: start OBT of the pointing maneuver, start OBT of the stable pointing, end OBT of the pointing, number of samples of the pointing, number of stable samples of the pointing, start sample of the stable pointing and sample number from the start of the nominal mission. Valid samples and OBTs are defined where any of the radiometers from that frequency cohort contain valid data.

ADC Correction[edit]

During analysis it appeared that white noise and calibration seemed affected by something in common. It turn out to be a non linearity in the Analogic/Digital Converter on board. More on Planck-2013-II[1],Planck-2013-III[2].

Evaluation[edit]

The mathematical model represents the digital ADC output as:

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

where [math] V [/math] is the voltage input, [math] \gamma [/math] is the DAE gain, [math] \Delta [/math] is the DAE offset and [math] x_0 [/math] is the DAE [math] T_{zero} [/math].

We can model the non-linearity as a function of the input voltage [math] R(V) [/math]. So we have the apparent inferred voltage [math] V^' [/math] 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 [math] V \gt \gt \Delta [/math] and [math] V \gamma \gt \gt x_0 [/math] we can use the much simpler relation:

[math] R(V) = {V^' \over V} [/math]

and we expect it to be very near to unity for all [math] V [/math].

To find the response curve we have only the apparent voltage to work with, so we had to use the inverse response function [math] R^'(V^') [/math] and replace the real input voltage with [math] T_{sys} [/math] times the time varying gain factor [math] G(t) [/math].

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

If we introduce a small signal on top of [math] T_{sys} [/math] which leads to increased detected voltage and corresponding apparent voltage increment:

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

so carrying out the differentiation respect to [math] V^' [/math] to 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 [math] T_{sys} [/math] and [math] \delta T [/math] are fixed and that the variations are due to slow drifts in the gain. So we can isolate the terms:

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

Combining the equations through the gain factor to remove it:

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

Rearranging and putting [math] a = {\delta T \over T_{sys}} [/math]

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

So there is the expected direct proportionality of [math] \delta V^' [/math] to [math] V^' [/math] due to the assumption that the variations in voltage are due to overall gain drift, so the amplitude of voltage and signal will vary together. Then there is the additional differential term which will pull signal amplitude away from the linear relationship. So if we plot measured white noise or dipole gain factor against recovered voltage we should see this 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 up to get the inverse response curve, what we need to convert the measured voltages to corrected voltages.

Application[edit]

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

Data loaded by the module are used to initialize two different interpolators using CSPLINE and the functions from gsl (GNU Scientific Libraries) libraries. The interpolators are then used to correct each sample.

Spikes Removal[edit]

Some of the LFI receivers exhibit a small artifact with exactly 1 second repetition, which visible in the power spectra. The effect is a set of spikes at 1 Hz and harmonics. The spurious signal is very well modeled and is removed from the timelines. More information can be found in Planck-2013-II[1], Planck-2013-III[2].

Modeling[edit]

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

[math] nbins = fsamp * template\_resolution[/math]

where fsamp is the sampling frequency and is 136 at 70 GHz, 80 at 44 GHz and 56 at 30 GHz. Then the bins vector is initialized with time intervals. To avoid aliasing effects template resolution is [math] \sqrt {3} [/math] . We can write the process adding an index to the time sample: 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 [math] \Delta x (t_{i}^{j})[/math] is the filter weight which is determined by where within the bin sample lies. If we use [math] t^j [/math] with only an upper index to denote the start of each bin, then we can write the filter weight as follows:

[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 [math] a_j [/math] from the data. With the assumption that the instrument has stable noise properties, we can use a least square 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 matrix equation:

[math] M_{jk}a_k = b_j [/math]

with the following definitions:

[math] M_{k,k-1} = \sum_i (1 - \Delta x (t_i^{k-1})) \Delta x (t_i^{k-1}) [/math]
[math] M_{k,k} = \sum_i (1 - \Delta x (t_i^k))^2 \Delta x (t_i^{k-1})^2 [/math]
[math] M_{k,k+1} = \sum_i (1 - \Delta x (t_i^k)) \Delta x (t_i^k) [/math]
[math] M_{k,k+n} (|n| \gt 1) = 0 [/math]
[math] b_j = \sum_i d_i^k (1- \Delta x (t_k^i)) + 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 [math] k = 0 [/math], [math] k-1 = n-1 [/math] and [math] k = n-1 [/math], [math] k+1 = 0 [/math]. Once this is done, we have a symmetric tridiagonal matrix with additional values at the upper right and lower left corners of the matrix. The matrix is 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.

Application[edit]

For each of the 44 LFI diodes there is the corresponding object in the Database. Because of the amplitude of the spikes we choose to apply the correction only on the 44 GHz radiometers. Each object contains 3 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 = skyAmp_k (1 - \Delta x (t_k)) + skyAmp_{k+1} \Delta x (t_k) [/math]

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

Gaps Filling[edit]

During the mission some of the data packets were lost Planck-2013-II[1]. Moreover in two different and very peculiar situations LFI was shutdown and restarted, giving inconsistencies in data sampling. All of those data aren't used for scientific purpose but to avoid discrepancies in data analysis all of the radiometers at the same frequency must have the same samples.

To accomplish this the length of the data stream to be reduced in a specific pointing period is compared with 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 raised.

Gain Modulation Factor[edit]

The pseudo-correlation design of the LFI radiometers allows a dramatic reduction of [math] 1/f [/math] noise when the [math] V_{sky} [/math] and [math] V_{load} [/math] outputs are differenced (see LFI instrument description). The two streams are slightly unbalanced, as 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 eq. (3) in LFI description):

[math] R = {\lt V_{sky}\gt \over \lt V_{load}\gt } [/math]

Then the data are differenced using:

[math] TOI_{diff}^i = V_{sky}^i – R V_{load}^i [/math]

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

At this point the maneuver flag bit is set to identify which samples 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 [math] V_{sky} [/math] and [math] V_{load} [/math] are stored in order to 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 [math] G_0 [/math] and [math] G_1 [/math], subtract an estimated sky signal and calculate the calibrated white noise [math] \sigma_0 [/math] and [math] \sigma_1 [/math], for the pair of diodes (see eq. (6) in LFI description):. The weights for the two diodes ([math] i [/math] = 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}} [G_0 \sigma_1^2 + G_1 \sigma_0^2] [/math]

The weights are fixed to a single value per diode for the entire dataset. Small variations in the relative noise of the diodes would in principle suggest recalculating the weights on shorter timescales, however, we decided a time varying weight could possibly induce more significant subtle systematics, so chose a single best estimate for the weights for each diode pair.

Horn Weight M-00 Weight M-01 Weight S-10 Weight S-11
18 0.567304963 0.432695037 0.387168785 0.612831215
19 0.502457723 0.497542277 0.55143474 0.44856526
20 0.523020094 0.476979906 0.476730576 0.523269424
21 0.500324722 0.499675278 0.563712153 0.436287847
22 0.536283158 0.463716842 0.553913461 0.446086539
23 0.508036034 0.491963966 0.36160661 0.63839339
24 0.602269189 0.397730811 0.456037835 0.543962165
25 0.482050606 0.517949394 0.369618239 0.630381761
26 0.593126369 0.406873631 0.424268188 0.575731812
27 0.519877701 0.480122299 0.484831449 0.515168551
28 0.553227696 0.446772304 0.467677355 0.532322645

Application[edit]

The weights in the table above are used in the formula:

[math] TOI_{diff} = w_0 TOI_{diff0} + w_1 TOI_{diff1} [/math]

Planet Flagging[edit]

Extraction Method[edit]

The planets Temperature have been estimated from chunk of samples affected, 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 planets detection. Relevant samples are samples affected by the planet plus samples in the neighbor. The search radius to select samples as relevant is 5 deg around the planet 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 application.

Random errors are estimated by taking the variance of samples entering each micromap pixel. This is fast and the major problems (near a bright source the noise gives a larger value and it is difficult to extract the correlation matrix) causes the noise to be overestimated by a factor of two that in this situation is not a major drawback.

The apparent position of Planets as seen from Planck at a given time is derived from JPL Horizon. Position are sampled in tables at steps of 15 minutes and then linearly interpolated at the sampling frequency of each detector. JPL Horizons tables allow also to derive other quantities such as the Planet-Planck distance and the Planet-Sun distance nad the planet angular diameter affecting the apparent brightness of the planet.

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

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

where [math] T_{ant,obs} [/math] and [math] T_{ant,1} [/math] are the observed and reduced [math] T_{ant} [/math], [math] \theta [/math] the instantaneous planets angular diameter and [math] b_{fwhm} [/math] the beam full width half maximum.

With the above definition [math] T_{ant,1} [/math] could be considered as the [math] T_{ant} [/math] for a planet with [math] b_{fwhm} = \theta [/math], but a more convenient view is to take a Reference Dilution factor [math] D_0 [/math], as the dilution factor for a standardized planet angular diameter and beam fwhm [math] b_{fwhm} [/math], [math] \theta_0 [/math], to have:

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

leading to the following definition of a standardized [math] T_{ant} [/math]:

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

with the advantage of removing variations among different detectors and transits while keeping the value of [math] T_{ant} [/math] similar to that seen by the instrument and then allowing a prompt comparison of signals and sensitivities.

Application[edit]

The OBT vector found by the search are saved in a set of object, one for each horn. In Level2 Pipeline those OBTs are compared with the OBT vector of the data to raise planet bit flag where needed.

Photometric Calibration[edit]

Photometric calibration is the procedure used to convert data from volts to kelvin. The source of the calibration is the well known 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 get the observed Dipole.

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}_E(t) \cdot \mathbf{D}_E [/math]

where [math] \mathbf{P}_E(t) [/math] is the pointing direction, in the observer reference frame and [math] \mathbf{D}_E [/math] is the dipole axis scaled by the dipole amplitude again in the same reference frame.

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 is described by a single vector.

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

[math] \mathcal{U}(t) \mathbf{P}_E(t) = \mathbf{e}_z [/math]

the instantaneous dipole direction in the beam reference frame is:

[math] \mathbf{D}(t) = \mathcal{U}(t) \mathbf{D}_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 [math] \mathbf{N} [/math] is a normalization costant.

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

Denoting with [math] \mathbf{P}_x [/math], [math] \mathbf{P}_y [/math], [math] \mathbf{P}_z [/math] the three cartesian components of the [math] \mathbf{P} [/math] 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]

those 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 1.4105692317321994e-03 -3.7689062388084022e-04 9.9999893412338192e-01
LFI18M 1.1200251268914613e-03 -3.2838598619563524e-04 9.9999931885294768e-01
LFI19S 1.7861136968831050e-03 -4.4036975450455066e-04 9.9999830793473898e-01
LFI19M 1.4292780457919835e-03 -4.7454175238335579e-04 9.9999886598655352e-01
LFI20S 1.7008692096818349e-03 -6.1036624911600191e-04 9.9999836724715374e-01
LFI20M 1.5548897911626446e-03 -5.9289001736737262e-04 9.9999861539862389e-01
LFI21S 1.6975720932854463e-03 6.0961185087824777e-04 9.9999837330986663e-01
LFI21M 1.5486274949897787e-03 5.9228926426513112e-04 9.9999862547220986e-01
LFI22S 1.7861136968831245e-03 4.4036975450366470e-04 9.9999830793473898e-01
LFI22M 1.4292780457920242e-03 4.7454175238250377e-04 9.9999886598655352e-01
LFI23S 1.4105692317321714e-03 3.7689062387997129e-04 9.9999893412338203e-01
LFI23M 1.1200251268914476e-03 3.2838598619481239e-04 9.9999931885294757e-01
LFI24S 3.4636411743209074e-04 -2.8530917087092225e-07 9.9999994001590664e-01
LFI24M 4.3939553230170735e-04 -2.9414231975370517e-07 9.9999990346573508e-01
LFI25S -1.0428719495964051e-04 1.9328051933678115e-04 9.9999997588341061e-01
LFI25M -1.1004766833423990e-04 2.7656488668259429e-04 9.9999995570068612e-01
LFI26S -1.0428719495970346e-04 -1.9328051933760877e-04 9.9999997588341061e-01
LFI26M -1.1004766833430009e-04 -2.7656488668343130e-04 9.9999995570068612e-01
LFI27S 1.6613273546973915e-03 6.6518363019636186e-04 9.9999839875979735e-01
LFI27M 1.5583345016298123e-03 6.4183510236962536e-04 9.9999857981963269e-01
LFI28S 1.6633788116048607e-03 -6.6629002345089925e-04 9.9999839461297824e-01
LFI28M 1.5571200481047094e-03 -6.4144198187461837e-04 9.9999858196366442e-01


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] by the dipole axis rotated in the beam reference frame.

[math] \Delta T (t) = \mathbf{S}^T \mathcal{U}(t) \mathbf{D}_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 with flagged for maneuvers, planets, gaps and the ones flagged in Level1 analysis as not recoverable are discharged.

Fit[edit]

The first order calibration values are given by a Least Square Fit between the signal and the dipole. For each pointing a gain ([math] g_k [/math]) and an offset ([math] b_k [/math]) values are computed minimizing:

[math] \chi^2 = \sum_{i \in k} {[ \Delta V (t_i) - \Delta V_m (t_i|g_k, b_k)]^2 \over rms_i^2 } [/math]

The sum includes samples outside a Galactic mask.

Mademoiselle[edit]

The largest source of error in the fit arises from unmodeled sky signal [math] \Delta T_a [/math] from CMB anisotropy. To correct this we iteratively project the calibrated data (without the dipole) onto a map, scan this map to produce a new TOD with astrophysical signal removed, and finally run a simple destriping algorithm to find the corrections to the gain and offset factors.

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. We used two different algorithms: OSG for the 44 and 70 GHz radiometers, and DV/V Fix for the 30 GHz. The reasons behind this choice can be found in Planck-2013-V[3].

OSG[edit]

OSG is a python code that performs smoothing with a 3 step algorithm.

The first step is a Moving Average Window: the gain and offset factors are streams containing one value for each pointing period, that we call dipole fit raw streams. The optimized window has a length of 600 pointing periods.

The second step is a wavelet algorithm, using pywt (Discrete Wavelet Transform in Python) libraries. Both dipole fit raw streams and averaged streams are denoised using wavelets of the Daubechies family extending the signals using symmetric-padding.

The third step is the combination of dipole fit raw and averaged denoised signal using knowledge about the instrument performance during the mission.

4 K total-power and Fix[edit]

For the 30 GHz channels we used 4K total-power to track gain changes. The theory and explanation of the choice can be found in Planck-2013-V[3].

The algorithm uses [math] V_{load} [/math] mean values computed during differentiation and raw gains as they are after iterative calibration, performing a linear weighted fit between the two streams using as weight the dipole variance in single pointing periods. The fit is a single parameter fit, so the offsets are put to zero in this smoothing method. It uses the gsl libraries.

In addition to the smoothing, to better follow sudden gain changes due to instrument configuration changes, a fix algorithm is implemented. The first step is the application of the 4k total-power smoothed gains to the data and the production of single radiometer maps in the periods between events. The resulting maps are then fit with dipole maps covering the same period of time producing two factor for each radiometer: [math] corrM [/math] is the result of the fit using the main radiometer and [math] corrS [/math] the one coming from the side radiometer. The correction to be applied to the gain values is then computed as:

[math] corr = {1 \over {1 + {{corrM+corrS} \over 2 }}} [/math]

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)) g(k) – convDip(t) [/math]

where t is the time and k is the pointing period. [math] convDip [/math] is the CMB Dipole convolved with the beam.

Noise[edit]

This pipeline step aims at the reconstruction of the noise parameters from calibrated flight TOI. The goal is two-folds: one the one side we need to know the actual noise properties of our instrument in order to properly take them into account especially during the following processing and analysis steps like map-making and power spectrum estimation. On the other side evaluation of noise properties along 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 and since we would like to track possible noise variations along 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 an IGLS map-making is a quite consuming in terms of time and resources required. However the length of the data is such that running 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

$\mathbf{\Delta T} = \mathbf{P} \mathbf{m} + \mathbf{n}$

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

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

where $\mathbf{\hat{N}_i}$ is the noise covariance matrix in time domain out from iteration $i$. After three iterations convergence is achieved.

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

Fitting Pipeline[edit]

In the very first release of Planck data, once noise spectra were extracted a simply log-periodogram fitting approach was applied to derive the most important noise parameters (white noise level, knee-frequency and slope of the low-frequency noise component). However during mission life-time there were some specific events (e.g. the switch over of the sorption coolers) that we expect were able to cause variation in instrument behaviour and hence in its noise properties. In this respect we have improved our fitting pipeline adding a Monte Carlo Markov Chain approach to estimate noise parameters.

MCMC approach[edit]

This new approach allows us to improve our noise model. Indeed this can be parametrized by the usual combination of white plus [math] 1/f [/math] noise

[math] P(f)=\sigma^2\left[1+\left(\frac{f}{f_k}\right)^\beta\right] [/math]

with three basic noise parameters. However it is also possible to work with a functional form with two more parameters as

[math] P(f) = \sigma^2\left[1 + \left(\frac{f}{f_{k1}}\right)^{\beta_{1}} +\left(\frac{f}{f_{k2}}\right)^{\beta_{2}}\right] [/math]

This latter could be useful when there are clearly two different behaviour in the low-frequency part of the spectrum where, beside usual radiometric [math] 1/f [/math] noise, appears signature of thermal fluctuations induced noise.

As for the white noise part, this is, as before, computed making a simple average of noise spectrum on the last 10% of frequency bins. This percentage works well for almost all radiometers at 44 and 70 GHz but it is indeed quite delicate for the 30 GHz radiometers which show typical values of knee-frequency around 100 mHz and, therefore, require a smaller number to get an un-biased white noise estimation. Once white noise is computed, the code creates Markov Chains for the other parameters. Discarding the burn-in period of the chains we can directly get from the chain samples distribution, the expected value and variance of each noise parameters sampled.

The left panel of the following Figure shows a typical spectrum at 70 GHz with superimposed the simple log-periodogram fit (purple line) and the new MCMC derived spectrum (blue line). The right panel instead shows distribution for knee-frequency and slope derived from the example spectrum.


The final noise parameters[edit]

As already reported we know that during the nominal operations there was a quite dramatic change in LFI induced by the switch over of the two sorption coolers and particularly we expect to see the effect of degradation of the performance of the first sorption cooler and the onset of the redundant one.

In the following figure we report a set of noise frequency spectra for three LFI radiometers (LFI28M, LFI24S and LFI18M) from the beginning of the operation till the time of the current data release. Some comments are in order. First of all the white noise level is extremely stable in all the three cases (but this is also true for all the LFI radiometer). Also knee-frequency and low-frequency slope are quite stable till OD 326. After that period spectra show a noise increase and two slopes for the low-frequency part which become more evident for spectra around OD 366 and OD 466 where the first cooler starts to be less effective and produces low-frequency thermal noise. After the switch-over to the redundant cooler data still present (the very last spectrum) thermal noise at very low-frequency. This behaviour is almost present in all radiometers with different trends ranging from the small effect shown by LFI24S to more prominent effect as shown by LFI28M and LFI18M.

References[edit]

  1. 1.01.11.2 Planck 2013 results: The Low Frequency Instrument data processing, Planck Collaboration 2013 II, A&A, in press, (2014).
  2. 2.02.1 Planck 2013 results: LFI systematic uncertainties, Planck Collaboration 2013 III, A&A, in press, (2014).
  3. 3.03.1 Planck 2013 results: LFI Calibration, Planck Collaboration 2013 V, A&A, in press, (2014).

(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

Cosmic Microwave background

[LFI meaning]: absolute calibration refers to the 0th order calibration for each channel, 1 single number, while the relative calibration refers to the component of the calibration that varies pointing period by pointing period.