Note
This page was generated from a jupyter notebook.
Tidal Flow Calculator¶
(Greg Tucker, August 2020)
This tutorial explains the theory behind the TidalFlowCalculator
Landlab component, and shows several examples of how to use the component in various different configurations.
Theory¶
The TidalFlowCalculator
computes a tidal-cycle averaged flow velocity field, given a topography (bathymetry), mean sea level, tidal range, and tidal period. The approach that the component uses is based on Mariotti (2018). The idea is to calculate a flow velocity field that is just sufficient to bring in (flood tide) or send out (ebb tide) all of the water that enters or leaves the system during one tidal cycle.
The inertial terms in the shallow-water momentum equations are assumed to be negligible, so that the operative driving forces are gravity and pressure (represented by the water-surface slope), and the resisting force is friction. The resulting relationship between velocity, depth, roughness, and water-surface slope is linearized into the following form:
(1)
Here, \(U\) is velocity (2D vector), \(h\) is tidal-averaged water depth, \(n\) is roughness, \(\chi\) is a scale velocity (here assumed to be 1 m/s), and \(\eta = h + z\) is water surface elevation (and \(z\) is bed surface elevation). The equation above represents momentum conservation. Note that \(U\) and \(\nabla\eta\) are vectors, representing the \(x\) and \(y\) components of flow velocity and water-surface gradient, respectively.
The method uses a steady form of the mass-conservation equation—again, the idea is that we’re seeking a flow velocity field that is just sufficient to carry in or out all the water that enters or exits during a tidal cycle. The mass conservation equation is:
Here, \(\mathbf{q} = U h\) is the volume flow per unit width (again, a two-dimensional vector). The variable \(I\) is “the distributed input of water over half a tidal cycle” (Mariotti, 2018), defined as
where \(r\) is the tidal range [L] and \(T\) is the tidal period [T]. In the expression above, if the water at a point \((x,y)\) is deeper than the tidal amplitude (i.e, half the tidal range, or \(r/2\)), then the depth of inundation or drainage during half of a tidal cycle is simply the tidal range \(r\). All of this water must enter or leave during half a tidal cycle, or \(T/2\). Therefore the rate [L/T] of inundation or drainage is equal to the depth divided by \(T/2\). Again, if the water is deeper than \(r/2\), the rate is just \(2r/T\).
Our goal is to calculate \(U\) at each location. We get it by solving for \(\eta\) then using equation (1) to calculate \(U\). It turns out that we can formulate this as a Poisson equation: a steady diffusion equation, in this case in two (horizontal) dimensions. First, approximate that \(h\), \(n\) are uniform (even though they aren’t, in the general problem). Substituting, we have
Plugging this into our mass conservation law
This can be rearranged to:
This is the Poisson problem to be solved numerically.
Note that \(I\) is positive on the flood tide and negative on the ebb tide. In practice, the component solves for the ebb tide velocity, than calculates the flood tide velocity as -1 times the ebb tide velocity (i.e., just the reverse of the ebb tide).
Numerical methods¶
The TidalFlowCalculator
uses a finite-volume method to solve equation (1) numerically at the core nodes of a Landlab grid. The grid must be either a RasterModelGrid
or a HexModelGrid
. You can find a discussion of finite-volume methods in the tutorial for Landlab’s matrix-building utility. Here, a quick sketch of the solution method is as follows. The governing mass conservation equation is:
The basis for the 2d finite-volume method is to integrate both sides of the equation over a region \(R\), representing a grid cell. Then Green’s theorem is used to turn the divergence term into a line integral of the flux around the perimeter of the region, \(S\). The above equation becomes
where \(A_c\) is the surface area of the region and \(\mathbf{n}\) is the outward unit vector normal to the perimeter of the region. When the region is a grid cell with \(N\) faces of width \(w\), the above becomes
where \(q_k\) is the magnitude of \(q\) in the face-perpendicular direction at cell face \(k\), and \(\delta\) is either 1 or -1, depending on the orientation of the grid link that crosses the face. The flux strength \(q\) is positive when flow is in the direction of the link, and negative when it is in the opposite direction. For a RasterModelGrid
, \(N=4\), and for a HexModelGrid
, \(N=6\).
As discussed in the tutorial Building a matrix for numerical methods using a Landlab grid, when \(q\) depends on the gradient in some field (in this case, water-surface elevation), the above equation can be translated into a matrix equation of the form \(A\mathbf{x}=\mathbf{b}\), whose solution gives the solution to the Poisson equation.
Examples¶
One-dimensional case¶
Consider a one dimensional domain with open water at the east (right) side and a closed boundary (e.g., seawall) at the west (left) side, where by definition the distance from the seawall is \(x=0\). Assume that the mean water depth is larger than the tidal amplitude, so that the sea bed is never exposed, even at low tide. Imagine that our tidal range is 2 meters, the water depth is 50 meters, and (to make the math a bit easier) the tidal period is 40,000 seconds. The analytical solution for flow discharge, \(q\), can be found by noting that at any given distance from the sea wall, \(q\) must be just enough to carry out all the outgoing water (ebb tide) or carry in all the incoming water (flood tide). The rate of inflow or outflow is equal to the inundation/drainage rate \(I\) times distance from the sea wall, \(x\):
The negative sign just means that \(q\) is positive (flow to the right/east) when the tide is going out (negative \(I\)) and negative (flow to the left/west) when the tide is coming in. The velocity is
Here, \(h\) is a function of \(x\), but with a modest roughness (Manning’s \(n\)) of 0.01 and relatively deep water, we can get a good approximation using just the tidal-average depth of 50 m. With this approximation, we expect the solution to be:
The code below runs the component for these conditions, and compares the solution with this analytical solution.
[ ]:
import matplotlib.pyplot as plt
import numpy as np
from landlab import RasterModelGrid
from landlab.components import TidalFlowCalculator
[ ]:
# set up the grid
# only 1 row of core nodes, between 2 boundary rows
grid = RasterModelGrid((3, 101), xy_spacing=2.0)
# only east/right side open
grid.set_closed_boundaries_at_grid_edges(False, True, True, True)
# create the bathymetry field
z = grid.add_zeros("topographic__elevation", at="node")
z[:] = -50.0 # mean water depth is 50 m below MSL, which is our vertical datum
# create the component
tfc = TidalFlowCalculator(grid, tidal_range=2.0, tidal_period=4.0e4, roughness=0.01)
# run the component
tfc.run_one_step()
# calculate the analytical solution
x = np.arange(3.0, 200.0, 2.0)
vel_analytical = 2.0e-6 * x
# plot both
plt.plot(x, grid.at_link["ebb_tide_flow__velocity"][grid.active_links], "b.")
plt.plot(x, vel_analytical, "r")
plt.xlabel("Distance from sea wall (x)")
plt.ylabel("Ebb tide velocity (m/s)")
plt.legend(["numerical", "analytical"])
As we would expect, the numerical solution is slightly lower than the analytical solution, because our simplified analytical solution does not take into account the extra water depth whose gradient propels the ebb tide. (Exercise to the reader: develop the analytical solution for water surface elevation, and then use it to derive a correct flow velocity that accounts for a little bit of extra depth at ebb tide, and a little less depth at flood tide.)
Idealized two-dimensional cases¶
Two open boundaries¶
Here we use a rectangular domain with two open sides and two closed sides. Start by defining a generic plotting function:
[ ]:
from landlab.grid.mappers import map_link_vector_components_to_node
def map_velocity_components_to_nodes(grid):
"""Map the velocity components from the links to the nodes, and return the node arrays."""
ebb_vel_x, ebb_vel_y = map_link_vector_components_to_node(
grid, grid.at_link["ebb_tide_flow__velocity"]
)
flood_vel_x = -ebb_vel_x
flood_vel_y = -ebb_vel_y
return (ebb_vel_x, ebb_vel_y, flood_vel_x, flood_vel_y)
def plot_tidal_flow(grid, resample=1):
(ebb_x, ebb_y, flood_x, flood_y) = map_velocity_components_to_nodes(grid)
# depth
plt.figure()
grid.imshow(grid.at_node["mean_water__depth"], cmap="YlGnBu", color_for_closed="g")
plt.title("Water depth (m)")
plt.xlabel("Distance (m)")
plt.ylabel("Distance (m)")
# down-sample for legible quiver plots if needed
if resample != 1:
xr = grid.x_of_node.reshape(
(grid.number_of_node_rows, grid.number_of_node_columns)
)[::resample, ::resample]
yr = grid.y_of_node.reshape(
(grid.number_of_node_rows, grid.number_of_node_columns)
)[::resample, ::resample]
ebb_xr = ebb_x.reshape((grid.number_of_node_rows, grid.number_of_node_columns))[
::resample, ::resample
]
ebb_yr = ebb_y.reshape((grid.number_of_node_rows, grid.number_of_node_columns))[
::resample, ::resample
]
fld_xr = flood_x.reshape(
(grid.number_of_node_rows, grid.number_of_node_columns)
)[::resample, ::resample]
fld_yr = flood_y.reshape(
(grid.number_of_node_rows, grid.number_of_node_columns)
)[::resample, ::resample]
else:
xr = grid.x_of_node
yr = grid.y_of_node
ebb_xr = ebb_x
ebb_yr = ebb_y
fld_xr = flood_x
fld_yr = flood_y
# ebb tide
plt.figure()
grid.imshow(grid.at_node["topographic__elevation"])
plt.quiver(xr, yr, ebb_xr, ebb_yr)
plt.title("Ebb Tide")
plt.xlabel("Distance (m)")
plt.ylabel("Distance (m)")
ebb_vel_magnitude = np.sqrt(ebb_x * ebb_x + ebb_y * ebb_y)
plt.figure()
grid.imshow(ebb_vel_magnitude, cmap="magma", color_for_closed="g")
plt.title("Ebb Tide Velocity Magnitude (m/s)")
plt.xlabel("Distance (m)")
plt.ylabel("Distance (m)")
# flood tide
plt.figure()
grid.imshow(grid.at_node["topographic__elevation"])
plt.quiver(xr, yr, fld_xr, fld_yr)
plt.title("Flood Tide")
plt.xlabel("Distance (m)")
plt.ylabel("Distance (m)")
plt.figure()
flood_vel_magnitude = np.sqrt(flood_x * flood_x + flood_y * flood_y)
grid.imshow(flood_vel_magnitude, cmap="magma", color_for_closed="g")
plt.title("Flood Tide Velocity Magnitude (m/s)")
plt.xlabel("Distance (m)")
plt.ylabel("Distance (m)")
[ ]:
# parameters
nrows = 15
ncols = 25
grid_spacing = 100.0 # m
mean_depth = 2.0 # m
tidal_range = 2.0 # m
roughness = 0.01 # s/m^1/3, i.e., Manning's n
# create and set up the grid
grid = RasterModelGrid((nrows, ncols), xy_spacing=grid_spacing)
z = grid.add_zeros("topographic__elevation", at="node")
z[:] = -mean_depth
grid.set_closed_boundaries_at_grid_edges(False, False, True, True)
# instantiate the TidalFlowCalculator
tfc = TidalFlowCalculator(grid, tidal_range=2.0, roughness=0.01)
# run it
tfc.run_one_step()
# make plots...
plot_tidal_flow(grid)
Uniform with one open boundary¶
[ ]:
# parameters
nrows = 400
ncols = 200
grid_spacing = 2.0 # m
mean_depth = 2.0 # m
tidal_range = 3.1 # m
tidal_period = 12.5 * 3600.0 # s
roughness = 0.01 # s/m^1/3, i.e., Manning's n
open_nodes = np.arange(95, 105, dtype=int)
# create and set up the grid
grid = RasterModelGrid((nrows, ncols), xy_spacing=grid_spacing)
z = grid.add_zeros("topographic__elevation", at="node")
z[:] = -mean_depth
grid.set_closed_boundaries_at_grid_edges(True, True, True, False)
# instantiate the TidalFlowCalculator
tfc = TidalFlowCalculator(
grid, tidal_range=tidal_range, tidal_period=tidal_period, roughness=0.01
)
# run it
tfc.run_one_step()
# make plots...
plot_tidal_flow(grid, resample=5)
Uniform with narrow open boundary¶
[ ]:
# parameters
nrows = 400
ncols = 200
grid_spacing = 2.0 # m
mean_depth = 2.0 # m
tidal_range = 3.1 # m
tidal_period = 12.5 * 3600.0 # s
roughness = 0.01 # s/m^1/3, i.e., Manning's n
open_nodes = np.arange(95, 105, dtype=int)
# create and set up the grid
grid = RasterModelGrid((nrows, ncols), xy_spacing=grid_spacing)
z = grid.add_zeros("topographic__elevation", at="node")
z[:] = -mean_depth
grid.set_closed_boundaries_at_grid_edges(True, True, True, True)
grid.status_at_node[open_nodes] = grid.BC_NODE_IS_FIXED_VALUE
# instantiate the TidalFlowCalculator
tfc = TidalFlowCalculator(
grid, tidal_range=tidal_range, tidal_period=tidal_period, roughness=0.01
)
# run it
tfc.run_one_step()
# make plots...
plot_tidal_flow(grid, resample=5)
Straight channel¶
[ ]:
from landlab.grid.mappers import map_max_of_link_nodes_to_link
# parameters
nrows = 400
ncols = 200
grid_spacing = 2.0 # m
marsh_height = 1.0 # m
channel_depth = 2.0 # m
tidal_range = 3.1 # m
tidal_period = 12.5 * 3600.0 # s
open_nodes = np.arange(
94, 105, dtype=int
) # IDs of open-boundary nodes (along channel at bottom/south boundary)
roughness_shallow = 0.2 # Manning's n for areas above mean sea level (i.e., the marsh)
roughness_deep = 0.01 # Manning's n for areas below mean sea level (i.e., the channel)
# create and set up the grid
grid = RasterModelGrid((nrows, ncols), xy_spacing=grid_spacing)
z = grid.add_zeros("topographic__elevation", at="node")
z[grid.core_nodes] = marsh_height
channel = np.logical_and(grid.x_of_node >= 188.0, grid.x_of_node <= 208.0)
z[channel] = -channel_depth
grid.set_closed_boundaries_at_grid_edges(True, True, True, True)
grid.status_at_node[open_nodes] = grid.BC_NODE_IS_FIXED_VALUE
# set up roughness field (calculate on nodes, then map to links)
roughness_at_nodes = roughness_shallow + np.zeros(z.size)
roughness_at_nodes[z < 0.0] = roughness_deep
roughness = grid.add_zeros("roughness", at="link")
map_max_of_link_nodes_to_link(grid, roughness_at_nodes, out=roughness)
# instantiate the TidalFlowCalculator
tfc = TidalFlowCalculator(
grid, tidal_range=tidal_range, tidal_period=tidal_period, roughness="roughness"
)
# run it
tfc.run_one_step()
# make plots...
plot_tidal_flow(grid, resample=10)
Case study based on example in Giulio Mariotti’s MarshMorpho2D package¶
This example reads topography/bathymetry from a 2-meter resolution digital elevation model. Locations above mean high tide are flagged as closed boundaries.
[ ]:
from landlab.io import esri_ascii
# Set parameters (these are from the MarshMorpho2D source code)
tidal_period = 12.5 * 3600.0 # tidal period in seconds
tidal_range = 3.1 # tidal range in meters
roughness = 0.02 # Manning's n
mean_sea_level = 0.0 # mean sea level in meters
min_water_depth = (
0.01 # minimum depth for water on areas higher than low tide water surface, meters
)
nodata_code = 999 # code for a DEM cell with no valid data
# Read the DEM to create a grid and topography field
with open("zSW3.asc") as fp:
grid = esri_ascii.load(fp, name="topographic__elevation", at="node")
z = grid.at_node["topographic__elevation"]
# Configure boundaries: any nodata nodes, plus any nodes higher than mean high tide
grid.status_at_node[z == nodata_code] = grid.BC_NODE_IS_CLOSED
grid.status_at_node[z > 1.8] = grid.BC_NODE_IS_CLOSED
boundaries_above_msl = np.logical_and(
grid.status_at_node == grid.BC_NODE_IS_FIXED_VALUE, z > 0.0
)
grid.status_at_node[boundaries_above_msl] = grid.BC_NODE_IS_CLOSED
# Instantiate a TidalFlowCalculator component
tfc = TidalFlowCalculator(
grid,
tidal_period=tidal_period,
tidal_range=tidal_range,
roughness=roughness,
mean_sea_level=mean_sea_level,
min_water_depth=min_water_depth,
)
# Calculate tidal flow
tfc.run_one_step()
# make plots...
plot_tidal_flow(grid, resample=5)
Example with hex grid¶
The following example demonstrates that the TidalFlowCalculator
can operate on a hex grid
(Note that the slightly odd flow patterns along the two closed edges are just artifacts of the method used to map velocity vectors from links onto nodes for plotting purposes; the current method doesn’t accurately handle nodes adjacent to closed boundaries.)
[ ]:
def plot_tidal_flow_hex(grid):
(ebb_x, ebb_y) = map_link_vector_components_to_node(
grid, grid.at_link["ebb_tide_flow__velocity"]
)
# ebb tide velocity vectors & magnitude
ebb_vel_magnitude = np.sqrt(ebb_x * ebb_x + ebb_y * ebb_y)
plt.figure()
grid.imshow(ebb_vel_magnitude, cmap="magma")
plt.quiver(grid.x_of_node, grid.y_of_node, ebb_x, ebb_y)
plt.title("Ebb Tide")
plt.xlabel("Distance (m)")
plt.ylabel("Distance (m)")
[ ]:
from landlab import HexModelGrid
# parameters
nrows = 15
ncols = 25
grid_spacing = 100.0 # m
mean_depth = 2.0 # m
tidal_range = 2.0 # m
roughness = 0.01 # s/m^1/3, i.e., Manning's n
# create and set up the grid
grid = HexModelGrid((nrows, ncols), spacing=grid_spacing, node_layout="rect")
z = grid.add_zeros("topographic__elevation", at="node")
z[:] = -mean_depth
grid.status_at_node[grid.nodes_at_bottom_edge] = grid.BC_NODE_IS_CLOSED
grid.status_at_node[grid.nodes_at_left_edge] = grid.BC_NODE_IS_CLOSED
# instantiate the TidalFlowCalculator
tfc = TidalFlowCalculator(grid, tidal_range=2.0, roughness=0.01)
# run it
tfc.run_one_step()
# make plots...
plot_tidal_flow_hex(grid)