ArticlePDF Available

A neural network radiative transfer model approach applied to TROPOMI’s aerosol height algorithm

Authors:

Abstract and Figures

To retrieve aerosol properties from satellite measurements of the oxygen A-band in the near infrared, a line-by-line radiative transfer model implementation requires a large number of calculations. These calculations severely restrict a retrieval algorithm's operational capability as it can take several minutes to retrieve aerosol layer height for a single ground pixel. This paper proposes a forward modeling approach using artificial neural networks to speed up the retrieval algorithm. The forward model outputs are trained into a set of neural network models to completely replace line-by-line calculations in the operational processor. Results of comparing the forward model to the neural network alternative show encouraging results with good agreements between the two when applied to retrieval scenarios using both synthetic and real measured spectra from TROPOMI (TROPOspheric Monitoring Instrument) on board the ESA Sentinel-5 Precursor mission. With an enhancement of the computational speed by three orders of magnitude, TROPOMI's operational aerosol layer height processor is now able to retrieve aerosol layer heights well within operational capacity.
Content may be subject to copyright.
A neural network radiative transfer model approach applied to
TROPOMI’s aerosol height algorithm
Swadhin Nanda1,2, Martin de Graaf1, J. Pepijn Veefkind1,2, Mark ter Linden3, Maarten Sneep1, Johan de
Haan1, and Pieternel F. Levelt1,2
1Royal Netherlands Meteorological Institute (KNMI), Utrechtseweg 297, 3731 GA De Bilt, The Netherlands
2Delft university of Technology (TU Delft), Mekelweg 2, 2628 CD Delft, The Netherlands
3S&T Corp, Delft, The Netherlands
Correspondence to: Swadhin Nanda (nanda@knmi.nl)
Abstract. To retrieve aerosol properties from satellite measurements of the oxygen A-band in the near infrared, a line-by-
line radiative transfer model implementation requires a large number of calculations. These calculations severely restrict a
retrieval algorithm’s operational capability as it can take several minutes to retrieve aerosol layer height for a single ground
pixel. This paper proposes a forward modeling approach using artificial neural networks to speed up the retrieval algorithm.
The forward model outputs are trained into a set of neural network models to completely replace line-by-line calculations in5
the operational processor. Results of comparing the forward model to the neural network alternative show encouraging results
with good agreements between the two when applied to retrieval scenarios using both synthetic and real measured spectra from
TROPOMI (TROPOspheric Monitoring Instrument) on board the ESA Sentinel-5 Precursor mission. With an enhancement of
the computational speed by three orders of magnitude, TROPOMI’s operational aerosol layer height processor is now able to
retrieve aerosol layer heights well within operational capacity.10
1 Introduction
Launched in October 13, 2017, The TROPOsperic Monitoring Instrument (Veefkind et al., 2012) on board the Sentinel-5
Precursor mission is the first of the satellite-based atmospheric composition monitoring instruments in the Sentinel mission of
the European Space Agency. The aerosol layer height (ALH) retrieval algorithm (Sanders and de Haan, 2013; Sanders et al.,
2015; Nanda et al., 2018a, b) is a part of TROPOMI’s operational product suite, expected to be delivered near real time. The15
ALH (symbolised as zaer) retrieval algorithm, operating within the near infrared region in the oxygen A-band between 758 nm
- 770 nm, exploits information about heights of scattering layers derived from absorption of photons by molecular oxygen —
the amount of absorption indicates whether the scattering layer is closer or farther from the surface; if the number of photons
absorbed by oxygen is higher, it suggests a longer photon path length due to an aerosol layer present closer to the surface. This
principle has been applied to cloud height algorithms such as FRESCO (Fast Retrieval Scheme for Clouds from the Oxygen20
A-band) by Wang et al. (2008), which use look up tables for generating top of atmosphere (TOA) reflectances to compute cloud
parameters. Since clouds are such efficient scatterers of light, FRESCO can approximate scattering by cloud using a Lambertian
model — this simplification works for optically thick cloud layers quite well. For aerosol layers, however, such calculations
1
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
need to be done in much greater detail due to their weaker scattering properties. TROPOMI’s ALH algorithm employs the
science code Disamar (Determining Instrument Specifications and Methods for Atmospheric Retrievals) that uses the Layer-
Based Orders of Scattering (LABOS) radiative transfer model based on the doubling-adding method (de Haan et al., 1987)
that calculates reflectances at the TOA and its derivatives with respect to aerosol layer height and aerosol optical thickness (τ).
These calculations are done line-by-line, requiring calculations at 3980 wavelengths to generate these TOA reflectances within5
the oxygen A-band. Having computed the TOA reflectance spectra, aerosol layer heights are retrieved with Optimal Estimation
(OE), an iterative retrieval scheme developed by Rodgers (2000) that incorporates a priori knowledge of retrieval parameters
into their estimation. Such a retrieval scheme also provides a posteriori error estimations, which are important for assimilation
models and diagnosing the retrieval results.
The ALH retrieval algorithm is computationally expensive, requiring several minutes to compute zaer for a single ground10
pixel (Sanders et al., 2015). As near-real time processors need to consistently go through large volumes of data recorded by
the satellite for the mission lifetime, operational retrievals are time restricted. With TROPOMI recording approximately 1.4
million pixels within a single orbit, a rough estimate of an average of three percent of all TROPOMI pixels in an orbit over an
area as big as Europe may be eligible for retrieving aerosol layer height. This number can go up to as much as 50,000 pixels
per orbit. This places a steep requirement on the computational infrastructure to process all possible pixels from a single orbit.15
The online radiative transfer model severely limits the ALH data product, processing only a small fraction of the total possible
pixels within a single orbit while compromising the timeliness of the data delivery.
The bottleneck identified here is the large number of calculations that the forward model has to compute to retrieve in-
formation on weak scatterers such as aerosols. Several steps to circumvent this bottleneck exist, such as using correlative
k-distribution method to reduce the number of calculations Hasekamp and Butz (2008), using a look up table for calculating20
forward model outputs, or entirely foregoing the forward model and directly retrieving zaer from observed spectra using neural
networks (Chimot et al., 2017, 2018). Studies by Sanders and de Haan (2016) have shown that the look up table for reflectance
alone measure up to 46 GB in size, and perhaps similar or larger sizes for the derivatives. Chimot et al. (2017) describe an
artificial neural network approach using the same radiative transfer model as for TROPOMI to generate training data, in com-
bination with the NASA MODIS aerosol optical depth product, and successfully retrieve aerosol layer heights directly from25
the O2-O2bands in the visible spectral region at 477 nm. They demonstrated this by retrieving aerosol layer heights from
spectra measured by the Ozone Monitoring Instrument (OMI) on board the NASA Aura mission, without using line-by-line
calculations or an iterative estimation step such as OE (Chimot et al., 2018). A similar example of retrievals is the ROCINN
(Retrieval of Cloud Information using Neural Networks) cloud algorithm developed by Loyola (2004) which uses neural net-
works to compute convolved reflectance spectra to retrieve cloud properties. These retrievals show the exploitable capabilities30
of artificial neural networks in the context of retrieving atmospheric properties from oxygen absorption bands.
The work of Chimot et al. (2017) brings to light an interesting use case of artificial neural networks for retrieving aerosol
information from oxygen absorption bands. This paper approaches the problem from a different direction by using artificial
neural networks to improve the computational speed of the radiative transfer calculations of the reflectance and its derivatives
with respect to retrieval parameters, and keeping intact the OE approach as the a posteriori statistics generated act as diagnostic35
2
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
tools for analysing retrieval behaviour. By reducing the time consumed for calculating forward model outputs, computational
efficiency of TROPOMI’s aerosol layer height retrieval algorithm can be significantly improved. Section 2 introduces the
operational aerosol layer height algorithm and discusses the line-by-line forward model. The neural network forward model
approach is detailed in section 3, and its verification on a test data set is discussed in same section. This approach is then
applied to various test cases using synthetic and real TROPOMI spectra (section 4) before concluding in section 5.5
2 The TROPOMI aerosol layer height retrieval algorithm
The TROPOMI aerosol layer height is one of the many algorithms that exploit vertical information of scattering aerosol
species in the oxygen A-band (Gabella et al., 1999; Corradini and Cervino, 2006; Pelletier et al., 2008; Dubuisson et al., 2009;
Frankenberg et al., 2012; Wang et al., 2012; Hollstein and Fischer, 2014; Sanders and de Haan, 2013; Sanders et al., 2015;
Sanders and de Haan, 2016; Nanda et al., 2018b). These methods invert a forward model that describes the atmosphere, to10
compute the height of the scattering layer. This section discusses the setup of the TROPOMI ALH retrieval algorithm, which
consists of the inversion of a forward model representing the atmosphere using optimal estimation as the retrieval method, and
a description of the forward model.
2.1 The retrieval method
The cost function χ2represents the departure of the modeled reflectance F(x)from the observed reflectance yscaled by the15
measurement error covariance matrix S, and is defined as
χ2= [yF(x)]TS
1[yF(x)] + (xxa)TSa
1(xxa).(1)
Minimising this cost function for a particular zaer and τ(the elements of the state vector xto be retrieved and fitted) gives
us the final retrieval product. This definition of the cost function is unique to OE, as it constrains its minimisation with a
priori knowledge of the state vector x, contained in xaand the a priori error covariance matrix Sa. In the TROPOMI ALH20
processor’s OE framework, the a priori state vector is fixed at specific values, usually 200 hPa above the surface for zaer and 1.0
for τat 760 nm. The a priori error of the zaer is fixed at 500 hPa, and the same for τis 1.0, to allow freedom for the variables
in the estimation (this also reduces the impact of the a priori on the retrieval). The modeled measured reflectance spectrum is
calculated using the forward model (denoted as F) for model parameters xfollowing,
F(x)(λ) = πI(λ)
µ0E0(λ),(2)25
3
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
where µ0is the cosine of the solar zenith angle θ0,I(λ)for wavelength λ) is the Earth radiance and E0(λ)is the solar irradiance.
Since the forward model is non-linear, a Gauss-Newton iteration is employed and the updated state vector is calculated as,
xi+1 =xa+ [KiTS
1Ki+Sa
1]1Ki
1S
1[yF(x)+Ki(xixa)],(3)
where iis the current iteration and Kiis the matrix of derivatives (Jacobian) of the reflectance with respect to state vector
parameters at the current iteration. The derivatives are calculated semi-analytically similar to the method described by Landgraf5
et al. (2001). The retrieval is said to converge to a solution if the state vector’s update is less than the expected precision (usually
fixed at a certain value). The retrieval fails to converge if the number of iterations exceeds the maximum number of iterations
(usually set at 12), or if the state vector parameters are projected outside their respective boundary conditions by OE. Retrieval
errors are derived from the a posteriori error covariance matrix ˆ
S, computed as
ˆ
S= [KTS
1K+Sa
1]1.(4)10
2.2 The Disamar forward model and its many simplifications of atmospheric properties
The forward model generates synthetic observed TOA radiance spectra by an instrument for a specific solar-satellite geometry,
which is required for minimising χ2(Equation 1). For this, a high resolution reference solar spectrum adopted from Chance
and Kurucz (2010) is used to obtain the TOA Earth radiance spectrum, which is further convolved with the instrument’s slit
function and combined with the solar irradiance to compute reflectances following Equation 2.15
Radiances are calculated by accounting for scattering and absorption of photons from their interactions with aerosols, the
surface and molecular species. Molecular scattering of photons in the oxygen A-band is described by Rayleigh scattering, and
absorption is described by photon-induced magnetic dipole transition between b1Σ+
gX3Σ
g(0,0) electric potential levels
of molecular oxygen, and collision-induced absorption between O2-O2and O2-N2. The total influence of the O2A-band in
the TOA reflectance is described by its extinction cross-section, which is a sum of the three aforementioned contributions. As20
the vertical distribution of oxygen is exactly known, the extinction cross-section can be exploited to retrieve zaer from satellite
measurements of the oxygen A-band. For this, Disamar calculates absorption (or extinction) cross sections at 3980 wavelengths
within the range 758 nm - 770 nm.
To reduce the number of calculations, various atmospheric properties are simplified. The polarised component of light need
not be calculated because second order scattering by air molecules is small compared to first order scattering, as the Rayleigh25
optical thickness is small around 760 nm. Calculating the influence of Rotational Raman Scattering (RRS) is also ignored,
as it is a computationally expensive step. This exclusion of calculations is not advised by literature (Vasilkov et al., 2013;
Sioris and Evans, 2000), as RRS can alter the line depths in the O2A-band, but this effect is small. The choice of ignoring
RRS is borne out of computational burden it puts on the overall retrieval algorithm. From preliminary tests, the exclusion of
RRS seems to not affect zaer retrievals significantly. The atmosphere is assumed cloud-free, which is a required simplification30
as the retrieval of zaer in the presence of clouds becomes challenging. The aerosol fraction is assumed as 1.0, which further
4
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
simplifies the representation of aerosols within the atmosphere. Perhaps the largest simplification of the atmosphere lies in
model’s description of aerosols, assumed to be distributed in a homogeneous layer at a height zaer with a 50 hPa thickness,
a fixed aerosol optical thickness (τ) and a single scattering albedo of 0.95 (so, scattering aerosols). The aerosol scattering
phase function assumed is a Henyey-Greenstein model (Henyey and Greenstein, 1941), instead of alternatives such as Mie-
scattering models which require significantly more computations. Finally, the surface is assumed to be an isotropic reflector5
with a brightness described by its Lambertian Equivalent Reflectivity (LER). This is also an important simplification, requiring
less computations over other surface models such as a Bi-directional Reflectance Model. Lastly, the atmosphere is spherically-
corrected for incoming solar radiation and remains plane-parallel for outgoing Earth radiance.
2.3 Application to TROPOMI
TROPOMI’s near infrared (NIR) spectrometer records data between 675 nm - 775 nm, spread across two bands — band 510
contains the oxygen B-band and band 6 the oxygen A-band. The spectral resolution, which is described by the full width at half
maximum (FWHM) of the instrument spectral response function (ISRF), is 0.38 nm with a spectral sampling interval of 0.12
nm. The spatial resolution is around 7 km ×3.5 km for band 5 and 6. Initial observations from the TROPOMI NIR spectrometer
show a signal to noise ratio (SNR) of 3000 in the continuum before the oxygen A-band. The instrument polarization sensitivity
is reduced to below 0.5% by adopting the technology of the polarization scrambler of the ozone monitoring instrument (OMI)15
(Veefkind et al., 2012; Levelt et al., 2006). Disamar utilizes TROPOMI’s swath-dependent ISRFs to convolve I(λ)and E0(λ)
into I(λi)and E0(λi)in the instrument’s spectral wavelength grid, after which the modeled measured reflectance is calculated
using Equation 2.
Input parameters required by the TROPOMI ALH retrieval algorithm encompass satellite observations of the radiance and
the irradiance, solar-satellite geometry, and a host of atmospheric and surface parameters required for modeling the interactions20
of photons within the Earth’s atmosphere (see Table 1). Meteorological parameters are derived from ECMWF (European
Centre for Medium-range Weather Forecast), which provide the temperature-pressure profile at 91 atmospheric levels. The
various databases supplying meteorological and surface parameters are interpolated to TROPOMI’s ground pixels using nearest
neighbour interpolation.
Calculation of TOA reflectance and its derivatives with respect to zaer, and τin an line-by-line fashion requires approxi-25
mately 40-60 seconds to complete on a computer equipped with Intel(R) Xeon(R) CPU E3-1275 v5 at a clock speed of 3.60
GHz. In an iterative framework such as the Gauss-Newton method, the retrieval of zaer can take between 3-6 iterations de-
pending on the amount of aerosol information available in the observed spectra, requiring several minutes to compute retrieval
outputs for a specific scene. If these retrievals fail by not converging within the maximum number of iterations, the processor
can waste up to 10 minutes on a pixel without retrieving a product. In order to compute Disamar’s outputs quicker, a neural30
network implementation is discussed in the next section.
5
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
Table 1. Input parameters required for retrieving aerosol layer height using TROPOMI measured spectra.
Parameter Source Remarks
Radiance and irradiance TROPOMI Level-1b product
SNR measured spectrum TROPOMI Level-1b product
Geolocation parameters TROPOMI Level-1b product
Surface albedo GOME-2 LER database Tilstra et al. (2017)
Meteorological parameters ECMWF 17km horizontal resolution
Cloud fraction TROPOMI Level-2 FRESCO product
Absorbing aerosol index TROPOMI Level-2 AAI product
Land-sea mask NASA Toolkit
Surface altitude GMTED 2010 pre-averaged
3 The neural network (NN) forward model
Artificial neural networks consist of connected processing units, each individually producing an output value given a certain
input value. The interaction of these individual processing units, also known as nodes (or neurons), enable the connecting
network to map a set of inputs (also known as the input layer) to a set of outputs (or, the output layer). The connections are
known as weights whose value symbolises the strength of a connection between two nodes. Since the nodes connect inputs to5
the outputs, higher values in a set of connecting weights represent a stronger influence of a particular parameter in the input
layer over a particular parameter in the output layer. These weights are determined after training the neural network.
The training (or optimisation) of a neural network begins with a training data set containing many instances of input and
output layer elements. As true values of the output layer for a given set of inputs are exactly known in the training data set, the
biased output of the neural network calculated after using randomised, non-optimised weights can be easily calculated. These10
biases are called prediction errors, an essential element in the optimization of the neural network weights. The mean squared
error (MSE) between the true output and the calculated output is also called the loss function (henceforth annotated as ),
which is synonymous to a cost function (Equation 5),
∆ = 1
nλX
λ
(nnλoλ)2(5)
where λis the wavelength, nλrepresents the number of elements in the output layer, nnλrepresents the calculated output for15
wavelength via forward propagation, and oλare the outputs in the training data set. The weights are updated using optimisers
such as the ADAM optimiser (Adaptive Moment Estimation, Kingma and Ba (2014)) to minimise , within set number of
iterations.
6
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
3.1 The TROPOMI NN forward model for the ALH retrieval algorithm
The standard architecture of the NN-augmented operational aerosol layer height processor includes three neural network mod-
els for estimating top of atmosphere sun-normalised radiance, the derivative of the reflectance with respect to zaer, and the
same for τ. It is also possible to assign the neural network to compute the reflectance instead of the sun-normalized radiance
— the results will not change. The definition of sun-normalised radiance used in this paper is the ratio of Earth radiance to5
solar irradiance. Disamar calculates derivatives with respect to reflectance, which is the sun-normalised radiance multiplied by
the ratio of πand cosine of solar zenith angle. All three neural network models share the same input model parameters. Opti-
mising a single neural network model for all three forward model outputs is not necessary; the correlations between the input
parameters and the different forward model outputs are different, which can complicate the optimisation of a general-purpose
neural network. This paper, however, acknowledges modern developments in neural network optimisation techniques that now10
afford selectively optimising a neural network for different tasks (Kirkpatrick et al., 2016; Wen and Itti, 2018).
The models are trained using the python Tensorflow module (Abadi et al., 2015), and further implemented into an operational
processor using C++ interface to Tensorflow. These neural network models require training data containing Disamar input and
output parameters and a connecting architecture that encompasses the input feature vector containing scene-varying model
parameters, the number of hidden layers, number of nodes in each hidden layer, and an activation function that maps the15
input to the final output layer containing Disamar outputs. In Tensorflow, the derivative of with respect to the weights
are computed using reverse-mode automatic differentiation which is a powerful algorithm that computes numerical values of
derivatives without the use of analytical expressions (Wengert, 1964).
The inputs for NN are referred together as the feature vector. The choice of the parameters included into the feature vector
is a very important factor deciding the performance of the neural network. The primary classes of model parameters (relevant20
to retrieving zaer) varying from scene to scene are solar-satellite geometry, aerosol parameters, meteorological parameters
and surface parameters (Table 2). The various aerosol parameters that are fixed from scene to scene are the aerosol single
scattering albedo (ω), the asymmetry factor of the phase function, and the angstrom exponent, as they are also fixed in the
line-by-line operational aerosol layer height processor. The scattering phase function of aerosols is currently limited to a
Henyey-Greenstein model with a fixed gvalue of 0.7 to mimic Disamar. Surface pressure as well as the temperature-pressure25
profile are two important meteorological parameters relevant to retrieving zaer. A difference between Disamar and NN models
is the definition of this temperature information in the input. Disamar requires the entire temperature-pressure profile of the
atmosphere, whereas NN only uses the temperature at zaer. Surface albedo is specified at 758 nm as well as 772 nm in Disamar,
whereas it is only specified at 758 nm in the feature vector of NN. In general there is a greater scope to add detailed information
in Disamar, whereas the goal of NN is to optimally limit input model parameters while accurately calculating forward model30
outputs.
7
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
Table 2. Scene-dependent input model parameters for the NN model. See also Figure 1 for a histogram of the input parameters. The solar-
satellite geometry parameters are generated in combinations conforming to the ones encountered by TROPOMI’s orbits.
Parameter class Model Parameters Remarks limits
Geometry
Solar zenith angle (θ0) in feature vector 8.20- 80.0
Viewing zenith angle (θ) in feature vector 0.0- 66.60
Solar azimuth angle (φ0) in feature vector -180.0- 180.0
Viewing azimuth angle (φ) in feature vector -180.0- 180.0
Aerosol parameters
Aerosol fraction fixed 1.0
Single scattering albedo (ω) fixed 0.95
Aerosol optical thickness (τ) in feature vector 0.05 - 5.0
Aerosol layer height (zaer) in feature vector 75 hPa - 1000.0 hPa
Aerosol layer thickness (pthick) varied -
Scattering phase function fixed Henyey-Greenstein
asymmetry factor (g) fixed 0.7
Angstrom exponent (Å) fixed 0.0
Meteorological parameters Temperature in feature vector temperature at zaer
Surface parameters
Surface pressure (ps) in feature vector 520 hPa - 1048.50 hPa
Surface reflectance model LER
Surface albedo (As) in feature vector 2.08E-7 - 0.70
3.2 Training the neural networks
Since the NN forward model is specifically designed for TROPOMI, the solar-satellite geometry is selected TROPOMI orbits
for the training data. Meteorological parameters for the locations associated with these solar-satellite geometries are derived
from the 2017 60-layer ERA-Interim Reanalysis data (Dee et al., 2011), and aerosol and surface parameters are randomly
generated within their physical boundaries.5
Generally, the required training data size increases with increasing non-linearity between input an output layers in a neural
network — there isn’t a specific method to accurately determine the required sample size before training. Following testing
and scrutinizing forward model calculation accuracy, a choice of 500,000 Disamar generated spectra is finalised as the size of
the training data set. The generation of this training data set is by far the most time consuming step since each Disamar run
requires between 50-60 seconds to generate the synthetic spectra. Once the data has been generated, it is prepared for training10
the neural network models in NN. This is done by data normalisation, achieved by subtracting the mean of each of the training
input and output parameters and dividing the difference by its standard deviation, which makes the learning process quicker by
reducing the search space for the optimizer. The offset and scaling parameters are important, as the neural network computes
outputs within this scaled range, which needs to be re-scaled back to legible values. This training requires a few hours on an
Intel(R) Xeon(R) CPU E3-1275 v5 at a clock speed of 3.60 GHz.15
8
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
The most optimal configurations for each of the three NN models are determined by the number of hidden layers, the number
of nodes on each layer and the chosen activation function for which the discrepancy between the modeled output for specific
inputs and the truth (derived from Disamar) is minimal. Finding the most optimal neural network configuration requires a test
data set which in this case contains 100,000 scenes outside the training data set. These test data follow the same input model
parameter distributions as described in Figure 1 and Table 1. The difference between the outputs calculated by Disamar and5
NN for these three models provide insight on their performance. The sigmoid function is chosen as the activation function for
the NN processor, as it performs the best (lowest loss function value) over other alternatives.
For each of the neural network models, five configurations were tested. The first three configurations comprise of a single
hidden layer, two hidden layers and three hidden layers, all consisting of 50 nodes each. Depending on the best performing
configuration of the number of hidden layers, two other configurations are added containing 100 and 200 nodes in each of10
the layers. For instance, if the neural network configuration comprising of two hidden layers performs best, the last two
configurations will consist of two hidden layers with 100 and 200 nodes on each layer. Each configuration were trained for a
total of 25,000 iterations. Of every configuration tested for each of the neural network models, the most optimal configuration
was found to be two hidden layers containing 100 nodes each. Figure 2 gives a graphic representation of the neural network
model.15
The finalised configurations were then trained for one million iterations after which they were applied to the test data set
to study prediction errors. An error analysis revealed that the trained neural networks were generally capable of calculating
Disamar outputs with low errors, within 1-3% to Disamar calculations. Averaged convolved errors of the neural network model
for the sun normalised radiance (NNI) did not exceed 1%. The neural network model for the derivative of the reflectance with
respect to τ(NNKτ) performed very well with errors not exceeding more than 3%. Averaged convolved errors for the neural20
network model for the derivative of the reflectance with respect to zaer (NNKzaer ) also show good agreements, with errors
in parts of the spectrum with very low zaer information, e.g. the continuum (3d). It is important to note that although the
relative errors for the derivatives appear quite large at parts of the oxygen A-band spectrum, these parts have low aerosol
information content due to low oxygen absorption cross sections (with respect to parts of the wavelength band with stronger
oxygen absorption, i.e. the R-branch between 759 nm and 762 nm).25
4 Comparison between Disamar and NN aerosol layer height retrieval algorithms
To test the NN augmented retrieval algorithm, we apply the generated NN models to synthetic test data and real data from
TROPOMI, and compare its retrieval capabilities to those of Disamar. The synthetic data were produced using the Disamar
radiative transfer model because of which we expect the online radiative transfer retrievals to be generally better than the NN-
based retrievals. The aerosol model used in the retrieval is as in Section 2.2, using fixed parameters for aerosol single scattering30
albedo, aerosol layer thickness and aerosol scattering phase function.
9
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
4.1 Performance of NN versus Disamar in retrieving aerosol layer height in the presence of model errors
A comparison of biases (in the presence of model errors) in the final retrieved solution is indicative of the efficacy of NN in
replacing Disamar to retrieve ALH. To directly compare zaer retrieval capabilities of Disamar and NN, radiance and irradiance
spectra convolved with a TROPOMI slit function were generated to replicate TROPOMI-measured spectra. Bias is defined as
the difference between retrieved and true aerosol layer height (i.e., retrieved - true). A total of 2000 scenes for four synthetic5
experiments were generated from the test data set containing TROPOMI geometries, with randomly varied model errors in
aerosol single scattering albedo, Henyey-Greenstein phase function asymmetery parameter, and surface albedo (described in
Table 3).
The retrieved aerosol layer heights from Disamar and NN in the presence of model errors in aerosol layer thickness were
found to be almost similar (Figure 4a), with a Pearson correlation coefficient close to 1.0. Introducing model errors in other10
aerosol properties such as single scattering albedo (Figure 4b) and scattering phase function (Figure 4c) also resulted in a similar
agreement between Disamar and NN retrieved aerosol layer heights. Furthermore, both methods retrieved similar aerosol layer
heights in the presence of model errors in surface albedo as well (Figure 4d).
A total of 5558 retrievals out of the 8000 difference cases converged to a final solution. On average, zaer retrieved using
NN differed by approximately 5.0 hPa from the same using Disamar (Figure 5), with a median of approximately 2.0 hPa. The15
spread of the retrieval differences were minimal, with a majority of the retrievals differing less than 13.0 hPa approximately.
Differences close to and above 100.0 hPa did exist, but such retrievals were very uncommon.
Out of the 8000 scenes within the synthetic experiment, NN retrieved aerosol layer heights for 546 scenes where Disamar
did not. Contrariwise, 586 scenes converged for Disamar and not for NN. A comparison of the biases from these odd retrieval
results indicate that retrievals from NN in cases where Disamar fails are realistic, as the distribution of the biases is very20
similar to those cases when Disamar succeeds and NN does not (Figure 6). Retrievals using the NN forward model on average
required three more iterations to reach a solution when compared to the same by Disamar. Similarly, retrievals from Disamar
had a significantly lower minimised cost function (less than four orders of magnitude on average) at the end of the retrieval
when compared to NN. This is within expectation as NN cannot truly replicate Disamar. Having tested the NN augmented
retrieval algorithm in a synthetic environment, the retrieval algorithm was installed into the operational TROPOMI processor25
for testing with real data.
4.2 Application to December 2017 Californian forest fires observed by TROPOMI
The December 2017 Southern California wildfires have been attributed to very low humidity levels, following delayed autumn
precipitation and severe multi-annual drought (Nauslar et al., 2018). Particularly on December 12, the region of the fires were
cloud-free, owing to high-pressure conditions. The biomass burning plume extended well beyond the coastline and over the30
ocean, which provides a roughly cloud-free and low surface brightness test case for implementing the aerosol layer height
retrieval algorithm (Figure 7a). The absorbing aerosol index values were above 5.0 in the bulk of the plume, indicating a very
high concentration of elevated absorbing aerosols. Pixels with an AAI value less than 1.0 were excluded from the retrieval
10
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
Table 3. A count of converged an non-converged results from synthetic experiments comparing retrieved aerosol layer heights between
Disamar and NN.
experiment Disamar NN
model parameter value in sim value in ret converged non converged converged non converged
pthick 200 hPa 50 ha 1641 359 1550 450
ω0.93 - 0.96 0.95 1396 604 1412 588
g0.67 - 0.73 0.7 1571 429 1567 433
As0.95As- 1.05AsAs1536 464 1575 425
experiment. Pixels that were cloud contaminated were removed from the processing chain using the FRESCO cloud mask
product from TROPOMI (maximum cloud fraction of 0.2), but parts of the biomass burning plume that did not contain any
clouds (Figure 7b) were also removed, as the cloud fraction values for these pixels were higher than the threshold. The retrieval
algorithms did not process pixels in the coastline, as the surface albedo values could be incorrect in these regions.
The operational line-by-line algorithm was applied to ground pixels within a bounding box around the plume. A total of5
7418 pixels within this bounding box converged to a solution (Figure 8a). The neural network augmented operational processor
retrieved 7370 pixels out of the 7418 pixels that had converged for the operational line-by-line processor (Figure 8b). Although
visually discernable in the difference map in Figure 8c, the retrieved zaer from both algorithms were quite similar (Figure 9a).
The neural network augmented processor retrieved aerosol layer heights which were (on average) less than 50.0 meters apart
from the same by the line-by-line counterpart (Figure 9b). While the standard deviation of approximately 160 meters indicates10
the presence of outliers, the 15th and the 85th percentile values of -115.0 meters and 40.0 meters, respectively, indicate that the
significant majority of retrieved pixels were only off by less than 100.0 meters. Although the retrieval algorithms have good
agreements, they primarily departed in the lower aerosol loading scenes (Table 4). The majority of the pixels where the neural
network algorithm differed from the line-by-line counterpart by more than 200 meters were for absorbing aerosol index values
less than 2.0 (Figure 9c). Most of these biases were due to over-estimation by the neural network retrieval algorithm. Pixels15
with AAI values larger than 5.0 also showed a consistent departure, different on average by 60 meters with a standard deviation
of 30 meters. This departure is not well understood.
Table 4. Statistics of difference between retrieved zaer from disamar and NN, as defined in figure 8c.
AAI [-] number of samples mean [m] median [m] standard deviation [m] 15th percentile [m] 85th percentile [m]
<2.0 3227 -50.74 -62.10 206.44 -228.65 108.31
2.0 - 3.0 2723 -54.96 -43.20 110.75 -184.85 67.10
3.0 - 5.0 1167 10.32 19.42 63.65 -61.63 65.26
>5.0 253 61.35 61.00 30.954 26.56 95.22
11
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
The time required by the line-by-line operational processor was 184.01±0.50 seconds per pixel, whereas the same for the
neural network processor was 0.167±0.0003 seconds per pixel. The neural network algorithm shows an improvement in the
computational speed by three orders of magnitude over the line-by-line retrieval algorithm. The computational speed gained
from implementing NN enables retrieval of aerosol layer heights from all potential scenes in the entire orbit within the stipulated
operational processing time slot.5
5 Conclusions
Of the algorithms that currently retrieve TROPOMI’s suite of level-2 products, the aerosol layer height processor requires online
radiative transfer calculations. These online calculations have traditionally been tackled with KNMI’s radiative transfer code
Disamar, which calculates sun-normalised radiances in the oxygen A-band. There are, in total, 3980 line-by-line calculations
per iteration in the optimal estimation scheme, requiring several minutes to retrieve aerosol layer height estimates from a single10
scene. This limits the yield of the aerosol layer height processor significantly.
The bottleneck is identified to be the number of calculations Disamar needs to do at every iteration of the Gauss-Newton
scheme of the estimation process. As a replacement, this paper proposes using artificial neural networks in the forward model
step. Three neural networks are trained, for the sun-normalised radiance and the derivative of the reflectance with respect to
aerosol layer height and aerosol optical thickness, the two state vector elements. As the goal is to replicate and replace Disamar,15
line-by-line forward model calculations from Disamar were used to train these neural networks. A total of 500,000 spectra were
generated using Disamar, and each of the neural network models were trained for a total of 1 million iterations with the mean
squared error between the training data output and the neural network output being the cost function to be minimised in the
optimisation process.
Over a test data set with 100,000 different scenes unique from the training data set, the neural network models performed20
well, with errors not exceeding 1-3% in general in the predicted spectra and derivatives. Having tested the neural network
models for prediction errors in the forward model output spectra, they were implemented into the aerosol layer height bread-
board algorithm and further tested for retrieval accuracy. In order to do so, experiments with synthetic as well as real data were
conducted. The synthetic scenes included 2000 spectra with different model errors in aerosol and surface properties. In these
cases, the neural network algorithm showed very good compatibility with the aerosol layer height algorithm, since it was able25
to replicate the biases satisfactorily.
For a real test case, TROPOMI spectra over the December 12, 2017 forest fires in Southern California were chosen. On
this day, the biomass burning plume extended from land to the ocean over a dry and almost cloudless scene. Operational
retrievals using both Disamar and the neural network forward models showed very similar results, with a few outliers around
500 meters for pixels containing low aerosol loads. These biases were outweighed by the upgrade in the computational speed30
of the retrieval algorithm, as the neural network augmented processor observed a speedup of three orders of magnitude, making
the aerosol layer height processor operationally feasible. Having achieved this improvement in its computational performance,
the aerosol layer height algorithm is planned to be operationally retrieving the product for the all possible pixels in each orbit of
12
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
TROPOMI. Such a boost in processor output allows for better analyses of retrievals and opens the possibility to remove some
of the forward model simplifications mentioned in Section 2.2, which paves the way for further developing the TROPOMI
aerosol layer height algorithm.
Competing interests. The author declares no conflict of interests in the work expressed in this publication.
Acknowledgements. This publication contains modified Copernicus Sentinel data. This research is partly funded by the European Space5
Agency (ESA) within the EU Copernicus programme.
13
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
Figure 1. Histograms of the various input parameters for each of the neural network models in NN. Minimum and maximum values for each
of the parameters are available in Table 2.
14
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
Figure 2. A schematic of each of the three neural networks in NN. There are two hidden layers, each containing 100 nodes. zrepresents
inputs for each of the nodes, whereas nn represents the inputs and outputs of the neural network.
15
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
Figure 3. Performance of the finalised neural network. The top row represents the averaged output of each of the neural networks for surface
albedo less than 0.4. The bottom row represents the convolved version of the top row (plotted as the red line with the left-handed y-axis)
and the convolved relative error (plotted in log scale) with the truth (plotted in blue with the right-handed y-axis). The relative errors are
computed as the absolute value of the difference (post-convolution) between the averaged true and averaged predicted spectra, divided by the
averaged true spectra. (a,b) represent the neural network computed sun-normalised radiances, (c,d) represent the same for the derivative of
reflectance with respect to aerosol layer height, and (e,f) the same with respect to aerosol optical thickness.
16
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
Figure 4. Retrieved layer heights compared between Disamar and NN for 2000 synthetic spectra in the presence of model errors. The dots
represent converged scenes only, with the x axis representing retrievals from Disamar and the y-axis representing the same from NN. The
model errors represented in this figure are (a) aerosol layer pressure thickness, (b) aerosol single scattering albedo, (c) aerosol scattering
phase function asymmetry factor, and (d) surface albedo. These results as well as the introduced model errors are summarised in Table 3.
The Pearson correlation coefficient (R) between the retrieved zaer from different methods is mentioned in each of the plots.
17
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
Figure 5. A histogram of differences between the retrieved zaer values using Disamar and NN retrieval methods for synthetic spectra
generated by Disamar. Total number of cases is 8000, whereas the plot contains 5558 retrieved samples for both Disamar and NN; non-
converged cases are not included. A map of these differences are plotting in Figure 8c.
18
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
Figure 6. A histogram of biases (retrieved - true) for scenes in the synthetic experiment for which either NN converges to a solution (red bar
plot) and Disamar does not, or Disamar converges to a solution (blue bar plot) whereas NN does not.
19
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
Figure 7. (a) A MODIS Terra image of the December 12, 2017 Southern Californian wildfire plume, extending from land to the ocean. (b)
Calculated aerosol absorbing index from the TROPOMI level-2 processor. Missing pixels either are flagged by a cloud mask, or by a land-sea
mask, or have an absorbing aerosol index less than 1.0.
20
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
Figure 8. (a) Aerosol layer height retrieved using Disamar as the forward model. (b) The same, but with NN replacing Disamar in the
operational processor. (c) represents the difference between Disamar and NN retrieved aerosol layer heights.
Figure 9. Comparison of retrieved aerosol layer heights from TROPOMI-measured spectra (orbit number 858) for the 12th December, 2017
Southern California fires using Disamar and NN. Figre (a) directly compares retrieved aerosol layer heights from the two methods. Figure (b)
provides a histogram of the difference between these retrieved heights from Disamar and NN. The difference is defined as zaer(Disamar) -
zaer(NN). Figure (c) compares these differences with TROPOMI’s operational absorbing aerosol index product (x axis).
21
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
References
Abadi, M., Agarwal, A., Barham, P., Brevdo, E., Chen, Z., Citro, C., Corrado, G. S., Davis, A., Dean, J., Devin, M., Ghemawat, S., Good-
fellow, I., Harp, A., Irving, G., Isard, M., Jia, Y., Jozefowicz, R., Kaiser, L., Kudlur, M., Levenberg, J., Mané, D., Monga, R., Moore, S.,
Murray, D., Olah, C., Schuster, M., Shlens, J., Steiner, B., Sutskever, I., Talwar, K., Tucker, P., Vanhoucke, V., Vasudevan, V., Viégas, F.,
Vinyals, O., Warden, P., Wattenberg, M., Wicke, M., Yu, Y., and Zheng, X.: TensorFlow: Large-Scale Machine Learning on Heterogeneous5
Systems, https://www.tensorflow.org/, software available from tensorflow.org, 2015.
Chance, K. and Kurucz, R.: An improved high-resolution solar reference spectrum for earth’s atmosphere measurements in
the ultraviolet, visible, and near infrared, Journal of Quantitative Spectroscopy and Radiative Transfer, 111, 1289–1295,
https://doi.org/10.1016/j.jqsrt.2010.01.036, http://linkinghub.elsevier.com/retrieve/pii/S0022407310000610, 2010.
Chimot, J., Veefkind, J. P., Vlemmix, T., de Haan, J. F., Amiridis, V., Proestakis, E., Marinou, E., and Levelt, P. F.: An exploratory study on10
the aerosol layer height retrieval from OMI measurements of the 477 nm O2-O2 spectral band using a neural network approach, Atmos.
Meas. Tech., 10, 783–809, https://doi.org/10.5194/amt-10-783-2017, https://www.atmos-meas-tech.net/10/783/2017/, 2017.
Chimot, J., Veefkind, J. P., Vlemmix, T., and Levelt, P. F.: Spatial distribution analysis of the OMI aerosol layer height: a pixel-
by-pixel comparison to CALIOP observations, Atmos. Meas. Tech., 11, 2257–2277, https://doi.org/10.5194/amt-11-2257-2018, https:
//www.atmos-meas-tech.net/11/2257/2018/, 2018.15
Corradini, S. and Cervino, M.: Aerosol extinction coefficient profile retrieval in the oxygen A-band considering multiple scattering at-
mosphere. Test case: SCIAMACHY nadir simulated measurements, Journal of Quantitative Spectroscopy and Radiative Transfer, 97,
354–380, https://doi.org/10.1016/j.jqsrt.2005.05.061, http://www.sciencedirect.com/science/article/pii/S0022407305002207, 2006.
de Haan, J. F., Bosma, P. B., and Hovenier, J. W.: The adding method for multiple scattering calculations of polarized light, Astronomy and
Astrophysics, 183, 1987.20
Dee, D. P., Uppala, S. M., Simmons, A. J., Berrisford, P., Poli, P., Kobayashi, S., Andrae, U., Balmaseda, M. A., Balsamo, G., Bauer,
P., Bechtold, P., Beljaars, A. C. M., van de Berg, L., Bidlot, J., Bormann, N., Delsol, C., Dragani, R., Fuentes, M., Geer, A. J., Haim-
berger, L., Healy, S. B., Hersbach, H., Hólm, E. V., Isaksen, L., Kållberg, P., Köhler, M., Matricardi, M., McNally, A. P., Monge-Sanz,
B. M., Morcrette, J.-J., Park, B.-K., Peubey, C., de Rosnay, P., Tavolato, C., Thépaut, J.-N., and Vitart, F.: The ERA-Interim reanalysis:
configuration and performance of the data assimilation system, Quarterly Journal of the Royal Meteorological Society, 137, 553–597,25
https://doi.org/10.1002/qj.828, http://doi.wiley.com/10.1002/qj.828, 2011.
Dubuisson, P., Frouin, R., Dessailly, D., Duforêt, L., Léon, J.-F., Voss, K., and Antoine, D.: Estimating the altitude of aerosol
plumes over the ocean from reflectance ratio measurements in the O2 A-band, Remote Sensing of Environment, 113, 1899–1911,
https://doi.org/10.1016/j.rse.2009.04.018, http://www.sciencedirect.com/science/article/pii/S0034425709001333, 2009.
Frankenberg, C., Hasekamp, O., O’Dell, C., Sanghavi, S., Butz, A., and Worden, J.: Aerosol information content analysis of multi-angle30
high spectral resolution measurements and its benefit for high accuracy greenhouse gas retrievals, Atmos. Meas. Tech., 5, 1809–1821,
https://doi.org/10.5194/amt-5-1809-2012, https://www.atmos-meas-tech.net/5/1809/2012/, 2012.
Gabella, M., Kisselev, V., and Perona, G.: Retrieval of aerosol profile variations from reflected radiation in the oxygen absorption A band,
Applied Optics, 38, 3190–3195, https://doi.org/10.1364/AO.38.003190, https://www.osapublishing.org/abstract.cfm?uri=ao-38-15-3190,
1999.35
22
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
Hasekamp, O. P. and Butz, A.: Efficient calculation of intensity and polarization spectra in vertically inhomogeneous scattering and absorbing
atmospheres, Journal of Geophysical Research: Atmospheres, 113, D20 309, https://doi.org/10.1029/2008JD010379, http://onlinelibrary.
wiley.com/doi/10.1029/2008JD010379/abstract, 2008.
Henyey, L. C. and Greenstein, J. L.: Diffuse radiation in the Galaxy, The Astrophysical Journal, 93, 70, https://doi.org/10.1086/144246,
http://adsabs.harvard.edu/doi/10.1086/144246, 1941.5
Hollstein, A. and Fischer, J.: Retrieving aerosol height from the oxygen A band: a fast forward operator and sensitivity study con-
cerning spectral resolution, instrumental noise, and surface inhomogeneity, Atmospheric Measurement Techniques, 7, 1429–1441,
https://doi.org/10.5194/amt-7-1429-2014, http://www.atmos-meas-tech.net/7/1429/2014/, 2014.
Kingma, D. P. and Ba, J.: Adam: A Method for Stochastic Optimization, arXiv:1412.6980 [cs], http://arxiv.org/abs/1412.6980, arXiv:
1412.6980, 2014.10
Kirkpatrick, J., Pascanu, R., Rabinowitz, N., Veness, J., Desjardins, G., Rusu, A. A., Milan, K., Quan, J., Ramalho, T., Grabska-Barwinska,
A., Hassabis, D., Clopath, C., Kumaran, D., and Hadsell, R.: Overcoming catastrophic forgetting in neural networks, arXiv:1612.00796
[cs, stat], http://arxiv.org/abs/1612.00796, arXiv: 1612.00796, 2016.
Landgraf, J., Hasekamp, O. P., Box, M. A., and Trautmann, T.: A linearized radiative transfer model for ozone profile retrieval us-
ing the analytical forward-adjoint perturbation theory approach, Journal of Geophysical Research: Atmospheres, 106, 27 291–27 305,15
https://doi.org/10.1029/2001JD000636, http://doi.wiley.com/10.1029/2001JD000636, 2001.
Levelt, P. F., Oord, G. H. J. v. d., Dobber, M. R., Malkki, A., Visser, H., Vries, J. d., Stammes, P., Lundell, J. O. V.,
and Saari, H.: The ozone monitoring instrument, IEEE Transactions on Geoscience and Remote Sensing, 44, 1093–1101,
https://doi.org/10.1109/TGRS.2006.872333, 2006.
Loyola, D. G. R.: Automatic cloud analysis from polar-orbiting satellites using neural network and data fusion techniques,20
in: IGARSS 2004. 2004 IEEE International Geoscience and Remote Sensing Symposium, vol. 4, pp. 2530–2533 vol.4,
https://doi.org/10.1109/IGARSS.2004.1369811, 2004.
Nanda, S., de Graaf, M., Sneep, M., de Haan, J. F., Stammes, P., Sanders, A. F. J., Tuinder, O., Veefkind, J. P., and Levelt, P. F.: Error sources
in the retrieval of aerosol information over bright surfaces from satellite measurements in the oxygen A band, Atmos. Meas. Tech., 11,
161–175, https://doi.org/10.5194/amt-11-161-2018, https://www.atmos-meas-tech.net/11/161/2018/, 2018a.25
Nanda, S., Veefkind, J. P., de Graaf, M., Sneep, M., Stammes, P., de Haan, J. F., Sanders, A. F. J., Apituley, A., Tuinder, O., and Levelt,
P. F.: A weighted least squares approach to retrieve aerosol layer height over bright surfaces applied to GOME-2 measurements of the
oxygen A band for forest fire cases over Europe, Atmos. Meas. Tech., 11, 3263–3280, https://doi.org/10.5194/amt-11-3263-2018, https:
//www.atmos-meas-tech.net/11/3263/2018/, 2018b.
Nauslar, N. J., Abatzoglou, J. T., and Marsh, P. T.: The 2017 North Bay and Southern California Fires: A Case Study, Fire, 1, 18,30
https://doi.org/10.3390/fire1010018, https://www.mdpi.com/2571-6255/1/1/18, 2018.
Pelletier, B., Frouin, R., and Dubuisson, P.: Retrieval of the aerosol vertical distribution from atmospheric radiance, vol. 7150, p.
71501R, International Society for Optics and Photonics, https://doi.org/10.1117/12.806527, https://www.spiedigitallibrary.org/
conference-proceedings-of-spie/7150/71501R/Retrieval-of-the-aerosol-vertical-distribution-from-atmospheric-radiance/10.1117/
12.806527.short, 2008.35
Rodgers, C. D.: Inverse methods for atmospheric sounding: theory and practice, vol. 2, World Scientific, 2000.
23
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
Sanders, A. F. J. and de Haan, J. F.: Retrieval of aerosol parameters from the oxygen A band in the presence of chlorophyll fluorescence, At-
mospheric Measurement Techniques, 6, 2725–2740, https://doi.org/10.5194/amt-6-2725-2013, http://www.atmos-meas-tech.net/6/2725/
2013/, 2013.
Sanders, A. F. J. and de Haan, J. F.: TROPOMI ATBD of the Aerosol Layer Height product, http://www.tropomi.eu/sites/default/files/files/
S5P-KNMI-L2-0006-RP-TROPOMI_ATBD_Aerosol_Height-v1p0p0-20160129.pdf, 2016.5
Sanders, A. F. J., de Haan, J. F., Sneep, M., Apituley, A., Stammes, P., Vieitez, M. O., Tilstra, L. G., Tuinder, O. N. E., Koning, C. E., and
Veefkind, J. P.: Evaluation of the operational Aerosol Layer Height retrieval algorithm for Sentinel-5 Precursor: application to Oxygen
A band observations from GOME-2A, Atmospheric Measurement Techniques, 8, 4947–4977, https://doi.org/10.5194/amt-8-4947-2015,
http://www.atmos-meas-tech.net/8/4947/2015/, 2015.
Sioris, C. E. and Evans, W. F. J.: Impact of rotational Raman scattering in the O2A band, Geophysical Research Letters, 27, 4085–4088,10
https://doi.org/10.1029/2000GL012231, https://agupubs.onlinelibrary.wiley.com/doi/abs/10.1029/2000GL012231, 2000.
Tilstra, L. G., Tuinder, O. N. E., Wang, P., and Stammes, P.: Surface reflectivity climatologies from UV to NIR determined from Earth
observations by GOME-2 and SCIAMACHY: GOME-2 and SCIAMACHY surface reflectivity climatologies, Journal of Geophysical
Research: Atmospheres, https://doi.org/10.1002/2016JD025940, http://doi.wiley.com/10.1002/2016JD025940, 2017.
Vasilkov, A., Joiner, J., and Spurr, R.: Note on rotational-Raman scattering in the O2A- and B-bands, Atmospheric Measurement Techniques,15
6, 981–990, https://doi.org/https://doi.org/10.5194/amt-6-981-2013, https://www.atmos-meas-tech.net/6/981/2013/amt-6-981-2013.html,
2013.
Veefkind, J. P., Aben, I., McMullan, K., Förster, H., de Vries, J., Otter, G., Claas, J., Eskes, H. J., de Haan, J. F., Kleipool, Q., van Weele,
M., Hasekamp, O., Hoogeveen, R., Landgraf, J., Snel, R., Tol, P., Ingmann, P., Voors, R., Kruizinga, B., Vink, R., Visser, H., and Levelt,
P. F.: TROPOMI on the ESA Sentinel-5 Precursor: A GMES mission for global observations of the atmospheric composition for climate,20
air quality and ozone layer applications, Remote Sensing of Environment, 120, 70–83, https://doi.org/10.1016/j.rse.2011.09.027, http:
//www.sciencedirect.com/science/article/pii/S0034425712000661, 2012.
Wang, P., Stammes, P., van der A, R., Pinardi, G., and van Roozendael, M.: FRESCO+: an improved O2 A-band cloud retrieval algo-
rithm for tropospheric trace gas retrievals, Atmos. Chem. Phys., 8, 6565–6576, https://doi.org/10.5194/acp-8-6565-2008, https://www.
atmos-chem-phys.net/8/6565/2008/, 2008.25
Wang, P., Tuinder, O. N. E., Tilstra, L. G., de Graaf, M., and Stammes, P.: Interpretation of FRESCO cloud retrievals in case of ab-
sorbing aerosol events, Atmospheric Chemistry and Physics, 12, 9057–9077, https://doi.org/10.5194/acp-12-9057-2012, http://www.
atmos-chem-phys.net/12/9057/2012/, 2012.
Wen, S. and Itti, L.: Overcoming catastrophic forgetting problem by weight consolidation and long-term memory, arXiv:1805.07441 [cs,
stat], http://arxiv.org/abs/1805.07441, arXiv: 1805.07441, 2018.30
Wengert, R. E.: A Simple Automatic Derivative Evaluation Program, Commun. ACM, 7, 463–464, https://doi.org/10.1145/355586.364791,
http://doi.acm.org/10.1145/355586.364791, 1964.
24
Atmos. Meas. Tech. Discuss., https://doi.org/10.5194/amt-2019-143
Manuscript under review for journal Atmos. Meas. Tech.
Discussion started: 8 May 2019
c
Author(s) 2019. CC BY 4.0 License.
... For instance, the OMI aerosol retrieval algorithm fits narrow-band radiance in several atmospheric window channels rather than a fine spectral structure (Torres et al., 2007). Last but not least, fitting the fine spectral structure of observations consumes far more time, resulting in unacceptable computational burden for an operational algorithm producing near-real-time products; this high computational demand is one of the motivations to use the neural network (NN)-based forward model in the current TRO-POMI ALH operational algorithm (Nanda et al., 2019). In contrast, fitting narrow-band measurements through look-up tables, as done in several aerosol retrieval algorithms, is computationally efficient and fast. ...
Article
Full-text available
Constraint of the vertical distribution of aerosol particles is crucial for the study of aerosol plume structure, aerosol radiative effects, and ultimately monitoring surface air pollution. We developed an algorithm to retrieve the aerosol optical central height (AOCH) of absorbing aerosols by using, for the first time, the oxygen (O2) A and B absorption band measurements from the TROPOspheric Monitoring Instrument (TROPOMI) over dark targets. For the retrieval, narrow band radiance at seven channels ranging from ultraviolet (UV) to shortwave infrared (SWIR) are convolved from TROPOMI hyperspectral measurements. Subsequently, cloudy pixels are screened out by using the slope of spectral reflectance, while aerosol types (dust and smoke) are classified by the wavelength dependence of aerosol path radiance in conjunction with UV aerosol index. Surface reflectance over land is derived from the MODIS surface bi-directional reflectance climatology, and over water from the GOME-2 surface Lambert-equivalent reflectivity (LER) database. The aerosol optical depth (AOD) and AOCH are retrieved through an approach of look-up-table accounting for AERONET-based dust and smoke optical properties. For multiple smoke and dust plume events around the world, our retrieved AOCH values agree with space-borne lidar CALIOP counterparts, with a mean bias of <0.15 km and a correlation coefficient of 0.85–0.87. Due in part to adding the O2 B band, our retrieval represents an aerosol extinction peak height better than the TROPOMI operational Level 2 aerosol layer height retrieved from only the O2 A band. The latter shows 0.5–2 km low bias, especially over land. Finally, the high potential of AOCH for improving surface PM2.5 estimates is also illustrated with a case study in which the high bias of surface PM2.5 in MERRA-2 data is corrected after being scaled by the retrieved AOCH.
... This is important because UVAI is sensitive to the aerosol layer vertical location [18], [24], [28], [25]. Many efforts have been made on measuring aerosol vertical structures [29], including ground-based lidar systems [91], [92], space-borne lidar missions [93], [94], multi-angle measurements [95], polarimetry [96], oxygen absorption at A-band [97], [98], [99], [100], [101], [102], [103], [56], oxygen absorption in the visible band [104] and thermal infrared [105], [106]. However, currently an aerosol vertical distribution product based on observations that has a daily global coverage as that of UVAI is still missing. ...
Article
Full-text available
Quantitative measurements of aerosol absorptive properties, e.g. the absorbing aerosol optical depth (AAOD) and the single scattering albedo (SSA), are important to reduce uncertainties of the aerosol climate radiative forcing assessments. Currently, global retrievals of AAOD and SSA are mainly provided by the ground-based Aerosol RObotic NETwork (AERONET), whereas it is still challenging to retrieve them from space. However, we found the AERONET AAOD has a relatively strong correlation with the satellite Ultra-Violet Aerosol Index (UVAI). Based on this, a numerical relation is built by a Deep Neural Network (DNN) to predict global AAOD and SSA over land from the long-term UVAI record (2006 to 2019) provided by the Ozone Monitoring Instrument (OMI) onboard Aura. The DNN predicted aerosol absorption is satisfying for samples with AOD at 550 nm larger than 0.1 and the model performance is better for smaller absorbing aerosols (e.g. smoke) than larger ones (e.g. mineral dust). The validation of the DNN predictions with AERONET shows a high correlation coefficient of 0.90 and a root mean square of 0.005 for the AAOD, and over 80% of samples are within the expected uncertainty of AERONET SSA (0.03).
... attention from the remote sensing community [47][48][49]. An additional feature that makes MLP NNs useful for emulating radiative transfer models for remote sensing applications is that the derivative of a MLP model with respect to its inputs can be computed analytically [50][51][52]. ...
Article
Full-text available
For aerosol retrieval from multi-angle polarimetric (MAP) measurements over the ocean it is important to accurately account for the contribution of the ocean-body to the top-of-atmosphere signal, especially for wavelengths <500 nm. Performing online radiative transfer calculations in the coupled atmosphere ocean system is too time consuming for operational retrieval algorithms. Therefore, mostly lookup-tables of the ocean body reflection matrix are used to represent the lower boundary in an atmospheric radiative transfer model. For hyperspectral measurements such as those from Spectro-Polarimeter for Planetary Exploration (SPEXone) on the NASA Plankton, Aerosol, Cloud and ocean Ecosystem (PACE) mission, also the use of look-up tables is unfeasible because they will become too big. In this paper, we propose a new method for aerosol retrieval over ocean from MAP measurements using a neural network (NN) to model the ocean body reflection matrix. We apply the NN approach to synthetic SPEXone measurements and also to real data collected by SPEX airborne during the Aerosol Characterization from Polarimeter and Lidar (ACEPOL) campaign. We conclude that the NN approach is well capable for aerosol retrievals over ocean, introducing no significant error on the retrieved aerosol properties
Preprint
Full-text available
Abstract. Before the launch of TROPOMI, only two other satellite instruments were able to observe aerosol plume heights globally, MISR and CALIOP. The TROPOMI aerosol layer height is a potential game changer, since it has daily global coverage and the aerosol layer height retrieval is available in near-real time. The aerosol layer height can be useful for aviation and air quality alerts, as well as for improving air quality forecasting related to wildfires. Here, TROPOMI's aerosol layer height product is evaluated with MISR and CALIOP observations for wildfire plumes in North America for the 2018 fire season (June to August). Further, observing system simulation experiments were performed to interpret the fundamental differences between the different products. The results show that MISR and TROPOMI are, in theory, very close for aerosol profiles with single plumes. For more complex profiles with multiple plumes, however, different plume heights are retrieved: the MISR plume height represents the top layer, and the plume height retrieved with TROPOMI tends to be an average altitude of several plume layers. The comparison between TROPOMI and MISR plume heights shows, that on average, the TROPOMI aerosol layer heights are lower, by approximately 600 m, compared to MISR which is likely due to the different measurement techniques. From the comparison to CALIOP, our results show that the TROPOMI aerosol layer height is more accurate for thicker plumes and plumes below approximately 4.5 km. MISR and TROPOMI are further used to evaluate the plume height of Environment and Climate Change Canada's operational forecasting system FireWork with fire plume injection height estimates from the Canadian Forest Fire Emissions Prediction System (CFFEPS). The modelled plume heights are similar compared to the satellite observations, but tend to be slightly higher with average differences of 270–580 m and 60–320 m compared to TROPOMI and MISR, respectively.
Preprint
Full-text available
The Tropospheric Monitoring Instrument's (TROPOMI) level-2 aerosol layer height (ALH) product has now been released to the general public. This product is retrieved using TROPOMI's measurements of the oxygen A-band, radiative transfer model (RTM) calculations augmented by neural networks and an iterative optimal estimation technique. The TROPOMI ALH product will deliver aerosol layer height estimates over cloud-free scenes over the ocean and land that contain aerosols above a certain threshold of the measured UV absorbing index (UVAI) in the ultraviolet region. This paper provides background for the ALH product and explores its quality by comparing ALH estimates to similar quantities derived from spaceborne lidars observing the same scene. The spaceborne lidar chosen for this study is the Cloud-Aerosol Lidar with Orthogonal Polarisation (CALIOP) on board the Cloud-Aerosol Lidar and Infrared Pathfinder Satellite Observations (CALIPSO) mission, which flies in formation with NASA's A-train constellation since 2006 and is a proven source of data for studying aerosol layer heights. The influence of the surface and clouds are discussed and the aspects of the TROPOMI ALH algorithm that will require future development efforts are highlighted.
Article
Full-text available
This paper presents a weighted least squares approach to retrieve aerosol layer height from top-of-atmosphere reflectance measurements in the oxygen A band (758–770 nm) over bright surfaces. A property of the measurement error covariance matrix is discussed, due to which photons travelling from the surface are given a higher preference over photons that scatter back from the aerosol layer. This is a potential source of biases in the estimation of aerosol properties over land, which can be mitigated by revisiting the design of the measurement error covariance matrix. The alternative proposed in this paper, which we call the dynamic scaling method, introduces a scene-dependent and wavelength-dependent modification in the measurement signal-to-noise ratio in order to influence this matrix. This method is generally applicable to other retrieval algorithms using weighted least squares. To test this method, synthetic experiments are done in addition to application to GOME-2A and GOME-2B measurements of the oxygen A band over the August 2010 Russian wildfires and the October 2017 Portugal wildfire plume over western Europe.
Article
Full-text available
A global picture of atmospheric aerosol vertical distribution with a high temporal resolution is of key importance not only for climate, cloud formation, and air quality research studies but also for correcting scattered radiation induced by aerosols in absorbing trace gas retrievals from passive satellite sensors. Aerosol layer height (ALH) was retrieved from the OMI 477 nm O2 − O2 band and its spatial pattern evaluated over selected cloud-free scenes. Such retrievals benefit from a synergy with MODIS data to provide complementary information on aerosols and cloudy pixels. We used a neural network approach previously trained and developed. Comparison with CALIOP aerosol level 2 products over urban and industrial pollution in eastern China shows consistent spatial patterns with an uncertainty in the range of 462–648 m. In addition, we show the possibility to determine the height of thick aerosol layers released by intensive biomass burning events in South America and Russia from OMI visible measurements. A Saharan dust outbreak over sea is finally discussed. Complementary detailed analyses show that the assumed aerosol properties in the forward modelling are the key factors affecting the accuracy of the results, together with potential cloud residuals in the observation pixels. Furthermore, we demonstrate that the physical meaning of the retrieved ALH scalar corresponds to the weighted average of the vertical aerosol extinction profile. These encouraging findings strongly suggest the potential of the OMI ALH product, and in more general the use of the 477 nm O2 − O2 band from present and future similar satellite sensors, for climate studies as well as for future aerosol correction in air quality trace gas retrievals.
Article
Full-text available
Retrieving aerosol optical thickness and aerosol layer height over a bright surface from measured top-of-atmosphere reflectance spectrum in the oxygen A band is known to be challenging, often resulting in large errors. In certain atmospheric conditions and viewing geometries, a loss of sensitivity to aerosol optical thickness has been reported in the literature. This loss of sensitivity has been attributed to a phenomenon known as critical surface albedo regime, which is a range of surface albedos for which the top-of-atmosphere reflectance has minimal sensitivity to aerosol optical thickness. This paper extends the concept of critical surface albedo for aerosol layer height retrievals in the oxygen A band, and discusses its implications. The underlying physics are introduced by analysing the top-of-atmosphere reflectance spectrum as a sum of atmospheric path contribution and surface contribution, obtained using a radiative transfer model. Furthermore, error analysis of an aerosol layer height retrieval algorithm is conducted over dark and bright surfaces to show the dependence on surface reflectance. The analysis shows that the derivative with respect to aerosol layer height of the atmospheric path contribution to the top-of-atmosphere reflectance is opposite in sign to that of the surface contribution – an increase in surface brightness results in a decrease in information content. In the case of aerosol optical thickness, these derivatives are anti-correlated, leading to large retrieval errors in high surface albedo regimes. The consequence of this anti-correlation is demonstrated with measured spectra in the oxygen A band from the GOME-2 instrument on board the Metop-A satellite over the 2010 Russian wildfires incident.
Article
Full-text available
This paper presents an exploratory study on the aerosol layer height (ALH) retrieval from the OMI 477 nm O2 − O2 spectral band. We have developed algorithms based on the multilayer perceptron (MLP) neural network (NN) approach and applied them to 3-year (2005–2007) OMI cloud-free scenes over north-east Asia, collocated with MODIS Aqua aerosol product. In addition to the importance of aerosol altitude for climate and air quality objectives, our long-term motivation is to evaluate the possibility of retrieving ALH for potential future improvements of trace gas retrievals (e.g. NO2, HCHO, SO2) from UV–visible air quality satellite measurements over scenes including high aerosol concentrations. This study presents a first step of this long-term objective and evaluates, from a statistic point of view, an ensemble of OMI ALH retrievals over a long time period of 3 years covering a large industrialized continental region. This ALH retrieval relies on the analysis of the O2 − O2 slant column density (SCD) and requires an accurate knowledge of the aerosol optical thickness, τ. Using MODIS Aqua τ(550 nm) as a prior information, absolute seasonal differences between the LIdar climatology of vertical Aerosol Structure for space-based lidar simulation (LIVAS) and average OMI ALH, over scenes with MODIS τ(550 nm) ≥ 1. 0, are in the range of 260–800 m (assuming single scattering albedo ω0 = 0. 95) and 180–310 m (assuming ω0 = 0. 9). OMI ALH retrievals depend on the assumed aerosol single scattering albedo (sensitivity up to 660 m) and the chosen surface albedo (variation less than 200 m between OMLER and MODIS black-sky albedo). Scenes with τ ≤ 0. 5 are expected to show too large biases due to the little impact of particles on the O2−O2 SCD changes. In addition, NN algorithms also enable aerosol optical thickness retrieval by exploring the OMI reflectance in the continuum. Comparisons with collocated MODIS Aqua show agreements between −0. 02 ± 0. 45 and −0. 18 ± 0. 24, depending on the season. Improvements may be obtained from a better knowledge of the surface albedo and higher accuracy of the aerosol model. Following the previous work over ocean of Park et al.(2016), our study shows the first encouraging aerosol layer height retrieval results over land from satellite observations of the 477 nm O2 − O2 absorption spectral band.
Article
Full-text available
An algorithm setup for the operational Aerosol Layer Height product for TROPOMI on the Sentinel-5 Precursor mission is described and discussed, applied to GOME-2A data, and evaluated with lidar measurements. The algorithm makes a spectral fit of reflectance at the O2 A band in the near-infrared and the fit window runs from 758 to 770 nm. The aerosol profile is parameterised by a scattering layer with constant aerosol volume extinction coefficient and aerosol single scattering albedo and with a fixed pressure thickness. The algorithm's target parameter is the height of this layer. In this paper, we apply the algorithm to observations from GOME-2A in a number of systematic and extensive case studies, and we compare retrieved aerosol layer heights with lidar measurements. Aerosol scenes cover various aerosol types, both elevated and boundary layer aerosols, and land and sea surfaces. The aerosol optical thicknesses for these scenes are relatively moderate. Retrieval experiments with GOME-2A spectra are used to investigate various sensitivities, in which particular attention is given to the role of the surface albedo. From retrieval simulations with the single-layer model, we learn that the surface albedo should be a fit parameter when retrieving aerosol layer height from the O2 A band. Current uncertainties in surface albedo climatologies cause biases and non-convergences when the surface albedo is fixed in the retrieval. Biases disappear and convergence improves when the surface albedo is fitted, while precision of retrieved aerosol layer pressure is still largely within requirement levels. Moreover, we show that fitting the surface albedo helps to ameliorate biases in retrieved aerosol layer height when the assumed aerosol model is inaccurate. Subsequent retrievals with GOME-2A spectra confirm that convergence is better when the surface albedo is retrieved simultaneously with aerosol parameters. However, retrieved aerosol layer pressures are systematically low (i.e., layer high in the atmosphere) to the extent that retrieved values no longer realistically represent actual extinction profiles. When the surface albedo is fixed in retrievals with GOME-2A spectra, convergence deteriorates as expected, but retrieved aerosol layer pressures become much higher (i.e., layer lower in atmosphere). The comparison with lidar measurements indicates that retrieved aerosol layer heights are indeed representative of the underlying profile in that case. Finally, subsequent retrieval simulations with two-layer aerosol profiles show that a model error in the assumed profile (two layers in the simulation but only one in the retrieval) is partly absorbed by the surface albedo when this parameter is fitted. This is expected in view of the correlations between errors in fit parameters and the effect is relatively small for elevated layers (less than 100 hPa). If one of the scattering layers is near the surface (boundary layer aerosols), the effect becomes surprisingly large, in such a way that the retrieved height of the single layer is above the two-layer profile. Furthermore, we find that the retrieval solution, once retrieval converges, hardly depends on the starting values for the fit. Sensitivity experiments with GOME-2A spectra also show that aerosol layer height is indeed relatively robust against inaccuracies in the assumed aerosol model, even when the surface albedo is not fitted. We show spectral fit residuals, which can be used for further investigations. Fit residuals may be partly explained by spectroscopic uncertainties, which is suggested by an experiment showing the improvement of convergence when the absorption cross section is scaled in agreement with Butz et al. (2013) and Crisp et al. (2012), and a temperature offset to the a priori ECMWF temperature profile is fitted. Retrieved temperature offsets are always negative and quite large (ranging between −4 and −8 K), which is not expected if temperature offsets absorb remaining inaccuracies in meteorological data. Other sensitivity experiments investigate fitting of stray light and fluorescence emissions. We find negative radiance offsets and negative fluorescence emissions, also for non-vegetated areas, but from the results it is not clear whether fitting these parameters improves the retrieval. Based on the present results, the operational baseline for the Aerosol Layer Height product currently will not fit the surface albedo. The product will be particularly suited for elevated, optically thick aerosol layers. In addition to its scientific value in climate research, anticipated applications of the product for TROPOMI are providing aerosol height information for aviation safety and improving interpretation of the Absorbing Aerosol Index.
Article
Full-text available
This paper presents an exploratory study on the retrieval of aerosol layer height (ALH) from the OMI 477 nm O2 −O2 spectral band. We have developed algorithms based on the Multilayer Perceptron (MLP) Neural Network (NN) approach and applied them on 3-year (2005-2007) OMI cloud-free scenes over NorthEast Asia, collocated with MODIS-Aqua aerosol product. In addition to the importance of aerosol altitude for climate and air quality objectives, the main motivation of this study is to evaluate the possibility of retrieving ALH for potential future improvements of trace gas retrievals (e.g. NO2 , 5 HCHO, SO2 , etc..) from UV-Vis air quality satellite measurements over scenes including high aerosol concentrations. ALH retrieval relies on the analysis of the O2 −O2 slant column density (SCD) and requires an accurate knowledge of the aerosol optical thickness τ. Using the MODIS-Aqua aerosol optical thickness at 550 nm as a prior information, comparison with the LIdar climatology of vertical Aerosol Structure for space-based lidar simulation (LIVAS) shows that ALH average biases over scenes with MODIS τ ≥ 1.0 are in the range of 260-800 m. These results depend on the assumed aerosol single scattering 10 albedo (sensitivity up to 600 m) and the chosen surface albedo (variation less than 200 m). Scenes with τ ≤ 0.5 are expected to show too large biases due to the little impacts of particles on the O2 −O2 SCD changes. In addition, NN algorithms also enable aerosol optical thickness retrieval by exploring the OMI reflectance in the continuum. Comparisons with collocated MODIS-Aqua show agreements between −0.02 ± 0.45 and −0.18 ± 0.24 depending on the season. Improvements may be obtained from a better knowledge of the surface albedo, and higher accuracy of the aerosol model. This study shows the first 15 encouraging aerosol layer height retrieval results over land from satellite observations of the 477 nm O2 −O2 spectral band.
Article
Full-text available
We have investigated the precision of retrieved aerosol parameters for a generic aerosol retrieval algorithm over vegetated land using the O2 A band. Chlorophyll fluorescence is taken into account in the forward model. Fluorescence emissions are modeled as isotropic contributions to the upwelling radiance field at the surface and they are retrieved along with aerosol parameters. Precision is calculated by propagating measurement errors and a priori errors, including model parameter errors, using the forward model's derivatives. Measurement errors consist of noise and calibration errors. The model parameter errors considered are related to the single scattering albedo, surface pressure and temperature profile. We assume that measurement noise is dominated by shot noise; thus, results apply to grating spectrometers in particular. We describe precision for various atmospheric states, observation geometries and spectral resolutions of the instrument in a number of retrieval simulations. These precision levels can be compared with user requirements. A comparison of precision estimates with the literature and an analysis of the dependence on the a priori error in the fluorescence emission indicate that aerosol parameters can be retrieved in the presence of chlorophyll fluorescence: if fluorescence is present, fluorescence emissions should be included in the state vector to avoid biases in retrieved aerosol parameters.
Article
Full-text available
Cloud and aerosol information is needed in trace gas retrievals from satellite measurements. The Fast REtrieval Scheme for Clouds from the Oxygen A band (FRESCO) cloud algorithm employs reflectance spectra of the O<sub>2</sub> A band around 760 nm to derive cloud pressure and effective cloud fraction. In general, clouds contribute more to the O<sub>2</sub> A band reflectance than aerosols. Therefore, the FRESCO algorithm does not correct for aerosol effects in the retrievals and attributes the retrieved cloud information entirely to the presence of clouds, and not to aerosols. For events with high aerosol loading, aerosols may have a dominant effect, especially for almost cloud free scenes. We have analysed FRESCO cloud data and Absorbing Aerosol Index (AAI) data from the Global Ozone Monitoring Experiment (GOME-2) instrument on the Metop-A satellite for events with typical absorbing aerosol types, such as volcanic ash, desert dust and smoke. We find that the FRESCO effective cloud fractions are correlated with the AAI data for these absorbing aerosol events and that the FRESCO cloud pressure contains information on aerosol layer pressure. For cloud free scenes, the derived FRESCO cloud pressure is close to the aerosol layer pressure, especially for optically thick aerosol layers. For cloudy scenes, if the strongly absorbing aerosols are located above the clouds, then the retrieved FRESCO cloud pressure may represent the height of the aerosol layer rather than the height of the clouds. Combining FRESCO and AAI data, an estimate for the aerosol layer pressure can be given.
Article
The primary goal of this paper is to introduce two new surface reflectivity climatologies. The two databases contain the Lambertian-equivalent reflectivity (LER) of the Earth's surface, and they are meant to support satellite retrieval of trace gases and of cloud and aerosol information. The surface LER databases are derived from the GOME-2 and SCIAMACHY instruments and can be considered as improved and extended descendants of earlier surface LER climatologies based on the TOMS, GOME-1, and OMI instruments. The GOME-2 surface LER database consists of 21 wavelength bands that span the wavelength range from 335 to 772 nm. The SCIAMACHY surface LER database covers the wavelength range between 335 and 1670 nm in 29 wavelength bands. The two databases are made for each month of the year and their spatial resolution is 1∘×1∘. In this paper we present the methods that are used to derive the surface LER, we analyze the spatial and temporal behavior of the surface LER fields, and study the amount of residual cloud contamination in the databases. For several surface types we analyze the spectral surface albedo and the seasonal variation. When compared to the existing surface LER databases, both databases are found to perform well. As an example of possible application of the databases we study the performance of the FRESCO cloud information retrieval when it is equipped with the new surface albedo databases. We find considerable improvements. The databases introduced here can not only improve retrievals from GOME-2 and SCIAMACHY, but also support those from other instruments, such as TROPOMI, to be launched in 2017.