Heat and Trees#
Urban Heat Islands and Street Trees#
In this notebook we’ll be exploring the urban heat island effect by looking at the impact on surface temperature of roof color and street trees. We’ll be replicating the process described here but using Python tools rather than ESRI.
Data sources: This notebook uses Landsat data from Google Cloud Storage as well as some geographic data from OpenDataPhilly.
import intake
import xarray as xr
import pandas as pd
import numpy as np
import geopandas as gpd
import cartopy.crs as ccrs
import hvplot.xarray # noqa
import hvplot.pandas # noqa
from geoviews.tile_sources import EsriImagery
from pyproj import CRS
Just some extra info about Landsat data:
band_info = pd.DataFrame([
(1, "Aerosol", " 0.43 - 0.45", 0.440, "30", "Coastal aerosol"),
(2, "Blue", " 0.45 - 0.51", 0.480, "30", "Blue"),
(3, "Green", " 0.53 - 0.59", 0.560, "30", "Green"),
(4, "Red", " 0.64 - 0.67", 0.655, "30", "Red"),
(5, "NIR", " 0.85 - 0.88", 0.865, "30", "Near Infrared (NIR)"),
(6, "SWIR1", " 1.57 - 1.65", 1.610, "30", "Shortwave Infrared (SWIR) 1"),
(7, "SWIR2", " 2.11 - 2.29", 2.200, "30", "Shortwave Infrared (SWIR) 2"),
(8, "Panc", " 0.50 - 0.68", 0.590, "15", "Panchromatic"),
(9, "Cirrus", " 1.36 - 1.38", 1.370, "30", "Cirrus"),
(10, "TIRS1", "10.60 - 11.19", 10.895, "100 * (30)", "Thermal Infrared (TIRS) 1"),
(11, "TIRS2", "11.50 - 12.51", 12.005, "100 * (30)", "Thermal Infrared (TIRS) 2")],
columns=['Band', 'Name', 'Wavelength Range (µm)', 'Nominal Wavelength (µm)', 'Resolution (m)', 'Description']).set_index(["Band"])
band_info
Name | Wavelength Range (µm) | Nominal Wavelength (µm) | Resolution (m) | Description | |
---|---|---|---|---|---|
Band | |||||
1 | Aerosol | 0.43 - 0.45 | 0.440 | 30 | Coastal aerosol |
2 | Blue | 0.45 - 0.51 | 0.480 | 30 | Blue |
3 | Green | 0.53 - 0.59 | 0.560 | 30 | Green |
4 | Red | 0.64 - 0.67 | 0.655 | 30 | Red |
5 | NIR | 0.85 - 0.88 | 0.865 | 30 | Near Infrared (NIR) |
6 | SWIR1 | 1.57 - 1.65 | 1.610 | 30 | Shortwave Infrared (SWIR) 1 |
7 | SWIR2 | 2.11 - 2.29 | 2.200 | 30 | Shortwave Infrared (SWIR) 2 |
8 | Panc | 0.50 - 0.68 | 0.590 | 15 | Panchromatic |
9 | Cirrus | 1.36 - 1.38 | 1.370 | 30 | Cirrus |
10 | TIRS1 | 10.60 - 11.19 | 10.895 | 100 * (30) | Thermal Infrared (TIRS) 1 |
11 | TIRS2 | 11.50 - 12.51 | 12.005 | 100 * (30) | Thermal Infrared (TIRS) 2 |
Loading data#
For this example, we will be using landsat data stored on Google Cloud Storage. Since these data are accessed via https, there is no guaranteed directory structure, so we will need to specify the url pointing to each file and then iterate over the files to create a concatenated dataset. We use jinja template notation in intake to pass parameters to the urlpath
.
cat = intake.open_catalog('catalog.yml')
list(cat)
['google_landsat_band',
'neighborhoods_philadelphia',
'ppr_tree_inventory_2022']
Let’s take a look at what the google_landsat_band
looks like:
google_landsat_band:
description: Landsat bands from Google Cloud Storage
driver: rasterio
parameters:
path:
description: landsat path
type: int
row:
description: landsat row
type: int
product_id:
description: landsat file id
type: str
band:
description: band
type: int
args:
urlpath: https://storage.googleapis.com/gcp-public-data-landsat/LC08/01/{{ '%03d' % path }}/{{ '%03d' % row }}/{{ product_id }}/{{ product_id }}_B{{ band }}.TIF
chunks:
band: 1
x: 256
y: 256
The following might feel a bit arbitrary, but we have chosen the path and row corresponding to the area over Philadelphia using the earth explorer. We have also found the id of the particular date of interest using the same tool. With these values in hand, we can access parts of each file on Google Cloud Storage.
path = 14
row = 32
product_id = 'LC08_L1TP_014032_20160727_20170222_01_T1'
The first step to using intake is to initialize the catalog entry with user parameters to create a data source
.
data_source = cat.google_landsat_band(path=path, row=row, product_id=product_id)
From this data source
we can get a lazily loaded xarray object using dask. To make sure that we can inspect what dask is up to, it can be helpful to create a dask client.
ds = data_source.to_dask()
ds.name = 'value'
/home/runner/work/examples/examples/heat_and_trees/envs/default/lib/python3.11/site-packages/intake_xarray/raster.py:107: FutureWarning: The return type of `Dataset.dims` will be changed to return a set of dimension names in future, in order to be more consistent with `DataArray.dims`. To access a mapping from dimension names to lengths, please use `Dataset.sizes`.
'dims': dict(ds2.dims),
Loading in metadata regarding these particular Landsat images from the associated matlab.txt file.
def load_google_landsat_metadata(path, row, product_id):
"""Load Landsat metadata for path, row, product_id from Google Cloud Storage
"""
def parse_type(x):
try:
return eval(x)
except:
return x
baseurl = 'https://storage.googleapis.com/gcp-public-data-landsat/LC08/01'
suffix = f'{path:03d}/{row:03d}/{product_id}/{product_id}_MTL.txt'
df = intake.open_csv(
urlpath=f'{baseurl}/{suffix}',
csv_kwargs={'sep': '=',
'header': None,
'names': ['index', 'value'],
'skiprows': 2,
'converters': {'index': (lambda x: x.strip()),
'value': parse_type}}).read()
metadata = df.set_index('index')['value']
return metadata
metadata = load_google_landsat_metadata(path, row, product_id)
metadata.head()
index
ORIGIN Image courtesy of the U.S. Geological Survey
REQUEST_ID 0501702206266_00020
LANDSAT_SCENE_ID LC80140322016209LGN01
LANDSAT_PRODUCT_ID LC08_L1TP_014032_20160727_20170222_01_T1
COLLECTION_NUMBER 01
Name: value, dtype: object
Sub-setting to area of interest#
So far we haven’t downloaded any band data. Since we know that we are interested in Philadelphia, we can just take a smaller square of data that covers the extents of the city. First we need to know the projection of the dataset:
ds.rio.crs
CRS.from_epsg(32618)
We’ll convert that into something directly usable for later:
proj_crs= CRS.from_epsg(32618)
proj_crs
<Projected CRS: EPSG:32618>
Name: WGS 84 / UTM zone 18N
Axis Info [cartesian]:
- E[east]: Easting (metre)
- N[north]: Northing (metre)
Area of Use:
- name: Between 78°W and 72°W, northern hemisphere between equator and 84°N, onshore and offshore. Bahamas. Canada - Nunavut; Ontario; Quebec. Colombia. Cuba. Ecuador. Greenland. Haiti. Jamaica. Panama. Turks and Caicos Islands. United States (USA). Venezuela.
- bounds: (-78.0, 0.0, -72.0, 84.0)
Coordinate Operation:
- name: UTM zone 18N
- method: Transverse Mercator
Datum: World Geodetic System 1984 ensemble
- Ellipsoid: WGS 84
- Prime Meridian: Greenwich
crs = ccrs.UTM(zone=18)
Now if we were just looking for one particular point we could use that point, converted to the coordinate system of the data, and then select the data nearest to it:
x_center, y_center = crs.transform_point(-75.1652, 39.9526, ccrs.PlateCarree())
nearest_to_center = ds.sel(x=x_center, y=y_center, method='nearest')
print(nearest_to_center.compute())
nearest_to_center.hvplot.line(x='band')
<xarray.DataArray 'value' (band: 4)> Size: 8B
array([11465, 12774, 30347, 26335], dtype=uint16)
Coordinates:
x float64 8B 4.859e+05
y float64 8B 4.423e+06
spatial_ref int64 8B 0
* band (band) int64 32B 4 5 10 11
Attributes:
AREA_OR_POINT: Point
scale_factor: 1.0
add_offset: 0.0
In this case, though, we are interested in a subset of data that covers that city of Philadelphia. So we need some geometry to specify the bounds of the city. We can get a GeoJSON of neighborhood data from OpenDataPhilly.
geoms = gpd.GeoDataFrame.from_features(cat.neighborhoods_philadelphia.read(), crs=4326)
bounds = geoms.geometry.bounds
lower_left_corner_lat_lon = bounds.minx.min(), bounds.miny.min()
upper_right_corner_lat_lon = bounds.maxx.max(), bounds.maxy.max()
print(lower_left_corner_lat_lon, upper_right_corner_lat_lon)
(np.float64(-75.280266), np.float64(39.867004)) (np.float64(-74.955763), np.float64(40.137992))
Using the crs defined above, we can transform these lat/lons into map coordinates.
ll_corner = crs.transform_point(*lower_left_corner_lat_lon, ccrs.PlateCarree())
ur_corner = crs.transform_point(*upper_right_corner_lat_lon, ccrs.PlateCarree())
print(ll_corner, ur_corner)
(np.float64(476030.21311048063), np.float64(4413033.712613887)) (np.float64(503768.4451229614), np.float64(4443074.1017383))
Then we can use those corners to slice the data. If the subset is empty along x or y, the ordering of the coordinates might not be what you anticipated. Try swapping the order of arguments in the slice.
subset = ds.sel(x=slice(ll_corner[0], ur_corner[0]), y=slice(ur_corner[1], ll_corner[1]))
We can persist this slice of the dataset in memory for easy use later.
subset = subset.persist()
subset
<xarray.DataArray 'value' (band: 4, y: 1001, x: 925)> Size: 7MB dask.array<getitem, shape=(4, 1001, 925), dtype=uint16, chunksize=(1, 256, 256), chunktype=numpy.ndarray> Coordinates: * x (x) float64 7kB 4.76e+05 4.761e+05 ... 5.037e+05 5.038e+05 * y (y) float64 8kB 4.443e+06 4.443e+06 ... 4.413e+06 4.413e+06 spatial_ref int64 8B 0 * band (band) int64 32B 4 5 10 11 Attributes: AREA_OR_POINT: Point scale_factor: 1.0 add_offset: 0.0
To check that we got the right area, we can do a simple plot of one of the bands and overlay the neighborhoods on top of it. We’ll use hvplot to quickly create a holoviews object rendered in bokeh.
geoms.head()
geometry | name | listname | mapname | shape_leng | shape_area | cartodb_id | created_at | updated_at | |
---|---|---|---|---|---|---|---|---|---|
0 | MULTIPOLYGON (((-75.05646 40.08743, -75.05667 ... | PENNYPACK_PARK | Pennypack Park | Pennypack Park | 87084.285589 | 6.014076e+07 | 9 | 2013-03-19T17:41:50.508Z | 2013-03-19T17:41:50.743Z |
1 | MULTIPOLYGON (((-75.2272 39.9774, -75.22984 39... | OVERBROOK | Overbrook | Overbrook | 57004.924607 | 7.692499e+07 | 138 | 2013-03-19T17:41:50.508Z | 2013-03-19T17:41:50.743Z |
2 | MULTIPOLYGON (((-75.16208 40.02829, -75.16145 ... | GERMANTOWN_SOUTHWEST | Germantown, Southwest | Southwest Germantown | 14880.743608 | 1.441867e+07 | 59 | 2013-03-19T17:41:50.508Z | 2013-03-19T17:41:50.743Z |
3 | MULTIPOLYGON (((-75.19931 39.97462, -75.19869 ... | EAST_PARKSIDE | East Parkside | East Parkside | 10885.781535 | 4.231000e+06 | 129 | 2013-03-19T17:41:50.508Z | 2013-03-19T17:41:50.743Z |
4 | MULTIPOLYGON (((-75.22722 40.03523, -75.22865 ... | GERMANY_HILL | Germany Hill | Germany Hill | 13041.939087 | 6.949968e+06 | 49 | 2013-03-19T17:41:50.508Z | 2013-03-19T17:41:50.743Z |
band_plot = subset.mean('band').hvplot(x='x', y='y', rasterize=True, crs=crs, cnorm='eq_hist', cmap='gray')
hood_plot = geoms.hvplot(geo=True, alpha=.5, c='mapname', legend=False, frame_height=450)
band_plot * hood_plot
Calculate NDVI#
We’ll calculate NDVI but we won’t yet do any computations – our bands are actually dask arrays, which allow for lazy computation.
subset = subset.where(subset > 0)
NDVI = (subset.sel(band=5) - subset.sel(band=4)) / (subset.sel(band=5) + subset.sel(band=4))
NDVI = NDVI.where(NDVI < np.inf)
NDVI
<xarray.DataArray 'value' (y: 1001, x: 925)> Size: 4MB dask.array<where, shape=(1001, 925), dtype=float32, chunksize=(256, 256), chunktype=numpy.ndarray> Coordinates: * x (x) float64 7kB 4.76e+05 4.761e+05 ... 5.037e+05 5.038e+05 * y (y) float64 8kB 4.443e+06 4.443e+06 ... 4.413e+06 4.413e+06 spatial_ref int64 8B 0
In order to visualize NDVI, the data will need to be loaded and the NDVI computed.
NDVI.hvplot(x='x', y='y', crs=crs, rasterize=True, cmap='viridis', frame_height=450)
Calculate land surface temperature#
Given the NDVI calculated above, we can determine land surface temperature. For ease, we’ll use some top of atmosphere calculations that have already been written up as Python functions as part of rasterio work in the rio_toa module. We will reproduce the brightness_temp
and temp_rescale
functions from the rio_toa
module here to make it easier and faster.
def brightness_temp(img, ML, AL, K1, K2, src_nodata=0):
"""Calculate brightness temperature of Landsat 8 combining the calculations of radiance and temperature.
Parameters:
img (ndarray): Input pixels array.
ML (float): Multiplicative rescaling factor from scene metadata.
AL (float): Additive rescaling factor from scene metadata.
K1 (float): Thermal conversion constant from scene metadata.
K2 (float): Thermal conversion constant from scene metadata.
src_nodata (int, optional): Value representing 'no data' in input array.
Returns:
ndarray: Array of at-satellite brightness temperature in degrees Kelvin.
"""
L = ML * img.astype(np.float32) + AL
L[img == src_nodata] = np.nan
T = K2 / np.log((K1 / L) + 1)
return T
def temp_rescale(arr, temp_scale):
"""Converts the `arr` in Kelvin (K) to the specified `temp_scale`- Kelvin(K), Farenheit(F) or Celcius(C)."""
if temp_scale == 'K':
return arr
elif temp_scale == 'F':
return arr * (9 / 5.0) - 459.67
elif temp_scale == 'C':
return arr - 273.15
else:
raise ValueError('%s is not a valid temperature scale'
% (temp_scale))
We’ll also need to specify one more for transforming satellite temperature (brightness temp) to land surface temperature. For these calculations we’ll use both Thermal Infrared bands - 10 and 11.
def land_surface_temp(BT, w, NDVI):
"""Calculate land surface temperature of Landsat 8
temp = BT/1 + w * (BT /p) * ln(e)
BT = At Satellite temperature (brightness)
w = wavelength of emitted radiance (μm)
where p = h * c / s (1.439e-2 mK)
h = Planck's constant (Js)
s = Boltzmann constant (J/K)
c = velocity of light (m/s)
"""
h = 6.626e-34
s = 1.38e-23
c = 2.998e8
p = (h * c / s) * 1e6
Pv = (NDVI - NDVI.min() / NDVI.max() - NDVI.min())**2
e = 0.004 * Pv + 0.986
return BT / 1 + w * (BT / p) * np.log(e)
Now we’ll set up a helper function to retrieve all the parameters from the metadata and general Landsat info table, and calculate the land surface temperature for bands 10 and 11.
def land_surface_temp_for_band(band, data, units='F'):
# params from general Landsat info
w = band_info.loc[band]['Nominal Wavelength (µm)']
# params from specific Landsat data text file for these images
ML = metadata[f'RADIANCE_MULT_BAND_{band}']
AL = metadata[f'RADIANCE_ADD_BAND_{band}']
K1 = metadata[f'K1_CONSTANT_BAND_{band}']
K2 = metadata[f'K2_CONSTANT_BAND_{band}']
at_satellite_temp = brightness_temp(data.sel(band=band).values, ML, AL, K1, K2)
temp = land_surface_temp(at_satellite_temp, w, NDVI).compute()
return temp_rescale(temp, units)
temp_10_f = land_surface_temp_for_band(10, subset)
temp_11_f = land_surface_temp_for_band(11, subset)
temp_f = xr.concat([temp_10_f, temp_11_f],
dim=xr.DataArray([10,11], name='band', dims=['band']))
temp_f
<xarray.DataArray 'value' (band: 2, y: 1001, x: 925)> Size: 15MB array([[[83.10190773, 82.91038143, 82.67288905, ..., 97.35640666, 97.21178541, 96.91421685], [82.62258043, 82.52232388, 82.3720934 , ..., 96.97288604, 97.08645353, 97.08646979], [82.26775089, 82.28015277, 82.26777613, ..., 96.63993145, 97.01599609, 97.15681299], ..., [88.05508444, 87.47605606, 86.78928098, ..., 85.07908909, 84.91395173, 84.42642427], [88.10400659, 87.44762669, 86.74031197, ..., 85.20723063, 84.98407479, 84.53367951], [87.99411402, 87.16168887, 86.3177346 , ..., 85.281523 , 85.19033867, 85.04210212]], [[76.12944534, 75.90282469, 75.70644289, ..., 86.37502271, 86.23002248, 86.07993913], [75.86254687, 75.62539663, 75.35801324, ..., 86.16211013, 86.13313787, 86.17671576], [75.59035087, 75.47415302, 75.27727088, ..., 86.0315293 , 86.31695341, 86.31209094], ..., [79.19698228, 78.86343219, 78.50471789, ..., 76.37078288, 76.08386229, 75.64569458], [79.33132965, 78.85358094, 78.37023776, ..., 76.59738754, 76.33553043, 75.96802994], [79.34624269, 78.68921338, 78.03036429, ..., 76.74314736, 76.67230547, 76.56716019]]]) Coordinates: * x (x) float64 7kB 4.76e+05 4.761e+05 ... 5.037e+05 5.038e+05 * y (y) float64 8kB 4.443e+06 4.443e+06 ... 4.413e+06 4.413e+06 spatial_ref int64 8B 0 * band (band) int64 16B 10 11
Compare the results from the two different bands, noticing that the colorbars are different.
temp_f.hvplot(x='x', y='y', groupby='band', cmap='fire_r',
crs=crs, rasterize=True, project=True, frame_height=350).layout()
We’ll take the mean of the calculated land surface temperature for each of the bands and mimic the colormap used in the project that we are duplicating.
mean_temp_f = temp_f.mean(dim='band')
mean_temp_f.hvplot(x='x', y='y', title='Mean Surface Temp (F)', crs=crs, tiles='EsriImagery',
frame_height=450, project=True, cmap='rainbow', alpha=.5, legend=False)
Notice how the hot spots are located over warehouse roofs and parking lots. This becomes even more visible when just the temperatures greater than 90F are displayed. To show this, we’ll make a special colormap that just includes high intensity reds that are found at the top of the fire_r
colormap.
import colorcet as cc
special_cmap = cc.fire[::-1][90:]
thresholded_temp = mean_temp_f.where(mean_temp_f > 90)
thresholded_temp_p = thresholded_temp.hvplot(x='x', y='y', title='Mean Temp (F) > 90',
cmap=special_cmap, crs=crs, frame_width=400, frame_height=450, legend=False)
thresholded_temp_p + thresholded_temp_p.opts(alpha=.3, data_aspect=None) * EsriImagery