Free Access
Issue
A&A
Volume 620, December 2018
Article Number A65
Number of page(s) 7
Section The Sun
DOI https://doi.org/10.1051/0004-6361/201834086
Published online 29 November 2018

© ESO 2018

1. Introduction

Differential emission measure (DEM) inversion is a technique to use multi-band photometry or spectrometry and convert it to a temperature distribution of the plasma along the line-of-sight (see, e.g. Cheung et al. 2015). Given the ubiquity of observations from the Solar Dynamics Observatory/Atmospheric Imaging Assembly (SDO/AIA), several independent methods have been developed to invert the emission in the different AIA filters to a DEM distribution (Aschwanden & Boerner 2011; Guennou et al. 2012; Plowman et al. 2013; Cheung et al. 2015). Testa et al. (2012) used the method by Kashyap & Drake (1998) to show that the DEM inversions from the AIA filters have lower accuracy in the high temperature range (and the same was shown for the combination of the X-ray Telescope (XRT) and Hinode/EUV Imaging Spectrometer (Hinode/EIS; Winebarger et al. 2012).

The DEM inversion method is often used to observationally study the thermal structure of coronal loops (e.g. Reale et al. 2009; Schmelz et al. 2011). Often, it is found that coronal loops are multi-thermal, in the sense that they display a broad temperature distribution in the differential emission measure (Schmelz et al. 2014). Typically, this is interpreted as the proof of the presence of multi-stranded (or multi-threaded) loops aligned with the magnetic field (e.g. Aschwanden et al. 2000; Klimchuk 2015), and this is supported by forward modelling as well (Brooks et al. 2012; Viall & Klimchuk 2015) and by high-resolution observations (Peter et al. 2013).

In multi-stranded loop models, each of the strands has a thermodynamic evolution independent of the other strands. In this approximation, the magnetic field is assumed to play no role in the longitudinal, thermodynamic evolution of these strands. Additionally, the thermal conduction perpendicular to the magnetic field is taken to be small and the structures are considered to be optically thin (and are thus not absorbing the radiation from the neighbouring strands). With these assumptions, there is no mechanism for energy exchange between the multiple strands. In such models, each strand is heated with nano-flares (Viall & Klimchuk 2013; Klimchuk 2015), usually assumed to be because of small-scale reconnection between different threads.

Since a few years, we know that the solar corona is filled with transverse (Tomczyk et al. 2007; Nisticò et al. 2013) and longitudinal waves (Krishna Prasad et al. 2012). Numerical simulations show that these ubiquitous transverse oscillations have a strong effect on coronal loop models, because the transverse waves trigger the Kelvin-Helmholtz instability (KHI) in the loop boundaries (Terradas et al. 2008), resulting in a turbulent regime. This instability has previously been simulated in different conditions corresponding to photospheric and chromospheric structures (Karpen et al. 1993; Ofman et al. 1994; Poedts et al. 1997; Ziegler & Ulmschneider 1997). In a loop configuration, the multi-shelled structure at different radii from the centre present an Alfvén continuum due to their continuous change in density, which is expected to generate quasi-modes from resonant absorption (e.g. Goossens et al. 1992) and mode coupling (De Moortel et al. 2016). This means that in such multi-shelled loops there will be a continuous transfer of energy from global oscillation modes (the kink wave) into these shells. This energy is manifested, in particular, as an increase in the azimuthal velocity, that is, the velocity along these shells, and ends up in the turbulence after the KHI sets in. In these models there is therefore a strong redistribution and mixing of the energy and plasma in the transverse direction.

Antolin et al. (2014) show that such KHIs are expected at basically any amplitude for impulsive transverse velocity perturbations of long coronal loops (for which the radius-to-length ratio is small), and used forward modelling to show that the transverse wave-induced Kelvin-Helmholtz (TWIKH) roll-ups may make the loop appear as multi-stranded in high-resolution observations. Karampelas & Van Doorsselaere (2018) model coronal loops that are driven by transverse waves at the footpoint, and showed that the loop becomes entirely turbulent, resulting in a strong mixing of all of the loop plasma with the exterior.

It had been suggested that finite twist or transport coefficients may inhibit the development of the KHI. The effect of twist on the TWIKH rolls is investigated by Howson & De Moortel (2017a), Terradas et al. (2018) and the effect of viscosity and resistivity by Howson et al. (2017b). All these studies show that the onset of the KHI may be delayed because of these effects, but the KHI is not stabilised.

Considering the effect of transverse waves on multi-stranded loop models, Magyar & Van Doorsselaere (2016) showed that an initially multi-stranded loop is thoroughly mixed by the TWIKH rolls. Such a mixing of plasma is not at all considered in the multi-stranded loop models. The mixing results also in a turbulent state of the loop plasma, which can no longer be considered as multi-stranded in the conventional sense. Thus, these recent simulations show that the multi-stranded loops are not stable to the omnipresent transverse motions, and thus it is unlikely that such loops exist (given the omnipresence of transverse oscillations, Anfinogentov et al. 2015). Therefore, the question arises if other models than multi-stranded loops (in the conventional sense, i.e., composed of independent strands) can explain the observed broad DEMs. Here we will study the influence of the TWIKH rolls on the DEM, and we shall investigate if the loop models with TWIKH rolls can explain the broad DEMs as well, given that the TWIKH rolls keep similar filling factors and emission measures (Magyar & Van Doorsselaere 2016).

In order to perform this investigation, we first explain the numerical methods that are used in Sect. 2. Then, we consider DEMs of multi-shelled loops (Sect. 3.1), before constructing DEMs for impulsively excited loops (Sect. 3.2) and driven loops (Sect. 3.3). We discuss the implications of our results in Sect. 4.

2. Methods

In this paper, several methods have been used to construct the DEM of numerical data.

2.1. Numerical DEM

In general, the DEM is defined by the equation

(1)

where EM is the emission measure, ne is the electron number density, and z is the coordinate along the line-of-sight. To numerically construct the DEM in a simulation for a particular pixel, we extract from the simulation the distribution of the density ne(z) (array ne) and temperature T(z) (array te) along the line-of-sight, with a similar method to Peter et al. (2006). We used the following IDL code to construct the DEM:

nbins=33

deltax=(x_grid[1]-x_grid[0]) ; in cm!

dem=make_array(nbins)

; te in K!

thist=histogram(alog10(te[*]),nbins=nbins, $

      locations=locs,reverse_indices=R, $

      min=5.5,max=6.8)

deltalocs=locs[1]-locs[0]

for i=0,nbins-1 do begin

; ne in cm^{-3}!

    if R[i] ne R[i+1] then dem[i]+= $

       total(ne[R[R[i] : R[i+1]-1]]^2)* $

       deltax/10^locs[i]/(10^deltalocs-1)

endfor

Thus, the DEM is constructed as a histogram of log T with 33 bins between log Tmin = 5.5 and log Tmax = 6.8, with weights of . In essence, the DEM is the probability density function (PDF) of the electron density squared () as a function of log T, multiplied by the total emission measure (EM). In what follows, we only construct DEMs using “infinite” resolution, meaning that we take the values on a strip along the line-of-sight with a width of only one simulation pixel. We have investigated the effect of including macro-pixels by considering wider strips, but its effect is only to smooth the DEM distributions: they show fewer gaps, and are smoother functions in that case.

Following the same procedure for a location outside of the loop, we also compute the DEM of the background. Then we subtracted the background DEM from the relevant DEM to mimic background subtraction. In what follows, we always show background subtracted DEMs only.

When displaying the obtained numerical log DEM as a function of log T, the typical shape is trapezoid-like, bound between log Tmin and log Tmax (see middle panel of Fig. 1), and a peak at the internal loop temperature. In between, the log DEM has a curved shape, with a tail at the background value of the temperature of 1 MK.

Instead of using the standard expression for the standard deviation and the full-width-half-maximum (FWHM), we characterise the width of the distribution by computing

(2)

so we define σ as the standard deviation of the temperature distribution (for T > 1.1 MK) from the theoretical value of T max, with as weights. The reason for not using the standard expressions for the standard deviation is that the mean temperature is decreasing in the dynamic models, especially in the later part of the simulations when the loops become turbulent (see later). The above expression for the width of these asymmetric distributions is less influenced by temperature changes, and allows to disentangle the effects of temperature change and broadening. The obtained value for the width of the distribution is then converted to the FWHM with the formula

(3)

thumbnail Fig. 1.

Top panel: different temperature distributions as a function of radius. The linestyle in all panels corresponds to the temperature profile given with that linestyle in the top panel. Middle panel: numerical DEM without forward modelling for the LOS through the centre of the loop. Bottom panel: DEM after forward modelling and DEM inversion.

where we have taken into account that it is only half the width of a normal Gaussian, because of the special asymmetric shape of the DEM.

2.2. DEM by forward modelling

We also used an alternative method to first construct a forward model of the simulation snapshots and afterwards perform a DEM inversion. Each model is processed with version 3.3 of the FoMo code1 (as described in Van Doorsselaere et al. 2016). The code computes the emission of the model in the six filters (94 Å, 131 Å, 171 Å, 193 Å, 211 Å, 335 Å) of SDO/AIA (Boerner et al. 2012), using the method described in Del Zanna et al. (2011), Yuan et al. (2015). For the computation of the filter intensities, we used the sun_coronal.abund file of CHIANTI v8 (Dere et al. 1997; Landi et al. 2013).

Then, a DEM inversion is performed on the emission of the forward model. Before performing the DEM analysis, we performed a background subtraction: from the emission in the loop, we subtract the emission observed at r = 2.41 Mm (which is well outside the loop region). This is a standard procedure when performing DEM analysis of coronal loop observations (e.g. Tripathi et al. 2009). For the DEM inversion, we used the regularised inversion code which was published by Hannah & Kontar (2012). As error estimates for the emission, we put a nominal value of 10% of the pixel’s emission. We have performed the DEM inversion in the temperature interval log (T) ∈ [5.5,6.8], with 33 temperature bins, as we also did in the DEM without forward modelling.

We characterised the forward modelled DEM by computing the full width half maximum (FWHM), assuming that the DEM distributions are close to log-normal (e.g. Cheung et al. 2015). These parameters are measured by fitting a parabola to the logarithm of the DEM:

(4)

with a, b, and c the fitting parameters. The position of the maximum Tmax,FoMo and the FWHM of the DEM distribution is calculated by

(5)

For the fitting of the profile, we took a range of temperatures around Tmax with a width of 0.32 (in log T). We only considered the positive DEM values.

3. Results

3.1. DEM for multi-shelled loops

First we constructed simple 1D cylindrical models for a loop, with only variation of the density and temperature in the radial direction. The radial variation of the density and temperature can be considered as multi-shelled. For the density profile, we take

(6)

with the parameters

This results in a loop that is three times as dense as the surroundings. For the temperature profile, we similarly take

(7)

with Tmin = 1 MK. For the central, peak temperature, we consider six values: {2,2.8,3.6,4.4,5.2,6} MK. Each of the temperature profiles is drawn in the top panel of Fig. 1, each different linestyle corresponding to a different peak temperature.

thumbnail Fig. 2.

Left panel: peak temperature of the DEM from the forward model compared to the input Tmax. Right panel: FWHM of the DEM as a function of the peak temperature of the profile (Tmax = T(r = 0)), for the numerical DEM without forward modelling (*, middle panel of Fig. 1) and the forward modelled DEM (⋄, bottom panel of Fig. 1).

Table 1.

Numerical values for the peak temperature and widths of the DEM.

For each of the temperature profiles, we constructed the numerical DEM and the DEM by forward modelling. These are shown by the corresponding linestyles in the middle and bottom panels of Fig. 1, respectively. The first thing to see in Fig. 1 is that the DEMs from both models do not agree very well. The DEM from the forward modelling is much broader than the DEM without the forward modelling, which are printed for clarity in the Table 1. Still, the peak temperature of the DEM from the forward modelling corresponds rather well with the input maximum temperature Tmax, as is shown in the left panel of Fig. 2. Thus, from this limited parameter study, we can conclude that the DEM in our artificial observations measures the position of the peak temperature well. On the other hand, the DEM from the forward modelling does not capture the true width of the DEM. This is displayed in the right panel of Fig. 2. The width of the theoretical DEM is shown with stars, and the width of the DEM from forward modelling is shown with diamonds. It is clear that the DEM from the forward modelling is most of the time much broader than the numerical DEM.

For the later results, it is important to notice the behaviour of the FWHM of the numerical DEM (without forward modelling) with the peak temperature. The higher the peak temperature, the broader the distribution, and these two quantities show a strong correlation (see right panel of Fig. 2). This is also readily visible in the middle panel of Fig. 1. This is, however, not true for the DEM from the forward modelling. Neglecting the very high value for log Tmax = 6.72, the width of the DEM from the forward modelling seems to be nearly insensitive to the input value of Tmax.

3.2. DEM for impulsively excited loops

The next model to consider is a dynamic evolution of a loop with a sharp boundary, based on the simulations performed in Antolin et al. (2014, 2015), using the CIP-MOCCT code (Kudoh et al. 1999). From a parameter study, we estimate that the effective (combined explicit and numerical) Reynolds and Lundquist numbers in the code are of the order of 104 − 105, with some anomalous resistivity included to stabilise the simulation.

The density and temperature in the initial state are taken to have a discontinuous step, corresponding to d → ∞. The density parameters are as before, and the temperature ranges from 1 MK (outside) to 3 MK (inside). The magnetic field is adjusted in order to keep the perpendicular pressure balance.

thumbnail Fig. 3.

Evolution of density (top row), temperature (middle row) and DEM (bottom row) in the loop top cross section of the impulsively excited model, at the times specified in the title of each column. The DEM was computed for a single pixel corresponding to the LOS through the centre-of-mass, perpendicular to the initial motion.

The static loop model is perturbed by a velocity field at the start of the simulation, with dependence

(8)

where ex is the unit vector in the x-direction, ν0 = 0.05 cs is the initial amplitude, with cs the sound speed. This corresponds to ν0 = 15 km s−1 in this model. ζ(r) is the Heaviside function: the driver is finite within the loop, and zero outside the loop. As a result, the loop starts to oscillate transversally with a kink mode, at its fundamental harmonic with a period of P = 315 s. The kink mode experiences large shear motions near the loop boundary, and these lead to the formation of TWIKH roll-ups at the edge of the coronal loop (as was first shown by Terradas et al. 2008), also known as TWIKH rolls. Then, the Kelvin-Helmholtz roll-ups further cascade to form a turbulent regime, smearing out the density and temperature profile radially (Magyar & Van Doorsselaere 2016). The temporal evolution of the density and temperature is shown in the top two rows of Fig. 3, where the shown times correspond to t = 0, t = P/4, t = P/2, t = P, t = 2P and t = 5P. For more details on the models, we advise the readers to consult Antolin et al. (2014, 2016).

In the bottom row, the numerical DEM is shown for the corresponding time of the evolution. The DEM is computed for the line-of-sight through the centre-of-mass of the loop perpendicular to the original perturbation, and the DEM of the background has been subtracted as before. In the left panel (for t = 0), the DEM shows a sharp peak at 3 MK, as expected in the original configuration. Over time, the peak spreads more to the lower (exterior) temperatures, gradually filling up the entire range between the exterior temperature of 1 MK and the internal temperature of 3 MK. This is expected because of the mixing effect of the TWIKH rolls, mixing the interior, hot plasma, with the exterior, cool plasma (Magyar & Van Doorsselaere 2016; Karampelas et al. 2017). The resulting DEM is thus compatible with our conclusions of Sect. 3.1: the turbulent density and temperature from the TWIKH rolls evolve into a smooth boundary layer. In that smooth boundary layer, the emission follows the same behaviour as the static models in Sect. 3.1, resulting in a “trapezoid” shaped DEM.

We compute the FWHM of the DEM, following the method outlined in Eq. (3). The evolution of the FWHM of the DEM as a function of time is shown in Fig. 4. The figure confirms our understanding of the DEMs in the bottom row of Fig. 3. Initially, there is a very sharp DEM, and this is confirmed with a FWHM of around 0. Then, the loop plasma is mixed with the exterior because of the TWIKH rolls, and this results in a (roughly linear) increase in the FWHM over the first four periods of the oscillation. This is the first important conclusion in this paper: {the DEM of loops is broadened by the presence of transverse oscillations. Then, the FWHM settles to fluctuate around a constant final value of around 0.07 (in log(T), corresponding to 17%). This value is somewhat lower than what can be inferred from the right panel of Fig. 2, but this discrepancy can be attributed to having a larger d, which would decrease the FWHM of the DEM. The saturation of the FWHM is to be expected, because the oscillation was impulsively excited. At the time the FWHM saturates, the global oscillation is nearly completely damped and the TWIKH rolls are no longer amplified. As we understand from the previous Sect. 3.1, the final value of the FWHM is mainly determined by the initial temperature profile, and particularly the temperature contrast between the interior and exterior.

thumbnail Fig. 4.

FWHM of the numerical DEM (without forward modelling) as a function of time, for the impulsively excited model.

thumbnail Fig. 5.

Same as Fig. 3, but for the driven model (Sect. 3.3).

3.3. DEM of driven loops

In our final model, we consider the models of Karampelas & Van Doorsselaere (2018), which have been extended for a longer time from Karampelas et al. (2017). These models are the driven counterpart of the models by Antolin et al. (2014): the excitation is no longer by an initial velocity pulse, but rather by a continuous footpoint driver with an amplitude of 2 km s−1. We take the transverse temperature and density profile of the initial configuration as in Eqs. (6) and (7), with T max = 3 MK and d → ∞. This profile coincides with the profiles in Sect. 3.2. This profile is in contrast to the models of Karampelas et al. (2017), which considered cool loops in a hot exterior plasma. The footpoint driver is a transverse oscillation in the velocity, of which the period is P = 315 s (which is the kink period). The driver has a uniform velocity field inside the loop and in the x-direction, and a dipole field outside the loop, which are connected with a tanh profile (for more details, see Karampelas et al. 2017). Snapshots of the simulation have been included in Fig. 5.

Figure 6 shows the FWHM of the DEM as a function of time. As before, the initial width of the DEM is 0. Over time, the loop becomes more and more turbulent, to finally having completely turbulent cross-sections (Karampelas & Van Doorsselaere 2018). This has a clear impact on the derived DEM. We see that the FWHM increases steadily. This is surprising, because the kinetic energy in the loop saturates around t = 4−5 P = 1250−1600 s. Moreover, the loop becomes fully turbulent after t = 8−9 P = 2500−2800 s, and we would have expected that the DEM would also stabilise after that time (by assuming that the plasma is already fully mixed). Some indications are visible in Fig. 6 that the increase stagnates, but the evidence is insufficient in the current length of simulations.

After 10 periods of driving, the width of the DEM has increased to log T = 0.15, which corresponds to a 41% increase. Following our results from Sect. 3.1, the width of the DEM is determined by the initial temperature contrast. The value log T = 0.15 corresponds well with the values on the right panel of Fig. 2, given our initial temperature difference is 0.5 (in log T). Because of this correspondence, it may indeed be that the FWHM of the DEM would saturate around the end value or slightly higher. Some readers may even suggest that this is shown in Fig. 6 for t > 2500 s. It indicates that the plasma mixing by the TWIKH rolls has not been completed yet, because the DEM keeps broadening, even at the final stage of the simulation.

thumbnail Fig. 6.

FWHM of the DEM as a function of time, for the driven model. The full line is the FWHM of the numerical DEM, while the dashed line is the FWHM of the DEM from the forward modelling.

Here we consider the DEM from the forward modelling. As in Sect. 3.1, we performed forward modelling of the simulation snapshot and then perform a DEM inversion. However, as in Sect. 3.1, the DEM from the forward modelling does not reflect the simulated DEM very well. The FWHM of the reconstructed DEM as a function of time is plotted with the dashed line in Fig. 6. To compute the FWHM, we have selected a range for fitting of 0.16 (in log T) around the peak temperature of the DEM.

The reconstructed DEM has a broad peak near the peak temperature of the plasma, perhaps caused by the lack of DEM resolution. This is clearly reflected in the graph for its FWHM: its value is significantly larger than the one of the numerical DEM without forward modelling. The FWHM of the reconstructed DEM seems to be a poor measure for the real FWHM of the numerical DEM. Its behaviour does not show the increase of the DEM width. We conclude that the broadening of the DEM due to loop turbulence by footpoint driving can probably not be observed with imaging telescopes with a limited number of filters, such as AIA.

4. Conclusions and discussion

From the models in the previous sections, we can conclude that the loop turbulence caused by transverse waves results in broadening of the DEM. From multi-shelled, toy models of loops, we found that the width of the DEM is mainly determined by the initial temperature difference between the interior and exterior of the loop.

For an impulsively excited loop, the width of the DEM saturates after some periods, because the transverse wave energy is completely absorbed in the TWIKH rolls, inhibiting further mixing of the interior, hot plasma with the exterior, cool plasma. The saturation width of the DEM is 0.07, which is significantly lower than multi-thermal loops (e.g. Schmelz et al. 2014). Thus, such an impulsively excited loop cannot explain the observed broad DEMs, unless much larger temperature contrasts are considered.

In our long simulation of driven transverse waves, we find that the width of the DEM increased steadily over the time of the simulation. The final value of the width of 0.15 becomes nearly comparable to some observational values (Schmelz et al. 2014). In accordance with our first result, we attribute this width to the initial temperature contrast of the loop with the exterior plasma. With these values of the width of the DEM, it seems that these models of driven transversally oscillating loops can potentially explain the broad, observed DEMs.

However, our results from forward modelling and DEM reconstruction showed that the increase of the DEM width is not observable with the AIA instrument. This is caused by a bad reconstruction of the peculiar input DEMs, resulting in large overestimates of the FWHM from the forward modelling.

Our results have an important implication. In previous work, multi-thermal loops were modelled as being multi-stranded (e.g. Bradshaw & Klimchuk 2011; Brooks et al. 2012; Regnier 2014), and each of the strands had a single temperature at a given time (i.e., a delta-function DEM). Even if we do not take into account the destruction of the strands by the mixing of the transverse waves (Magyar & Van Doorsselaere 2016), we show here that the omnipresent transverse waves broaden the DEM of a strand beyond a delta-function. The finite width of each strand’s DEM is determined by the initial and evolving temperature and the background. Therefore, the number of strands needed to model the broad, observed DEMs can be drastically reduced. The finite width DEMs of single strands are then easily superposed to form broad, observed DEMs. Perhaps even strongly mixed single loops can explain broad DEMs single-handedly in some cases.

But importantly, this physical model also implies a transverse correlation between the strands, since a common physical mechanism (the transverse MHD wave) is responsible for their thermodynamic evolution. This implies that a 1D multi-stranded loop model constructed from thousands of strands, if ever possible, needs to be constructed taking into account a specific transverse correlation and temporal correlation.

The fact that our forward modelling and DEM inversion cannot properly reconstruct the input DEMs begs the question if the observation of broad DEMs is indeed a product of a physical process (such as the one described in this paper), or if it just implies that the temperature structure of the loops is unresolved with the limited number of AIA filters. Moreover, one may argue that if the increase of the DEM width by the TWIKH rolls cannot be observed with current imaging instruments, then the observed broadening must be caused by another mechanism. However, inclusion of multiple strands (perhaps two or three) in our model with each different peak temperatures would result in much broader final DEMs, which can potentially be observed by SDO and explain the observed DEMs.

On the other hand, spectroscopic instruments (such as Hinode/EIS) have a much finer “temperature resolution” and can potentially study the DEM distribution with sufficient accuracy to follow its evolution over time. Thus, to observationally test the predicted DEM broadening in this paper, spectroscopy in multiple spectral lines with broad temperature coverage is definitely needed.

The key conclusion of this paper is that the turbulent loop models (which take into account the observed dynamic behaviour of the loops) can explain the observed broad DEMs in the solar corona, equally well as multi-stranded loops. This is an important point, because it means that the turbulent loop model with TWIKH rolls can explain several observed features: (i) small scale transverse motions (Antolin et al. 2016), (ii) apparent strands (Antolin et al. 2014), (iii) phase shift between Doppler shifts and intensity (Antolin et al. 2015), (iv) unchanged filling factors (Magyar & Van Doorsselaere 2016), (v) unchanged emission measures (Magyar & Van Doorsselaere 2016), and (vi) broad DEMs (this manuscript). Adding to this list, and generating observables (predicted broadening of DEM), is important to verify this turbulent loop model or to disqualify it.

Acknowledgments

TVD was supported by an Odysseus grant of the FWO Vlaanderen, the IAP P7/08 CHARM (Belspo), the GOA-2015-014 (KU∼Leuven) and the European Research Council (ERC) under the European Union’s Horizon 2020 research and innovation programme (grant agreement No 724326). The results were inspired by discussions at the ISSI Bern and at ISSI Beijing. TVD is grateful for the support from the NAOJ Visiting Fellows Program. PA has received funding from the UK Science and Technology Facilities Council (Consolidated Grant ST/K000950/1), the European Union Horizon 2020 research and innovation programme (grant agreement No. 647214) and his STFC Ernest Rutherford Fellowship (grant agreement No. ST/R004285/1). Numerical computations were carried out on Cray XC30 at the Center for Computational Astrophysics, NAOJ.


1

The FoMo code can be downloaded from https://wiki.esat.kuleuven.be/FoMo/

References

  1. Anfinogentov, S. A., Nakariakov, V. M., & Nisticò, G. 2015, A&A, 583, A136 [NASA ADS] [CrossRef] [EDP Sciences] [Google Scholar]
  2. Antolin, P., Yokoyama, T., & Van Doorsselaere, T. 2014, ApJ, 787, L22 [NASA ADS] [CrossRef] [Google Scholar]
  3. Antolin, P., Okamoto, T. J., De Pontieu, B., et al. 2015, ApJ, 809, 72 [NASA ADS] [CrossRef] [Google Scholar]
  4. Antolin, P., De Moortel, I., Van Doorsselaere, T., & Yokoyama, T. 2016, ApJ, 830, L22 [Google Scholar]
  5. Aschwanden, M. J., & Boerner, P. 2011, ApJ, 732, 81 [NASA ADS] [CrossRef] [Google Scholar]
  6. Aschwanden, M. J., Nightingale, R. W., & Alexander, D. 2000, ApJ, 541, 1059 [NASA ADS] [CrossRef] [Google Scholar]
  7. Boerner, P., Edwards, C., Lemen, J., et al. 2012, Sol. Phys., 275, 41 [NASA ADS] [CrossRef] [Google Scholar]
  8. Bradshaw, S. J., & Klimchuk, J. A. 2011, ApJS, 194, 26 [NASA ADS] [CrossRef] [Google Scholar]
  9. Brooks, D. H., Warren, H. P., & Ugarte-Urra, I. 2012, ApJ, 755, L33 [NASA ADS] [CrossRef] [Google Scholar]
  10. Cheung, M. C. M., Boerner, P., Schrijver, C. J., et al. 2015, ApJ, 807, 143 [NASA ADS] [CrossRef] [Google Scholar]
  11. De Moortel, I., Pascoe, D. J., Wright, A. N., & Hood, A. W. 2016, Plasma Phys. Controlled Fusion, 58, 014001 [Google Scholar]
  12. Del Zanna, G., O’Dwyer, B., & Mason, H. E. 2011, A&A, 535, A46 [NASA ADS] [CrossRef] [EDP Sciences] [Google Scholar]
  13. Dere, K. P., Landi, E., Mason, H. E., Monsignori Fossi, B. C., & Young, P. R. 1997, A&AS, 125, 149 [NASA ADS] [CrossRef] [EDP Sciences] [Google Scholar]
  14. Goossens, M., Hollweg, J. V., & Sakurai, T. 1992, Sol. Phys., 138, 233 [NASA ADS] [CrossRef] [Google Scholar]
  15. Guennou, C., Auchère, F., Soubrié, E., et al. 2012, ApJS, 203, 25 [NASA ADS] [CrossRef] [Google Scholar]
  16. Hannah, I. G., & Kontar, E. P. 2012, A&A, 539, A146 [NASA ADS] [CrossRef] [EDP Sciences] [Google Scholar]
  17. Howson, T. A., & De Moortel, I. 2017a, A&A, 607, A77 [NASA ADS] [CrossRef] [EDP Sciences] [Google Scholar]
  18. Howson, T. A., De Moortel, I., & Antolin, P. 2017b, A&A, 602, A74 [NASA ADS] [CrossRef] [EDP Sciences] [Google Scholar]
  19. Karampelas, K., & Van Doorsselaere, T. 2018, A&A, 610, L9 [NASA ADS] [CrossRef] [EDP Sciences] [Google Scholar]
  20. Karampelas, K., Van Doorsselaere, T., & Antolin, P. 2017, A&A, 604, A130 [NASA ADS] [CrossRef] [EDP Sciences] [Google Scholar]
  21. Karpen, J. T., Antiochos, S. K., Dahlburg, R. B., & Spicer, D. S. 1993, ApJ, 403, 769 [NASA ADS] [CrossRef] [Google Scholar]
  22. Kashyap, V., & Drake, J. J. 1998, ApJ, 503, 450 [NASA ADS] [CrossRef] [Google Scholar]
  23. Klimchuk, J. A. 2015, Phil. Trans. R. Soc. London Ser. A, 373, 20140256 [NASA ADS] [CrossRef] [Google Scholar]
  24. Krishna Prasad, S., Banerjee, D., Van Doorsselaere, T., & Singh, J. 2012, A&A, 546, A50 [NASA ADS] [CrossRef] [EDP Sciences] [Google Scholar]
  25. Kudoh, T., Matsumoto, R., & Shibata, K. 1999, Comput. Fluid Dyn. J., 8, 56 [Google Scholar]
  26. Landi, E., Young, P. R., Dere, K. P., Del Zanna, G., & Mason, H. E. 2013, ApJ, 763, 86 [NASA ADS] [CrossRef] [Google Scholar]
  27. Magyar, N., & Van Doorsselaere, T. 2016, ApJ, 823, 82 [NASA ADS] [CrossRef] [Google Scholar]
  28. Nisticò, G., Nakariakov, V. M., & Verwichte, E. 2013, A&A, 552, A57 [NASA ADS] [CrossRef] [EDP Sciences] [Google Scholar]
  29. Ofman, L., Davila, J. M., & Steinolfson, R. S. 1994, Geophys. Res. Lett., 21, 2259 [NASA ADS] [CrossRef] [Google Scholar]
  30. Peter, H., Gudiksen, B. V., & Nordlund, Å. 2006, ApJ, 638, 1086 [NASA ADS] [CrossRef] [MathSciNet] [Google Scholar]
  31. Peter, H., Bingert, S., Klimchuk, J. A., et al. 2013, A&A, 556, A104 [NASA ADS] [CrossRef] [EDP Sciences] [Google Scholar]
  32. Plowman, J., Kankelborg, C., & Martens, P. 2013, ApJ, 771, 2 [NASA ADS] [CrossRef] [Google Scholar]
  33. Poedts, S., Toth, G., Belien, A. J. C., & Goedbloed, J. P. 1997, Sol. Phys., 172, 45 [NASA ADS] [CrossRef] [Google Scholar]
  34. Reale, F., Testa, P., Klimchuk, J. A., & Parenti, S. 2009, ApJ, 698, 756 [CrossRef] [Google Scholar]
  35. Regnier, S. 2014, ArXiv e-prints [arXiv:1405.3450] [Google Scholar]
  36. Schmelz, J. T., Jenkins, B. S., Worley, B. T., et al. 2011, ApJ, 731, 49 [NASA ADS] [CrossRef] [Google Scholar]
  37. Schmelz, J. T., Pathak, S., Brooks, D. H., Christian, G. M., & Dhaliwal, R. S. 2014, ApJ, 795, 171 [NASA ADS] [CrossRef] [Google Scholar]
  38. Terradas, J., Andries, J., Goossens, M., et al. 2008, ApJ, 687, L115 [Google Scholar]
  39. Terradas, J., Magyar, N., & Van Doorsselaere, T. 2018, ApJ, 853, 35 [NASA ADS] [CrossRef] [Google Scholar]
  40. Testa, P., De Pontieu, B., Martínez-Sykora, J., Hansteen, V., & Carlsson, M. 2012, ApJ, 758, 54 [NASA ADS] [CrossRef] [Google Scholar]
  41. Tomczyk, S., McIntosh, S. W., Keil, S. L., et al. 2007, Science, 317, 1192 [NASA ADS] [CrossRef] [PubMed] [Google Scholar]
  42. Tripathi, D., Mason, H. E., Dwivedi, B. N., del Zanna, G., & Young, P. R. 2009, ApJ, 694, 1256 [NASA ADS] [CrossRef] [Google Scholar]
  43. Van Doorsselaere, T., Antolin, P., Yuan, D., Reznikova, V., & Magyar, N. 2016, Front. Astron. Space Sci., 3, [Google Scholar]
  44. Viall, N. M., & Klimchuk, J. A. 2013, ApJ, 771, 115 [NASA ADS] [CrossRef] [Google Scholar]
  45. Viall, N. M., & Klimchuk, J. A. 2015, ApJ, 799, 58 [NASA ADS] [CrossRef] [Google Scholar]
  46. Winebarger, A. R., Warren, H. P., Schmelz, J. T., et al. 2012, ApJ, 746, L17 [NASA ADS] [CrossRef] [Google Scholar]
  47. Yuan, D., Van Doorsselaere, T., Banerjee, D., & Antolin, P. 2015, ApJ, 807, 98 [NASA ADS] [CrossRef] [Google Scholar]
  48. Ziegler, U., & Ulmschneider, P. 1997, A&A, 327, 854 [NASA ADS] [Google Scholar]

All Tables

Table 1.

Numerical values for the peak temperature and widths of the DEM.

All Figures

thumbnail Fig. 1.

Top panel: different temperature distributions as a function of radius. The linestyle in all panels corresponds to the temperature profile given with that linestyle in the top panel. Middle panel: numerical DEM without forward modelling for the LOS through the centre of the loop. Bottom panel: DEM after forward modelling and DEM inversion.

In the text
thumbnail Fig. 2.

Left panel: peak temperature of the DEM from the forward model compared to the input Tmax. Right panel: FWHM of the DEM as a function of the peak temperature of the profile (Tmax = T(r = 0)), for the numerical DEM without forward modelling (*, middle panel of Fig. 1) and the forward modelled DEM (⋄, bottom panel of Fig. 1).

In the text
thumbnail Fig. 3.

Evolution of density (top row), temperature (middle row) and DEM (bottom row) in the loop top cross section of the impulsively excited model, at the times specified in the title of each column. The DEM was computed for a single pixel corresponding to the LOS through the centre-of-mass, perpendicular to the initial motion.

In the text
thumbnail Fig. 4.

FWHM of the numerical DEM (without forward modelling) as a function of time, for the impulsively excited model.

In the text
thumbnail Fig. 5.

Same as Fig. 3, but for the driven model (Sect. 3.3).

In the text
thumbnail Fig. 6.

FWHM of the DEM as a function of time, for the driven model. The full line is the FWHM of the numerical DEM, while the dashed line is the FWHM of the DEM from the forward modelling.

In the text

Current usage metrics show cumulative count of Article Views (full-text article views including HTML views, PDF and ePub downloads, according to the available data) and Abstracts Views on Vision4Press platform.

Data correspond to usage on the plateform after 2015. The current usage metrics is available 48-96 hours after online publication and is updated daily on week days.

Initial download of the metrics may take a while.