Xarray - multidimensional science data¶
This notebook reads aerosol index and Tropospheric $NO_{2}$ Concentration from Sentinel-5P TROPOMI data using Opengeo Tools
Tutorial data and code are from NASA ARSET program: https://appliedsciences.nasa.gov/join-mission/training/english/high-resolution-no2-monitoring-space-tropomi
import numpy as np
# from mpl_toolkits.basemap import Basemap
import matplotlib.pyplot as plt
import sys
from netCDF4 import Dataset
from pprint import pprint, pp
import pandas as pd
ls TROPOMI_PythonCodesAndData/
S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822.nc* S5P_OFFL_L2__CO_____20180816T183016_20180816T201146_04361_01_010100_20180822T174815.nc* S5P_RPRO_L2__CH4____20180816T182917_20180816T201245_04361_01_010202_20190101T194705.nc* fileList.txt* read_and_map_tropomi_no2_ai.py* read_tropomi_and_list_sds.py* read_tropomi_no2_ai_and_dump_ascii.py* read_tropomi_no2_ai_at_a_location.py*
Explore NetCDF file for its contents¶
The NetCDF file is like a folder with multiple sub-folders and files within it. Folders are called as groups
and files within it are called as variables
. NASA supplies a cross-platform app called Panoply which gives you a UI to query and visualize NetCDF files. Below is a screenshot of Panoply reading the Aerosol Index file.
The first step is to read this file as a netCDF4.Dataset
class.
file_path = 'TROPOMI_PythonCodesAndData/S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822.nc'
ds = Dataset(file_path, mode='r')
type(ds)
netCDF4._netCDF4.Dataset
ds.groups.keys()
dict_keys(['PRODUCT', 'METADATA'])
Explore the different variables as a DataFrame
v = {'variables':[], 'long_name':[], 'units':[]}
for var in list(ds.groups['PRODUCT'].variables.keys()):
v['variables'].append(ds.groups['PRODUCT'].variables[var].name)
v['long_name'].append(ds.groups['PRODUCT'].variables[var].long_name)
try:
v['units'].append(ds.groups['PRODUCT'].variables[var].units)
except:
v['units'].append(None)
vars_df = pd.DataFrame.from_dict(v)
vars_df
variables | long_name | units | |
---|---|---|---|
0 | scanline | along-track dimension index | 1 |
1 | ground_pixel | across-track dimension index | 1 |
2 | time | reference time for the measurements | seconds since 2010-01-01 00:00:00 |
3 | corner | pixel corner index | 1 |
4 | latitude | pixel center latitude | degrees_north |
5 | longitude | pixel center longitude | degrees_east |
6 | delta_time | offset from reference start time of measurement | milliseconds |
7 | time_utc | Time of observation as ISO 8601 date-time string | None |
8 | qa_value | data quality value | 1 |
9 | aerosol_index_354_388 | Aerosol index from 388 and 354 nm | 1 |
10 | aerosol_index_340_380 | Aerosol index from 380 and 340 nm | 1 |
11 | aerosol_index_354_388_precision | Precision of aerosol index from 388 and 354 nm | 1 |
12 | aerosol_index_340_380_precision | Precision of aerosol index from 380 and 340 nm | 1 |
Read Aerosol Index 354 - 388 nm into memory¶
# preview contents of the variable
ds.groups['PRODUCT'].variables['aerosol_index_354_388']
<class 'netCDF4._netCDF4.Variable'> float32 aerosol_index_354_388(time, scanline, ground_pixel) units: 1 proposed_standard_name: ultraviolet_aerosol_index comment: Aerosol index from 388 and 354 nm long_name: Aerosol index from 388 and 354 nm radiation_wavelength: [354. 388.] coordinates: longitude latitude ancillary_variables: aerosol_index_354_388_precision _FillValue: 9.96921e+36 path = /PRODUCT unlimited dimensions: current shape = (1, 3245, 450) filling on
ai_data = ds.groups['PRODUCT'].variables['aerosol_index_354_388'][:]
type(ai_data)
numpy.ma.core.MaskedArray
ai_data.shape
(1, 3245, 450)
plt.imshow(ai_data[0]);
Reading using xarray
¶
See https://github.com/acgeospatial/Sentinel-5P/blob/master/sentinel5p_xarray_blog.ipynb
import xarray
xr_data = xarray.open_dataset(file_path, group='PRODUCT',
engine='netcdf4', decode_coords=True)
type(xr_data)
xarray.core.dataset.Dataset
xr_data
<xarray.Dataset> Dimensions: (corner: 4, ground_pixel: 450, scanline: 3245, time: 1) Coordinates: * scanline (scanline) float64 0.0 1.0 ... 3.244e+03 * ground_pixel (ground_pixel) float64 0.0 1.0 ... 449.0 * time (time) datetime64[ns] 2018-08-16 * corner (corner) float64 0.0 1.0 2.0 3.0 latitude (time, scanline, ground_pixel) float32 ... longitude (time, scanline, ground_pixel) float32 ... Data variables: delta_time (time, scanline) timedelta64[ns] 18:51:5... time_utc (time, scanline) object '2018-08-16T18:5... qa_value (time, scanline, ground_pixel) float32 ... aerosol_index_354_388 (time, scanline, ground_pixel) float32 ... aerosol_index_340_380 (time, scanline, ground_pixel) float32 ... aerosol_index_354_388_precision (time, scanline, ground_pixel) float32 ... aerosol_index_340_380_precision (time, scanline, ground_pixel) float32 ...
- corner: 4
- ground_pixel: 450
- scanline: 3245
- time: 1
- scanline(scanline)float640.0 1.0 2.0 ... 3.243e+03 3.244e+03
- units :
- 1
- axis :
- Y
- long_name :
- along-track dimension index
- comment :
- This coordinate variable defines the indices along track; index starts at 0
array([0.000e+00, 1.000e+00, 2.000e+00, ..., 3.242e+03, 3.243e+03, 3.244e+03])
- ground_pixel(ground_pixel)float640.0 1.0 2.0 ... 447.0 448.0 449.0
- units :
- 1
- axis :
- X
- long_name :
- across-track dimension index
- comment :
- This coordinate variable defines the indices across track, from west to east; index starts at 0
array([ 0., 1., 2., ..., 447., 448., 449.])
- time(time)datetime64[ns]2018-08-16
- standard_name :
- time
- axis :
- T
- long_name :
- reference time for the measurements
- comment :
- The time in this variable corresponds to the time in the time_reference global attribute
array(['2018-08-16T00:00:00.000000000'], dtype='datetime64[ns]')
- corner(corner)float640.0 1.0 2.0 3.0
- units :
- 1
- long_name :
- pixel corner index
- comment :
- This coordinate variable defines the indices for the pixel corners; index starts at 0 (counter-clockwise, starting from south-western corner of the pixel in ascending part of the orbit)
array([0., 1., 2., 3.])
- latitude(time, scanline, ground_pixel)float32...
- long_name :
- pixel center latitude
- units :
- degrees_north
- standard_name :
- latitude
- valid_min :
- -90.0
- valid_max :
- 90.0
- bounds :
- /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/latitude_bounds
[1460250 values with dtype=float32]
- longitude(time, scanline, ground_pixel)float32...
- long_name :
- pixel center longitude
- units :
- degrees_east
- standard_name :
- longitude
- valid_min :
- -180.0
- valid_max :
- 180.0
- bounds :
- /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/longitude_bounds
[1460250 values with dtype=float32]
- delta_time(time, scanline)timedelta64[ns]...
- long_name :
- offset from reference start time of measurement
array([[67911027000000, 67912107000000, 67913187000000, ..., 71412302000000, 71413382000000, 71414462000000]], dtype='timedelta64[ns]')
- time_utc(time, scanline)object...
- long_name :
- Time of observation as ISO 8601 date-time string
array([['2018-08-16T18:51:51.027000Z', '2018-08-16T18:51:52.107000Z', '2018-08-16T18:51:53.187000Z', ..., '2018-08-16T19:50:12.301999Z', '2018-08-16T19:50:13.381999Z', '2018-08-16T19:50:14.461999Z']], dtype=object)
- qa_value(time, scanline, ground_pixel)float32...
- units :
- 1
- valid_min :
- 0
- valid_max :
- 100
- long_name :
- data quality value
- comment :
- A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value < 0.5
[1460250 values with dtype=float32]
- aerosol_index_354_388(time, scanline, ground_pixel)float32...
- units :
- 1
- proposed_standard_name :
- ultraviolet_aerosol_index
- comment :
- Aerosol index from 388 and 354 nm
- long_name :
- Aerosol index from 388 and 354 nm
- radiation_wavelength :
- [354. 388.]
- ancillary_variables :
- aerosol_index_354_388_precision
[1460250 values with dtype=float32]
- aerosol_index_340_380(time, scanline, ground_pixel)float32...
- units :
- 1
- proposed_standard_name :
- ultraviolet_aerosol_index
- comment :
- Aerosol index from 380 and 340 nm
- long_name :
- Aerosol index from 380 and 340 nm
- radiation_wavelength :
- [340. 380.]
- ancillary_variables :
- aerosol_index_340_380_precision
[1460250 values with dtype=float32]
- aerosol_index_354_388_precision(time, scanline, ground_pixel)float32...
- units :
- 1
- proposed_standard_name :
- ultraviolet_aerosol_index standard_error
- comment :
- Precision of aerosol index from 388 and 354 nm
- long_name :
- Precision of aerosol index from 388 and 354 nm
- radiation_wavelength :
- [354. 388.]
[1460250 values with dtype=float32]
- aerosol_index_340_380_precision(time, scanline, ground_pixel)float32...
- units :
- 1
- proposed_standard_name :
- ultraviolet_aerosol_index standard_error
- comment :
- Precision of aerosol index from 380 and 340 nm
- long_name :
- Precision of aerosol index from 380 and 340 nm
- radiation_wavelength :
- [340. 380.]
[1460250 values with dtype=float32]
xr_data_ai = xr_data['aerosol_index_340_380']
print(type(xr_data_ai))
print(xr_data_ai.shape)
<class 'xarray.core.dataarray.DataArray'> (1, 3245, 450)
xr_data_ai[0].plot();
(xr_data.latitude.attrs, xr_data.longitude.attrs)
({'long_name': 'pixel center latitude', 'units': 'degrees_north', 'standard_name': 'latitude', 'valid_min': -90.0, 'valid_max': 90.0, 'bounds': '/PRODUCT/SUPPORT_DATA/GEOLOCATIONS/latitude_bounds'}, {'long_name': 'pixel center longitude', 'units': 'degrees_east', 'standard_name': 'longitude', 'valid_min': -180.0, 'valid_max': 180.0, 'bounds': '/PRODUCT/SUPPORT_DATA/GEOLOCATIONS/longitude_bounds'})
Plot using matplotlib¶
plt.figure(figsize=(14,8))
ax = plt.axes()
xr_data.aerosol_index_340_380[0].plot.pcolormesh(ax=ax, x='longitude',
y='latitude',
add_colorbar=True, cmap='jet');
Plotting using cartopy
¶
import cartopy.crs as ccrs
plt.figure(figsize=(14,6))
ax = plt.axes(projection = ccrs.PlateCarree())
xr_data.aerosol_index_340_380[0].plot.pcolormesh(ax=ax, x='longitude',
y='latitude',
add_colorbar=True, cmap='jet')
ax.set_global()
ax.coastlines();
plt.figure(figsize=(10,10))
ax = plt.axes(projection = ccrs.Orthographic(-88,40))
xr_data.aerosol_index_340_380[0].plot.pcolormesh(ax=ax, x='longitude',
y='latitude',
add_colorbar=True, cmap='jet',
transform=ccrs.PlateCarree())
ax.set_global()
ax.coastlines();
xr_data_rio = xr_data_ai.rio
type(xr_data_rio)
rioxarray.rioxarray.RasterArray
xr_data.aerosol_index_340_380.rio.to_raster('xr_test.tif')
Reading using rioxarray
¶
import rioxarray
import warnings; warnings.simplefilter('ignore')
rds = rioxarray.open_rasterio(filename = file_path, parse_coordinates=True,
)
type(rds)
list
rds[0]
<xarray.Dataset> Dimensions: (band: 1, time: 1, x: 450, y: 3245) Coordinates: * y (y) float64 3.244e+03 ... 0.0 * x (x) float64 0.0 1.0 ... 449.0 * time (time) int64 272073600 spatial_ref int64 0 * band (band) int64 1 Data variables: latitude (time, y, x) float32 ... solar_zenith_angle (band, y, x) float32 ... solar_azimuth_angle (band, y, x) float32 ... viewing_zenith_angle (band, y, x) float32 ... viewing_azimuth_angle (band, y, x) float32 ... longitude (time, y, x) float32 ... geolocation_flags (band, y, x) uint8 ... processing_quality_flags (band, y, x) uint32 ... number_of_spectral_points_in_retrieval (band, y, x) uint16 ... scene_albedo_388 (band, y, x) float32 ... scene_albedo_388_precision (band, y, x) float32 ... reflectance_measured_354 (band, y, x) float32 ... reflectance_measured_354_precision (band, y, x) float32 ... reflectance_measured_388 (band, y, x) float32 ... reflectance_measured_388_precision (band, y, x) float32 ... reflectance_calculated_354 (band, y, x) float32 ... reflectance_calculated_354_precision (band, y, x) float32 ... scene_albedo_380 (band, y, x) float32 ... scene_albedo_380_precision (band, y, x) float32 ... reflectance_measured_340 (band, y, x) float32 ... reflectance_measured_340_precision (band, y, x) float32 ... reflectance_measured_380 (band, y, x) float32 ... reflectance_measured_380_precision (band, y, x) float32 ... reflectance_calculated_340 (band, y, x) float32 ... reflectance_calculated_340_precision (band, y, x) float32 ... wavelength_calibration_offset (band, y, x) float32 ... wavelength_calibration_offset_precision (band, y, x) float32 ... wavelength_calibration_stretch (band, y, x) float32 ... wavelength_calibration_stretch_precision (band, y, x) float32 ... wavelength_calibration_chi_square (band, y, x) float32 ... surface_altitude (band, y, x) float32 ... surface_altitude_precision (band, y, x) float32 ... surface_classification (band, y, x) uint8 ... qa_value (time, y, x) uint8 ... scaled_small_pixel_variance (band, y, x) float32 ... ozone_total_column (band, y, x) float32 ... surface_pressure (band, y, x) float32 ... aerosol_index_354_388 (time, y, x) float32 ... aerosol_index_340_380 (time, y, x) float32 ... aerosol_index_354_388_precision (time, y, x) float32 ... aerosol_index_340_380_precision (time, y, x) float32 ... Attributes: algo.algorithm_variant: 1 algo.n_pair: 2 algo.pair_1.delta_wavelength: 2.0 algo.pair_1.id: TOMS_pair algo.pair_1.min_wavelength: 1 algo.pair_1.number_spectral_pixels: 7 algo.pair_1.wavelength_1: 340 algo.pair_1.wavelength_2: 380 algo.pair_2.delta_wavelength: 2.0 algo.pair_2.id: OMI_pair algo.pair_2.min_wavelength: 1 algo.pair_2.number_spectral_pixels: 7 algo.pair_2.wavelength_1: 354 algo.pair_2.wavelength_2: 388 configuration.version.algorithm: 1.1.0 configuration.version.framework: 1.1.0 input.1.band: 3 input.1.irrType: L1B_IR... input.1.type: L1B_RA... input.count: 1 output.1.band: 3 output.1.config: cfg/pr... output.1.type: L2__AE... output.compressionLevel: 3 output.count: 1 output.histogram.aerosol_index_340_380.end: 14 output.histogram.aerosol_index_340_380.start: -6 output.histogram.aerosol_index_354_388.end: 14 output.histogram.aerosol_index_354_388.start: -6 output.useCompression: true output.useFletcher32: true output.useShuffleFilter: true processing.algorithm: AER_AI processing.correct_surface_pressure_for_altitude: true processing.exclude_flags: 429496... processing.groupDem: DEM_RA... processing.ignore_pixel_flags: False processing.radiancePixelsMinError: 2 processing.radiancePixelsMinWarning: 7 processing.signal_to_noise.test: yes processing.signal_to_noise.threshold: 12 processing.signal_to_noise.window.range: 350.0,... processing.szaMax: 88.0 processing.szaMin: 0.0 processing.vzaMax: 78.0 processing.vzaMin: 0.0 qa_value.AAI_warning: 100.0 qa_value.altitude_consistency_warning: 100.0 qa_value.cloud_warning: 100.0 qa_value.data_range_warning: 100.0 qa_value.deconvolution_warning: 100.0 qa_value.extrapolation_warning: 100.0 qa_value.input_spectrum_warning: 70.0 qa_value.interpolation_warning: 100.0 qa_value.low_cloud_fraction_warning: 100.0 qa_value.pixel_level_input_data_missing: 80.0 qa_value.signal_to_noise_ratio_warning: 100.0 qa_value.snow_ice_warning: 100.0 qa_value.so2_volcanic_origin_certain_warning: 100.0 qa_value.so2_volcanic_origin_likely_warning: 100.0 qa_value.south_atlantic_anomaly_warning: 100.0 qa_value.sun_glint_correction: 100.0 qa_value.sun_glint_warning: 70.0 qa_value.wavelength_calibration_warning: 90.0 wavelength_calibration.convergence_threshold: 1.0 wavelength_calibration.include_stretch: no wavelength_calibration.initial_guess.a0: 1.0 wavelength_calibration.initial_guess.a1: 0.1 wavelength_calibration.initial_guess.a2: 0.01 wavelength_calibration.initial_guess.ring: 0.06 wavelength_calibration.initial_guess.shift: 0.0 wavelength_calibration.initial_guess.stretch: 0.0 wavelength_calibration.irr.include_ring: no wavelength_calibration.irr.max_iterations: 20 wavelength_calibration.irr.polynomial_order: 2 wavelength_calibration.max_iterations: 12 wavelength_calibration.perform_wavelength_fit: yes wavelength_calibration.rad.include_ring: yes wavelength_calibration.rad.polynomial_order: 3 wavelength_calibration.sigma.a0: 1.0 wavelength_calibration.sigma.a1: 0.1 wavelength_calibration.sigma.ring: 0.06 wavelength_calibration.sigma.shift: 0.07 wavelength_calibration.sigma.stretch: 0.07 wavelength_calibration.window: 338.0,... /METADATA/EOP_METADATA/eop: metaDa... gml: id=S5P... objectType: gmi:MI... /METADATA/EOP_METADATA/om: proced... File_Class: OFFL File_Description: Aeroso... File_Name: S5P_OF... File_Type: L2__AE... File_Version: 1 Mission: S5P Notes: Creation_Date: UTC=20... Creator: TROPNL... Creator_Version: 1.1.0 System: PDGS-OP Validity_Start: UTC=20... Validity_Stop: UTC=20... /METADATA/ESA_METADATA/earth_explorer_header/variable_header/gmd: lineag... GranuleEnd: 2018-0... GranuleStart: 2018-0... InstrumentName: TROPOMI LongitudeOfDaysideNadirEquatorCrossing: -86.44... MissionName: Sentin... MissionShortName: S5P ProcessingCenter: PDGS-OP ProcessingMode: Offline ProcessingNode: s5p-of... ProcessLevel: 2 ProcessorVersion: 1.1.0 ProductFormatVersion: 10000 ProductShortName: L2__AE... /METADATA/ISO_METADATA/gmd: langua... /METADATA/ISO_METADATA/gmi: acquis... gmd: metada... global_processing_warnings: --- TE... number_of_aai_filter_occurrences: 0 number_of_aai_scene_albedo_filter_occurrences: 0 number_of_AAI_warning_occurrences: 0 number_of_abort_error_occurrences: 0 number_of_aerosol_boundary_error_occurrences: 0 number_of_airmass_factor_error_occurrences: 0 number_of_altitude_consistency_filter_occurrences: 0 number_of_altitude_consistency_warning_occurrences: 0 number_of_altitude_roughness_filter_occurrences: 0 number_of_aot_lower_boundary_convergence_error_occurrences: 0 number_of_assertion_error_occurrences: 31 number_of_boundary_hit_error_occurrences: 0 number_of_cf_viirs_nir_ifov_filter_occurrences: 0 number_of_cf_viirs_nir_ofova_filter_occurrences: 0 number_of_cf_viirs_nir_ofovb_filter_occurrences: 0 number_of_cf_viirs_nir_ofovc_filter_occurrences: 0 number_of_cf_viirs_swir_ifov_filter_occurrences: 0 number_of_cf_viirs_swir_ofova_filter_occurrences: 0 number_of_cf_viirs_swir_ofovb_filter_occurrences: 0 number_of_cf_viirs_swir_ofovc_filter_occurrences: 0 number_of_ch4_noscat_ratio_filter_occurrences: 0 number_of_ch4_noscat_ratio_std_filter_occurrences: 0 number_of_ch4_noscat_zero_error_occurrences: 0 number_of_chi2_error_occurrences: 0 number_of_cirrus_reflectance_viirs_filter_occurrences: 0 number_of_cloud_error_occurrences: 0 number_of_cloud_filter_convergence_error_occurrences: 0 number_of_cloud_filter_occurrences: 0 number_of_cloud_fraction_fresco_filter_occurrences: 0 number_of_cloud_fraction_viirs_filter_occurrences: 0 number_of_cloud_pressure_spread_too_low_error_occurrences: 0 number_of_cloud_too_low_level_error_occurrences: 0 number_of_cloud_warning_occurrences: 0 number_of_configuration_error_occurrences: 0 number_of_convergence_error_occurrences: 0 number_of_coregistration_error_occurrences: 0 number_of_data_range_warning_occurrences: 0 number_of_deconvolution_warning_occurrences: 0 number_of_dfs_error_occurrences: 0 number_of_diff_psurf_fresco_ecmwf_filter_occurrences: 0 number_of_diff_refl_cirrus_viirs_filter_occurrences: 0 number_of_extrapolation_warning_occurrences: 0 number_of_failed_retrievals: 222068 number_of_generic_exception_occurrences: 0 number_of_generic_range_error_occurrences: 0 number_of_geographic_region_filter_occurrences: 0 number_of_geolocation_error_occurrences: 0 number_of_groundpixels: 1460250 number_of_ground_pixels_with_warnings: 84516 number_of_h2o_noscat_ratio_filter_occurrences: 0 number_of_h2o_noscat_ratio_std_filter_occurrences: 0 number_of_h2o_noscat_zero_error_occurrences: 0 number_of_initialization_error_occurrences: 0 number_of_input_spectrum_alignment_error_occurrences: 0 number_of_input_spectrum_missing_occurrences: 0 number_of_input_spectrum_warning_occurrences: 0 number_of_interpolation_warning_occurrences: 0 number_of_io_error_occurrences: 0 number_of_irradiance_missing_occurrences: 0 number_of_ISRF_error_occurrences: 0 number_of_key_error_occurrences: 0 number_of_ler_range_error_occurrences: 0 number_of_low_cloud_fraction_warning_occurrences: 0 number_of_lut_error_occurrences: 0 number_of_lut_range_error_occurrences: 0 number_of_max_iteration_convergence_error_occurrences: 0 number_of_max_optical_thickness_error_occurrences: 0 number_of_memory_error_occurrences: 0 number_of_mixed_surface_type_filter_occurrences: 0 number_of_model_error_occurrences: 0 number_of_number_of_input_data_points_too_low_error_occurrences: 0 number_of_numerical_error_occurrences: 0 number_of_ocean_filter_occurrences: 0 number_of_optimal_estimation_error_occurrences: 0 number_of_other_boundary_convergence_error_occurrences: 0 number_of_ozone_range_error_occurrences: 0 number_of_pixel_level_input_data_missing_occurrences: 0 number_of_pixel_or_scanline_index_filter_occurrences: 0 number_of_processed_pixels: 1460250 number_of_profile_error_occurrences: 0 number_of_psurf_fresco_stdv_filter_occurrences: 0 number_of_radiance_missing_occurrences: 0 number_of_radiative_transfer_error_occurrences: 0 number_of_reflectance_range_error_occurrences: 0 number_of_refl_cirrus_viirs_nir_filter_occurrences: 0 number_of_refl_cirrus_viirs_swir_filter_occurrences: 0 number_of_rejected_pixels_not_enough_spectrum: 0 number_of_saturation_error_occurrences: 0 number_of_saturation_warning_occurrences: 0 number_of_signal_to_noise_ratio_error_occurrences: 0 number_of_signal_to_noise_ratio_warning_occurrences: 0 number_of_slant_column_density_error_occurrences: 0 number_of_small_pixel_radiance_std_filter_occurrences: 0 number_of_snow_ice_filter_occurrences: 0 number_of_snow_ice_warning_occurrences: 0 number_of_snr_range_error_occurrences: 0 number_of_so2_volcanic_origin_certain_warning_occurrences: 0 number_of_so2_volcanic_origin_likely_warning_occurrences: 0 number_of_solar_eclipse_filter_occurrences: 0 number_of_south_atlantic_anomaly_warning_occurrences: 0 number_of_successfully_processed_pixels: 1238182 number_of_sun_glint_correction_occurrences: 0 number_of_sun_glint_filter_occurrences: 0 number_of_sun_glint_warning_occurrences: 84516 number_of_svd_error_occurrences: 0 number_of_sza_range_error_occurrences: 222037 number_of_time_range_filter_occurrences: 0 number_of_vertical_column_density_error_occurrences: 0 number_of_vza_range_error_occurrences: 0 number_of_wavelength_calibration_error_occurrences: 0 number_of_wavelength_calibration_warning_occurrences: 0 number_of_wavelength_offset_error_occurrences: 0 number_of_wrong_input_type_error_occurrences: 0 time_for_algorithm_initialization: 23.927286 time_for_processing: 212.96926 time_per_pixel: 0.0015... time_standard_deviation_per_pixel: 2.5657... algorithm_version: 1.1.0 build_date: 2018-0... cdm_data_type: Swath Conventions: CF-1.7 cpp_compiler_flags: -g -O2... cpp_compiler_version: g++ (G... creator_email: EOSupp... creator_name: The Se... creator_url: http:/... date_created: 2018-0... f90_compiler_flags: -gdwar... f90_compiler_version: GNU Fo... geolocation_grid_from_band: 3 geospatial_lat_max: 89.972939 geospatial_lat_min: -86.81926 geospatial_lon_max: -179.9... geospatial_lon_min: 179.99924 history: 2018-0... id: S5P_OF... identifier_product_doi: 10.527... identifier_product_doi_authority: http:/... institution: KNMI keywords: 0300 A... keywords_vocabulary: AGU in... license: No con... naming_authority: nl.knmi orbit: 4361 platform: S5P processing_status: Nominal processor_version: 1.1.0 product_version: 1.0.0 project: Sentin... references: http:/... revision_control_identifier: df649d... sensor: TROPOMI source: Sentin... spatial_resolution: 7x3.5km2 standard_name_vocabulary: NetCDF... Status_MET_2D: Nominal summary: TROPOM... time_coverage_duration: PT3503... time_coverage_end: 2018-0... time_coverage_resolution: PT1.080S time_coverage_start: 2018-0... time_reference: 2018-0... time_reference_days_since_1950: 25064 time_reference_julian_day: 2458346.5 time_reference_seconds_since_1970: 153437... title: TROPOM... tracking_id: 0b05f3...
- band: 1
- time: 1
- x: 450
- y: 3245
- y(y)float643.244e+03 3.243e+03 ... 1.0 0.0
array([3.244e+03, 3.243e+03, 3.242e+03, ..., 2.000e+00, 1.000e+00, 0.000e+00])
- x(x)float640.0 1.0 2.0 ... 447.0 448.0 449.0
array([ 0., 1., 2., ..., 447., 448., 449.])
- time(time)int64272073600
array([272073600])
- spatial_ref()int640
- GeoTransform :
- -0.5 1.0 0.0 3244.5 0.0 -1.0
array(0)
- band(band)int641
array([1])
- latitude(time, y, x)float32...
- bounds :
- /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/latitude_bounds
- long_name :
- pixel center latitude
- standard_name :
- latitude
- units :
- degrees_north
- valid_max :
- 90
- valid_min :
- -90
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- solar_zenith_angle(band, y, x)float32...
- comment :
- Solar zenith angle at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- solar zenith angle
- NETCDF_DIM_time :
- 1
- standard_name :
- solar_zenith_angle
- units :
- degree
- valid_max :
- 180
- valid_min :
- 0
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- solar_azimuth_angle(band, y, x)float32...
- comment :
- Solar azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = 180, West = 270)
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- solar azimuth angle
- NETCDF_DIM_time :
- 1
- standard_name :
- solar_azimuth_angle
- units :
- degree
- valid_max :
- 180
- valid_min :
- -180
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- viewing_zenith_angle(band, y, x)float32...
- comment :
- Zenith angle of the satellite at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- viewing zenith angle
- NETCDF_DIM_time :
- 1
- standard_name :
- viewing_zenith_angle
- units :
- degree
- valid_max :
- 180
- valid_min :
- 0
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- viewing_azimuth_angle(band, y, x)float32...
- comment :
- Satellite azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = 180, West = 270)
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- viewing azimuth angle
- NETCDF_DIM_time :
- 1
- standard_name :
- viewing_azimuth_angle
- units :
- degree
- valid_max :
- 180
- valid_min :
- -180
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- longitude(time, y, x)float32...
- bounds :
- /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/longitude_bounds
- long_name :
- pixel center longitude
- standard_name :
- longitude
- units :
- degrees_east
- valid_max :
- 180
- valid_min :
- -180
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- geolocation_flags(band, y, x)uint8...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- flag_masks :
- [ 0. 1. 2. 4. 8. 16. 128.]
- flag_meanings :
- no_error solar_eclipse sun_glint_possible descending night geo_boundary_crossing geolocation_error
- flag_values :
- [ 0. 1. 2. 4. 8. 16. 128.]
- long_name :
- ground pixel quality flag
- max_val :
- 254
- min_val :
- 0
- NETCDF_DIM_time :
- 1
- units :
- 1
- _FillValue :
- 255.0
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=uint8]
- processing_quality_flags(band, y, x)uint32...
- comment :
- Flags indicating conditions that affect quality of the retrieval.
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- flag_masks :
- [2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5600000e+02 5.1200000e+02 1.0240000e+03 2.0480000e+03 4.0960000e+03 8.1920000e+03 1.6384000e+04 3.2768000e+04 6.5536000e+04 1.3107200e+05 2.6214400e+05 5.2428800e+05 1.0485760e+06 2.0971520e+06 4.1943040e+06 8.3886080e+06 1.6777216e+07 3.3554432e+07 6.7108864e+07]
- flag_meanings :
- success radiance_missing irradiance_missing input_spectrum_missing reflectance_range_error ler_range_error snr_range_error sza_range_error vza_range_error lut_range_error ozone_range_error wavelength_offset_error initialization_error memory_error assertion_error io_error numerical_error lut_error ISRF_error convergence_error cloud_filter_convergence_error max_iteration_convergence_error aot_lower_boundary_convergence_error other_boundary_convergence_error geolocation_error ch4_noscat_zero_error h2o_noscat_zero_error max_optical_thickness_error aerosol_boundary_error boundary_hit_error chi2_error svd_error dfs_error radiative_transfer_error optimal_estimation_error profile_error cloud_error model_error number_of_input_data_points_too_low_error cloud_pressure_spread_too_low_error cloud_too_low_level_error generic_range_error generic_exception input_spectrum_alignment_error abort_error wrong_input_type_error wavelength_calibration_error coregistration_error slant_column_density_error airmass_factor_error vertical_column_density_error signal_to_noise_ratio_error configuration_error key_error saturation_error solar_eclipse_filter cloud_filter altitude_consistency_filter altitude_roughness_filter sun_glint_filter mixed_surface_type_filter snow_ice_filter aai_filter cloud_fraction_fresco_filter aai_scene_albedo_filter small_pixel_radiance_std_filter cloud_fraction_viirs_filter cirrus_reflectance_viirs_filter cf_viirs_swir_ifov_filter cf_viirs_swir_ofova_filter cf_viirs_swir_ofovb_filter cf_viirs_swir_ofovc_filter cf_viirs_nir_ifov_filter cf_viirs_nir_ofova_filter cf_viirs_nir_ofovb_filter cf_viirs_nir_ofovc_filter refl_cirrus_viirs_swir_filter refl_cirrus_viirs_nir_filter diff_refl_cirrus_viirs_filter ch4_noscat_ratio_filter ch4_noscat_ratio_std_filter h2o_noscat_ratio_filter h2o_noscat_ratio_std_filter diff_psurf_fresco_ecmwf_filter psurf_fresco_stdv_filter ocean_filter time_range_filter pixel_or_scanline_index_filter geographic_region_filter input_spectrum_warning wavelength_calibration_warning extrapolation_warning sun_glint_warning south_atlantic_anomaly_warning sun_glint_correction snow_ice_warning cloud_warning AAI_warning pixel_level_input_data_missing data_range_warning low_cloud_fraction_warning altitude_consistency_warning signal_to_noise_ratio_warning deconvolution_warning so2_volcanic_origin_likely_warning so2_volcanic_origin_certain_warning interpolation_warning saturation_warning
- flag_values :
- [0.0000000e+00 1.0000000e+00 2.0000000e+00 3.0000000e+00 4.0000000e+00 5.0000000e+00 6.0000000e+00 7.0000000e+00 8.0000000e+00 9.0000000e+00 1.0000000e+01 1.1000000e+01 1.2000000e+01 1.3000000e+01 1.4000000e+01 1.5000000e+01 1.6000000e+01 1.7000000e+01 1.8000000e+01 1.9000000e+01 2.0000000e+01 2.1000000e+01 2.2000000e+01 2.3000000e+01 2.4000000e+01 2.5000000e+01 2.6000000e+01 2.7000000e+01 2.8000000e+01 2.9000000e+01 3.0000000e+01 3.1000000e+01 3.2000000e+01 3.3000000e+01 3.4000000e+01 3.5000000e+01 3.6000000e+01 3.7000000e+01 3.8000000e+01 3.9000000e+01 4.0000000e+01 4.1000000e+01 4.2000000e+01 4.3000000e+01 4.4000000e+01 4.5000000e+01 4.6000000e+01 4.7000000e+01 4.8000000e+01 4.9000000e+01 5.0000000e+01 5.1000000e+01 5.2000000e+01 5.3000000e+01 5.4000000e+01 6.4000000e+01 6.5000000e+01 6.6000000e+01 6.7000000e+01 6.8000000e+01 6.9000000e+01 7.0000000e+01 7.1000000e+01 7.2000000e+01 7.3000000e+01 7.4000000e+01 7.5000000e+01 7.6000000e+01 7.7000000e+01 7.8000000e+01 7.9000000e+01 8.0000000e+01 8.1000000e+01 8.2000000e+01 8.3000000e+01 8.4000000e+01 8.5000000e+01 8.6000000e+01 8.7000000e+01 8.8000000e+01 8.9000000e+01 9.0000000e+01 9.1000000e+01 9.2000000e+01 9.3000000e+01 9.4000000e+01 9.5000000e+01 9.6000000e+01 9.7000000e+01 2.5600000e+02 5.1200000e+02 1.0240000e+03 2.0480000e+03 4.0960000e+03 8.1920000e+03 1.6384000e+04 3.2768000e+04 6.5536000e+04 1.3107200e+05 2.6214400e+05 5.2428800e+05 1.0485760e+06 2.0971520e+06 4.1943040e+06 8.3886080e+06 1.6777216e+07 3.3554432e+07 6.7108864e+07]
- long_name :
- Processing quality flags
- NETCDF_DIM_time :
- 1
- _FillValue :
- 4294967295.0
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=uint32]
- number_of_spectral_points_in_retrieval(band, y, x)uint16...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Number of spectral points used in the retrieval
- NETCDF_DIM_time :
- 1
- _FillValue :
- 65535.0
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=uint16]
- scene_albedo_388(band, y, x)float32...
- ancillary_variables :
- scene_albedo_388_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Scene albedo at 388 nm calculated from the top of atmosphere reflectance. For a cloud- and aerosol-free scene this is equivalent to the surface albedo
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 388
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- scene_albedo_388_precision(band, y, x)float32...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the scene albedo at 388 nm calculated from the top of atmosphere reflectance and its precision. For a cloud- and aerosol-free scene this is equivalent to the surface albedo
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 388
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- reflectance_measured_354(band, y, x)float32...
- ancillary_variables :
- reflectance_measured_354_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Top of atmosphere reflectance at 354 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 354
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- reflectance_measured_354_precision(band, y, x)float32...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the top of atmosphere reflectance at 354 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 354
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- reflectance_measured_388(band, y, x)float32...
- ancillary_variables :
- reflectance_measured_388_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Top of atmosphere reflectance at 388 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 388
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- reflectance_measured_388_precision(band, y, x)float32...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the top of atmosphere reflectance at 388 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 388
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- reflectance_calculated_354(band, y, x)float32...
- ancillary_variables :
- reflectance_calculated_354_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Calculated top of atmosphere reflectance at 354 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 354
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- reflectance_calculated_354_precision(band, y, x)float32...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the calculated top of atmosphere reflectance at 354 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 354
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- scene_albedo_380(band, y, x)float32...
- ancillary_variables :
- scene_albedo_380_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Scene albedo at 380 nm calculated from the top of atmosphere reflectance. For a cloud- and aerosol-free scene this is equivalent to the surface albedo
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 380
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- scene_albedo_380_precision(band, y, x)float32...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the scene albedo at 380 nm calculated from the top of atmosphere reflectance and its precision. For a cloud- and aerosol-free scene this is equivalent to the surface albedo
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 380
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- reflectance_measured_340(band, y, x)float32...
- ancillary_variables :
- reflectance_measured_340_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Top of atmosphere reflectance at 340 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 340
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- reflectance_measured_340_precision(band, y, x)float32...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the top of atmosphere reflectance at 340 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 340
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- reflectance_measured_380(band, y, x)float32...
- ancillary_variables :
- reflectance_measured_380_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Top of atmosphere reflectance at 380 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 380
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- reflectance_measured_380_precision(band, y, x)float32...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the top of atmosphere reflectance at 380 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 380
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- reflectance_calculated_340(band, y, x)float32...
- ancillary_variables :
- reflectance_calculated_340_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Calculated top of atmosphere reflectance at 340 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 340
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- reflectance_calculated_340_precision(band, y, x)float32...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the calculated top of atmosphere reflectance at 340 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 340
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- wavelength_calibration_offset(band, y, x)float32...
- ancillary_variables :
- wavelength_calibration_offset_precision
- comment :
- True wavelength = nominal wavelength + wavelength offset + wavelength stretch * scaled wavelength
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength offset
- NETCDF_DIM_time :
- 1
- units :
- nm
- wavelength_fit_window_end :
- 390
- wavelength_fit_window_start :
- 338
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- wavelength_calibration_offset_precision(band, y, x)float32...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength offset precision
- NETCDF_DIM_time :
- 1
- units :
- nm
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- wavelength_calibration_stretch(band, y, x)float32...
- ancillary_variables :
- wavelength_calibration_stretch_precision
- comment :
- True wavelength = nominal wavelength + wavelength offset + wavelength stretch * scaled wavelength
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength stretch
- NETCDF_DIM_time :
- 1
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- wavelength_calibration_stretch_precision(band, y, x)float32...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength stretch precision
- NETCDF_DIM_time :
- 1
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- wavelength_calibration_chi_square(band, y, x)float32...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength calibration chi square
- NETCDF_DIM_time :
- 1
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- surface_altitude(band, y, x)float32...
- comment :
- The mean of the sub-pixels of the surface altitudewithin the approximate field of view, based on the GMTED2010 surface elevation database
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Surface altitude
- NETCDF_DIM_time :
- 1
- source :
- http://topotools.cr.usgs.gov/gmted_viewer/
- standard_name :
- surface_altitude
- units :
- m
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- surface_altitude_precision(band, y, x)float32...
- comment :
- The standard deviation of sub-pixels used in calculating the mean surface altitude, based on the GMTED2010 surface elevation database
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- surface altitude precision
- NETCDF_DIM_time :
- 1
- source :
- http://topotools.cr.usgs.gov/gmted_viewer/
- standard_error_multiplier :
- 1
- standard_name :
- surface_altitude standard_error
- units :
- m
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- surface_classification(band, y, x)uint8...
- comment :
- Flag indicating land/water and further surface classifications for the ground pixel
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- flag_masks :
- [ 3. 3. 3. 3. 4. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249.]
- flag_meanings :
- land water some_water coast value_covers_majority_of_pixel water+shallow_ocean water+shallow_inland_water water+ocean_coastline-lake_shoreline water+intermittent_water water+deep_inland_water water+continental_shelf_ocean water+deep_ocean land+urban_and_built-up_land land+dryland_cropland_and_pasture land+irrigated_cropland_and_pasture land+mixed_dryland-irrigated_cropland_and_pasture land+cropland-grassland_mosaic land+cropland-woodland_mosaic land+grassland land+shrubland land+mixed_shrubland-grassland land+savanna land+deciduous_broadleaf_forest land+deciduous_needleleaf_forest land+evergreen_broadleaf_forest land+evergreen_needleleaf_forest land+mixed_forest land+herbaceous_wetland land+wooded_wetland land+barren_or_sparsely_vegetated land+herbaceous_tundra land+wooded_tundra land+mixed_tundra land+bare_ground_tundra land+snow_or_ice
- flag_values :
- [ 0. 1. 2. 3. 4. 9. 17. 25. 33. 41. 49. 57. 8. 16. 24. 32. 40. 48. 56. 64. 72. 80. 88. 96. 104. 112. 120. 128. 136. 144. 152. 160. 168. 176. 184.]
- long_name :
- Land-water mask and surface classification based on a static database
- NETCDF_DIM_time :
- 1
- source :
- USGS (https://lta.cr.usgs.gov/GLCC) and NASA SDP toolkit (http://newsroom.gsfc.nasa.gov/sdptoolkit/toolkit.html)
- _FillValue :
- 255.0
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=uint8]
- qa_value(time, y, x)uint8...
- add_offset :
- 0.0
- comment :
- A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value < 0.5
- coordinates :
- longitude latitude
- long_name :
- data quality value
- scale_factor :
- 0.009999999776482582
- units :
- 1
- valid_max :
- 100
- valid_min :
- 0
- _FillValue :
- 255.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=uint8]
- scaled_small_pixel_variance(band, y, x)float32...
- comment :
- The scaled variance of the reflectances of the small pixels
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- scaled small pixel variance
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 373
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- ozone_total_column(band, y, x)float32...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- total column amount of ozone from ECMWF model data
- multiplication_factor_to_convert_to_DU :
- 2241.1499
- multiplication_factor_to_convert_to_molecules_percm2 :
- 6.0221409e+19
- NETCDF_DIM_time :
- 1
- source :
- standard_name :
- atmosphere_mole_content_of_ozone
- units :
- mol m-2
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- surface_pressure(band, y, x)float32...
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- surface_air_pressure
- NETCDF_DIM_time :
- 1
- source :
- standard_name :
- surface_air_pressure
- units :
- Pa
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- aerosol_index_354_388(time, y, x)float32...
- ancillary_variables :
- aerosol_index_354_388_precision
- comment :
- Aerosol index from 388 and 354 nm
- coordinates :
- longitude latitude
- long_name :
- Aerosol index from 388 and 354 nm
- proposed_standard_name :
- ultraviolet_aerosol_index
- radiation_wavelength :
- [354. 388.]
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- aerosol_index_340_380(time, y, x)float32...
- ancillary_variables :
- aerosol_index_340_380_precision
- comment :
- Aerosol index from 380 and 340 nm
- coordinates :
- longitude latitude
- long_name :
- Aerosol index from 380 and 340 nm
- proposed_standard_name :
- ultraviolet_aerosol_index
- radiation_wavelength :
- [340. 380.]
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- aerosol_index_354_388_precision(time, y, x)float32...
- comment :
- Precision of aerosol index from 388 and 354 nm
- coordinates :
- longitude latitude
- long_name :
- Precision of aerosol index from 388 and 354 nm
- proposed_standard_name :
- ultraviolet_aerosol_index standard_error
- radiation_wavelength :
- [354. 388.]
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- aerosol_index_340_380_precision(time, y, x)float32...
- comment :
- Precision of aerosol index from 380 and 340 nm
- coordinates :
- longitude latitude
- long_name :
- Precision of aerosol index from 380 and 340 nm
- proposed_standard_name :
- ultraviolet_aerosol_index standard_error
- radiation_wavelength :
- [340. 380.]
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
[1460250 values with dtype=float32]
- algo.algorithm_variant :
- 1
- algo.n_pair :
- 2
- algo.pair_1.delta_wavelength :
- 2.0
- algo.pair_1.id :
- TOMS_pair
- algo.pair_1.min_wavelength :
- 1
- algo.pair_1.number_spectral_pixels :
- 7
- algo.pair_1.wavelength_1 :
- 340
- algo.pair_1.wavelength_2 :
- 380
- algo.pair_2.delta_wavelength :
- 2.0
- algo.pair_2.id :
- OMI_pair
- algo.pair_2.min_wavelength :
- 1
- algo.pair_2.number_spectral_pixels :
- 7
- algo.pair_2.wavelength_1 :
- 354
- algo.pair_2.wavelength_2 :
- 388
- configuration.version.algorithm :
- 1.1.0
- configuration.version.framework :
- 1.1.0
- input.1.band :
- 3
- input.1.irrType :
- L1B_IR_UVN
- input.1.type :
- L1B_RA_BD3
- input.count :
- 1
- output.1.band :
- 3
- output.1.config :
- cfg/product/product.AER_AI.xml
- output.1.type :
- L2__AER_AI
- output.compressionLevel :
- 3
- output.count :
- 1
- output.histogram.aerosol_index_340_380.end :
- 14
- output.histogram.aerosol_index_340_380.start :
- -6
- output.histogram.aerosol_index_354_388.end :
- 14
- output.histogram.aerosol_index_354_388.start :
- -6
- output.useCompression :
- true
- output.useFletcher32 :
- true
- output.useShuffleFilter :
- true
- processing.algorithm :
- AER_AI
- processing.correct_surface_pressure_for_altitude :
- true
- processing.exclude_flags :
- 4294967295
- processing.groupDem :
- DEM_RADIUS_05000
- processing.ignore_pixel_flags :
- False
- processing.radiancePixelsMinError :
- 2
- processing.radiancePixelsMinWarning :
- 7
- processing.signal_to_noise.test :
- yes
- processing.signal_to_noise.threshold :
- 12
- processing.signal_to_noise.window.range :
- 350.0, 355.0
- processing.szaMax :
- 88.0
- processing.szaMin :
- 0.0
- processing.vzaMax :
- 78.0
- processing.vzaMin :
- 0.0
- qa_value.AAI_warning :
- 100.0
- qa_value.altitude_consistency_warning :
- 100.0
- qa_value.cloud_warning :
- 100.0
- qa_value.data_range_warning :
- 100.0
- qa_value.deconvolution_warning :
- 100.0
- qa_value.extrapolation_warning :
- 100.0
- qa_value.input_spectrum_warning :
- 70.0
- qa_value.interpolation_warning :
- 100.0
- qa_value.low_cloud_fraction_warning :
- 100.0
- qa_value.pixel_level_input_data_missing :
- 80.0
- qa_value.signal_to_noise_ratio_warning :
- 100.0
- qa_value.snow_ice_warning :
- 100.0
- qa_value.so2_volcanic_origin_certain_warning :
- 100.0
- qa_value.so2_volcanic_origin_likely_warning :
- 100.0
- qa_value.south_atlantic_anomaly_warning :
- 100.0
- qa_value.sun_glint_correction :
- 100.0
- qa_value.sun_glint_warning :
- 70.0
- qa_value.wavelength_calibration_warning :
- 90.0
- wavelength_calibration.convergence_threshold :
- 1.0
- wavelength_calibration.include_stretch :
- no
- wavelength_calibration.initial_guess.a0 :
- 1.0
- wavelength_calibration.initial_guess.a1 :
- 0.1
- wavelength_calibration.initial_guess.a2 :
- 0.01
- wavelength_calibration.initial_guess.ring :
- 0.06
- wavelength_calibration.initial_guess.shift :
- 0.0
- wavelength_calibration.initial_guess.stretch :
- 0.0
- wavelength_calibration.irr.include_ring :
- no
- wavelength_calibration.irr.max_iterations :
- 20
- wavelength_calibration.irr.polynomial_order :
- 2
- wavelength_calibration.max_iterations :
- 12
- wavelength_calibration.perform_wavelength_fit :
- yes
- wavelength_calibration.rad.include_ring :
- yes
- wavelength_calibration.rad.polynomial_order :
- 3
- wavelength_calibration.sigma.a0 :
- 1.0
- wavelength_calibration.sigma.a1 :
- 0.1
- wavelength_calibration.sigma.ring :
- 0.06
- wavelength_calibration.sigma.shift :
- 0.07
- wavelength_calibration.sigma.stretch :
- 0.07
- wavelength_calibration.window :
- 338.0, 390.0
- /METADATA/EOP_METADATA/eop :
- metaDataProperty/NC_GLOBAL#objectType=eop:EarthObservationMetaData
- gml :
- id=S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822.ID
- objectType :
- gmi:MI_Metadata
- /METADATA/EOP_METADATA/om :
- procedure/NC_GLOBAL#objectType=eop:EarthObservationEquipment
- File_Class :
- OFFL
- File_Description :
- Aerosol index with a spatial resolution of 7x3.5km2 observed at about 13:30 local solar time from spectra measured by TROPOMI
- File_Name :
- S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822
- File_Type :
- L2__AER_AI
- File_Version :
- 1
- Mission :
- S5P
- Notes :
- Creation_Date :
- UTC=2018-08-22T19:32:01
- Creator :
- TROPNLL2DP
- Creator_Version :
- 1.1.0
- System :
- PDGS-OP
- Validity_Start :
- UTC=2018-08-16T18:51:51
- Validity_Stop :
- UTC=2018-08-16T19:50:14
- /METADATA/ESA_METADATA/earth_explorer_header/variable_header/gmd :
- lineage/NC_GLOBAL#objectType=gmd:LI_Lineage
- GranuleEnd :
- 2018-08-16T19:50:14Z
- GranuleStart :
- 2018-08-16T18:51:51Z
- InstrumentName :
- TROPOMI
- LongitudeOfDaysideNadirEquatorCrossing :
- -86.442253
- MissionName :
- Sentinel-5 precursor
- MissionShortName :
- S5P
- ProcessingCenter :
- PDGS-OP
- ProcessingMode :
- Offline
- ProcessingNode :
- s5p-off-pn37
- ProcessLevel :
- 2
- ProcessorVersion :
- 1.1.0
- ProductFormatVersion :
- 10000
- ProductShortName :
- L2__AER_AI
- /METADATA/ISO_METADATA/gmd :
- language/NC_GLOBAL#objectType=gmd:LanguageCode
- /METADATA/ISO_METADATA/gmi :
- acquisitionInformation/NC_GLOBAL#objectType=gmi:MI_AcquisitionInformation
- gmd :
- metadataStandardVersion=ISO 19115-2:2009(E), S5P profile
- global_processing_warnings :
- --- TEST FLAG SET IN JOB ORDER ---
- number_of_aai_filter_occurrences :
- 0
- number_of_aai_scene_albedo_filter_occurrences :
- 0
- number_of_AAI_warning_occurrences :
- 0
- number_of_abort_error_occurrences :
- 0
- number_of_aerosol_boundary_error_occurrences :
- 0
- number_of_airmass_factor_error_occurrences :
- 0
- number_of_altitude_consistency_filter_occurrences :
- 0
- number_of_altitude_consistency_warning_occurrences :
- 0
- number_of_altitude_roughness_filter_occurrences :
- 0
- number_of_aot_lower_boundary_convergence_error_occurrences :
- 0
- number_of_assertion_error_occurrences :
- 31
- number_of_boundary_hit_error_occurrences :
- 0
- number_of_cf_viirs_nir_ifov_filter_occurrences :
- 0
- number_of_cf_viirs_nir_ofova_filter_occurrences :
- 0
- number_of_cf_viirs_nir_ofovb_filter_occurrences :
- 0
- number_of_cf_viirs_nir_ofovc_filter_occurrences :
- 0
- number_of_cf_viirs_swir_ifov_filter_occurrences :
- 0
- number_of_cf_viirs_swir_ofova_filter_occurrences :
- 0
- number_of_cf_viirs_swir_ofovb_filter_occurrences :
- 0
- number_of_cf_viirs_swir_ofovc_filter_occurrences :
- 0
- number_of_ch4_noscat_ratio_filter_occurrences :
- 0
- number_of_ch4_noscat_ratio_std_filter_occurrences :
- 0
- number_of_ch4_noscat_zero_error_occurrences :
- 0
- number_of_chi2_error_occurrences :
- 0
- number_of_cirrus_reflectance_viirs_filter_occurrences :
- 0
- number_of_cloud_error_occurrences :
- 0
- number_of_cloud_filter_convergence_error_occurrences :
- 0
- number_of_cloud_filter_occurrences :
- 0
- number_of_cloud_fraction_fresco_filter_occurrences :
- 0
- number_of_cloud_fraction_viirs_filter_occurrences :
- 0
- number_of_cloud_pressure_spread_too_low_error_occurrences :
- 0
- number_of_cloud_too_low_level_error_occurrences :
- 0
- number_of_cloud_warning_occurrences :
- 0
- number_of_configuration_error_occurrences :
- 0
- number_of_convergence_error_occurrences :
- 0
- number_of_coregistration_error_occurrences :
- 0
- number_of_data_range_warning_occurrences :
- 0
- number_of_deconvolution_warning_occurrences :
- 0
- number_of_dfs_error_occurrences :
- 0
- number_of_diff_psurf_fresco_ecmwf_filter_occurrences :
- 0
- number_of_diff_refl_cirrus_viirs_filter_occurrences :
- 0
- number_of_extrapolation_warning_occurrences :
- 0
- number_of_failed_retrievals :
- 222068
- number_of_generic_exception_occurrences :
- 0
- number_of_generic_range_error_occurrences :
- 0
- number_of_geographic_region_filter_occurrences :
- 0
- number_of_geolocation_error_occurrences :
- 0
- number_of_groundpixels :
- 1460250
- number_of_ground_pixels_with_warnings :
- 84516
- number_of_h2o_noscat_ratio_filter_occurrences :
- 0
- number_of_h2o_noscat_ratio_std_filter_occurrences :
- 0
- number_of_h2o_noscat_zero_error_occurrences :
- 0
- number_of_initialization_error_occurrences :
- 0
- number_of_input_spectrum_alignment_error_occurrences :
- 0
- number_of_input_spectrum_missing_occurrences :
- 0
- number_of_input_spectrum_warning_occurrences :
- 0
- number_of_interpolation_warning_occurrences :
- 0
- number_of_io_error_occurrences :
- 0
- number_of_irradiance_missing_occurrences :
- 0
- number_of_ISRF_error_occurrences :
- 0
- number_of_key_error_occurrences :
- 0
- number_of_ler_range_error_occurrences :
- 0
- number_of_low_cloud_fraction_warning_occurrences :
- 0
- number_of_lut_error_occurrences :
- 0
- number_of_lut_range_error_occurrences :
- 0
- number_of_max_iteration_convergence_error_occurrences :
- 0
- number_of_max_optical_thickness_error_occurrences :
- 0
- number_of_memory_error_occurrences :
- 0
- number_of_mixed_surface_type_filter_occurrences :
- 0
- number_of_model_error_occurrences :
- 0
- number_of_number_of_input_data_points_too_low_error_occurrences :
- 0
- number_of_numerical_error_occurrences :
- 0
- number_of_ocean_filter_occurrences :
- 0
- number_of_optimal_estimation_error_occurrences :
- 0
- number_of_other_boundary_convergence_error_occurrences :
- 0
- number_of_ozone_range_error_occurrences :
- 0
- number_of_pixel_level_input_data_missing_occurrences :
- 0
- number_of_pixel_or_scanline_index_filter_occurrences :
- 0
- number_of_processed_pixels :
- 1460250
- number_of_profile_error_occurrences :
- 0
- number_of_psurf_fresco_stdv_filter_occurrences :
- 0
- number_of_radiance_missing_occurrences :
- 0
- number_of_radiative_transfer_error_occurrences :
- 0
- number_of_reflectance_range_error_occurrences :
- 0
- number_of_refl_cirrus_viirs_nir_filter_occurrences :
- 0
- number_of_refl_cirrus_viirs_swir_filter_occurrences :
- 0
- number_of_rejected_pixels_not_enough_spectrum :
- 0
- number_of_saturation_error_occurrences :
- 0
- number_of_saturation_warning_occurrences :
- 0
- number_of_signal_to_noise_ratio_error_occurrences :
- 0
- number_of_signal_to_noise_ratio_warning_occurrences :
- 0
- number_of_slant_column_density_error_occurrences :
- 0
- number_of_small_pixel_radiance_std_filter_occurrences :
- 0
- number_of_snow_ice_filter_occurrences :
- 0
- number_of_snow_ice_warning_occurrences :
- 0
- number_of_snr_range_error_occurrences :
- 0
- number_of_so2_volcanic_origin_certain_warning_occurrences :
- 0
- number_of_so2_volcanic_origin_likely_warning_occurrences :
- 0
- number_of_solar_eclipse_filter_occurrences :
- 0
- number_of_south_atlantic_anomaly_warning_occurrences :
- 0
- number_of_successfully_processed_pixels :
- 1238182
- number_of_sun_glint_correction_occurrences :
- 0
- number_of_sun_glint_filter_occurrences :
- 0
- number_of_sun_glint_warning_occurrences :
- 84516
- number_of_svd_error_occurrences :
- 0
- number_of_sza_range_error_occurrences :
- 222037
- number_of_time_range_filter_occurrences :
- 0
- number_of_vertical_column_density_error_occurrences :
- 0
- number_of_vza_range_error_occurrences :
- 0
- number_of_wavelength_calibration_error_occurrences :
- 0
- number_of_wavelength_calibration_warning_occurrences :
- 0
- number_of_wavelength_offset_error_occurrences :
- 0
- number_of_wrong_input_type_error_occurrences :
- 0
- time_for_algorithm_initialization :
- 23.927286
- time_for_processing :
- 212.96926
- time_per_pixel :
- 0.001535914273508207
- time_standard_deviation_per_pixel :
- 2.56573665351871e-05
- algorithm_version :
- 1.1.0
- build_date :
- 2018-07-04T06:04:00Z
- cdm_data_type :
- Swath
- Conventions :
- CF-1.7
- cpp_compiler_flags :
- -g -O2 -fPIC -std=c++11 -W -Wall -Wno-ignored-qualifiers -Wno-write-strings -Wno-unused-variable -DTROPNLL2DP
- cpp_compiler_version :
- g++ (GCC) 4.8.5 20150623 (Red Hat 4.8.5-11)
- creator_email :
- EOSupport@Copernicus.esa.int
- creator_name :
- The Sentinel 5 Precursor TROPOMI Level 2 products are developed with funding from the European Space Agency (ESA), the Netherlands Space Office (NSO), the Belgian Science Policy Office, the German Aerospace Center (DLR) and the Bayerisches Staatsministerium für Wirtschaft und Medien, Energie und Technologie (StMWi).
- creator_url :
- http://www.tropomi.eu
- date_created :
- 2018-08-22T19:32:01Z
- f90_compiler_flags :
- -gdwarf-3 -O2 -fPIC -cpp -ffpe-trap=invalid -fno-range-check -frecursive -fimplicit-none -ffree-line-length-none -DTROPNLL2DP -Wuninitialized -Wtabs
- f90_compiler_version :
- GNU Fortran (GCC) 4.8.5 20150623 (Red Hat 4.8.5-11)
- geolocation_grid_from_band :
- 3
- geospatial_lat_max :
- 89.972939
- geospatial_lat_min :
- -86.81926
- geospatial_lon_max :
- -179.99773
- geospatial_lon_min :
- 179.99924
- history :
- 2018-08-22 19:35:59 f_s5pops tropnll2dp /mnt/data1/storage_offl_l2/cache_offl_l2/WORKING-564386761/JobOrder.564386738.xml
- id :
- S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822
- identifier_product_doi :
- 10.5270/S5P-0wafvaf
- identifier_product_doi_authority :
- http://dx.doi.org/
- institution :
- KNMI
- keywords :
- 0300 Atmospheric Composition and Structure; 0305 Aerosols and Particles; 0360 Radiation, Transmission and Scattering; 3311 Clouds and Aerosols; 3360 Remote Sensing
- keywords_vocabulary :
- AGU index terms, http://publications.agu.org/author-resource-center/index-terms/
- license :
- No conditions apply
- naming_authority :
- nl.knmi
- orbit :
- 4361
- platform :
- S5P
- processing_status :
- Nominal
- processor_version :
- 1.1.0
- product_version :
- 1.0.0
- project :
- Sentinel 5 precursor/TROPOMI
- references :
- http://www.tropomi.eu/data-products/aerosol-index
- revision_control_identifier :
- df649da886db
- sensor :
- TROPOMI
- source :
- Sentinel 5 precursor, TROPOMI, space-borne remote sensing, L2
- spatial_resolution :
- 7x3.5km2
- standard_name_vocabulary :
- NetCDF Climate and Forecast Metadata Conventions Standard Name Table (v29, 08 July 2015), http://cfconventions.org/standard-names.html
- Status_MET_2D :
- Nominal
- summary :
- TROPOMI/S5P Aerosol Index 1-Orbit L2 Swath 7x3.5km
- time_coverage_duration :
- PT3503.000S
- time_coverage_end :
- 2018-08-16T19:50:14Z
- time_coverage_resolution :
- PT1.080S
- time_coverage_start :
- 2018-08-16T18:51:51Z
- time_reference :
- 2018-08-16T00:00:00Z
- time_reference_days_since_1950 :
- 25064
- time_reference_julian_day :
- 2458346.5
- time_reference_seconds_since_1970 :
- 1534377600
- title :
- TROPOMI/S5P Aerosol Index 1-Orbit L2 Swath 7x3.5km
- tracking_id :
- 0b05f3ea-704b-4ab5-8df3-cf6e31764960
r1 = rds[0]
type(r1)
xarray.core.dataset.Dataset
r1.geolocation_flags
<xarray.DataArray 'geolocation_flags' (band: 1, y: 3245, x: 450)> array([[[12, 12, ..., 12, 12], [12, 12, ..., 12, 12], ..., [ 8, 8, ..., 8, 8], [ 8, 8, ..., 8, 8]]], dtype=uint8) Coordinates: * y (y) float64 3.244e+03 3.243e+03 3.242e+03 ... 2.0 1.0 0.0 * x (x) float64 0.0 1.0 2.0 3.0 4.0 ... 446.0 447.0 448.0 449.0 spatial_ref int64 0 * band (band) int64 1 Attributes: coordinates: /PRODUCT/longitude /PRODUCT/latitude flag_masks: [ 0. 1. 2. 4. 8. 16. 128.] flag_meanings: no_error solar_eclipse sun_glint_possible descending ni... flag_values: [ 0. 1. 2. 4. 8. 16. 128.] long_name: ground pixel quality flag max_val: 254 min_val: 0 NETCDF_DIM_time: 1 units: 1 _FillValue: 255.0 scale_factor: 1.0 add_offset: 0.0 grid_mapping: spatial_ref
- band: 1
- y: 3245
- x: 450
- 12 12 12 12 12 12 12 12 12 12 12 12 12 ... 8 8 8 8 8 8 8 8 8 8 8 8 8
array([[[12, 12, ..., 12, 12], [12, 12, ..., 12, 12], ..., [ 8, 8, ..., 8, 8], [ 8, 8, ..., 8, 8]]], dtype=uint8)
- y(y)float643.244e+03 3.243e+03 ... 1.0 0.0
array([3.244e+03, 3.243e+03, 3.242e+03, ..., 2.000e+00, 1.000e+00, 0.000e+00])
- x(x)float640.0 1.0 2.0 ... 447.0 448.0 449.0
array([ 0., 1., 2., ..., 447., 448., 449.])
- spatial_ref()int640
- GeoTransform :
- -0.5 1.0 0.0 3244.5 0.0 -1.0
array(0)
- band(band)int641
array([1])
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- flag_masks :
- [ 0. 1. 2. 4. 8. 16. 128.]
- flag_meanings :
- no_error solar_eclipse sun_glint_possible descending night geo_boundary_crossing geolocation_error
- flag_values :
- [ 0. 1. 2. 4. 8. 16. 128.]
- long_name :
- ground pixel quality flag
- max_val :
- 254
- min_val :
- 0
- NETCDF_DIM_time :
- 1
- units :
- 1
- _FillValue :
- 255.0
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
r1.spatial_ref
<xarray.DataArray 'spatial_ref' ()> array(0) Coordinates: spatial_ref int64 0 Attributes: GeoTransform: -0.5 1.0 0.0 3244.5 0.0 -1.0
- 0
array(0)
- spatial_ref()int640
- GeoTransform :
- -0.5 1.0 0.0 3244.5 0.0 -1.0
array(0)
- GeoTransform :
- -0.5 1.0 0.0 3244.5 0.0 -1.0
r1.spatial_resolution
'7x3.5km2'
(r1.geospatial_lat_max, r1.geospatial_lat_min,
r1.geospatial_lon_max, r1.geospatial_lon_min)
(89.972939, -86.81926, -179.99773, 179.99924)
r1_ai = r1['aerosol_index_340_380']
r1_ai.plot()
<matplotlib.collections.QuadMesh at 0x1965f1520>
r1_ai.spatial_ref
<xarray.DataArray 'spatial_ref' ()> array(0) Coordinates: spatial_ref int64 0 Attributes: GeoTransform: -0.5 1.0 0.0 3244.5 0.0 -1.0
- 0
array(0)
- spatial_ref()int640
- GeoTransform :
- -0.5 1.0 0.0 3244.5 0.0 -1.0
array(0)
- GeoTransform :
- -0.5 1.0 0.0 3244.5 0.0 -1.0
# rds[0].rio.set_spatial_dims(x_dim='/PRODUCT/longitude', y_dim='/PRODUCT/latitude')
rds_crs_set = rds[0].rio.set_crs(4326)
rds_crs_set
<xarray.Dataset> Dimensions: (band: 1, time: 1, x: 450, y: 3245) Coordinates: * y (y) float64 3.244e+03 ... 0.0 * x (x) float64 0.0 1.0 ... 449.0 * time (time) int64 272073600 spatial_ref int64 0 * band (band) int64 1 Data variables: latitude (time, y, x) float32 53.289627 ... solar_zenith_angle (band, y, x) float32 97.89976 .... solar_azimuth_angle (band, y, x) float32 54.418926 ... viewing_zenith_angle (band, y, x) float32 66.529594 ... viewing_azimuth_angle (band, y, x) float32 -60.276833... longitude (time, y, x) float32 119.45596 ... geolocation_flags (band, y, x) uint8 12 12 ... 8 8 processing_quality_flags (band, y, x) uint32 7 7 7 ... 7 7 number_of_spectral_points_in_retrieval (band, y, x) uint16 65535 ... 6... scene_albedo_388 (band, y, x) float32 9.96921e+3... scene_albedo_388_precision (band, y, x) float32 9.96921e+3... reflectance_measured_354 (band, y, x) float32 9.96921e+3... reflectance_measured_354_precision (band, y, x) float32 9.96921e+3... reflectance_measured_388 (band, y, x) float32 9.96921e+3... reflectance_measured_388_precision (band, y, x) float32 9.96921e+3... reflectance_calculated_354 (band, y, x) float32 9.96921e+3... reflectance_calculated_354_precision (band, y, x) float32 9.96921e+3... scene_albedo_380 (band, y, x) float32 9.96921e+3... scene_albedo_380_precision (band, y, x) float32 9.96921e+3... reflectance_measured_340 (band, y, x) float32 9.96921e+3... reflectance_measured_340_precision (band, y, x) float32 9.96921e+3... reflectance_measured_380 (band, y, x) float32 9.96921e+3... reflectance_measured_380_precision (band, y, x) float32 9.96921e+3... reflectance_calculated_340 (band, y, x) float32 9.96921e+3... reflectance_calculated_340_precision (band, y, x) float32 9.96921e+3... wavelength_calibration_offset (band, y, x) float32 9.96921e+3... wavelength_calibration_offset_precision (band, y, x) float32 9.96921e+3... wavelength_calibration_stretch (band, y, x) float32 9.96921e+3... wavelength_calibration_stretch_precision (band, y, x) float32 9.96921e+3... wavelength_calibration_chi_square (band, y, x) float32 9.96921e+3... surface_altitude (band, y, x) float32 9.96921e+3... surface_altitude_precision (band, y, x) float32 9.96921e+3... surface_classification (band, y, x) uint8 255 255 ... 255 qa_value (time, y, x) uint8 0 0 0 ... 0 0 0 scaled_small_pixel_variance (band, y, x) float32 9.96921e+3... ozone_total_column (band, y, x) float32 9.96921e+3... surface_pressure (band, y, x) float32 9.96921e+3... aerosol_index_354_388 (time, y, x) float32 9.96921e+3... aerosol_index_340_380 (time, y, x) float32 9.96921e+3... aerosol_index_354_388_precision (time, y, x) float32 9.96921e+3... aerosol_index_340_380_precision (time, y, x) float32 9.96921e+3... Attributes: algo.algorithm_variant: 1 algo.n_pair: 2 algo.pair_1.delta_wavelength: 2.0 algo.pair_1.id: TOMS_pair algo.pair_1.min_wavelength: 1 algo.pair_1.number_spectral_pixels: 7 algo.pair_1.wavelength_1: 340 algo.pair_1.wavelength_2: 380 algo.pair_2.delta_wavelength: 2.0 algo.pair_2.id: OMI_pair algo.pair_2.min_wavelength: 1 algo.pair_2.number_spectral_pixels: 7 algo.pair_2.wavelength_1: 354 algo.pair_2.wavelength_2: 388 configuration.version.algorithm: 1.1.0 configuration.version.framework: 1.1.0 input.1.band: 3 input.1.irrType: L1B_IR... input.1.type: L1B_RA... input.count: 1 output.1.band: 3 output.1.config: cfg/pr... output.1.type: L2__AE... output.compressionLevel: 3 output.count: 1 output.histogram.aerosol_index_340_380.end: 14 output.histogram.aerosol_index_340_380.start: -6 output.histogram.aerosol_index_354_388.end: 14 output.histogram.aerosol_index_354_388.start: -6 output.useCompression: true output.useFletcher32: true output.useShuffleFilter: true processing.algorithm: AER_AI processing.correct_surface_pressure_for_altitude: true processing.exclude_flags: 429496... processing.groupDem: DEM_RA... processing.ignore_pixel_flags: False processing.radiancePixelsMinError: 2 processing.radiancePixelsMinWarning: 7 processing.signal_to_noise.test: yes processing.signal_to_noise.threshold: 12 processing.signal_to_noise.window.range: 350.0,... processing.szaMax: 88.0 processing.szaMin: 0.0 processing.vzaMax: 78.0 processing.vzaMin: 0.0 qa_value.AAI_warning: 100.0 qa_value.altitude_consistency_warning: 100.0 qa_value.cloud_warning: 100.0 qa_value.data_range_warning: 100.0 qa_value.deconvolution_warning: 100.0 qa_value.extrapolation_warning: 100.0 qa_value.input_spectrum_warning: 70.0 qa_value.interpolation_warning: 100.0 qa_value.low_cloud_fraction_warning: 100.0 qa_value.pixel_level_input_data_missing: 80.0 qa_value.signal_to_noise_ratio_warning: 100.0 qa_value.snow_ice_warning: 100.0 qa_value.so2_volcanic_origin_certain_warning: 100.0 qa_value.so2_volcanic_origin_likely_warning: 100.0 qa_value.south_atlantic_anomaly_warning: 100.0 qa_value.sun_glint_correction: 100.0 qa_value.sun_glint_warning: 70.0 qa_value.wavelength_calibration_warning: 90.0 wavelength_calibration.convergence_threshold: 1.0 wavelength_calibration.include_stretch: no wavelength_calibration.initial_guess.a0: 1.0 wavelength_calibration.initial_guess.a1: 0.1 wavelength_calibration.initial_guess.a2: 0.01 wavelength_calibration.initial_guess.ring: 0.06 wavelength_calibration.initial_guess.shift: 0.0 wavelength_calibration.initial_guess.stretch: 0.0 wavelength_calibration.irr.include_ring: no wavelength_calibration.irr.max_iterations: 20 wavelength_calibration.irr.polynomial_order: 2 wavelength_calibration.max_iterations: 12 wavelength_calibration.perform_wavelength_fit: yes wavelength_calibration.rad.include_ring: yes wavelength_calibration.rad.polynomial_order: 3 wavelength_calibration.sigma.a0: 1.0 wavelength_calibration.sigma.a1: 0.1 wavelength_calibration.sigma.ring: 0.06 wavelength_calibration.sigma.shift: 0.07 wavelength_calibration.sigma.stretch: 0.07 wavelength_calibration.window: 338.0,... /METADATA/EOP_METADATA/eop: metaDa... gml: id=S5P... objectType: gmi:MI... /METADATA/EOP_METADATA/om: proced... File_Class: OFFL File_Description: Aeroso... File_Name: S5P_OF... File_Type: L2__AE... File_Version: 1 Mission: S5P Notes: Creation_Date: UTC=20... Creator: TROPNL... Creator_Version: 1.1.0 System: PDGS-OP Validity_Start: UTC=20... Validity_Stop: UTC=20... /METADATA/ESA_METADATA/earth_explorer_header/variable_header/gmd: lineag... GranuleEnd: 2018-0... GranuleStart: 2018-0... InstrumentName: TROPOMI LongitudeOfDaysideNadirEquatorCrossing: -86.44... MissionName: Sentin... MissionShortName: S5P ProcessingCenter: PDGS-OP ProcessingMode: Offline ProcessingNode: s5p-of... ProcessLevel: 2 ProcessorVersion: 1.1.0 ProductFormatVersion: 10000 ProductShortName: L2__AE... /METADATA/ISO_METADATA/gmd: langua... /METADATA/ISO_METADATA/gmi: acquis... gmd: metada... global_processing_warnings: --- TE... number_of_aai_filter_occurrences: 0 number_of_aai_scene_albedo_filter_occurrences: 0 number_of_AAI_warning_occurrences: 0 number_of_abort_error_occurrences: 0 number_of_aerosol_boundary_error_occurrences: 0 number_of_airmass_factor_error_occurrences: 0 number_of_altitude_consistency_filter_occurrences: 0 number_of_altitude_consistency_warning_occurrences: 0 number_of_altitude_roughness_filter_occurrences: 0 number_of_aot_lower_boundary_convergence_error_occurrences: 0 number_of_assertion_error_occurrences: 31 number_of_boundary_hit_error_occurrences: 0 number_of_cf_viirs_nir_ifov_filter_occurrences: 0 number_of_cf_viirs_nir_ofova_filter_occurrences: 0 number_of_cf_viirs_nir_ofovb_filter_occurrences: 0 number_of_cf_viirs_nir_ofovc_filter_occurrences: 0 number_of_cf_viirs_swir_ifov_filter_occurrences: 0 number_of_cf_viirs_swir_ofova_filter_occurrences: 0 number_of_cf_viirs_swir_ofovb_filter_occurrences: 0 number_of_cf_viirs_swir_ofovc_filter_occurrences: 0 number_of_ch4_noscat_ratio_filter_occurrences: 0 number_of_ch4_noscat_ratio_std_filter_occurrences: 0 number_of_ch4_noscat_zero_error_occurrences: 0 number_of_chi2_error_occurrences: 0 number_of_cirrus_reflectance_viirs_filter_occurrences: 0 number_of_cloud_error_occurrences: 0 number_of_cloud_filter_convergence_error_occurrences: 0 number_of_cloud_filter_occurrences: 0 number_of_cloud_fraction_fresco_filter_occurrences: 0 number_of_cloud_fraction_viirs_filter_occurrences: 0 number_of_cloud_pressure_spread_too_low_error_occurrences: 0 number_of_cloud_too_low_level_error_occurrences: 0 number_of_cloud_warning_occurrences: 0 number_of_configuration_error_occurrences: 0 number_of_convergence_error_occurrences: 0 number_of_coregistration_error_occurrences: 0 number_of_data_range_warning_occurrences: 0 number_of_deconvolution_warning_occurrences: 0 number_of_dfs_error_occurrences: 0 number_of_diff_psurf_fresco_ecmwf_filter_occurrences: 0 number_of_diff_refl_cirrus_viirs_filter_occurrences: 0 number_of_extrapolation_warning_occurrences: 0 number_of_failed_retrievals: 222068 number_of_generic_exception_occurrences: 0 number_of_generic_range_error_occurrences: 0 number_of_geographic_region_filter_occurrences: 0 number_of_geolocation_error_occurrences: 0 number_of_groundpixels: 1460250 number_of_ground_pixels_with_warnings: 84516 number_of_h2o_noscat_ratio_filter_occurrences: 0 number_of_h2o_noscat_ratio_std_filter_occurrences: 0 number_of_h2o_noscat_zero_error_occurrences: 0 number_of_initialization_error_occurrences: 0 number_of_input_spectrum_alignment_error_occurrences: 0 number_of_input_spectrum_missing_occurrences: 0 number_of_input_spectrum_warning_occurrences: 0 number_of_interpolation_warning_occurrences: 0 number_of_io_error_occurrences: 0 number_of_irradiance_missing_occurrences: 0 number_of_ISRF_error_occurrences: 0 number_of_key_error_occurrences: 0 number_of_ler_range_error_occurrences: 0 number_of_low_cloud_fraction_warning_occurrences: 0 number_of_lut_error_occurrences: 0 number_of_lut_range_error_occurrences: 0 number_of_max_iteration_convergence_error_occurrences: 0 number_of_max_optical_thickness_error_occurrences: 0 number_of_memory_error_occurrences: 0 number_of_mixed_surface_type_filter_occurrences: 0 number_of_model_error_occurrences: 0 number_of_number_of_input_data_points_too_low_error_occurrences: 0 number_of_numerical_error_occurrences: 0 number_of_ocean_filter_occurrences: 0 number_of_optimal_estimation_error_occurrences: 0 number_of_other_boundary_convergence_error_occurrences: 0 number_of_ozone_range_error_occurrences: 0 number_of_pixel_level_input_data_missing_occurrences: 0 number_of_pixel_or_scanline_index_filter_occurrences: 0 number_of_processed_pixels: 1460250 number_of_profile_error_occurrences: 0 number_of_psurf_fresco_stdv_filter_occurrences: 0 number_of_radiance_missing_occurrences: 0 number_of_radiative_transfer_error_occurrences: 0 number_of_reflectance_range_error_occurrences: 0 number_of_refl_cirrus_viirs_nir_filter_occurrences: 0 number_of_refl_cirrus_viirs_swir_filter_occurrences: 0 number_of_rejected_pixels_not_enough_spectrum: 0 number_of_saturation_error_occurrences: 0 number_of_saturation_warning_occurrences: 0 number_of_signal_to_noise_ratio_error_occurrences: 0 number_of_signal_to_noise_ratio_warning_occurrences: 0 number_of_slant_column_density_error_occurrences: 0 number_of_small_pixel_radiance_std_filter_occurrences: 0 number_of_snow_ice_filter_occurrences: 0 number_of_snow_ice_warning_occurrences: 0 number_of_snr_range_error_occurrences: 0 number_of_so2_volcanic_origin_certain_warning_occurrences: 0 number_of_so2_volcanic_origin_likely_warning_occurrences: 0 number_of_solar_eclipse_filter_occurrences: 0 number_of_south_atlantic_anomaly_warning_occurrences: 0 number_of_successfully_processed_pixels: 1238182 number_of_sun_glint_correction_occurrences: 0 number_of_sun_glint_filter_occurrences: 0 number_of_sun_glint_warning_occurrences: 84516 number_of_svd_error_occurrences: 0 number_of_sza_range_error_occurrences: 222037 number_of_time_range_filter_occurrences: 0 number_of_vertical_column_density_error_occurrences: 0 number_of_vza_range_error_occurrences: 0 number_of_wavelength_calibration_error_occurrences: 0 number_of_wavelength_calibration_warning_occurrences: 0 number_of_wavelength_offset_error_occurrences: 0 number_of_wrong_input_type_error_occurrences: 0 time_for_algorithm_initialization: 23.927286 time_for_processing: 212.96926 time_per_pixel: 0.0015... time_standard_deviation_per_pixel: 2.5657... algorithm_version: 1.1.0 build_date: 2018-0... cdm_data_type: Swath Conventions: CF-1.7 cpp_compiler_flags: -g -O2... cpp_compiler_version: g++ (G... creator_email: EOSupp... creator_name: The Se... creator_url: http:/... date_created: 2018-0... f90_compiler_flags: -gdwar... f90_compiler_version: GNU Fo... geolocation_grid_from_band: 3 geospatial_lat_max: 89.972939 geospatial_lat_min: -86.81926 geospatial_lon_max: -179.9... geospatial_lon_min: 179.99924 history: 2018-0... id: S5P_OF... identifier_product_doi: 10.527... identifier_product_doi_authority: http:/... institution: KNMI keywords: 0300 A... keywords_vocabulary: AGU in... license: No con... naming_authority: nl.knmi orbit: 4361 platform: S5P processing_status: Nominal processor_version: 1.1.0 product_version: 1.0.0 project: Sentin... references: http:/... revision_control_identifier: df649d... sensor: TROPOMI source: Sentin... spatial_resolution: 7x3.5km2 standard_name_vocabulary: NetCDF... Status_MET_2D: Nominal summary: TROPOM... time_coverage_duration: PT3503... time_coverage_end: 2018-0... time_coverage_resolution: PT1.080S time_coverage_start: 2018-0... time_reference: 2018-0... time_reference_days_since_1950: 25064 time_reference_julian_day: 2458346.5 time_reference_seconds_since_1970: 153437... title: TROPOM... tracking_id: 0b05f3...
- band: 1
- time: 1
- x: 450
- y: 3245
- y(y)float643.244e+03 3.243e+03 ... 1.0 0.0
array([3.244e+03, 3.243e+03, 3.242e+03, ..., 2.000e+00, 1.000e+00, 0.000e+00])
- x(x)float640.0 1.0 2.0 ... 447.0 448.0 449.0
array([ 0., 1., 2., ..., 447., 448., 449.])
- time(time)int64272073600
array([272073600])
- spatial_ref()int640
- GeoTransform :
- -0.5 1.0 0.0 3244.5 0.0 -1.0
array(0)
- band(band)int641
array([1])
- latitude(time, y, x)float3253.289627 53.328514 ... -68.705986
- bounds :
- /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/latitude_bounds
- long_name :
- pixel center latitude
- standard_name :
- latitude
- units :
- degrees_north
- valid_max :
- 90
- valid_min :
- -90
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[ 53.289627, 53.328514, ..., 60.861183, 60.871014], [ 53.34224 , 53.3812 , ..., 60.922707, 60.9325 ], ..., [-85.24866 , -85.31239 , ..., -68.77974 , -68.69752 ], [-85.28333 , -85.34773 , ..., -68.788284, -68.705986]]], dtype=float32)
- solar_zenith_angle(band, y, x)float3297.89976 97.93866 ... 107.63726
- comment :
- Solar zenith angle at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- solar zenith angle
- NETCDF_DIM_time :
- 1
- standard_name :
- solar_zenith_angle
- units :
- degree
- valid_max :
- 180
- valid_min :
- 0
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[ 97.89976 , 97.93866 , ..., 104.90762 , 104.9158 ], [ 97.84073 , 97.879616, ..., 104.848495, 104.8567 ], ..., [ 99.615 , 99.634796, ..., 107.54233 , 107.57679 ], [ 99.671555, 99.69138 , ..., 107.602806, 107.63726 ]]], dtype=float32)
- solar_azimuth_angle(band, y, x)float3254.418926 54.30675 ... -97.91921
- comment :
- Solar azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = 180, West = 270)
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- solar azimuth angle
- NETCDF_DIM_time :
- 1
- standard_name :
- solar_azimuth_angle
- units :
- degree
- valid_max :
- 180
- valid_min :
- -180
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[ 54.418926, 54.30675 , ..., 12.696914, 12.52919 ], [ 54.462734, 54.35049 , ..., 12.684926, 12.516912], ..., [ 33.408936, 32.67658 , ..., -97.71841 , -97.7543 ], [ 34.00804 , 33.27868 , ..., -97.884 , -97.91921 ]]], dtype=float32)
- viewing_zenith_angle(band, y, x)float3266.529594 66.31491 ... 66.36827
- comment :
- Zenith angle of the satellite at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- viewing zenith angle
- NETCDF_DIM_time :
- 1
- standard_name :
- viewing_zenith_angle
- units :
- degree
- valid_max :
- 180
- valid_min :
- 0
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[66.529594, 66.31491 , ..., 65.804245, 66.015175], [66.5298 , 66.31512 , ..., 65.80443 , 66.01536 ], ..., [66.87674 , 66.65851 , ..., 66.15328 , 66.36778 ], [66.87627 , 66.65804 , ..., 66.15376 , 66.36827 ]]], dtype=float32)
- viewing_azimuth_angle(band, y, x)float32-60.276833 ... -166.71306
- comment :
- Satellite azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = 180, West = 270)
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- viewing azimuth angle
- NETCDF_DIM_time :
- 1
- standard_name :
- viewing_azimuth_angle
- units :
- degree
- valid_max :
- 180
- valid_min :
- -180
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[ -60.276833, -60.361042, ..., 94.35131 , 94.22261 ], [ -60.22006 , -60.304413, ..., 94.32718 , 94.198105], ..., [ 138.82686 , 138.09726 , ..., -166.50058 , -166.54396 ], [ 139.448 , 138.72131 , ..., -166.67027 , -166.71306 ]]], dtype=float32)
- longitude(time, y, x)float32119.45596 119.32921 ... 1.9235005
- bounds :
- /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/longitude_bounds
- long_name :
- pixel center longitude
- standard_name :
- longitude
- units :
- degrees_east
- valid_max :
- 180
- valid_min :
- -180
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[ 119.45596 , 119.32921 , ..., 76.114655, 75.9475 ], [ 119.51897 , 119.39211 , ..., 76.110756, 75.94327 ], ..., [-135.85966 , -135.1101 , ..., 1.682641, 1.747748], [-136.46013 , -135.71352 , ..., 1.859037, 1.923501]]], dtype=float32)
- geolocation_flags(band, y, x)uint812 12 12 12 12 12 ... 8 8 8 8 8 8
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- flag_masks :
- [ 0. 1. 2. 4. 8. 16. 128.]
- flag_meanings :
- no_error solar_eclipse sun_glint_possible descending night geo_boundary_crossing geolocation_error
- flag_values :
- [ 0. 1. 2. 4. 8. 16. 128.]
- long_name :
- ground pixel quality flag
- max_val :
- 254
- min_val :
- 0
- NETCDF_DIM_time :
- 1
- units :
- 1
- _FillValue :
- 255.0
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[12, 12, ..., 12, 12], [12, 12, ..., 12, 12], ..., [ 8, 8, ..., 8, 8], [ 8, 8, ..., 8, 8]]], dtype=uint8)
- processing_quality_flags(band, y, x)uint327 7 7 7 7 7 7 7 ... 7 7 7 7 7 7 7 7
- comment :
- Flags indicating conditions that affect quality of the retrieval.
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- flag_masks :
- [2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5600000e+02 5.1200000e+02 1.0240000e+03 2.0480000e+03 4.0960000e+03 8.1920000e+03 1.6384000e+04 3.2768000e+04 6.5536000e+04 1.3107200e+05 2.6214400e+05 5.2428800e+05 1.0485760e+06 2.0971520e+06 4.1943040e+06 8.3886080e+06 1.6777216e+07 3.3554432e+07 6.7108864e+07]
- flag_meanings :
- success radiance_missing irradiance_missing input_spectrum_missing reflectance_range_error ler_range_error snr_range_error sza_range_error vza_range_error lut_range_error ozone_range_error wavelength_offset_error initialization_error memory_error assertion_error io_error numerical_error lut_error ISRF_error convergence_error cloud_filter_convergence_error max_iteration_convergence_error aot_lower_boundary_convergence_error other_boundary_convergence_error geolocation_error ch4_noscat_zero_error h2o_noscat_zero_error max_optical_thickness_error aerosol_boundary_error boundary_hit_error chi2_error svd_error dfs_error radiative_transfer_error optimal_estimation_error profile_error cloud_error model_error number_of_input_data_points_too_low_error cloud_pressure_spread_too_low_error cloud_too_low_level_error generic_range_error generic_exception input_spectrum_alignment_error abort_error wrong_input_type_error wavelength_calibration_error coregistration_error slant_column_density_error airmass_factor_error vertical_column_density_error signal_to_noise_ratio_error configuration_error key_error saturation_error solar_eclipse_filter cloud_filter altitude_consistency_filter altitude_roughness_filter sun_glint_filter mixed_surface_type_filter snow_ice_filter aai_filter cloud_fraction_fresco_filter aai_scene_albedo_filter small_pixel_radiance_std_filter cloud_fraction_viirs_filter cirrus_reflectance_viirs_filter cf_viirs_swir_ifov_filter cf_viirs_swir_ofova_filter cf_viirs_swir_ofovb_filter cf_viirs_swir_ofovc_filter cf_viirs_nir_ifov_filter cf_viirs_nir_ofova_filter cf_viirs_nir_ofovb_filter cf_viirs_nir_ofovc_filter refl_cirrus_viirs_swir_filter refl_cirrus_viirs_nir_filter diff_refl_cirrus_viirs_filter ch4_noscat_ratio_filter ch4_noscat_ratio_std_filter h2o_noscat_ratio_filter h2o_noscat_ratio_std_filter diff_psurf_fresco_ecmwf_filter psurf_fresco_stdv_filter ocean_filter time_range_filter pixel_or_scanline_index_filter geographic_region_filter input_spectrum_warning wavelength_calibration_warning extrapolation_warning sun_glint_warning south_atlantic_anomaly_warning sun_glint_correction snow_ice_warning cloud_warning AAI_warning pixel_level_input_data_missing data_range_warning low_cloud_fraction_warning altitude_consistency_warning signal_to_noise_ratio_warning deconvolution_warning so2_volcanic_origin_likely_warning so2_volcanic_origin_certain_warning interpolation_warning saturation_warning
- flag_values :
- [0.0000000e+00 1.0000000e+00 2.0000000e+00 3.0000000e+00 4.0000000e+00 5.0000000e+00 6.0000000e+00 7.0000000e+00 8.0000000e+00 9.0000000e+00 1.0000000e+01 1.1000000e+01 1.2000000e+01 1.3000000e+01 1.4000000e+01 1.5000000e+01 1.6000000e+01 1.7000000e+01 1.8000000e+01 1.9000000e+01 2.0000000e+01 2.1000000e+01 2.2000000e+01 2.3000000e+01 2.4000000e+01 2.5000000e+01 2.6000000e+01 2.7000000e+01 2.8000000e+01 2.9000000e+01 3.0000000e+01 3.1000000e+01 3.2000000e+01 3.3000000e+01 3.4000000e+01 3.5000000e+01 3.6000000e+01 3.7000000e+01 3.8000000e+01 3.9000000e+01 4.0000000e+01 4.1000000e+01 4.2000000e+01 4.3000000e+01 4.4000000e+01 4.5000000e+01 4.6000000e+01 4.7000000e+01 4.8000000e+01 4.9000000e+01 5.0000000e+01 5.1000000e+01 5.2000000e+01 5.3000000e+01 5.4000000e+01 6.4000000e+01 6.5000000e+01 6.6000000e+01 6.7000000e+01 6.8000000e+01 6.9000000e+01 7.0000000e+01 7.1000000e+01 7.2000000e+01 7.3000000e+01 7.4000000e+01 7.5000000e+01 7.6000000e+01 7.7000000e+01 7.8000000e+01 7.9000000e+01 8.0000000e+01 8.1000000e+01 8.2000000e+01 8.3000000e+01 8.4000000e+01 8.5000000e+01 8.6000000e+01 8.7000000e+01 8.8000000e+01 8.9000000e+01 9.0000000e+01 9.1000000e+01 9.2000000e+01 9.3000000e+01 9.4000000e+01 9.5000000e+01 9.6000000e+01 9.7000000e+01 2.5600000e+02 5.1200000e+02 1.0240000e+03 2.0480000e+03 4.0960000e+03 8.1920000e+03 1.6384000e+04 3.2768000e+04 6.5536000e+04 1.3107200e+05 2.6214400e+05 5.2428800e+05 1.0485760e+06 2.0971520e+06 4.1943040e+06 8.3886080e+06 1.6777216e+07 3.3554432e+07 6.7108864e+07]
- long_name :
- Processing quality flags
- NETCDF_DIM_time :
- 1
- _FillValue :
- 4294967295.0
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[7, 7, ..., 7, 7], [7, 7, ..., 7, 7], ..., [7, 7, ..., 7, 7], [7, 7, ..., 7, 7]]], dtype=uint32)
- number_of_spectral_points_in_retrieval(band, y, x)uint1665535 65535 65535 ... 65535 65535
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Number of spectral points used in the retrieval
- NETCDF_DIM_time :
- 1
- _FillValue :
- 65535.0
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[65535, 65535, ..., 65535, 65535], [65535, 65535, ..., 65535, 65535], ..., [65535, 65535, ..., 65535, 65535], [65535, 65535, ..., 65535, 65535]]], dtype=uint16)
- scene_albedo_388(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- scene_albedo_388_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Scene albedo at 388 nm calculated from the top of atmosphere reflectance. For a cloud- and aerosol-free scene this is equivalent to the surface albedo
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 388
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- scene_albedo_388_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the scene albedo at 388 nm calculated from the top of atmosphere reflectance and its precision. For a cloud- and aerosol-free scene this is equivalent to the surface albedo
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 388
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_354(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- reflectance_measured_354_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Top of atmosphere reflectance at 354 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 354
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_354_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the top of atmosphere reflectance at 354 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 354
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_388(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- reflectance_measured_388_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Top of atmosphere reflectance at 388 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 388
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_388_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the top of atmosphere reflectance at 388 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 388
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_calculated_354(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- reflectance_calculated_354_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Calculated top of atmosphere reflectance at 354 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 354
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_calculated_354_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the calculated top of atmosphere reflectance at 354 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 354
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- scene_albedo_380(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- scene_albedo_380_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Scene albedo at 380 nm calculated from the top of atmosphere reflectance. For a cloud- and aerosol-free scene this is equivalent to the surface albedo
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 380
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- scene_albedo_380_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the scene albedo at 380 nm calculated from the top of atmosphere reflectance and its precision. For a cloud- and aerosol-free scene this is equivalent to the surface albedo
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 380
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_340(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- reflectance_measured_340_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Top of atmosphere reflectance at 340 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 340
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_340_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the top of atmosphere reflectance at 340 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 340
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_380(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- reflectance_measured_380_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Top of atmosphere reflectance at 380 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 380
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_380_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the top of atmosphere reflectance at 380 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 380
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_calculated_340(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- reflectance_calculated_340_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Calculated top of atmosphere reflectance at 340 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 340
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_calculated_340_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the calculated top of atmosphere reflectance at 340 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 340
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- wavelength_calibration_offset(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- wavelength_calibration_offset_precision
- comment :
- True wavelength = nominal wavelength + wavelength offset + wavelength stretch * scaled wavelength
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength offset
- NETCDF_DIM_time :
- 1
- units :
- nm
- wavelength_fit_window_end :
- 390
- wavelength_fit_window_start :
- 338
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- wavelength_calibration_offset_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength offset precision
- NETCDF_DIM_time :
- 1
- units :
- nm
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- wavelength_calibration_stretch(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- wavelength_calibration_stretch_precision
- comment :
- True wavelength = nominal wavelength + wavelength offset + wavelength stretch * scaled wavelength
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength stretch
- NETCDF_DIM_time :
- 1
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- wavelength_calibration_stretch_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength stretch precision
- NETCDF_DIM_time :
- 1
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- wavelength_calibration_chi_square(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength calibration chi square
- NETCDF_DIM_time :
- 1
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- surface_altitude(band, y, x)float329.96921e+36 ... 9.96921e+36
- comment :
- The mean of the sub-pixels of the surface altitudewithin the approximate field of view, based on the GMTED2010 surface elevation database
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Surface altitude
- NETCDF_DIM_time :
- 1
- source :
- http://topotools.cr.usgs.gov/gmted_viewer/
- standard_name :
- surface_altitude
- units :
- m
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- surface_altitude_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- comment :
- The standard deviation of sub-pixels used in calculating the mean surface altitude, based on the GMTED2010 surface elevation database
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- surface altitude precision
- NETCDF_DIM_time :
- 1
- source :
- http://topotools.cr.usgs.gov/gmted_viewer/
- standard_error_multiplier :
- 1
- standard_name :
- surface_altitude standard_error
- units :
- m
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- surface_classification(band, y, x)uint8255 255 255 255 ... 255 255 255 255
- comment :
- Flag indicating land/water and further surface classifications for the ground pixel
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- flag_masks :
- [ 3. 3. 3. 3. 4. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249.]
- flag_meanings :
- land water some_water coast value_covers_majority_of_pixel water+shallow_ocean water+shallow_inland_water water+ocean_coastline-lake_shoreline water+intermittent_water water+deep_inland_water water+continental_shelf_ocean water+deep_ocean land+urban_and_built-up_land land+dryland_cropland_and_pasture land+irrigated_cropland_and_pasture land+mixed_dryland-irrigated_cropland_and_pasture land+cropland-grassland_mosaic land+cropland-woodland_mosaic land+grassland land+shrubland land+mixed_shrubland-grassland land+savanna land+deciduous_broadleaf_forest land+deciduous_needleleaf_forest land+evergreen_broadleaf_forest land+evergreen_needleleaf_forest land+mixed_forest land+herbaceous_wetland land+wooded_wetland land+barren_or_sparsely_vegetated land+herbaceous_tundra land+wooded_tundra land+mixed_tundra land+bare_ground_tundra land+snow_or_ice
- flag_values :
- [ 0. 1. 2. 3. 4. 9. 17. 25. 33. 41. 49. 57. 8. 16. 24. 32. 40. 48. 56. 64. 72. 80. 88. 96. 104. 112. 120. 128. 136. 144. 152. 160. 168. 176. 184.]
- long_name :
- Land-water mask and surface classification based on a static database
- NETCDF_DIM_time :
- 1
- source :
- USGS (https://lta.cr.usgs.gov/GLCC) and NASA SDP toolkit (http://newsroom.gsfc.nasa.gov/sdptoolkit/toolkit.html)
- _FillValue :
- 255.0
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[255, 255, ..., 255, 255], [255, 255, ..., 255, 255], ..., [255, 255, ..., 255, 255], [255, 255, ..., 255, 255]]], dtype=uint8)
- qa_value(time, y, x)uint80 0 0 0 0 0 0 0 ... 0 0 0 0 0 0 0 0
- add_offset :
- 0.0
- comment :
- A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value < 0.5
- coordinates :
- longitude latitude
- long_name :
- data quality value
- scale_factor :
- 0.009999999776482582
- units :
- 1
- valid_max :
- 100
- valid_min :
- 0
- _FillValue :
- 255.0
- grid_mapping :
- spatial_ref
array([[[0, 0, ..., 0, 0], [0, 0, ..., 0, 0], ..., [0, 0, ..., 0, 0], [0, 0, ..., 0, 0]]], dtype=uint8)
- scaled_small_pixel_variance(band, y, x)float329.96921e+36 ... 9.96921e+36
- comment :
- The scaled variance of the reflectances of the small pixels
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- scaled small pixel variance
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 373
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- ozone_total_column(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- total column amount of ozone from ECMWF model data
- multiplication_factor_to_convert_to_DU :
- 2241.1499
- multiplication_factor_to_convert_to_molecules_percm2 :
- 6.0221409e+19
- NETCDF_DIM_time :
- 1
- source :
- standard_name :
- atmosphere_mole_content_of_ozone
- units :
- mol m-2
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- surface_pressure(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- surface_air_pressure
- NETCDF_DIM_time :
- 1
- source :
- standard_name :
- surface_air_pressure
- units :
- Pa
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- aerosol_index_354_388(time, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- aerosol_index_354_388_precision
- comment :
- Aerosol index from 388 and 354 nm
- coordinates :
- longitude latitude
- long_name :
- Aerosol index from 388 and 354 nm
- proposed_standard_name :
- ultraviolet_aerosol_index
- radiation_wavelength :
- [354. 388.]
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- aerosol_index_340_380(time, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- aerosol_index_340_380_precision
- comment :
- Aerosol index from 380 and 340 nm
- coordinates :
- longitude latitude
- long_name :
- Aerosol index from 380 and 340 nm
- proposed_standard_name :
- ultraviolet_aerosol_index
- radiation_wavelength :
- [340. 380.]
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- aerosol_index_354_388_precision(time, y, x)float329.96921e+36 ... 9.96921e+36
- comment :
- Precision of aerosol index from 388 and 354 nm
- coordinates :
- longitude latitude
- long_name :
- Precision of aerosol index from 388 and 354 nm
- proposed_standard_name :
- ultraviolet_aerosol_index standard_error
- radiation_wavelength :
- [354. 388.]
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- aerosol_index_340_380_precision(time, y, x)float329.96921e+36 ... 9.96921e+36
- comment :
- Precision of aerosol index from 380 and 340 nm
- coordinates :
- longitude latitude
- long_name :
- Precision of aerosol index from 380 and 340 nm
- proposed_standard_name :
- ultraviolet_aerosol_index standard_error
- radiation_wavelength :
- [340. 380.]
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36]]], dtype=float32)
- algo.algorithm_variant :
- 1
- algo.n_pair :
- 2
- algo.pair_1.delta_wavelength :
- 2.0
- algo.pair_1.id :
- TOMS_pair
- algo.pair_1.min_wavelength :
- 1
- algo.pair_1.number_spectral_pixels :
- 7
- algo.pair_1.wavelength_1 :
- 340
- algo.pair_1.wavelength_2 :
- 380
- algo.pair_2.delta_wavelength :
- 2.0
- algo.pair_2.id :
- OMI_pair
- algo.pair_2.min_wavelength :
- 1
- algo.pair_2.number_spectral_pixels :
- 7
- algo.pair_2.wavelength_1 :
- 354
- algo.pair_2.wavelength_2 :
- 388
- configuration.version.algorithm :
- 1.1.0
- configuration.version.framework :
- 1.1.0
- input.1.band :
- 3
- input.1.irrType :
- L1B_IR_UVN
- input.1.type :
- L1B_RA_BD3
- input.count :
- 1
- output.1.band :
- 3
- output.1.config :
- cfg/product/product.AER_AI.xml
- output.1.type :
- L2__AER_AI
- output.compressionLevel :
- 3
- output.count :
- 1
- output.histogram.aerosol_index_340_380.end :
- 14
- output.histogram.aerosol_index_340_380.start :
- -6
- output.histogram.aerosol_index_354_388.end :
- 14
- output.histogram.aerosol_index_354_388.start :
- -6
- output.useCompression :
- true
- output.useFletcher32 :
- true
- output.useShuffleFilter :
- true
- processing.algorithm :
- AER_AI
- processing.correct_surface_pressure_for_altitude :
- true
- processing.exclude_flags :
- 4294967295
- processing.groupDem :
- DEM_RADIUS_05000
- processing.ignore_pixel_flags :
- False
- processing.radiancePixelsMinError :
- 2
- processing.radiancePixelsMinWarning :
- 7
- processing.signal_to_noise.test :
- yes
- processing.signal_to_noise.threshold :
- 12
- processing.signal_to_noise.window.range :
- 350.0, 355.0
- processing.szaMax :
- 88.0
- processing.szaMin :
- 0.0
- processing.vzaMax :
- 78.0
- processing.vzaMin :
- 0.0
- qa_value.AAI_warning :
- 100.0
- qa_value.altitude_consistency_warning :
- 100.0
- qa_value.cloud_warning :
- 100.0
- qa_value.data_range_warning :
- 100.0
- qa_value.deconvolution_warning :
- 100.0
- qa_value.extrapolation_warning :
- 100.0
- qa_value.input_spectrum_warning :
- 70.0
- qa_value.interpolation_warning :
- 100.0
- qa_value.low_cloud_fraction_warning :
- 100.0
- qa_value.pixel_level_input_data_missing :
- 80.0
- qa_value.signal_to_noise_ratio_warning :
- 100.0
- qa_value.snow_ice_warning :
- 100.0
- qa_value.so2_volcanic_origin_certain_warning :
- 100.0
- qa_value.so2_volcanic_origin_likely_warning :
- 100.0
- qa_value.south_atlantic_anomaly_warning :
- 100.0
- qa_value.sun_glint_correction :
- 100.0
- qa_value.sun_glint_warning :
- 70.0
- qa_value.wavelength_calibration_warning :
- 90.0
- wavelength_calibration.convergence_threshold :
- 1.0
- wavelength_calibration.include_stretch :
- no
- wavelength_calibration.initial_guess.a0 :
- 1.0
- wavelength_calibration.initial_guess.a1 :
- 0.1
- wavelength_calibration.initial_guess.a2 :
- 0.01
- wavelength_calibration.initial_guess.ring :
- 0.06
- wavelength_calibration.initial_guess.shift :
- 0.0
- wavelength_calibration.initial_guess.stretch :
- 0.0
- wavelength_calibration.irr.include_ring :
- no
- wavelength_calibration.irr.max_iterations :
- 20
- wavelength_calibration.irr.polynomial_order :
- 2
- wavelength_calibration.max_iterations :
- 12
- wavelength_calibration.perform_wavelength_fit :
- yes
- wavelength_calibration.rad.include_ring :
- yes
- wavelength_calibration.rad.polynomial_order :
- 3
- wavelength_calibration.sigma.a0 :
- 1.0
- wavelength_calibration.sigma.a1 :
- 0.1
- wavelength_calibration.sigma.ring :
- 0.06
- wavelength_calibration.sigma.shift :
- 0.07
- wavelength_calibration.sigma.stretch :
- 0.07
- wavelength_calibration.window :
- 338.0, 390.0
- /METADATA/EOP_METADATA/eop :
- metaDataProperty/NC_GLOBAL#objectType=eop:EarthObservationMetaData
- gml :
- id=S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822.ID
- objectType :
- gmi:MI_Metadata
- /METADATA/EOP_METADATA/om :
- procedure/NC_GLOBAL#objectType=eop:EarthObservationEquipment
- File_Class :
- OFFL
- File_Description :
- Aerosol index with a spatial resolution of 7x3.5km2 observed at about 13:30 local solar time from spectra measured by TROPOMI
- File_Name :
- S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822
- File_Type :
- L2__AER_AI
- File_Version :
- 1
- Mission :
- S5P
- Notes :
- Creation_Date :
- UTC=2018-08-22T19:32:01
- Creator :
- TROPNLL2DP
- Creator_Version :
- 1.1.0
- System :
- PDGS-OP
- Validity_Start :
- UTC=2018-08-16T18:51:51
- Validity_Stop :
- UTC=2018-08-16T19:50:14
- /METADATA/ESA_METADATA/earth_explorer_header/variable_header/gmd :
- lineage/NC_GLOBAL#objectType=gmd:LI_Lineage
- GranuleEnd :
- 2018-08-16T19:50:14Z
- GranuleStart :
- 2018-08-16T18:51:51Z
- InstrumentName :
- TROPOMI
- LongitudeOfDaysideNadirEquatorCrossing :
- -86.442253
- MissionName :
- Sentinel-5 precursor
- MissionShortName :
- S5P
- ProcessingCenter :
- PDGS-OP
- ProcessingMode :
- Offline
- ProcessingNode :
- s5p-off-pn37
- ProcessLevel :
- 2
- ProcessorVersion :
- 1.1.0
- ProductFormatVersion :
- 10000
- ProductShortName :
- L2__AER_AI
- /METADATA/ISO_METADATA/gmd :
- language/NC_GLOBAL#objectType=gmd:LanguageCode
- /METADATA/ISO_METADATA/gmi :
- acquisitionInformation/NC_GLOBAL#objectType=gmi:MI_AcquisitionInformation
- gmd :
- metadataStandardVersion=ISO 19115-2:2009(E), S5P profile
- global_processing_warnings :
- --- TEST FLAG SET IN JOB ORDER ---
- number_of_aai_filter_occurrences :
- 0
- number_of_aai_scene_albedo_filter_occurrences :
- 0
- number_of_AAI_warning_occurrences :
- 0
- number_of_abort_error_occurrences :
- 0
- number_of_aerosol_boundary_error_occurrences :
- 0
- number_of_airmass_factor_error_occurrences :
- 0
- number_of_altitude_consistency_filter_occurrences :
- 0
- number_of_altitude_consistency_warning_occurrences :
- 0
- number_of_altitude_roughness_filter_occurrences :
- 0
- number_of_aot_lower_boundary_convergence_error_occurrences :
- 0
- number_of_assertion_error_occurrences :
- 31
- number_of_boundary_hit_error_occurrences :
- 0
- number_of_cf_viirs_nir_ifov_filter_occurrences :
- 0
- number_of_cf_viirs_nir_ofova_filter_occurrences :
- 0
- number_of_cf_viirs_nir_ofovb_filter_occurrences :
- 0
- number_of_cf_viirs_nir_ofovc_filter_occurrences :
- 0
- number_of_cf_viirs_swir_ifov_filter_occurrences :
- 0
- number_of_cf_viirs_swir_ofova_filter_occurrences :
- 0
- number_of_cf_viirs_swir_ofovb_filter_occurrences :
- 0
- number_of_cf_viirs_swir_ofovc_filter_occurrences :
- 0
- number_of_ch4_noscat_ratio_filter_occurrences :
- 0
- number_of_ch4_noscat_ratio_std_filter_occurrences :
- 0
- number_of_ch4_noscat_zero_error_occurrences :
- 0
- number_of_chi2_error_occurrences :
- 0
- number_of_cirrus_reflectance_viirs_filter_occurrences :
- 0
- number_of_cloud_error_occurrences :
- 0
- number_of_cloud_filter_convergence_error_occurrences :
- 0
- number_of_cloud_filter_occurrences :
- 0
- number_of_cloud_fraction_fresco_filter_occurrences :
- 0
- number_of_cloud_fraction_viirs_filter_occurrences :
- 0
- number_of_cloud_pressure_spread_too_low_error_occurrences :
- 0
- number_of_cloud_too_low_level_error_occurrences :
- 0
- number_of_cloud_warning_occurrences :
- 0
- number_of_configuration_error_occurrences :
- 0
- number_of_convergence_error_occurrences :
- 0
- number_of_coregistration_error_occurrences :
- 0
- number_of_data_range_warning_occurrences :
- 0
- number_of_deconvolution_warning_occurrences :
- 0
- number_of_dfs_error_occurrences :
- 0
- number_of_diff_psurf_fresco_ecmwf_filter_occurrences :
- 0
- number_of_diff_refl_cirrus_viirs_filter_occurrences :
- 0
- number_of_extrapolation_warning_occurrences :
- 0
- number_of_failed_retrievals :
- 222068
- number_of_generic_exception_occurrences :
- 0
- number_of_generic_range_error_occurrences :
- 0
- number_of_geographic_region_filter_occurrences :
- 0
- number_of_geolocation_error_occurrences :
- 0
- number_of_groundpixels :
- 1460250
- number_of_ground_pixels_with_warnings :
- 84516
- number_of_h2o_noscat_ratio_filter_occurrences :
- 0
- number_of_h2o_noscat_ratio_std_filter_occurrences :
- 0
- number_of_h2o_noscat_zero_error_occurrences :
- 0
- number_of_initialization_error_occurrences :
- 0
- number_of_input_spectrum_alignment_error_occurrences :
- 0
- number_of_input_spectrum_missing_occurrences :
- 0
- number_of_input_spectrum_warning_occurrences :
- 0
- number_of_interpolation_warning_occurrences :
- 0
- number_of_io_error_occurrences :
- 0
- number_of_irradiance_missing_occurrences :
- 0
- number_of_ISRF_error_occurrences :
- 0
- number_of_key_error_occurrences :
- 0
- number_of_ler_range_error_occurrences :
- 0
- number_of_low_cloud_fraction_warning_occurrences :
- 0
- number_of_lut_error_occurrences :
- 0
- number_of_lut_range_error_occurrences :
- 0
- number_of_max_iteration_convergence_error_occurrences :
- 0
- number_of_max_optical_thickness_error_occurrences :
- 0
- number_of_memory_error_occurrences :
- 0
- number_of_mixed_surface_type_filter_occurrences :
- 0
- number_of_model_error_occurrences :
- 0
- number_of_number_of_input_data_points_too_low_error_occurrences :
- 0
- number_of_numerical_error_occurrences :
- 0
- number_of_ocean_filter_occurrences :
- 0
- number_of_optimal_estimation_error_occurrences :
- 0
- number_of_other_boundary_convergence_error_occurrences :
- 0
- number_of_ozone_range_error_occurrences :
- 0
- number_of_pixel_level_input_data_missing_occurrences :
- 0
- number_of_pixel_or_scanline_index_filter_occurrences :
- 0
- number_of_processed_pixels :
- 1460250
- number_of_profile_error_occurrences :
- 0
- number_of_psurf_fresco_stdv_filter_occurrences :
- 0
- number_of_radiance_missing_occurrences :
- 0
- number_of_radiative_transfer_error_occurrences :
- 0
- number_of_reflectance_range_error_occurrences :
- 0
- number_of_refl_cirrus_viirs_nir_filter_occurrences :
- 0
- number_of_refl_cirrus_viirs_swir_filter_occurrences :
- 0
- number_of_rejected_pixels_not_enough_spectrum :
- 0
- number_of_saturation_error_occurrences :
- 0
- number_of_saturation_warning_occurrences :
- 0
- number_of_signal_to_noise_ratio_error_occurrences :
- 0
- number_of_signal_to_noise_ratio_warning_occurrences :
- 0
- number_of_slant_column_density_error_occurrences :
- 0
- number_of_small_pixel_radiance_std_filter_occurrences :
- 0
- number_of_snow_ice_filter_occurrences :
- 0
- number_of_snow_ice_warning_occurrences :
- 0
- number_of_snr_range_error_occurrences :
- 0
- number_of_so2_volcanic_origin_certain_warning_occurrences :
- 0
- number_of_so2_volcanic_origin_likely_warning_occurrences :
- 0
- number_of_solar_eclipse_filter_occurrences :
- 0
- number_of_south_atlantic_anomaly_warning_occurrences :
- 0
- number_of_successfully_processed_pixels :
- 1238182
- number_of_sun_glint_correction_occurrences :
- 0
- number_of_sun_glint_filter_occurrences :
- 0
- number_of_sun_glint_warning_occurrences :
- 84516
- number_of_svd_error_occurrences :
- 0
- number_of_sza_range_error_occurrences :
- 222037
- number_of_time_range_filter_occurrences :
- 0
- number_of_vertical_column_density_error_occurrences :
- 0
- number_of_vza_range_error_occurrences :
- 0
- number_of_wavelength_calibration_error_occurrences :
- 0
- number_of_wavelength_calibration_warning_occurrences :
- 0
- number_of_wavelength_offset_error_occurrences :
- 0
- number_of_wrong_input_type_error_occurrences :
- 0
- time_for_algorithm_initialization :
- 23.927286
- time_for_processing :
- 212.96926
- time_per_pixel :
- 0.001535914273508207
- time_standard_deviation_per_pixel :
- 2.56573665351871e-05
- algorithm_version :
- 1.1.0
- build_date :
- 2018-07-04T06:04:00Z
- cdm_data_type :
- Swath
- Conventions :
- CF-1.7
- cpp_compiler_flags :
- -g -O2 -fPIC -std=c++11 -W -Wall -Wno-ignored-qualifiers -Wno-write-strings -Wno-unused-variable -DTROPNLL2DP
- cpp_compiler_version :
- g++ (GCC) 4.8.5 20150623 (Red Hat 4.8.5-11)
- creator_email :
- EOSupport@Copernicus.esa.int
- creator_name :
- The Sentinel 5 Precursor TROPOMI Level 2 products are developed with funding from the European Space Agency (ESA), the Netherlands Space Office (NSO), the Belgian Science Policy Office, the German Aerospace Center (DLR) and the Bayerisches Staatsministerium für Wirtschaft und Medien, Energie und Technologie (StMWi).
- creator_url :
- http://www.tropomi.eu
- date_created :
- 2018-08-22T19:32:01Z
- f90_compiler_flags :
- -gdwarf-3 -O2 -fPIC -cpp -ffpe-trap=invalid -fno-range-check -frecursive -fimplicit-none -ffree-line-length-none -DTROPNLL2DP -Wuninitialized -Wtabs
- f90_compiler_version :
- GNU Fortran (GCC) 4.8.5 20150623 (Red Hat 4.8.5-11)
- geolocation_grid_from_band :
- 3
- geospatial_lat_max :
- 89.972939
- geospatial_lat_min :
- -86.81926
- geospatial_lon_max :
- -179.99773
- geospatial_lon_min :
- 179.99924
- history :
- 2018-08-22 19:35:59 f_s5pops tropnll2dp /mnt/data1/storage_offl_l2/cache_offl_l2/WORKING-564386761/JobOrder.564386738.xml
- id :
- S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822
- identifier_product_doi :
- 10.5270/S5P-0wafvaf
- identifier_product_doi_authority :
- http://dx.doi.org/
- institution :
- KNMI
- keywords :
- 0300 Atmospheric Composition and Structure; 0305 Aerosols and Particles; 0360 Radiation, Transmission and Scattering; 3311 Clouds and Aerosols; 3360 Remote Sensing
- keywords_vocabulary :
- AGU index terms, http://publications.agu.org/author-resource-center/index-terms/
- license :
- No conditions apply
- naming_authority :
- nl.knmi
- orbit :
- 4361
- platform :
- S5P
- processing_status :
- Nominal
- processor_version :
- 1.1.0
- product_version :
- 1.0.0
- project :
- Sentinel 5 precursor/TROPOMI
- references :
- http://www.tropomi.eu/data-products/aerosol-index
- revision_control_identifier :
- df649da886db
- sensor :
- TROPOMI
- source :
- Sentinel 5 precursor, TROPOMI, space-borne remote sensing, L2
- spatial_resolution :
- 7x3.5km2
- standard_name_vocabulary :
- NetCDF Climate and Forecast Metadata Conventions Standard Name Table (v29, 08 July 2015), http://cfconventions.org/standard-names.html
- Status_MET_2D :
- Nominal
- summary :
- TROPOMI/S5P Aerosol Index 1-Orbit L2 Swath 7x3.5km
- time_coverage_duration :
- PT3503.000S
- time_coverage_end :
- 2018-08-16T19:50:14Z
- time_coverage_resolution :
- PT1.080S
- time_coverage_start :
- 2018-08-16T18:51:51Z
- time_reference :
- 2018-08-16T00:00:00Z
- time_reference_days_since_1950 :
- 25064
- time_reference_julian_day :
- 2458346.5
- time_reference_seconds_since_1970 :
- 1534377600
- title :
- TROPOMI/S5P Aerosol Index 1-Orbit L2 Swath 7x3.5km
- tracking_id :
- 0b05f3ea-704b-4ab5-8df3-cf6e31764960
rds_crs_set = rds_crs_set.set_coords(['longitude','latitude'])
rds_crs_set
<xarray.Dataset> Dimensions: (band: 1, time: 1, x: 450, y: 3245) Coordinates: * y (y) float64 3.244e+03 ... 0.0 * x (x) float64 0.0 1.0 ... 449.0 * time (time) int64 272073600 spatial_ref int64 0 latitude (time, y, x) float32 53.289627 ... * band (band) int64 1 longitude (time, y, x) float32 119.45596 ... Data variables: solar_zenith_angle (band, y, x) float32 97.89976 .... solar_azimuth_angle (band, y, x) float32 54.418926 ... viewing_zenith_angle (band, y, x) float32 66.529594 ... viewing_azimuth_angle (band, y, x) float32 -60.276833... geolocation_flags (band, y, x) uint8 12 12 ... 8 8 processing_quality_flags (band, y, x) uint32 7 7 7 ... 7 7 number_of_spectral_points_in_retrieval (band, y, x) uint16 65535 ... 6... scene_albedo_388 (band, y, x) float32 9.96921e+3... scene_albedo_388_precision (band, y, x) float32 9.96921e+3... reflectance_measured_354 (band, y, x) float32 9.96921e+3... reflectance_measured_354_precision (band, y, x) float32 9.96921e+3... reflectance_measured_388 (band, y, x) float32 9.96921e+3... reflectance_measured_388_precision (band, y, x) float32 9.96921e+3... reflectance_calculated_354 (band, y, x) float32 9.96921e+3... reflectance_calculated_354_precision (band, y, x) float32 9.96921e+3... scene_albedo_380 (band, y, x) float32 9.96921e+3... scene_albedo_380_precision (band, y, x) float32 9.96921e+3... reflectance_measured_340 (band, y, x) float32 9.96921e+3... reflectance_measured_340_precision (band, y, x) float32 9.96921e+3... reflectance_measured_380 (band, y, x) float32 9.96921e+3... reflectance_measured_380_precision (band, y, x) float32 9.96921e+3... reflectance_calculated_340 (band, y, x) float32 9.96921e+3... reflectance_calculated_340_precision (band, y, x) float32 9.96921e+3... wavelength_calibration_offset (band, y, x) float32 9.96921e+3... wavelength_calibration_offset_precision (band, y, x) float32 9.96921e+3... wavelength_calibration_stretch (band, y, x) float32 9.96921e+3... wavelength_calibration_stretch_precision (band, y, x) float32 9.96921e+3... wavelength_calibration_chi_square (band, y, x) float32 9.96921e+3... surface_altitude (band, y, x) float32 9.96921e+3... surface_altitude_precision (band, y, x) float32 9.96921e+3... surface_classification (band, y, x) uint8 255 255 ... 255 qa_value (time, y, x) uint8 0 0 0 ... 0 0 0 scaled_small_pixel_variance (band, y, x) float32 9.96921e+3... ozone_total_column (band, y, x) float32 9.96921e+3... surface_pressure (band, y, x) float32 9.96921e+3... aerosol_index_354_388 (time, y, x) float32 9.96921e+3... aerosol_index_340_380 (time, y, x) float32 9.96921e+3... aerosol_index_354_388_precision (time, y, x) float32 9.96921e+3... aerosol_index_340_380_precision (time, y, x) float32 9.96921e+3... Attributes: algo.algorithm_variant: 1 algo.n_pair: 2 algo.pair_1.delta_wavelength: 2.0 algo.pair_1.id: TOMS_pair algo.pair_1.min_wavelength: 1 algo.pair_1.number_spectral_pixels: 7 algo.pair_1.wavelength_1: 340 algo.pair_1.wavelength_2: 380 algo.pair_2.delta_wavelength: 2.0 algo.pair_2.id: OMI_pair algo.pair_2.min_wavelength: 1 algo.pair_2.number_spectral_pixels: 7 algo.pair_2.wavelength_1: 354 algo.pair_2.wavelength_2: 388 configuration.version.algorithm: 1.1.0 configuration.version.framework: 1.1.0 input.1.band: 3 input.1.irrType: L1B_IR... input.1.type: L1B_RA... input.count: 1 output.1.band: 3 output.1.config: cfg/pr... output.1.type: L2__AE... output.compressionLevel: 3 output.count: 1 output.histogram.aerosol_index_340_380.end: 14 output.histogram.aerosol_index_340_380.start: -6 output.histogram.aerosol_index_354_388.end: 14 output.histogram.aerosol_index_354_388.start: -6 output.useCompression: true output.useFletcher32: true output.useShuffleFilter: true processing.algorithm: AER_AI processing.correct_surface_pressure_for_altitude: true processing.exclude_flags: 429496... processing.groupDem: DEM_RA... processing.ignore_pixel_flags: False processing.radiancePixelsMinError: 2 processing.radiancePixelsMinWarning: 7 processing.signal_to_noise.test: yes processing.signal_to_noise.threshold: 12 processing.signal_to_noise.window.range: 350.0,... processing.szaMax: 88.0 processing.szaMin: 0.0 processing.vzaMax: 78.0 processing.vzaMin: 0.0 qa_value.AAI_warning: 100.0 qa_value.altitude_consistency_warning: 100.0 qa_value.cloud_warning: 100.0 qa_value.data_range_warning: 100.0 qa_value.deconvolution_warning: 100.0 qa_value.extrapolation_warning: 100.0 qa_value.input_spectrum_warning: 70.0 qa_value.interpolation_warning: 100.0 qa_value.low_cloud_fraction_warning: 100.0 qa_value.pixel_level_input_data_missing: 80.0 qa_value.signal_to_noise_ratio_warning: 100.0 qa_value.snow_ice_warning: 100.0 qa_value.so2_volcanic_origin_certain_warning: 100.0 qa_value.so2_volcanic_origin_likely_warning: 100.0 qa_value.south_atlantic_anomaly_warning: 100.0 qa_value.sun_glint_correction: 100.0 qa_value.sun_glint_warning: 70.0 qa_value.wavelength_calibration_warning: 90.0 wavelength_calibration.convergence_threshold: 1.0 wavelength_calibration.include_stretch: no wavelength_calibration.initial_guess.a0: 1.0 wavelength_calibration.initial_guess.a1: 0.1 wavelength_calibration.initial_guess.a2: 0.01 wavelength_calibration.initial_guess.ring: 0.06 wavelength_calibration.initial_guess.shift: 0.0 wavelength_calibration.initial_guess.stretch: 0.0 wavelength_calibration.irr.include_ring: no wavelength_calibration.irr.max_iterations: 20 wavelength_calibration.irr.polynomial_order: 2 wavelength_calibration.max_iterations: 12 wavelength_calibration.perform_wavelength_fit: yes wavelength_calibration.rad.include_ring: yes wavelength_calibration.rad.polynomial_order: 3 wavelength_calibration.sigma.a0: 1.0 wavelength_calibration.sigma.a1: 0.1 wavelength_calibration.sigma.ring: 0.06 wavelength_calibration.sigma.shift: 0.07 wavelength_calibration.sigma.stretch: 0.07 wavelength_calibration.window: 338.0,... /METADATA/EOP_METADATA/eop: metaDa... gml: id=S5P... objectType: gmi:MI... /METADATA/EOP_METADATA/om: proced... File_Class: OFFL File_Description: Aeroso... File_Name: S5P_OF... File_Type: L2__AE... File_Version: 1 Mission: S5P Notes: Creation_Date: UTC=20... Creator: TROPNL... Creator_Version: 1.1.0 System: PDGS-OP Validity_Start: UTC=20... Validity_Stop: UTC=20... /METADATA/ESA_METADATA/earth_explorer_header/variable_header/gmd: lineag... GranuleEnd: 2018-0... GranuleStart: 2018-0... InstrumentName: TROPOMI LongitudeOfDaysideNadirEquatorCrossing: -86.44... MissionName: Sentin... MissionShortName: S5P ProcessingCenter: PDGS-OP ProcessingMode: Offline ProcessingNode: s5p-of... ProcessLevel: 2 ProcessorVersion: 1.1.0 ProductFormatVersion: 10000 ProductShortName: L2__AE... /METADATA/ISO_METADATA/gmd: langua... /METADATA/ISO_METADATA/gmi: acquis... gmd: metada... global_processing_warnings: --- TE... number_of_aai_filter_occurrences: 0 number_of_aai_scene_albedo_filter_occurrences: 0 number_of_AAI_warning_occurrences: 0 number_of_abort_error_occurrences: 0 number_of_aerosol_boundary_error_occurrences: 0 number_of_airmass_factor_error_occurrences: 0 number_of_altitude_consistency_filter_occurrences: 0 number_of_altitude_consistency_warning_occurrences: 0 number_of_altitude_roughness_filter_occurrences: 0 number_of_aot_lower_boundary_convergence_error_occurrences: 0 number_of_assertion_error_occurrences: 31 number_of_boundary_hit_error_occurrences: 0 number_of_cf_viirs_nir_ifov_filter_occurrences: 0 number_of_cf_viirs_nir_ofova_filter_occurrences: 0 number_of_cf_viirs_nir_ofovb_filter_occurrences: 0 number_of_cf_viirs_nir_ofovc_filter_occurrences: 0 number_of_cf_viirs_swir_ifov_filter_occurrences: 0 number_of_cf_viirs_swir_ofova_filter_occurrences: 0 number_of_cf_viirs_swir_ofovb_filter_occurrences: 0 number_of_cf_viirs_swir_ofovc_filter_occurrences: 0 number_of_ch4_noscat_ratio_filter_occurrences: 0 number_of_ch4_noscat_ratio_std_filter_occurrences: 0 number_of_ch4_noscat_zero_error_occurrences: 0 number_of_chi2_error_occurrences: 0 number_of_cirrus_reflectance_viirs_filter_occurrences: 0 number_of_cloud_error_occurrences: 0 number_of_cloud_filter_convergence_error_occurrences: 0 number_of_cloud_filter_occurrences: 0 number_of_cloud_fraction_fresco_filter_occurrences: 0 number_of_cloud_fraction_viirs_filter_occurrences: 0 number_of_cloud_pressure_spread_too_low_error_occurrences: 0 number_of_cloud_too_low_level_error_occurrences: 0 number_of_cloud_warning_occurrences: 0 number_of_configuration_error_occurrences: 0 number_of_convergence_error_occurrences: 0 number_of_coregistration_error_occurrences: 0 number_of_data_range_warning_occurrences: 0 number_of_deconvolution_warning_occurrences: 0 number_of_dfs_error_occurrences: 0 number_of_diff_psurf_fresco_ecmwf_filter_occurrences: 0 number_of_diff_refl_cirrus_viirs_filter_occurrences: 0 number_of_extrapolation_warning_occurrences: 0 number_of_failed_retrievals: 222068 number_of_generic_exception_occurrences: 0 number_of_generic_range_error_occurrences: 0 number_of_geographic_region_filter_occurrences: 0 number_of_geolocation_error_occurrences: 0 number_of_groundpixels: 1460250 number_of_ground_pixels_with_warnings: 84516 number_of_h2o_noscat_ratio_filter_occurrences: 0 number_of_h2o_noscat_ratio_std_filter_occurrences: 0 number_of_h2o_noscat_zero_error_occurrences: 0 number_of_initialization_error_occurrences: 0 number_of_input_spectrum_alignment_error_occurrences: 0 number_of_input_spectrum_missing_occurrences: 0 number_of_input_spectrum_warning_occurrences: 0 number_of_interpolation_warning_occurrences: 0 number_of_io_error_occurrences: 0 number_of_irradiance_missing_occurrences: 0 number_of_ISRF_error_occurrences: 0 number_of_key_error_occurrences: 0 number_of_ler_range_error_occurrences: 0 number_of_low_cloud_fraction_warning_occurrences: 0 number_of_lut_error_occurrences: 0 number_of_lut_range_error_occurrences: 0 number_of_max_iteration_convergence_error_occurrences: 0 number_of_max_optical_thickness_error_occurrences: 0 number_of_memory_error_occurrences: 0 number_of_mixed_surface_type_filter_occurrences: 0 number_of_model_error_occurrences: 0 number_of_number_of_input_data_points_too_low_error_occurrences: 0 number_of_numerical_error_occurrences: 0 number_of_ocean_filter_occurrences: 0 number_of_optimal_estimation_error_occurrences: 0 number_of_other_boundary_convergence_error_occurrences: 0 number_of_ozone_range_error_occurrences: 0 number_of_pixel_level_input_data_missing_occurrences: 0 number_of_pixel_or_scanline_index_filter_occurrences: 0 number_of_processed_pixels: 1460250 number_of_profile_error_occurrences: 0 number_of_psurf_fresco_stdv_filter_occurrences: 0 number_of_radiance_missing_occurrences: 0 number_of_radiative_transfer_error_occurrences: 0 number_of_reflectance_range_error_occurrences: 0 number_of_refl_cirrus_viirs_nir_filter_occurrences: 0 number_of_refl_cirrus_viirs_swir_filter_occurrences: 0 number_of_rejected_pixels_not_enough_spectrum: 0 number_of_saturation_error_occurrences: 0 number_of_saturation_warning_occurrences: 0 number_of_signal_to_noise_ratio_error_occurrences: 0 number_of_signal_to_noise_ratio_warning_occurrences: 0 number_of_slant_column_density_error_occurrences: 0 number_of_small_pixel_radiance_std_filter_occurrences: 0 number_of_snow_ice_filter_occurrences: 0 number_of_snow_ice_warning_occurrences: 0 number_of_snr_range_error_occurrences: 0 number_of_so2_volcanic_origin_certain_warning_occurrences: 0 number_of_so2_volcanic_origin_likely_warning_occurrences: 0 number_of_solar_eclipse_filter_occurrences: 0 number_of_south_atlantic_anomaly_warning_occurrences: 0 number_of_successfully_processed_pixels: 1238182 number_of_sun_glint_correction_occurrences: 0 number_of_sun_glint_filter_occurrences: 0 number_of_sun_glint_warning_occurrences: 84516 number_of_svd_error_occurrences: 0 number_of_sza_range_error_occurrences: 222037 number_of_time_range_filter_occurrences: 0 number_of_vertical_column_density_error_occurrences: 0 number_of_vza_range_error_occurrences: 0 number_of_wavelength_calibration_error_occurrences: 0 number_of_wavelength_calibration_warning_occurrences: 0 number_of_wavelength_offset_error_occurrences: 0 number_of_wrong_input_type_error_occurrences: 0 time_for_algorithm_initialization: 23.927286 time_for_processing: 212.96926 time_per_pixel: 0.0015... time_standard_deviation_per_pixel: 2.5657... algorithm_version: 1.1.0 build_date: 2018-0... cdm_data_type: Swath Conventions: CF-1.7 cpp_compiler_flags: -g -O2... cpp_compiler_version: g++ (G... creator_email: EOSupp... creator_name: The Se... creator_url: http:/... date_created: 2018-0... f90_compiler_flags: -gdwar... f90_compiler_version: GNU Fo... geolocation_grid_from_band: 3 geospatial_lat_max: 89.972939 geospatial_lat_min: -86.81926 geospatial_lon_max: -179.9... geospatial_lon_min: 179.99924 history: 2018-0... id: S5P_OF... identifier_product_doi: 10.527... identifier_product_doi_authority: http:/... institution: KNMI keywords: 0300 A... keywords_vocabulary: AGU in... license: No con... naming_authority: nl.knmi orbit: 4361 platform: S5P processing_status: Nominal processor_version: 1.1.0 product_version: 1.0.0 project: Sentin... references: http:/... revision_control_identifier: df649d... sensor: TROPOMI source: Sentin... spatial_resolution: 7x3.5km2 standard_name_vocabulary: NetCDF... Status_MET_2D: Nominal summary: TROPOM... time_coverage_duration: PT3503... time_coverage_end: 2018-0... time_coverage_resolution: PT1.080S time_coverage_start: 2018-0... time_reference: 2018-0... time_reference_days_since_1950: 25064 time_reference_julian_day: 2458346.5 time_reference_seconds_since_1970: 153437... title: TROPOM... tracking_id: 0b05f3...
- band: 1
- time: 1
- x: 450
- y: 3245
- y(y)float643.244e+03 3.243e+03 ... 1.0 0.0
- axis :
- Y
- long_name :
- latitude
- standard_name :
- latitude
- units :
- degrees_north
array([3.244e+03, 3.243e+03, 3.242e+03, ..., 2.000e+00, 1.000e+00, 0.000e+00])
- x(x)float640.0 1.0 2.0 ... 447.0 448.0 449.0
- axis :
- X
- long_name :
- longitude
- standard_name :
- longitude
- units :
- degrees_east
array([ 0., 1., 2., ..., 447., 448., 449.])
- time(time)int64272073600
array([272073600])
- spatial_ref()int640
- GeoTransform :
- -0.5 1.0 0.0 3244.5 0.0 -1.0
array(0)
- latitude(time, y, x)float3253.289627 53.328514 ... -68.705986
- bounds :
- /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/latitude_bounds
- long_name :
- pixel center latitude
- standard_name :
- latitude
- units :
- degrees_north
- valid_max :
- 90
- valid_min :
- -90
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[ 53.289627, 53.328514, 53.366734, ..., 60.851288, 60.861183, 60.871014], [ 53.34224 , 53.3812 , 53.419495, ..., 60.912846, 60.922707, 60.9325 ], [ 53.39479 , 53.433826, 53.4722 , ..., 60.974384, 60.984215, 60.993973], ..., [-85.21351 , -85.27658 , -85.337944, ..., -68.85199 , -68.77097 , -68.68882 ], [-85.24866 , -85.31239 , -85.37443 , ..., -68.860825, -68.77974 , -68.69752 ], [-85.28333 , -85.34773 , -85.41043 , ..., -68.869446, -68.788284, -68.705986]]], dtype=float32)
- band(band)int641
array([1])
- longitude(time, y, x)float32119.45596 119.32921 ... 1.9235005
- bounds :
- /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/longitude_bounds
- long_name :
- pixel center longitude
- standard_name :
- longitude
- units :
- degrees_east
- valid_max :
- 180
- valid_min :
- -180
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[ 119.45596 , 119.32921 , 119.20397 , ..., 76.279495 , 76.114655 , 75.9475 ], [ 119.51897 , 119.39211 , 119.266785 , ..., 76.27593 , 76.110756 , 75.94327 ], [ 119.5822 , 119.45525 , 119.32983 , ..., 76.27239 , 76.106895 , 75.939064 ], ..., [-135.26692 , -134.51474 , -133.75343 , ..., 1.4409312, 1.5062535, 1.5720007], [-135.85966 , -135.1101 , -134.3511 , ..., 1.6179553, 1.6826414, 1.7477475], [-136.46013 , -135.71352 , -134.95714 , ..., 1.7949897, 1.8590373, 1.9235005]]], dtype=float32)
- solar_zenith_angle(band, y, x)float3297.89976 97.93866 ... 107.63726
- comment :
- Solar zenith angle at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- solar zenith angle
- NETCDF_DIM_time :
- 1
- standard_name :
- solar_zenith_angle
- units :
- degree
- valid_max :
- 180
- valid_min :
- 0
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[ 97.89976 , 97.93866 , 97.977005, ..., 104.89952 , 104.90762 , 104.9158 ], [ 97.84073 , 97.879616, 97.917946, ..., 104.84038 , 104.848495, 104.8567 ], [ 97.78168 , 97.82054 , 97.85886 , ..., 104.78124 , 104.78938 , 104.79759 ], ..., [ 99.558426, 99.57819 , 99.597664, ..., 107.44779 , 107.48182 , 107.51628 ], [ 99.615 , 99.634796, 99.6543 , ..., 107.50831 , 107.54233 , 107.57679 ], [ 99.671555, 99.69138 , 99.710915, ..., 107.56879 , 107.602806, 107.63726 ]]], dtype=float32)
- solar_azimuth_angle(band, y, x)float3254.418926 54.30675 ... -97.91921
- comment :
- Solar azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = 180, West = 270)
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- solar azimuth angle
- NETCDF_DIM_time :
- 1
- standard_name :
- solar_azimuth_angle
- units :
- degree
- valid_max :
- 180
- valid_min :
- -180
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[ 54.418926, 54.30675 , 54.19584 , ..., 12.862301, 12.696914, 12.52919 ], [ 54.462734, 54.35049 , 54.23951 , ..., 12.850599, 12.684926, 12.516912], [ 54.50679 , 54.394478, 54.28343 , ..., 12.83895 , 12.672991, 12.504687], ..., [ 32.81754 , 32.08251 , 31.338154, ..., -97.51621 , -97.552826, -97.58942 ], [ 33.408936, 32.67658 , 31.934553, ..., -97.68247 , -97.71841 , -97.7543 ], [ 34.00804 , 33.27868 , 32.539314, ..., -97.84875 , -97.884 , -97.91921 ]]], dtype=float32)
- viewing_zenith_angle(band, y, x)float3266.529594 66.31491 ... 66.36827
- comment :
- Zenith angle of the satellite at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- viewing zenith angle
- NETCDF_DIM_time :
- 1
- standard_name :
- viewing_zenith_angle
- units :
- degree
- valid_max :
- 180
- valid_min :
- 0
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[66.529594, 66.31491 , 66.10142 , ..., 65.59442 , 65.804245, 66.015175], [66.5298 , 66.31512 , 66.10162 , ..., 65.594604, 65.80443 , 66.01536 ], [66.53011 , 66.31543 , 66.10193 , ..., 65.59467 , 65.8045 , 66.01543 ], ..., [66.87699 , 66.65876 , 66.441795, ..., 65.93957 , 66.152885, 66.367386], [66.87674 , 66.65851 , 66.44155 , ..., 65.939964, 66.15328 , 66.36778 ], [66.87627 , 66.65804 , 66.44108 , ..., 65.94044 , 66.15376 , 66.36827 ]]], dtype=float32)
- viewing_azimuth_angle(band, y, x)float32-60.276833 ... -166.71306
- comment :
- Satellite azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = 180, West = 270)
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- viewing azimuth angle
- NETCDF_DIM_time :
- 1
- standard_name :
- viewing_azimuth_angle
- units :
- degree
- valid_max :
- 180
- valid_min :
- -180
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[ -60.276833, -60.361042, -60.444096, ..., 94.477974, 94.35131 , 94.22261 ], [ -60.22006 , -60.304413, -60.38761 , ..., 94.45422 , 94.32718 , 94.198105], [ -60.163074, -60.247574, -60.33092 , ..., 94.43045 , 94.30303 , 94.17358 ], ..., [ 138.21364 , 137.48146 , 136.74011 , ..., -166.28754 , -166.33116 , -166.37514 ], [ 138.82686 , 138.09726 , 137.35817 , ..., -166.45755 , -166.50058 , -166.54396 ], [ 139.448 , 138.72131 , 137.98479 , ..., -166.62784 , -166.67027 , -166.71306 ]]], dtype=float32)
- geolocation_flags(band, y, x)uint812 12 12 12 12 12 ... 8 8 8 8 8 8
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- flag_masks :
- [ 0. 1. 2. 4. 8. 16. 128.]
- flag_meanings :
- no_error solar_eclipse sun_glint_possible descending night geo_boundary_crossing geolocation_error
- flag_values :
- [ 0. 1. 2. 4. 8. 16. 128.]
- long_name :
- ground pixel quality flag
- max_val :
- 254
- min_val :
- 0
- NETCDF_DIM_time :
- 1
- units :
- 1
- _FillValue :
- 255.0
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[12, 12, 12, ..., 12, 12, 12], [12, 12, 12, ..., 12, 12, 12], [12, 12, 12, ..., 12, 12, 12], ..., [ 8, 8, 8, ..., 8, 8, 8], [ 8, 8, 8, ..., 8, 8, 8], [ 8, 8, 8, ..., 8, 8, 8]]], dtype=uint8)
- processing_quality_flags(band, y, x)uint327 7 7 7 7 7 7 7 ... 7 7 7 7 7 7 7 7
- comment :
- Flags indicating conditions that affect quality of the retrieval.
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- flag_masks :
- [2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5500000e+02 2.5600000e+02 5.1200000e+02 1.0240000e+03 2.0480000e+03 4.0960000e+03 8.1920000e+03 1.6384000e+04 3.2768000e+04 6.5536000e+04 1.3107200e+05 2.6214400e+05 5.2428800e+05 1.0485760e+06 2.0971520e+06 4.1943040e+06 8.3886080e+06 1.6777216e+07 3.3554432e+07 6.7108864e+07]
- flag_meanings :
- success radiance_missing irradiance_missing input_spectrum_missing reflectance_range_error ler_range_error snr_range_error sza_range_error vza_range_error lut_range_error ozone_range_error wavelength_offset_error initialization_error memory_error assertion_error io_error numerical_error lut_error ISRF_error convergence_error cloud_filter_convergence_error max_iteration_convergence_error aot_lower_boundary_convergence_error other_boundary_convergence_error geolocation_error ch4_noscat_zero_error h2o_noscat_zero_error max_optical_thickness_error aerosol_boundary_error boundary_hit_error chi2_error svd_error dfs_error radiative_transfer_error optimal_estimation_error profile_error cloud_error model_error number_of_input_data_points_too_low_error cloud_pressure_spread_too_low_error cloud_too_low_level_error generic_range_error generic_exception input_spectrum_alignment_error abort_error wrong_input_type_error wavelength_calibration_error coregistration_error slant_column_density_error airmass_factor_error vertical_column_density_error signal_to_noise_ratio_error configuration_error key_error saturation_error solar_eclipse_filter cloud_filter altitude_consistency_filter altitude_roughness_filter sun_glint_filter mixed_surface_type_filter snow_ice_filter aai_filter cloud_fraction_fresco_filter aai_scene_albedo_filter small_pixel_radiance_std_filter cloud_fraction_viirs_filter cirrus_reflectance_viirs_filter cf_viirs_swir_ifov_filter cf_viirs_swir_ofova_filter cf_viirs_swir_ofovb_filter cf_viirs_swir_ofovc_filter cf_viirs_nir_ifov_filter cf_viirs_nir_ofova_filter cf_viirs_nir_ofovb_filter cf_viirs_nir_ofovc_filter refl_cirrus_viirs_swir_filter refl_cirrus_viirs_nir_filter diff_refl_cirrus_viirs_filter ch4_noscat_ratio_filter ch4_noscat_ratio_std_filter h2o_noscat_ratio_filter h2o_noscat_ratio_std_filter diff_psurf_fresco_ecmwf_filter psurf_fresco_stdv_filter ocean_filter time_range_filter pixel_or_scanline_index_filter geographic_region_filter input_spectrum_warning wavelength_calibration_warning extrapolation_warning sun_glint_warning south_atlantic_anomaly_warning sun_glint_correction snow_ice_warning cloud_warning AAI_warning pixel_level_input_data_missing data_range_warning low_cloud_fraction_warning altitude_consistency_warning signal_to_noise_ratio_warning deconvolution_warning so2_volcanic_origin_likely_warning so2_volcanic_origin_certain_warning interpolation_warning saturation_warning
- flag_values :
- [0.0000000e+00 1.0000000e+00 2.0000000e+00 3.0000000e+00 4.0000000e+00 5.0000000e+00 6.0000000e+00 7.0000000e+00 8.0000000e+00 9.0000000e+00 1.0000000e+01 1.1000000e+01 1.2000000e+01 1.3000000e+01 1.4000000e+01 1.5000000e+01 1.6000000e+01 1.7000000e+01 1.8000000e+01 1.9000000e+01 2.0000000e+01 2.1000000e+01 2.2000000e+01 2.3000000e+01 2.4000000e+01 2.5000000e+01 2.6000000e+01 2.7000000e+01 2.8000000e+01 2.9000000e+01 3.0000000e+01 3.1000000e+01 3.2000000e+01 3.3000000e+01 3.4000000e+01 3.5000000e+01 3.6000000e+01 3.7000000e+01 3.8000000e+01 3.9000000e+01 4.0000000e+01 4.1000000e+01 4.2000000e+01 4.3000000e+01 4.4000000e+01 4.5000000e+01 4.6000000e+01 4.7000000e+01 4.8000000e+01 4.9000000e+01 5.0000000e+01 5.1000000e+01 5.2000000e+01 5.3000000e+01 5.4000000e+01 6.4000000e+01 6.5000000e+01 6.6000000e+01 6.7000000e+01 6.8000000e+01 6.9000000e+01 7.0000000e+01 7.1000000e+01 7.2000000e+01 7.3000000e+01 7.4000000e+01 7.5000000e+01 7.6000000e+01 7.7000000e+01 7.8000000e+01 7.9000000e+01 8.0000000e+01 8.1000000e+01 8.2000000e+01 8.3000000e+01 8.4000000e+01 8.5000000e+01 8.6000000e+01 8.7000000e+01 8.8000000e+01 8.9000000e+01 9.0000000e+01 9.1000000e+01 9.2000000e+01 9.3000000e+01 9.4000000e+01 9.5000000e+01 9.6000000e+01 9.7000000e+01 2.5600000e+02 5.1200000e+02 1.0240000e+03 2.0480000e+03 4.0960000e+03 8.1920000e+03 1.6384000e+04 3.2768000e+04 6.5536000e+04 1.3107200e+05 2.6214400e+05 5.2428800e+05 1.0485760e+06 2.0971520e+06 4.1943040e+06 8.3886080e+06 1.6777216e+07 3.3554432e+07 6.7108864e+07]
- long_name :
- Processing quality flags
- NETCDF_DIM_time :
- 1
- _FillValue :
- 4294967295.0
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[7, 7, 7, ..., 7, 7, 7], [7, 7, 7, ..., 7, 7, 7], [7, 7, 7, ..., 7, 7, 7], ..., [7, 7, 7, ..., 7, 7, 7], [7, 7, 7, ..., 7, 7, 7], [7, 7, 7, ..., 7, 7, 7]]], dtype=uint32)
- number_of_spectral_points_in_retrieval(band, y, x)uint1665535 65535 65535 ... 65535 65535
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Number of spectral points used in the retrieval
- NETCDF_DIM_time :
- 1
- _FillValue :
- 65535.0
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[65535, 65535, 65535, ..., 65535, 65535, 65535], [65535, 65535, 65535, ..., 65535, 65535, 65535], [65535, 65535, 65535, ..., 65535, 65535, 65535], ..., [65535, 65535, 65535, ..., 65535, 65535, 65535], [65535, 65535, 65535, ..., 65535, 65535, 65535], [65535, 65535, 65535, ..., 65535, 65535, 65535]]], dtype=uint16)
- scene_albedo_388(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- scene_albedo_388_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Scene albedo at 388 nm calculated from the top of atmosphere reflectance. For a cloud- and aerosol-free scene this is equivalent to the surface albedo
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 388
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- scene_albedo_388_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the scene albedo at 388 nm calculated from the top of atmosphere reflectance and its precision. For a cloud- and aerosol-free scene this is equivalent to the surface albedo
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 388
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_354(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- reflectance_measured_354_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Top of atmosphere reflectance at 354 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 354
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_354_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the top of atmosphere reflectance at 354 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 354
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_388(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- reflectance_measured_388_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Top of atmosphere reflectance at 388 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 388
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_388_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the top of atmosphere reflectance at 388 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 388
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_calculated_354(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- reflectance_calculated_354_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Calculated top of atmosphere reflectance at 354 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 354
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_calculated_354_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the calculated top of atmosphere reflectance at 354 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 354
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- scene_albedo_380(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- scene_albedo_380_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Scene albedo at 380 nm calculated from the top of atmosphere reflectance. For a cloud- and aerosol-free scene this is equivalent to the surface albedo
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 380
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- scene_albedo_380_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the scene albedo at 380 nm calculated from the top of atmosphere reflectance and its precision. For a cloud- and aerosol-free scene this is equivalent to the surface albedo
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 380
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_340(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- reflectance_measured_340_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Top of atmosphere reflectance at 340 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 340
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_340_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the top of atmosphere reflectance at 340 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 340
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_380(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- reflectance_measured_380_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Top of atmosphere reflectance at 380 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 380
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_measured_380_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the top of atmosphere reflectance at 380 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 380
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_calculated_340(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- reflectance_calculated_340_precision
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Calculated top of atmosphere reflectance at 340 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 340
- standard_name :
- toa_bidirectional_reflectance
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- reflectance_calculated_340_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Precision of the calculated top of atmosphere reflectance at 340 nm
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 340
- standard_name :
- toa_bidirectional_reflectance standard_error
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- wavelength_calibration_offset(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- wavelength_calibration_offset_precision
- comment :
- True wavelength = nominal wavelength + wavelength offset + wavelength stretch * scaled wavelength
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength offset
- NETCDF_DIM_time :
- 1
- units :
- nm
- wavelength_fit_window_end :
- 390
- wavelength_fit_window_start :
- 338
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- wavelength_calibration_offset_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength offset precision
- NETCDF_DIM_time :
- 1
- units :
- nm
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- wavelength_calibration_stretch(band, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- wavelength_calibration_stretch_precision
- comment :
- True wavelength = nominal wavelength + wavelength offset + wavelength stretch * scaled wavelength
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength stretch
- NETCDF_DIM_time :
- 1
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- wavelength_calibration_stretch_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength stretch precision
- NETCDF_DIM_time :
- 1
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- wavelength_calibration_chi_square(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- wavelength calibration chi square
- NETCDF_DIM_time :
- 1
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- surface_altitude(band, y, x)float329.96921e+36 ... 9.96921e+36
- comment :
- The mean of the sub-pixels of the surface altitudewithin the approximate field of view, based on the GMTED2010 surface elevation database
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- Surface altitude
- NETCDF_DIM_time :
- 1
- source :
- http://topotools.cr.usgs.gov/gmted_viewer/
- standard_name :
- surface_altitude
- units :
- m
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- surface_altitude_precision(band, y, x)float329.96921e+36 ... 9.96921e+36
- comment :
- The standard deviation of sub-pixels used in calculating the mean surface altitude, based on the GMTED2010 surface elevation database
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- surface altitude precision
- NETCDF_DIM_time :
- 1
- source :
- http://topotools.cr.usgs.gov/gmted_viewer/
- standard_error_multiplier :
- 1
- standard_name :
- surface_altitude standard_error
- units :
- m
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- surface_classification(band, y, x)uint8255 255 255 255 ... 255 255 255 255
- comment :
- Flag indicating land/water and further surface classifications for the ground pixel
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- flag_masks :
- [ 3. 3. 3. 3. 4. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249. 249.]
- flag_meanings :
- land water some_water coast value_covers_majority_of_pixel water+shallow_ocean water+shallow_inland_water water+ocean_coastline-lake_shoreline water+intermittent_water water+deep_inland_water water+continental_shelf_ocean water+deep_ocean land+urban_and_built-up_land land+dryland_cropland_and_pasture land+irrigated_cropland_and_pasture land+mixed_dryland-irrigated_cropland_and_pasture land+cropland-grassland_mosaic land+cropland-woodland_mosaic land+grassland land+shrubland land+mixed_shrubland-grassland land+savanna land+deciduous_broadleaf_forest land+deciduous_needleleaf_forest land+evergreen_broadleaf_forest land+evergreen_needleleaf_forest land+mixed_forest land+herbaceous_wetland land+wooded_wetland land+barren_or_sparsely_vegetated land+herbaceous_tundra land+wooded_tundra land+mixed_tundra land+bare_ground_tundra land+snow_or_ice
- flag_values :
- [ 0. 1. 2. 3. 4. 9. 17. 25. 33. 41. 49. 57. 8. 16. 24. 32. 40. 48. 56. 64. 72. 80. 88. 96. 104. 112. 120. 128. 136. 144. 152. 160. 168. 176. 184.]
- long_name :
- Land-water mask and surface classification based on a static database
- NETCDF_DIM_time :
- 1
- source :
- USGS (https://lta.cr.usgs.gov/GLCC) and NASA SDP toolkit (http://newsroom.gsfc.nasa.gov/sdptoolkit/toolkit.html)
- _FillValue :
- 255.0
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[255, 255, 255, ..., 255, 255, 255], [255, 255, 255, ..., 255, 255, 255], [255, 255, 255, ..., 255, 255, 255], ..., [255, 255, 255, ..., 255, 255, 255], [255, 255, 255, ..., 255, 255, 255], [255, 255, 255, ..., 255, 255, 255]]], dtype=uint8)
- qa_value(time, y, x)uint80 0 0 0 0 0 0 0 ... 0 0 0 0 0 0 0 0
- add_offset :
- 0.0
- comment :
- A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value < 0.5
- coordinates :
- longitude latitude
- long_name :
- data quality value
- scale_factor :
- 0.009999999776482582
- units :
- 1
- valid_max :
- 100
- valid_min :
- 0
- _FillValue :
- 255.0
- grid_mapping :
- spatial_ref
array([[[0, 0, 0, ..., 0, 0, 0], [0, 0, 0, ..., 0, 0, 0], [0, 0, 0, ..., 0, 0, 0], ..., [0, 0, 0, ..., 0, 0, 0], [0, 0, 0, ..., 0, 0, 0], [0, 0, 0, ..., 0, 0, 0]]], dtype=uint8)
- scaled_small_pixel_variance(band, y, x)float329.96921e+36 ... 9.96921e+36
- comment :
- The scaled variance of the reflectances of the small pixels
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- scaled small pixel variance
- NETCDF_DIM_time :
- 1
- radiation_wavelength :
- 373
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- ozone_total_column(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- total column amount of ozone from ECMWF model data
- multiplication_factor_to_convert_to_DU :
- 2241.1499
- multiplication_factor_to_convert_to_molecules_percm2 :
- 6.0221409e+19
- NETCDF_DIM_time :
- 1
- source :
- standard_name :
- atmosphere_mole_content_of_ozone
- units :
- mol m-2
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- surface_pressure(band, y, x)float329.96921e+36 ... 9.96921e+36
- coordinates :
- /PRODUCT/longitude /PRODUCT/latitude
- long_name :
- surface_air_pressure
- NETCDF_DIM_time :
- 1
- source :
- standard_name :
- surface_air_pressure
- units :
- Pa
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- aerosol_index_354_388(time, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- aerosol_index_354_388_precision
- comment :
- Aerosol index from 388 and 354 nm
- coordinates :
- longitude latitude
- long_name :
- Aerosol index from 388 and 354 nm
- proposed_standard_name :
- ultraviolet_aerosol_index
- radiation_wavelength :
- [354. 388.]
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- aerosol_index_340_380(time, y, x)float329.96921e+36 ... 9.96921e+36
- ancillary_variables :
- aerosol_index_340_380_precision
- comment :
- Aerosol index from 380 and 340 nm
- coordinates :
- longitude latitude
- long_name :
- Aerosol index from 380 and 340 nm
- proposed_standard_name :
- ultraviolet_aerosol_index
- radiation_wavelength :
- [340. 380.]
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- aerosol_index_354_388_precision(time, y, x)float329.96921e+36 ... 9.96921e+36
- comment :
- Precision of aerosol index from 388 and 354 nm
- coordinates :
- longitude latitude
- long_name :
- Precision of aerosol index from 388 and 354 nm
- proposed_standard_name :
- ultraviolet_aerosol_index standard_error
- radiation_wavelength :
- [354. 388.]
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- aerosol_index_340_380_precision(time, y, x)float329.96921e+36 ... 9.96921e+36
- comment :
- Precision of aerosol index from 380 and 340 nm
- coordinates :
- longitude latitude
- long_name :
- Precision of aerosol index from 380 and 340 nm
- proposed_standard_name :
- ultraviolet_aerosol_index standard_error
- radiation_wavelength :
- [340. 380.]
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- algo.algorithm_variant :
- 1
- algo.n_pair :
- 2
- algo.pair_1.delta_wavelength :
- 2.0
- algo.pair_1.id :
- TOMS_pair
- algo.pair_1.min_wavelength :
- 1
- algo.pair_1.number_spectral_pixels :
- 7
- algo.pair_1.wavelength_1 :
- 340
- algo.pair_1.wavelength_2 :
- 380
- algo.pair_2.delta_wavelength :
- 2.0
- algo.pair_2.id :
- OMI_pair
- algo.pair_2.min_wavelength :
- 1
- algo.pair_2.number_spectral_pixels :
- 7
- algo.pair_2.wavelength_1 :
- 354
- algo.pair_2.wavelength_2 :
- 388
- configuration.version.algorithm :
- 1.1.0
- configuration.version.framework :
- 1.1.0
- input.1.band :
- 3
- input.1.irrType :
- L1B_IR_UVN
- input.1.type :
- L1B_RA_BD3
- input.count :
- 1
- output.1.band :
- 3
- output.1.config :
- cfg/product/product.AER_AI.xml
- output.1.type :
- L2__AER_AI
- output.compressionLevel :
- 3
- output.count :
- 1
- output.histogram.aerosol_index_340_380.end :
- 14
- output.histogram.aerosol_index_340_380.start :
- -6
- output.histogram.aerosol_index_354_388.end :
- 14
- output.histogram.aerosol_index_354_388.start :
- -6
- output.useCompression :
- true
- output.useFletcher32 :
- true
- output.useShuffleFilter :
- true
- processing.algorithm :
- AER_AI
- processing.correct_surface_pressure_for_altitude :
- true
- processing.exclude_flags :
- 4294967295
- processing.groupDem :
- DEM_RADIUS_05000
- processing.ignore_pixel_flags :
- False
- processing.radiancePixelsMinError :
- 2
- processing.radiancePixelsMinWarning :
- 7
- processing.signal_to_noise.test :
- yes
- processing.signal_to_noise.threshold :
- 12
- processing.signal_to_noise.window.range :
- 350.0, 355.0
- processing.szaMax :
- 88.0
- processing.szaMin :
- 0.0
- processing.vzaMax :
- 78.0
- processing.vzaMin :
- 0.0
- qa_value.AAI_warning :
- 100.0
- qa_value.altitude_consistency_warning :
- 100.0
- qa_value.cloud_warning :
- 100.0
- qa_value.data_range_warning :
- 100.0
- qa_value.deconvolution_warning :
- 100.0
- qa_value.extrapolation_warning :
- 100.0
- qa_value.input_spectrum_warning :
- 70.0
- qa_value.interpolation_warning :
- 100.0
- qa_value.low_cloud_fraction_warning :
- 100.0
- qa_value.pixel_level_input_data_missing :
- 80.0
- qa_value.signal_to_noise_ratio_warning :
- 100.0
- qa_value.snow_ice_warning :
- 100.0
- qa_value.so2_volcanic_origin_certain_warning :
- 100.0
- qa_value.so2_volcanic_origin_likely_warning :
- 100.0
- qa_value.south_atlantic_anomaly_warning :
- 100.0
- qa_value.sun_glint_correction :
- 100.0
- qa_value.sun_glint_warning :
- 70.0
- qa_value.wavelength_calibration_warning :
- 90.0
- wavelength_calibration.convergence_threshold :
- 1.0
- wavelength_calibration.include_stretch :
- no
- wavelength_calibration.initial_guess.a0 :
- 1.0
- wavelength_calibration.initial_guess.a1 :
- 0.1
- wavelength_calibration.initial_guess.a2 :
- 0.01
- wavelength_calibration.initial_guess.ring :
- 0.06
- wavelength_calibration.initial_guess.shift :
- 0.0
- wavelength_calibration.initial_guess.stretch :
- 0.0
- wavelength_calibration.irr.include_ring :
- no
- wavelength_calibration.irr.max_iterations :
- 20
- wavelength_calibration.irr.polynomial_order :
- 2
- wavelength_calibration.max_iterations :
- 12
- wavelength_calibration.perform_wavelength_fit :
- yes
- wavelength_calibration.rad.include_ring :
- yes
- wavelength_calibration.rad.polynomial_order :
- 3
- wavelength_calibration.sigma.a0 :
- 1.0
- wavelength_calibration.sigma.a1 :
- 0.1
- wavelength_calibration.sigma.ring :
- 0.06
- wavelength_calibration.sigma.shift :
- 0.07
- wavelength_calibration.sigma.stretch :
- 0.07
- wavelength_calibration.window :
- 338.0, 390.0
- /METADATA/EOP_METADATA/eop :
- metaDataProperty/NC_GLOBAL#objectType=eop:EarthObservationMetaData
- gml :
- id=S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822.ID
- objectType :
- gmi:MI_Metadata
- /METADATA/EOP_METADATA/om :
- procedure/NC_GLOBAL#objectType=eop:EarthObservationEquipment
- File_Class :
- OFFL
- File_Description :
- Aerosol index with a spatial resolution of 7x3.5km2 observed at about 13:30 local solar time from spectra measured by TROPOMI
- File_Name :
- S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822
- File_Type :
- L2__AER_AI
- File_Version :
- 1
- Mission :
- S5P
- Notes :
- Creation_Date :
- UTC=2018-08-22T19:32:01
- Creator :
- TROPNLL2DP
- Creator_Version :
- 1.1.0
- System :
- PDGS-OP
- Validity_Start :
- UTC=2018-08-16T18:51:51
- Validity_Stop :
- UTC=2018-08-16T19:50:14
- /METADATA/ESA_METADATA/earth_explorer_header/variable_header/gmd :
- lineage/NC_GLOBAL#objectType=gmd:LI_Lineage
- GranuleEnd :
- 2018-08-16T19:50:14Z
- GranuleStart :
- 2018-08-16T18:51:51Z
- InstrumentName :
- TROPOMI
- LongitudeOfDaysideNadirEquatorCrossing :
- -86.442253
- MissionName :
- Sentinel-5 precursor
- MissionShortName :
- S5P
- ProcessingCenter :
- PDGS-OP
- ProcessingMode :
- Offline
- ProcessingNode :
- s5p-off-pn37
- ProcessLevel :
- 2
- ProcessorVersion :
- 1.1.0
- ProductFormatVersion :
- 10000
- ProductShortName :
- L2__AER_AI
- /METADATA/ISO_METADATA/gmd :
- language/NC_GLOBAL#objectType=gmd:LanguageCode
- /METADATA/ISO_METADATA/gmi :
- acquisitionInformation/NC_GLOBAL#objectType=gmi:MI_AcquisitionInformation
- gmd :
- metadataStandardVersion=ISO 19115-2:2009(E), S5P profile
- global_processing_warnings :
- --- TEST FLAG SET IN JOB ORDER ---
- number_of_aai_filter_occurrences :
- 0
- number_of_aai_scene_albedo_filter_occurrences :
- 0
- number_of_AAI_warning_occurrences :
- 0
- number_of_abort_error_occurrences :
- 0
- number_of_aerosol_boundary_error_occurrences :
- 0
- number_of_airmass_factor_error_occurrences :
- 0
- number_of_altitude_consistency_filter_occurrences :
- 0
- number_of_altitude_consistency_warning_occurrences :
- 0
- number_of_altitude_roughness_filter_occurrences :
- 0
- number_of_aot_lower_boundary_convergence_error_occurrences :
- 0
- number_of_assertion_error_occurrences :
- 31
- number_of_boundary_hit_error_occurrences :
- 0
- number_of_cf_viirs_nir_ifov_filter_occurrences :
- 0
- number_of_cf_viirs_nir_ofova_filter_occurrences :
- 0
- number_of_cf_viirs_nir_ofovb_filter_occurrences :
- 0
- number_of_cf_viirs_nir_ofovc_filter_occurrences :
- 0
- number_of_cf_viirs_swir_ifov_filter_occurrences :
- 0
- number_of_cf_viirs_swir_ofova_filter_occurrences :
- 0
- number_of_cf_viirs_swir_ofovb_filter_occurrences :
- 0
- number_of_cf_viirs_swir_ofovc_filter_occurrences :
- 0
- number_of_ch4_noscat_ratio_filter_occurrences :
- 0
- number_of_ch4_noscat_ratio_std_filter_occurrences :
- 0
- number_of_ch4_noscat_zero_error_occurrences :
- 0
- number_of_chi2_error_occurrences :
- 0
- number_of_cirrus_reflectance_viirs_filter_occurrences :
- 0
- number_of_cloud_error_occurrences :
- 0
- number_of_cloud_filter_convergence_error_occurrences :
- 0
- number_of_cloud_filter_occurrences :
- 0
- number_of_cloud_fraction_fresco_filter_occurrences :
- 0
- number_of_cloud_fraction_viirs_filter_occurrences :
- 0
- number_of_cloud_pressure_spread_too_low_error_occurrences :
- 0
- number_of_cloud_too_low_level_error_occurrences :
- 0
- number_of_cloud_warning_occurrences :
- 0
- number_of_configuration_error_occurrences :
- 0
- number_of_convergence_error_occurrences :
- 0
- number_of_coregistration_error_occurrences :
- 0
- number_of_data_range_warning_occurrences :
- 0
- number_of_deconvolution_warning_occurrences :
- 0
- number_of_dfs_error_occurrences :
- 0
- number_of_diff_psurf_fresco_ecmwf_filter_occurrences :
- 0
- number_of_diff_refl_cirrus_viirs_filter_occurrences :
- 0
- number_of_extrapolation_warning_occurrences :
- 0
- number_of_failed_retrievals :
- 222068
- number_of_generic_exception_occurrences :
- 0
- number_of_generic_range_error_occurrences :
- 0
- number_of_geographic_region_filter_occurrences :
- 0
- number_of_geolocation_error_occurrences :
- 0
- number_of_groundpixels :
- 1460250
- number_of_ground_pixels_with_warnings :
- 84516
- number_of_h2o_noscat_ratio_filter_occurrences :
- 0
- number_of_h2o_noscat_ratio_std_filter_occurrences :
- 0
- number_of_h2o_noscat_zero_error_occurrences :
- 0
- number_of_initialization_error_occurrences :
- 0
- number_of_input_spectrum_alignment_error_occurrences :
- 0
- number_of_input_spectrum_missing_occurrences :
- 0
- number_of_input_spectrum_warning_occurrences :
- 0
- number_of_interpolation_warning_occurrences :
- 0
- number_of_io_error_occurrences :
- 0
- number_of_irradiance_missing_occurrences :
- 0
- number_of_ISRF_error_occurrences :
- 0
- number_of_key_error_occurrences :
- 0
- number_of_ler_range_error_occurrences :
- 0
- number_of_low_cloud_fraction_warning_occurrences :
- 0
- number_of_lut_error_occurrences :
- 0
- number_of_lut_range_error_occurrences :
- 0
- number_of_max_iteration_convergence_error_occurrences :
- 0
- number_of_max_optical_thickness_error_occurrences :
- 0
- number_of_memory_error_occurrences :
- 0
- number_of_mixed_surface_type_filter_occurrences :
- 0
- number_of_model_error_occurrences :
- 0
- number_of_number_of_input_data_points_too_low_error_occurrences :
- 0
- number_of_numerical_error_occurrences :
- 0
- number_of_ocean_filter_occurrences :
- 0
- number_of_optimal_estimation_error_occurrences :
- 0
- number_of_other_boundary_convergence_error_occurrences :
- 0
- number_of_ozone_range_error_occurrences :
- 0
- number_of_pixel_level_input_data_missing_occurrences :
- 0
- number_of_pixel_or_scanline_index_filter_occurrences :
- 0
- number_of_processed_pixels :
- 1460250
- number_of_profile_error_occurrences :
- 0
- number_of_psurf_fresco_stdv_filter_occurrences :
- 0
- number_of_radiance_missing_occurrences :
- 0
- number_of_radiative_transfer_error_occurrences :
- 0
- number_of_reflectance_range_error_occurrences :
- 0
- number_of_refl_cirrus_viirs_nir_filter_occurrences :
- 0
- number_of_refl_cirrus_viirs_swir_filter_occurrences :
- 0
- number_of_rejected_pixels_not_enough_spectrum :
- 0
- number_of_saturation_error_occurrences :
- 0
- number_of_saturation_warning_occurrences :
- 0
- number_of_signal_to_noise_ratio_error_occurrences :
- 0
- number_of_signal_to_noise_ratio_warning_occurrences :
- 0
- number_of_slant_column_density_error_occurrences :
- 0
- number_of_small_pixel_radiance_std_filter_occurrences :
- 0
- number_of_snow_ice_filter_occurrences :
- 0
- number_of_snow_ice_warning_occurrences :
- 0
- number_of_snr_range_error_occurrences :
- 0
- number_of_so2_volcanic_origin_certain_warning_occurrences :
- 0
- number_of_so2_volcanic_origin_likely_warning_occurrences :
- 0
- number_of_solar_eclipse_filter_occurrences :
- 0
- number_of_south_atlantic_anomaly_warning_occurrences :
- 0
- number_of_successfully_processed_pixels :
- 1238182
- number_of_sun_glint_correction_occurrences :
- 0
- number_of_sun_glint_filter_occurrences :
- 0
- number_of_sun_glint_warning_occurrences :
- 84516
- number_of_svd_error_occurrences :
- 0
- number_of_sza_range_error_occurrences :
- 222037
- number_of_time_range_filter_occurrences :
- 0
- number_of_vertical_column_density_error_occurrences :
- 0
- number_of_vza_range_error_occurrences :
- 0
- number_of_wavelength_calibration_error_occurrences :
- 0
- number_of_wavelength_calibration_warning_occurrences :
- 0
- number_of_wavelength_offset_error_occurrences :
- 0
- number_of_wrong_input_type_error_occurrences :
- 0
- time_for_algorithm_initialization :
- 23.927286
- time_for_processing :
- 212.96926
- time_per_pixel :
- 0.001535914273508207
- time_standard_deviation_per_pixel :
- 2.56573665351871e-05
- algorithm_version :
- 1.1.0
- build_date :
- 2018-07-04T06:04:00Z
- cdm_data_type :
- Swath
- Conventions :
- CF-1.7
- cpp_compiler_flags :
- -g -O2 -fPIC -std=c++11 -W -Wall -Wno-ignored-qualifiers -Wno-write-strings -Wno-unused-variable -DTROPNLL2DP
- cpp_compiler_version :
- g++ (GCC) 4.8.5 20150623 (Red Hat 4.8.5-11)
- creator_email :
- EOSupport@Copernicus.esa.int
- creator_name :
- The Sentinel 5 Precursor TROPOMI Level 2 products are developed with funding from the European Space Agency (ESA), the Netherlands Space Office (NSO), the Belgian Science Policy Office, the German Aerospace Center (DLR) and the Bayerisches Staatsministerium für Wirtschaft und Medien, Energie und Technologie (StMWi).
- creator_url :
- http://www.tropomi.eu
- date_created :
- 2018-08-22T19:32:01Z
- f90_compiler_flags :
- -gdwarf-3 -O2 -fPIC -cpp -ffpe-trap=invalid -fno-range-check -frecursive -fimplicit-none -ffree-line-length-none -DTROPNLL2DP -Wuninitialized -Wtabs
- f90_compiler_version :
- GNU Fortran (GCC) 4.8.5 20150623 (Red Hat 4.8.5-11)
- geolocation_grid_from_band :
- 3
- geospatial_lat_max :
- 89.972939
- geospatial_lat_min :
- -86.81926
- geospatial_lon_max :
- -179.99773
- geospatial_lon_min :
- 179.99924
- history :
- 2018-08-22 19:35:59 f_s5pops tropnll2dp /mnt/data1/storage_offl_l2/cache_offl_l2/WORKING-564386761/JobOrder.564386738.xml
- id :
- S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822
- identifier_product_doi :
- 10.5270/S5P-0wafvaf
- identifier_product_doi_authority :
- http://dx.doi.org/
- institution :
- KNMI
- keywords :
- 0300 Atmospheric Composition and Structure; 0305 Aerosols and Particles; 0360 Radiation, Transmission and Scattering; 3311 Clouds and Aerosols; 3360 Remote Sensing
- keywords_vocabulary :
- AGU index terms, http://publications.agu.org/author-resource-center/index-terms/
- license :
- No conditions apply
- naming_authority :
- nl.knmi
- orbit :
- 4361
- platform :
- S5P
- processing_status :
- Nominal
- processor_version :
- 1.1.0
- product_version :
- 1.0.0
- project :
- Sentinel 5 precursor/TROPOMI
- references :
- http://www.tropomi.eu/data-products/aerosol-index
- revision_control_identifier :
- df649da886db
- sensor :
- TROPOMI
- source :
- Sentinel 5 precursor, TROPOMI, space-borne remote sensing, L2
- spatial_resolution :
- 7x3.5km2
- standard_name_vocabulary :
- NetCDF Climate and Forecast Metadata Conventions Standard Name Table (v29, 08 July 2015), http://cfconventions.org/standard-names.html
- Status_MET_2D :
- Nominal
- summary :
- TROPOMI/S5P Aerosol Index 1-Orbit L2 Swath 7x3.5km
- time_coverage_duration :
- PT3503.000S
- time_coverage_end :
- 2018-08-16T19:50:14Z
- time_coverage_resolution :
- PT1.080S
- time_coverage_start :
- 2018-08-16T18:51:51Z
- time_reference :
- 2018-08-16T00:00:00Z
- time_reference_days_since_1950 :
- 25064
- time_reference_julian_day :
- 2458346.5
- time_reference_seconds_since_1970 :
- 1534377600
- title :
- TROPOMI/S5P Aerosol Index 1-Orbit L2 Swath 7x3.5km
- tracking_id :
- 0b05f3ea-704b-4ab5-8df3-cf6e31764960
rds_crs_set = rds_crs_set.rio.set_crs(4326)
rds_crs_set.rio.crs
CRS.from_epsg(4326)
rds_crs_set = rds_crs_set.rio.write_coordinate_system()
r1_ai_crs_set = rds_crs_set['aerosol_index_340_380']
r1_ai_crs_set
<xarray.DataArray 'aerosol_index_340_380' (time: 1, y: 3245, x: 450)> array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32) Coordinates: * y (y) float64 3.244e+03 3.243e+03 3.242e+03 ... 2.0 1.0 0.0 * x (x) float64 0.0 1.0 2.0 3.0 4.0 ... 446.0 447.0 448.0 449.0 * time (time) int64 272073600 spatial_ref int64 0 latitude (time, y, x) float32 53.289627 53.328514 ... -68.705986 longitude (time, y, x) float32 119.45596 119.32921 ... 1.9235005 Attributes: ancillary_variables: aerosol_index_340_380_precision comment: Aerosol index from 380 and 340 nm coordinates: longitude latitude long_name: Aerosol index from 380 and 340 nm proposed_standard_name: ultraviolet_aerosol_index radiation_wavelength: [340. 380.] units: 1 _FillValue: 9.969209968386869e+36 scale_factor: 1.0 add_offset: 0.0 grid_mapping: spatial_ref
- time: 1
- y: 3245
- x: 450
- 9.96921e+36 9.96921e+36 9.96921e+36 ... 9.96921e+36 9.96921e+36
array([[[9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], ..., [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36], [9.96921e+36, 9.96921e+36, 9.96921e+36, ..., 9.96921e+36, 9.96921e+36, 9.96921e+36]]], dtype=float32)
- y(y)float643.244e+03 3.243e+03 ... 1.0 0.0
- axis :
- Y
- long_name :
- latitude
- standard_name :
- latitude
- units :
- degrees_north
array([3.244e+03, 3.243e+03, 3.242e+03, ..., 2.000e+00, 1.000e+00, 0.000e+00])
- x(x)float640.0 1.0 2.0 ... 447.0 448.0 449.0
- axis :
- X
- long_name :
- longitude
- standard_name :
- longitude
- units :
- degrees_east
array([ 0., 1., 2., ..., 447., 448., 449.])
- time(time)int64272073600
array([272073600])
- spatial_ref()int640
- GeoTransform :
- -0.5 1.0 0.0 3244.5 0.0 -1.0
array(0)
- latitude(time, y, x)float3253.289627 53.328514 ... -68.705986
- bounds :
- /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/latitude_bounds
- long_name :
- pixel center latitude
- standard_name :
- latitude
- units :
- degrees_north
- valid_max :
- 90
- valid_min :
- -90
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[ 53.289627, 53.328514, 53.366734, ..., 60.851288, 60.861183, 60.871014], [ 53.34224 , 53.3812 , 53.419495, ..., 60.912846, 60.922707, 60.9325 ], [ 53.39479 , 53.433826, 53.4722 , ..., 60.974384, 60.984215, 60.993973], ..., [-85.21351 , -85.27658 , -85.337944, ..., -68.85199 , -68.77097 , -68.68882 ], [-85.24866 , -85.31239 , -85.37443 , ..., -68.860825, -68.77974 , -68.69752 ], [-85.28333 , -85.34773 , -85.41043 , ..., -68.869446, -68.788284, -68.705986]]], dtype=float32)
- longitude(time, y, x)float32119.45596 119.32921 ... 1.9235005
- bounds :
- /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/longitude_bounds
- long_name :
- pixel center longitude
- standard_name :
- longitude
- units :
- degrees_east
- valid_max :
- 180
- valid_min :
- -180
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([[[ 119.45596 , 119.32921 , 119.20397 , ..., 76.279495 , 76.114655 , 75.9475 ], [ 119.51897 , 119.39211 , 119.266785 , ..., 76.27593 , 76.110756 , 75.94327 ], [ 119.5822 , 119.45525 , 119.32983 , ..., 76.27239 , 76.106895 , 75.939064 ], ..., [-135.26692 , -134.51474 , -133.75343 , ..., 1.4409312, 1.5062535, 1.5720007], [-135.85966 , -135.1101 , -134.3511 , ..., 1.6179553, 1.6826414, 1.7477475], [-136.46013 , -135.71352 , -134.95714 , ..., 1.7949897, 1.8590373, 1.9235005]]], dtype=float32)
- ancillary_variables :
- aerosol_index_340_380_precision
- comment :
- Aerosol index from 380 and 340 nm
- coordinates :
- longitude latitude
- long_name :
- Aerosol index from 380 and 340 nm
- proposed_standard_name :
- ultraviolet_aerosol_index
- radiation_wavelength :
- [340. 380.]
- units :
- 1
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
r1_ai_crs_set = r1_ai_crs_set.rio.set_crs(4326, True)
r1_ai_crs_set = r1_ai_crs_set.rio.write_coordinate_system()
r1_ai_crs_set.longitude.attrs
{'bounds': '/PRODUCT/SUPPORT_DATA/GEOLOCATIONS/longitude_bounds', 'long_name': 'pixel center longitude', 'standard_name': 'longitude', 'units': 'degrees_east', 'valid_max': 180, 'valid_min': -180, '_FillValue': 9.969209968386869e+36, 'scale_factor': 1.0, 'add_offset': 0.0, 'grid_mapping': 'spatial_ref'}
r1_ai_crs_set.latitude[0][0]
<xarray.DataArray 'latitude' (x: 450)> array([53.289627, 53.328514, 53.366734, 53.404312, 53.44126 , 53.477608, 53.51336 , 53.54854 , 53.58316 , 53.61724 , 53.65079 , 53.68383 , 53.716366, 53.748417, 53.77999 , 53.811104, 53.841766, 53.87199 , 53.901783, 53.93116 , 53.96013 , 53.9887 , 54.03083 , 54.085697, 54.13913 , 54.1912 , 54.24196 , 54.29147 , 54.339783, 54.386948, 54.433014, 54.478027, 54.522026, 54.565052, 54.607143, 54.648335, 54.68866 , 54.728153, 54.76684 , 54.80476 , 54.84193 , 54.87838 , 54.91413 , 54.949215, 54.983654, 55.01746 , 55.050663, 55.083282, 55.115334, 55.146835, 55.177803, 55.20826 , 55.238216, 55.26769 , 55.29669 , 55.32524 , 55.353348, 55.381027, 55.40829 , 55.435154, 55.46162 , 55.48771 , 55.513424, 55.53878 , 55.563786, 55.58845 , 55.612785, 55.636795, 55.660496, 55.683887, 55.70698 , 55.729786, 55.752308, 55.774555, 55.79653 , 55.81825 , 55.839714, 55.860928, 55.881897, 55.902634, 55.923138, 55.943417, 55.963474, 55.98332 , 56.002953, 56.022385, 56.041615, 56.06065 , 56.079494, 56.098152, 56.116627, 56.134926, 56.15305 , 56.171 , 56.18879 , 56.206413, 56.223877, 56.241188, 56.258347, 56.275352, 56.292213, 56.308933, 56.325516, 56.341957, 56.358265, 56.374443, 56.39049 , 56.406418, 56.42222 , 56.437897, 56.45346 , 56.468906, 56.484238, 56.49946 , 56.514572, 56.52958 , 56.54448 , 56.559277, 56.573975, 56.588577, ... 59.069664, 59.082832, 59.09606 , 59.109356, 59.12271 , 59.136127, 59.149612, 59.163162, 59.17678 , 59.190468, 59.20422 , 59.218044, 59.231937, 59.2459 , 59.259937, 59.274048, 59.28823 , 59.30249 , 59.316826, 59.331238, 59.345726, 59.360294, 59.37494 , 59.389668, 59.40448 , 59.419373, 59.434345, 59.449406, 59.464554, 59.479782, 59.495102, 59.51051 , 59.52601 , 59.541595, 59.557274, 59.573044, 59.588905, 59.604862, 59.620914, 59.637066, 59.65331 , 59.66965 , 59.686092, 59.702637, 59.719276, 59.73602 , 59.752865, 59.769814, 59.786865, 59.80402 , 59.82128 , 59.83865 , 59.856125, 59.873703, 59.891396, 59.90919 , 59.9271 , 59.945114, 59.96324 , 59.98148 , 59.999825, 60.018284, 60.036854, 60.05553 , 60.07432 , 60.093224, 60.112236, 60.13136 , 60.15059 , 60.16993 , 60.189377, 60.20893 , 60.228592, 60.24836 , 60.268227, 60.288197, 60.308266, 60.32843 , 60.348686, 60.369038, 60.389473, 60.409996, 60.430595, 60.451267, 60.47201 , 60.49282 , 60.513687, 60.534603, 60.555557, 60.57655 , 60.597565, 60.61859 , 60.63962 , 60.66064 , 60.676384, 60.68687 , 60.697346, 60.70781 , 60.718254, 60.728683, 60.739086, 60.74947 , 60.759827, 60.770153, 60.780445, 60.790703, 60.800922, 60.8111 , 60.821228, 60.831303, 60.841328, 60.851288, 60.861183, 60.871014], dtype=float32) Coordinates: y float64 3.244e+03 * x (x) float64 0.0 1.0 2.0 3.0 4.0 ... 446.0 447.0 448.0 449.0 time int64 272073600 spatial_ref int64 0 latitude (x) float32 53.289627 53.328514 ... 60.861183 60.871014 longitude (x) float32 119.45596 119.32921 119.20397 ... 76.114655 75.9475 Attributes: bounds: /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/latitude_bounds long_name: pixel center latitude standard_name: latitude units: degrees_north valid_max: 90 valid_min: -90 _FillValue: 9.969209968386869e+36 scale_factor: 1.0 add_offset: 0.0 grid_mapping: spatial_ref
- x: 450
- 53.289627 53.328514 53.366734 ... 60.851288 60.861183 60.871014
array([53.289627, 53.328514, 53.366734, 53.404312, 53.44126 , 53.477608, 53.51336 , 53.54854 , 53.58316 , 53.61724 , 53.65079 , 53.68383 , 53.716366, 53.748417, 53.77999 , 53.811104, 53.841766, 53.87199 , 53.901783, 53.93116 , 53.96013 , 53.9887 , 54.03083 , 54.085697, 54.13913 , 54.1912 , 54.24196 , 54.29147 , 54.339783, 54.386948, 54.433014, 54.478027, 54.522026, 54.565052, 54.607143, 54.648335, 54.68866 , 54.728153, 54.76684 , 54.80476 , 54.84193 , 54.87838 , 54.91413 , 54.949215, 54.983654, 55.01746 , 55.050663, 55.083282, 55.115334, 55.146835, 55.177803, 55.20826 , 55.238216, 55.26769 , 55.29669 , 55.32524 , 55.353348, 55.381027, 55.40829 , 55.435154, 55.46162 , 55.48771 , 55.513424, 55.53878 , 55.563786, 55.58845 , 55.612785, 55.636795, 55.660496, 55.683887, 55.70698 , 55.729786, 55.752308, 55.774555, 55.79653 , 55.81825 , 55.839714, 55.860928, 55.881897, 55.902634, 55.923138, 55.943417, 55.963474, 55.98332 , 56.002953, 56.022385, 56.041615, 56.06065 , 56.079494, 56.098152, 56.116627, 56.134926, 56.15305 , 56.171 , 56.18879 , 56.206413, 56.223877, 56.241188, 56.258347, 56.275352, 56.292213, 56.308933, 56.325516, 56.341957, 56.358265, 56.374443, 56.39049 , 56.406418, 56.42222 , 56.437897, 56.45346 , 56.468906, 56.484238, 56.49946 , 56.514572, 56.52958 , 56.54448 , 56.559277, 56.573975, 56.588577, ... 59.069664, 59.082832, 59.09606 , 59.109356, 59.12271 , 59.136127, 59.149612, 59.163162, 59.17678 , 59.190468, 59.20422 , 59.218044, 59.231937, 59.2459 , 59.259937, 59.274048, 59.28823 , 59.30249 , 59.316826, 59.331238, 59.345726, 59.360294, 59.37494 , 59.389668, 59.40448 , 59.419373, 59.434345, 59.449406, 59.464554, 59.479782, 59.495102, 59.51051 , 59.52601 , 59.541595, 59.557274, 59.573044, 59.588905, 59.604862, 59.620914, 59.637066, 59.65331 , 59.66965 , 59.686092, 59.702637, 59.719276, 59.73602 , 59.752865, 59.769814, 59.786865, 59.80402 , 59.82128 , 59.83865 , 59.856125, 59.873703, 59.891396, 59.90919 , 59.9271 , 59.945114, 59.96324 , 59.98148 , 59.999825, 60.018284, 60.036854, 60.05553 , 60.07432 , 60.093224, 60.112236, 60.13136 , 60.15059 , 60.16993 , 60.189377, 60.20893 , 60.228592, 60.24836 , 60.268227, 60.288197, 60.308266, 60.32843 , 60.348686, 60.369038, 60.389473, 60.409996, 60.430595, 60.451267, 60.47201 , 60.49282 , 60.513687, 60.534603, 60.555557, 60.57655 , 60.597565, 60.61859 , 60.63962 , 60.66064 , 60.676384, 60.68687 , 60.697346, 60.70781 , 60.718254, 60.728683, 60.739086, 60.74947 , 60.759827, 60.770153, 60.780445, 60.790703, 60.800922, 60.8111 , 60.821228, 60.831303, 60.841328, 60.851288, 60.861183, 60.871014], dtype=float32)
- y()float643.244e+03
- axis :
- Y
- long_name :
- latitude
- standard_name :
- latitude
- units :
- degrees_north
array(3244.)
- x(x)float640.0 1.0 2.0 ... 447.0 448.0 449.0
- axis :
- X
- long_name :
- longitude
- standard_name :
- longitude
- units :
- degrees_east
array([ 0., 1., 2., ..., 447., 448., 449.])
- time()int64272073600
array(272073600)
- spatial_ref()int640
- GeoTransform :
- -0.5 1.0 0.0 3244.5 0.0 -1.0
array(0)
- latitude(x)float3253.289627 53.328514 ... 60.871014
- bounds :
- /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/latitude_bounds
- long_name :
- pixel center latitude
- standard_name :
- latitude
- units :
- degrees_north
- valid_max :
- 90
- valid_min :
- -90
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([53.289627, 53.328514, 53.366734, 53.404312, 53.44126 , 53.477608, 53.51336 , 53.54854 , 53.58316 , 53.61724 , 53.65079 , 53.68383 , 53.716366, 53.748417, 53.77999 , 53.811104, 53.841766, 53.87199 , 53.901783, 53.93116 , 53.96013 , 53.9887 , 54.03083 , 54.085697, 54.13913 , 54.1912 , 54.24196 , 54.29147 , 54.339783, 54.386948, 54.433014, 54.478027, 54.522026, 54.565052, 54.607143, 54.648335, 54.68866 , 54.728153, 54.76684 , 54.80476 , 54.84193 , 54.87838 , 54.91413 , 54.949215, 54.983654, 55.01746 , 55.050663, 55.083282, 55.115334, 55.146835, 55.177803, 55.20826 , 55.238216, 55.26769 , 55.29669 , 55.32524 , 55.353348, 55.381027, 55.40829 , 55.435154, 55.46162 , 55.48771 , 55.513424, 55.53878 , 55.563786, 55.58845 , 55.612785, 55.636795, 55.660496, 55.683887, 55.70698 , 55.729786, 55.752308, 55.774555, 55.79653 , 55.81825 , 55.839714, 55.860928, 55.881897, 55.902634, 55.923138, 55.943417, 55.963474, 55.98332 , 56.002953, 56.022385, 56.041615, 56.06065 , 56.079494, 56.098152, 56.116627, 56.134926, 56.15305 , 56.171 , 56.18879 , 56.206413, 56.223877, 56.241188, 56.258347, 56.275352, 56.292213, 56.308933, 56.325516, 56.341957, 56.358265, 56.374443, 56.39049 , 56.406418, 56.42222 , 56.437897, 56.45346 , 56.468906, 56.484238, 56.49946 , 56.514572, 56.52958 , 56.54448 , 56.559277, 56.573975, 56.588577, ... 59.069664, 59.082832, 59.09606 , 59.109356, 59.12271 , 59.136127, 59.149612, 59.163162, 59.17678 , 59.190468, 59.20422 , 59.218044, 59.231937, 59.2459 , 59.259937, 59.274048, 59.28823 , 59.30249 , 59.316826, 59.331238, 59.345726, 59.360294, 59.37494 , 59.389668, 59.40448 , 59.419373, 59.434345, 59.449406, 59.464554, 59.479782, 59.495102, 59.51051 , 59.52601 , 59.541595, 59.557274, 59.573044, 59.588905, 59.604862, 59.620914, 59.637066, 59.65331 , 59.66965 , 59.686092, 59.702637, 59.719276, 59.73602 , 59.752865, 59.769814, 59.786865, 59.80402 , 59.82128 , 59.83865 , 59.856125, 59.873703, 59.891396, 59.90919 , 59.9271 , 59.945114, 59.96324 , 59.98148 , 59.999825, 60.018284, 60.036854, 60.05553 , 60.07432 , 60.093224, 60.112236, 60.13136 , 60.15059 , 60.16993 , 60.189377, 60.20893 , 60.228592, 60.24836 , 60.268227, 60.288197, 60.308266, 60.32843 , 60.348686, 60.369038, 60.389473, 60.409996, 60.430595, 60.451267, 60.47201 , 60.49282 , 60.513687, 60.534603, 60.555557, 60.57655 , 60.597565, 60.61859 , 60.63962 , 60.66064 , 60.676384, 60.68687 , 60.697346, 60.70781 , 60.718254, 60.728683, 60.739086, 60.74947 , 60.759827, 60.770153, 60.780445, 60.790703, 60.800922, 60.8111 , 60.821228, 60.831303, 60.841328, 60.851288, 60.861183, 60.871014], dtype=float32)
- longitude(x)float32119.45596 119.32921 ... 75.9475
- bounds :
- /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/longitude_bounds
- long_name :
- pixel center longitude
- standard_name :
- longitude
- units :
- degrees_east
- valid_max :
- 180
- valid_min :
- -180
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
array([119.45596 , 119.32921 , 119.20397 , 119.080215, 118.9579 , 118.837 , 118.717476, 118.5993 , 118.48243 , 118.36685 , 118.252525, 118.13943 , 118.027534, 117.91682 , 117.80725 , 117.69881 , 117.59147 , 117.485214, 117.38001 , 117.275856, 117.17271 , 117.07056 , 116.91917 , 116.72061 , 116.52572 , 116.33434 , 116.14636 , 115.961655, 115.780106, 115.601616, 115.42607 , 115.25338 , 115.08345 , 114.91619 , 114.75152 , 114.58936 , 114.42963 , 114.272255, 114.11717 , 113.96432 , 113.813614, 113.66501 , 113.51843 , 113.37385 , 113.231186, 113.0904 , 112.95143 , 112.81425 , 112.67879 , 112.54501 , 112.41288 , 112.28235 , 112.15338 , 112.02593 , 111.89996 , 111.77545 , 111.65234 , 111.53062 , 111.41024 , 111.29118 , 111.1734 , 111.056885, 110.94159 , 110.82749 , 110.71457 , 110.60279 , 110.492134, 110.382576, 110.27409 , 110.16666 , 110.06024 , 109.95484 , 109.85042 , 109.74696 , 109.64445 , 109.542854, 109.44217 , 109.34238 , 109.24345 , 109.14536 , 109.04812 , 108.95169 , 108.856064, 108.76122 , 108.667145, 108.57383 , 108.481255, 108.3894 , 108.29826 , 108.20782 , 108.118065, 108.02898 , 107.94055 , 107.852776, 107.76563 , 107.67911 , 107.5932 , 107.50789 , 107.42317 , 107.33903 , ... 90.14031 , 90.04494 , 89.94877 , 89.85178 , 89.75397 , 89.655304, 89.555786, 89.455376, 89.35407 , 89.25185 , 89.14868 , 89.04456 , 88.93946 , 88.83337 , 88.72624 , 88.61809 , 88.50886 , 88.398544, 88.28712 , 88.17455 , 88.06083 , 87.945915, 87.82979 , 87.71241 , 87.593765, 87.47382 , 87.35255 , 87.229904, 87.105865, 86.9804 , 86.85348 , 86.72505 , 86.595085, 86.463554, 86.33041 , 86.1956 , 86.059105, 85.92087 , 85.78085 , 85.639 , 85.49528 , 85.34962 , 85.20198 , 85.052315, 84.90055 , 84.74664 , 84.59053 , 84.43214 , 84.271416, 84.10829 , 83.94269 , 83.77454 , 83.603775, 83.4303 , 83.254036, 83.074905, 82.89281 , 82.70765 , 82.51933 , 82.32776 , 82.13281 , 81.93439 , 81.73236 , 81.5266 , 81.316986, 81.10338 , 80.88563 , 80.66358 , 80.43708 , 80.20595 , 79.97002 , 79.72909 , 79.48296 , 79.23144 , 78.97427 , 78.77756 , 78.64453 , 78.50995 , 78.373795, 78.236015, 78.09658 , 77.95546 , 77.812614, 77.66799 , 77.52156 , 77.37328 , 77.2231 , 77.07098 , 76.91686 , 76.76071 , 76.60247 , 76.442085, 76.279495, 76.114655, 75.9475 ], dtype=float32)
- bounds :
- /PRODUCT/SUPPORT_DATA/GEOLOCATIONS/latitude_bounds
- long_name :
- pixel center latitude
- standard_name :
- latitude
- units :
- degrees_north
- valid_max :
- 90
- valid_min :
- -90
- _FillValue :
- 9.969209968386869e+36
- scale_factor :
- 1.0
- add_offset :
- 0.0
- grid_mapping :
- spatial_ref
r1_ai_crs_set.rio.to_raster('ai_crs_try1_rio.tif')
Reading using rasterio¶
import rasterio
base_file_handle = rasterio.open(file_path)
base_file_handle.subdatasets[:5]
['netcdf:TROPOMI_PythonCodesAndData/S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822.nc:/PRODUCT/latitude', 'netcdf:TROPOMI_PythonCodesAndData/S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822.nc:/PRODUCT/SUPPORT_DATA/GEOLOCATIONS/satellite_latitude', 'netcdf:TROPOMI_PythonCodesAndData/S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822.nc:/PRODUCT/SUPPORT_DATA/GEOLOCATIONS/satellite_longitude', 'netcdf:TROPOMI_PythonCodesAndData/S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822.nc:/PRODUCT/SUPPORT_DATA/GEOLOCATIONS/satellite_altitude', 'netcdf:TROPOMI_PythonCodesAndData/S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822.nc:/PRODUCT/SUPPORT_DATA/GEOLOCATIONS/satellite_orbit_phase']
r2 = rasterio.open('netcdf:./'+file_path+":/PRODUCT/aerosol_index_340_380")
type(r2)
rasterio.io.DatasetReader
ai_data = r2.read()
type(ai_data)
numpy.ndarray
ai_data.shape
(1, 3245, 450)
plt.imshow(ai_data[0])
<matplotlib.image.AxesImage at 0x196e8b8b0>
Convert to GeoTIFF using GDAL¶
!gdal_translate NETCDF:"TROPOMI_PythonCodesAndData/S5P_OFFL_L2__AER_AI_20180816T183016_20180816T201146_04361_01_010100_20180822T174822.nc":/PRODUCT/aerosol_index_340_380 try1.tif
Input file size is 450, 3245 Warning 1: Metadata exceeding 32000 bytes cannot be written into GeoTIFF. Transferred to PAM instead. 0...10...20...30...40...50...60...70...80...90...100 - done.