1 Introduction
According to the “hairy ball theorem” of Poincaré (proved by Brouwer), every continuous horizontal vector field on the surface of a sphere must have a 0; a unit vector field must have a discontinuity. A differentiable coordinate on the surface of a sphere, for example, latitude or longitude, will have a gradient unit vector that is tangent to the sphere; such a coordinate will also have a discontinuity. A horizontal vector component has a magnitude and a direction based on an underlying coordinate (e.g., eastward velocity and longitude). The coordinate will have a discontinuity somewhere, so if the component is to be continuous over the whole sphere, its magnitude must be 0 where the coordinate is discontinuous. Scalar quantities have no associated direction and may be continuous over the whole sphere. Spatial derivatives acting on scalar quantities may use local coordinates, and coordinates of a point need not be continuous with respect to those of an adjacent point. Spatial derivatives acting on vector components require the components to be continuous. Coordinate discontinuities occur at the poles on a latitude–longitude (lat–long) grid or at the face edges on a cubed-sphere grid if coordinates are switched.
Many numerical schemes for solving the fluid dynamic equations on the surface of a sphere use two independent horizontal velocity components aligned with underlying coordinates. On a lat–long grid, polar singularities occur as well as other problems discussed in the introduction of . Components are orthogonal on a lat–long grid, but if they are not orthogonal on another grid, then greater obtuseness of the components' angle decreases stability and precision of the results. In addition, formulas involving the two coordinates are often not symmetric; this is certainly the case for standard lat–long schemes or spectral harmonic schemes .
To use the lat–long grid, but to avoid its polar deficiencies, the HYbrid Coordinate Ocean Model (HYCOM) uses a Mercator lat–long grid south of 58 N, and a different polar projection north of it, introducing the necessity to match variables along the boundary. The Yin–Yang grid (like the cover of a baseball) uses two orthogonal lat–long grids, one with a north–south axis and another with an equatorial axis; meeting of the domains is complicated, but the results are reasonable. tested a “skipped lat–long” grid that uses fewer cells in longitude poleward of 66 in a one-layer model. Other researchers have explored cubed-sphere grids: and . The advantages of using a cubed-sphere grid over a lat–long grid are that the two polar singularities on the lat–long grid are replaced by eight ill-behaved corners on the cubed-sphere grid and the extreme aspect ratio of grid cells near the poles on a lat–long grid is eliminated as well as the polar filter used to increase the time step. A more thorough discussion of advantages and disadvantages of a cubed-sphere grid over a lat–long grid occurs in . A problem with the abovementioned grids is that the treatment and behavior at grid edges differs significantly from that away from the edges. Choices that must be made in the pursuit of consistency have the potential for inducing edge errors. This will not be the case for the approach presented here.
Recent research on one-layer models has been directed at icosahedral grids: , , , , , , and others. The grid cells are usually pentagons and slightly irregular hexagons. Although irregularities are distributed all over the sphere, the hope is that icosahedral grid errors are less concentrated than edge errors of other grids and also less severe.
If two-component velocity is the prognostic transport variable that is advected in flux form, then spatial derivatives of vector components will cause discontinuities to occur. This is a principal reason why researchers developed forms of the shallow water equations wherein scalar quantities such as potential vorticity, specific kinetic energy, and divergence are continuous everywhere. Computations are performed on local spherical coordinates or on the local tangent plane after which the horizontal velocity components are resurrected or time integrated by manipulating spatial derivatives of scalar quantities; spatial derivatives of vector components are not needed. Such forms include vector-invariant , vorticity–divergence , or stream function and velocity potential , but the equations and programming can be complex.
The approach here uses three symmetric coordinates on the surface of a sphere to represent two-dimensional flow. When one coordinate reaches a singularity, it is ignored and the other two coordinates become perpendicular on the spherical surface. Symmetric equations are used to develop one-layer shallow water equation models: one for a gnomonic cubed-sphere grid (CSK), one for an icosahedral B grid with momentum defined at the primary grid cell corners (IB), and one for an icosahedral grid with a Voronoi tessellation (IK).
Several formulas of the symmetric equations are simplified by using relative specific angular momentum on the unit sphere, A, as opposed to using the three velocity components. A is continuous everywhere; each component converges to 0 at its respective poles. A has been used by and other researchers under the name , but it was not recognized as the specific angular momentum vector on the surface of a sphere. The north–south axis component of A is identical to eastward in the spectral model of which also uses northward . Both components are 0 and are continuous at the poles, but the other components of angular momentum are absent. presents a spectral transform three-dimensional Cartesian method to solve the shallow water equations on the sphere written in vorticity–divergence form. Putting aside the spectral transform method and vorticity–divergence form, there are some similarities (he again uses ) and major differences. His equations exist in and are later restricted to the spherical surface, whereas symmetric equations are compressed to the surface from the beginning, and his equations use velocity instead of specific angular momentum.
The shallow water equations based on A are simpler than those using velocity or those using vector-invariant methods. Components of A are symmetric; polar problems are absent; and the metric term disappears from the momentum equation that exists when using eastward and northward velocity. Conservation of A by advection in flux form is precise without time truncation errors. The symmetric equations are performed on the spherical surface without relying on tangent plane computations. Horizontal velocity and related A must be tangent to the spherical surface that allows only two degrees of freedom. Thus, three momentum components are not independent; there is a required alignment. If some process disturbs this alignment (e.g., advection or non-horizontal acceleration), causing momentum to no longer be horizontal, then a simple algorithm brings the three components back into alignment. This problem was recognized by , who added a “Lagrange multiplier” term to the velocity equation of Cartesian that was restricted to the spherical surface.
Computers require grid representations of differential equations; this causes numerical errors that relate to grid imprinting, mass variations, time integration, etc. Grid imprinting is easily recognized when integrating the solid body rotation Test Case 2 of , which lacks bottom topography. Errors due to grid imprinting should and do decrease with finer resolution.
Mass variations cause advection errors in numerical models and cause grid-matched alternating patterns. Mass is usually conserved by programming advection to use flux form, but when mass is needed at different locations, it is specific mass or concentration that is interpolated. Tracers that follow mass advection include linear momentum and velocity, angular momentum and specific angular momentum, kinetic energy and specific kinetic energy, or absolute vorticity and potential vorticity. investigated mass variations and stated, “Tracer concentration is defined relative to air mass and not relative to space. In fact, with nonuniform mass, second- and fourth-order schemes become first-order schemes …” The mass coordinate at a point, in a spatial one-dimensional model, is the number of kilograms between the origin and the point. Second-order, fourth-order, and spectral schemes, in one dimension, usually compute their polynomial or sine wave coefficients from equally distributed points in space, but the points are not equally distributed in the mass coordinate, and consequently the derived coefficients are erroneous.
If tracer concentration is a linear function of mass over several grid cells in one dimension, then “the linear upstream scheme” of will perform the advection over those cells perfectly, even with arbitrary mass variations. Similarly, if concentration is a quadratic function of mass in one dimension, then “the quadratic upstream scheme” of performs advection perfectly. Each of these schemes uses mean tracer values and prognostic tracer gradients (and second-order moments) inside each grid cell; these schemes are less sensitive to mass variations than are non-upstream schemes. The one-layer icosahedral model IB, discussed in detail later in this paper, uses a combination of linear upstream and second-order schemes for momentum advection but does not carry prognostic gradients. According to , “an upwind-based interpolation of the potential vorticity controls the computational Rossby modes” in some one-layer models.
To be applied to the Earth, models should be tested with mass variations comparable to those on Earth. In some mountainous regions, surface pressure gradients and mass variations increase with finer resolution and so do their errors. Test Case 5 of is insufficient to judge model quality considering the topography variations that occur on Earth. Surface pressure gradients in Williamson do not vary with resolution and are 2 orders of magnitude smaller than the gradient at some locations on Earth, particularly the Andes. When a one-layer model is tested with various resolutions, it should include tests where such increased gradients exist. If a one-layer model requires special filtering to produce good results with an Earth topography simulation, then that filtering should be used when the model is applied to the less rigorous tests of Williamson.
Section 2 explains symmetric mathematics, including coordinates and variables, symmetric calculus operators, and the differential solution to the shallow water equations in terms of symmetric coordinates. Section 3 presents the discrete implementation of alignment, the pressure gradient force, advection, the Coriolis force, and other aspects of icosahedral models including grid arrangements and time steps. Section 4 applies three test cases to lat–long, cubed-sphere, and icosahedral one-layer models with various resolutions. Section 5 contains discussion and conclusions.
Unlike computer languages, division has lower precedence than does multiplication in this paper. Vector quantities are indicated by bold capital letters; when displayed by three coordinates, e.g., , they are the Cartesian coordinates of on the fixed Earth and not a local coordinate system.
2 Symmetric mathematics
A sphere of radius 1 is centered at the origin in three-dimensional Cartesian space with axis unit vectors , , and . A concentric sphere represents the fixed Earth with its radius and its geometric labels such as latitude, longitude, Equator, and poles. The Z axis is aligned with the Earth's north–south axis, but this is only necessary for simplifying the sine of latitude for the Coriolis force. Horizontal velocity is resolved by the three components, one for each of the mutually orthogonal axes. One component is eastward velocity and its coordinate is longitude, which rotates around the Z axis. The other two components rotate around the two equatorial axes. Symmetric versions of the shallow water equations and vector calculus formulas are presented, in which each coordinate has symmetric representation in the equations and formulas. Each coordinate is defined continuously except at its two poles. But, as a coordinate approaches one of its poles, its numerical importance in the formulas decreases, having no importance at the pole, and the other two coordinates become more nearly perpendicular. Consequently, vector resolution and calculus operations are continuous over the whole sphere including the poles.
2.1 Coordinates and variables
Cartesian coordinates on the surface of the unit sphere are labeled , where ; this label is also used for points on the Earth's surface, but they mean the projection onto the unit sphere. Note that and are the sine and cosine of the Earth's latitude.
Three horizontal velocity components, , , and (m s), defined everywhere on the Earth's surface, except at their poles, rotate around each respective axis. Velocity unit vectors of the three symmetric components and the northward velocity component , at point P, are S (m s) is horizontal velocity at point P and is equal to u of Cartesian in Ringler et al. (2010). Note that , , and . Although there are three components, there are only two degrees of freedom, since .
Relative specific angular momentum on the unit sphere, A (m s), uses the variables , , and : The component pointing toward the Z axis is equal to the eastward velocity multiplied by the cosine of the Earth's latitude. If A and S are properly aligned, i.e., horizontal or tangent to the spherical surface at P, then they have the relationships , , and . Thus, on the surface of the sphere, A is at right angle to S and both are tangent to the surface. The components of A are mutually orthogonal, being aligned with the X, Y, and Z axes that are fixed with respect to the Earth, whereas the components of horizontal velocity aligned with the unit vectors U, V, and W are not orthogonal and change with location. Also, , , and are continuous everywhere, whereas , , and are discontinuous at their respective poles. S, written in terms of , , and , can be simplified using the components of A and is most readily derived from .
2.6 The northern velocity component rotated 90 from W is . The velocity component rotated 90 from U is and that rotated from V is , which are used for the Coriolis force. Velocity squared is .
Spherical angular rotation coordinates, measured in radians, that rotate around the X, Y, and Z axes are , , and , respectively. Angular rotation coordinates measured from pole to pole for each axis are , , and , respectively. and are the Earth's longitude and latitude. A point on the sphere can be designated by any of four different coordinate systems: 2.7 At any point, the gradients of , , , and on the spherical surface are parallel to the unit vectors U, V, W, and N. Partial derivatives of the angular rotation coordinates with respect to one another are needed to derive new and old forms of various terms. A change in causes a change in in the ratio of . In the limit, . A few useful derivatives are Prognostic variables for the shallow water equations on the sphere are the height field above the surface topography, (m), and A. Because density (kg m) is uniform and is set to 1, and mass per unit area are used interchangeably. The surface topography, (m), is specified. (m), the Earth's radius, (m s), the downward vertical acceleration due to gravity, and (s), the Earth's angular rotation rate, are assumed to be uniform. The field top geopotential (m s) is .
The new symmetric equations to be presented here are applicable to many grid arrangements; one is the gnomonic cubed-sphere grid. A symmetric tessellation of the surface of a cube [, , ] by line segments of length 2 parallel to an edge projects a rectangular grid onto great circle arcs on the surface of the sphere. Faces of the cube are numbered 1 to 6: , , , , , and ; see Fig. 1. On the sphere, grid cells are shaped like parallelograms and at least one of the unit vectors, U, V, or W, will be perpendicular to any grid edge. It was this property that led to the exploration of symmetric equations. At corners of the cube, the unit vectors are separated by 60 or 120. A proprietary one-layer shallow water equation model, labeled CSK, may be published later, but some results are presented in Sect. 4.
Figure 1Upper diagram shows arrangement of velocity components on Face 1 of cubed-sphere grid centered around the North Pole. Lower diagram shows arrangement of velocity components at the intersection of Faces 1, 2, and 3. Although U, V, and W are defined everywhere except at their poles, only the component perpendicular to an edge is displayed.
[Figure omitted. See PDF]
Two new shallow water equation models were developed on icosahedral grids. The centers of primary grid cells are the vertices of a triangular lattice covering the sphere; the cells themselves are pentagons and irregular hexagons. The B-grid icosahedral model, labeled IB, is discussed in detail in this paper. Its momentum cells (described as the dual mesh by ) are spherical triangles whose vertices are three primary cell centers and whose momentum centers are primary cell corners. The second icosahedral model, IK, uses proprietary techniques similar to CSK. All three models use the symmetric equations, but IB and IK perform less quantity averaging than CSK does with its unusual grid cell shape. Figure 2 shows a four-triangle wedge of an icosahedral grid.
Figure 2Four triangles of an icosahedron are surrounded by thick, bold lines. Vertices of the bold triangles are centers of incomplete pentagonal primary cells. Edges of primary cells, for grid level 2, are indicated by thin solid lines. Dotted lines, between primary cell centers, indicate edges of triangular momentum cells. Primary cell corners are momentum cell centers.
[Figure omitted. See PDF]
2.2The symmetric operator on the surface of a sphere
The symmetric del operator on the surface of a sphere , or simply in this paper, is 2.12 which is equivalent to the common two-dimensional del operator on the surface of a sphere, (Williamson et al., 1992, Eq. 3). or can be applied to three space, and be equivalent to the three-dimensional Cartesian operator , by restricting quantities to which they are applied to be radially constant or by adding the term to the del operator, where (m) is the radial coordinate. Computations of (or ), an arbitrary scalar , are identical in formulas that use or , but the factors that multiply those partial derivatives in the formulas are different.
The gradient of a scalar on the Earth's surface is The gradient vector is tangent to the sphere at point P, and, as P approaches the North or South Pole, approaches 1; and approach 1; , , and approach 0; and become less important in Eq. (2.13); and U and V become more nearly perpendicular. Using perpendicular unit vectors W and N, the gradient is commonly written as 2.14 This common form is not valid near the poles because of in the denominator, while the new symmetric form, Eq. (2.13), is valid everywhere, a benefit of using the symmetric equations. The equivalence between the common form and the new form of is shown in Appendix A. If is treated as a velocity, then the specific angular momentum with which it is associated is 2.15
The divergence of a horizontal vector at point P is which is equivalent to the common form on the surface of a sphere: . The first two forms of Eq. (2.16) are equivalent because and Similar reasoning shows the equivalence between the third and fourth forms of Eq. (2.16). If D is horizontal velocity, D = S, then the divergence of S can also be written as 2.18 Also,
Noting that is perpendicular to P and reasoning similar to Eq. (2.17), the Laplacian is The Laplacian of Eq. (2.20) is equivalent to the common form on the surface of a sphere: .
The curl of a horizontal vector is If were completely vertical, then would be 0. It is not; in fact, . The upward vertical component of the curl of D is 2.22 which is equivalent to the common form on the surface of a sphere: . If D = S, then the vertical component of the curl of S can also be written as
The upward vertical component of relative vorticity is 2.24 which is equivalent to the common form on the surface of a sphere: .
If G and H are differentiable vectors in three space, then a well-known identity using the Cartesian del operator is 2.25 If G is radially aligned and of constant magnitude (P for example), then . If G is a radially aligned unit vector and H is perpendicular to G, then 2.26 The above relationships apply to the present (or ) operator and are shown in the relationships of Eqs. (2.22) and (2.23).
Many of the new symmetric forms have no varying quantities outside their
derivatives and can be integrated using Green's theorem. Proofs of several of
the equivalences used above are available at
The differential form for conservation of mass, using Eq. (2.18), is applied to mass per unit area: This symmetric form is equivalent to the common equation:
2.28
The three-component advective form for specific angular momentum is where (s) is the Coriolis parameter and (m s) is the fluid top geopotential:
Replacing with in Eqs. (2.27) and (2.28) shows the differential form for momentum advection in flux form: 2.32 The last line of Eq. (2.32) evaluates to zero because of conservation of mass. Inside the square brackets, the penultimate line of Eq. (2.32) shows the form that may be used for advection of A at a grid edge when the edge is perpendicular to the unit vector W. Replacing A in the square brackets in that penultimate line with and dividing by yields which are the common shallow water forms for the time derivative, the advective terms, and the metric term of eastward velocity. Application of the momentum conservation form to A thus includes the metric term. Although the common shallow water form for can incorporate the metric term into the advective terms, cannot conveniently do so. In the present formulation, all three components act like with the metric term included into the advective terms.
Symmetric versions of the shallow water equations using vorticity and
divergence or vector-invariant form are shown at
3.1 Alignment of velocity or specific angular momentum
Alignment of the three momentum components at P means that and S are perpendicular to P (). Application of a horizontal acceleration vector to the components maintains alignment. Thus, the pressure gradient force vector and the Coriolis force maintain alignment. The pressure gradient force obtained via Green's theorem and advection may distort alignment. The following procedure brings distorted momentum components back into alignment.
Given unaligned velocity components , , and at point P, determine the least square fit velocity vector that is horizontal () and best matches the components weighted by the square of the distance to their axes. If , , and were already aligned, then , where
3.2 When is minimized, alignment of distorted components , , and produces
Performing this analysis with specific angular momentum components yields , , and 3.6 The minimization technique applied above is equivalent to projecting an unaligned S or A onto the tangent plane of the spherical surface at P. When P is close to an axis pole, say is close to 1, then is close to 0, or is most strongly modified, and and are modified weakly. Alignment has the same purpose as the “Lagrange multiplier” term of .
The benefit of using three aligned components instead of two for advection on
a particular cubed-sphere grid is shown at
Change of velocity by the pressure gradient force is proportional to the gradient of the field top geopotential :
3.7 where is the time step. Change of specific angular momentum, using Eq. (2.15), is 3.8
Application of the pressure gradient force to velocity averaged over an arc usually involves interpolating to the corners of the arc and to on either side of the arc. Application to velocity averaged over a cell is conveniently performed using Green's theorem. This computation is discussed first for cubed-sphere models and later for icosahedral models, like IB.
Acceleration of velocity averaged over a primary cell of a cubed-sphere model starts by knowing averaged over the cell's edges from interpolation of primary cell values. For each cell mean velocity component, edge multiplied by the cosine of the angle between the component's unit vector and a unit vector outwardly perpendicular to the edge is integrated with respect to distance around the cell's edges. This integral, multiplied by the time step and divided by the cell's area, accelerates the mean velocity component of the cell. On Face 1 (Fig. 1), where the outward perpendicular directions of the right and left edges are V and and those of the top and bottom edges are and U, and where is the spatial differential in the direction of W, where is the arc length of an edge and is the primary cell area [] in the computer implementation. For the right edge [], is evaluated as an integral over arc length as Similarly, the top edge [] is integrated over arc length as Integrating counterclockwise around the grid cell, similar formulas for different components yield 3.12 If all four edge values of are the same, then cancellation of the P values causes cell mean to be 0.
Relationships like Eqs. (3.10) or (3.11) apply to any great circle arc, not just cubed-sphere edges. To check this, any arc from to is a subset of a great circle that intersects the Equator at two points and ; the longitudinal angular rotation coordinate around this axis is and the latitudinal coordinate from to I is . P is computed as , and the horizontal unit vector perpendicular to the arc at point P is . . 3.13
Renaming the vertices of a spherical polygon with arcs , , ... counted counterclockwise around the cell, and generalizing Eq. (3.12), yields 3.14
Appendix B shows that if is a linear function of in the arc, then integrals that include in Eq. (3.13) can be computed in closed form knowing at each end of the arc, and Eq. (3.14) can be modified to use and instead of , as shown in Eq. (B4). This is applicable to model IB where primary mass and are centered at the momentum cell's vertices and may be interpolated along the edges. For the Sect. 4 tests performed on model IB, Eqs. (3.14) and (B4) produce very similar results. Equation (3.14) is used because it is simpler.
3.3 Advection for model IBChange in primary cell mass by advection, in flux form, is derived from Green's theorem and Eq. (2.27).
3.15 where (kg s) is the outwardly transported mass at primary cell edges. at each edge is the product of the mass per unit area at the edge, the perpendicular velocity component, and the length of each edge. Using the same notation of variables I, , and F as in the prior subsection, along an edge from to is computed as 3.16 where E is the unit vector parallel to the edge. The final form of Eq. (3.16) shows the elegance of using specific angular momentum as the transport variable; integration around a cell's boundary follows the position vector without a perpendicular velocity computation. As with Eq. (3.14) for the pressure gradient force, can be the average value over the counterclockwise arcs, to , so that 3.17 The inherent symmetry between variables of the shallow water equations is evidenced by Eqs. (3.14) and (3.17). As shown in Appendix B, variables A or may also be linearly interpolated with respect to , so that the formula for is closer to Eq. (B4). This is applicable to model IB because A is located at the primary cell corners. For Sect. 4 tests performed on IB, Eq. (3.17) is used; the more complex version with linearly interpolated A produces similar results.
The change in grid cell mean relative angular momentum by advection, in flux form, is equal to the summation of the angular momentum fluxes (kg m s) at the edges multiplied by . is the product of A multiplied by , the mass flux of momentum cell edges designated by subscript . If and are average values over the arcs surrounding the momentum cells, then the change in angular momentum averaged over a cell is
For stability purposes, if A is constant throughout several cells in a neighborhood, even though may be irregular, should be 0 throughout the neighborhood. If principal mass cells and momentum cells are identical, , this principle is obeyed automatically, assuming that and A is the constant.
Primary and momentum cells are not identical for model IB; triangular momentum cells are centered at the corners of primary cells. The solution for momentum cell mass presented here is different from that of , where and are labeled and , respectively. The area of a momentum cell is the summation of quadrilateral areas inside three touching primary cells, and the momentum cell's mass is the summation of the three quadrilaterals' masses (Figs. 2 or 3). Mass is always uniformly distributed with respect to area in primary cells, and the change in mass in a momentum cell during an advective time step is determined by the change in mass of primary cells. Mass fluxes must be chosen so that their mass changes into a momentum cell match the change caused by primary mass changes. is initially computed along an arc between two primary cell centers, but is then modified as explained in the caption to Fig. 3. halves are minimally adjusted so that the change in mass per unit area of each quadrilateral area of a primary cell is identical during the time step. Adjusted halves adjust full . This technique satisfies the stability principle of the prior paragraph.
Figure 3C points are primary cell centers or triangular momentum cell corners. A and B points are primary cell corners or momentum cell centers. Quadrilaterals are the intersection area between primary and momentum cells. Arc intersection D points are overwritten by in the diagram. D is halfway between C points but not halfway between A and B. Mass flux along a primary cell edge is computed and not changed; it is partitioned to each quadrilateral edge proportional to arc length. Change in mass of a primary cell by advection is computed by summing along the cell's edges. This total change is partitioned into each quadrilateral of the cell proportional to area. The initial value of mass flux is computed along each momentum cell edge; half of is attributed to each primary cell through which it passes. In each primary cell, the half values are adjusted minimally so that the sum of the mass fluxes into each quadrilateral matches the quadrilateral's expected partitioned change. Each final is equal to the sum of the two adjusted “half” values.
[Figure omitted. See PDF]
3.4 Coriolis forceFor computer implementations of symmetric equations created so far, momentum components have not been defined on staggered locations; all three components reside at the same locations. For each velocity component, the other two components determine the velocity that is perpendicular to the first component. Thus, is the velocity component that aligns with . The Coriolis acceleration (m s) acting on is and the acceleration acting on is . Each specific angular momentum component is accelerated by its local components:
3.20
3.5 Icosahedral modelsStarting with 12 vertices and 20 triangles of the icosahedron, new vertices for the raw grid are formed from the center points of triangular edges. After iterations of this process, the triangular lattice contains vertices as described by . is called the grid level. These vertices are the centers of primary cells where scalar quantities such as are defined. Primary cells are mainly irregular hexagons, although there are 12 regular pentagons centered on the vertices of the original icosahedron. For model IB, each three nearest primary cell centers form the vertices of a spherical triangle where momentum is defined and which contains the common corner of the three primary cells; these corners designate momentum cell centers. There are triangular momentum cells that cover the whole sphere; it is called the “dual” grid by and others; see Fig. 2.
Table 1
Properties of the raw, tweaked, and centroid grids; numerical columns are for grid levels 4 through 8. ArcA is the arc between adjacent primary cell corners or momentum cell centers. ArcC is the arc between nearby primary cell centers or momentum cell corners. Point D is intersection of ArcA and ArcC. The ideal number is 1 for first three properties and 0 for last two properties. Radius is the square root of cell area divided by .
Smallest arc length from primary cell corner to D divided by half of | |||||
---|---|---|---|---|---|
ArcA length | |||||
Grid | |||||
Raw | 0.80648 | 0.80655 | 0.80656 | 0.80657 | 0.80657 |
Tweaked | 0.96796 | 0.98366 | 0.99174 | 0.99585 | 0.99792 |
Centroid | 0.87402 | 0.87354 | 0.87344 | 0.87342 | 0.87341 |
For most extreme momentum cell: smallest ArcC length divided | |||||
by largest | |||||
Raw | 0.85110 | 0.85076 | 0.85068 | 0.85066 | 0.85065 |
Tweaked | 0.83810 | 0.83617 | 0.83543 | 0.83515 | 0.83504 |
Centroid | 0.85091 | 0.85070 | 0.85066 | 0.85065 | 0.85065 |
Smallest primary cell area divided by largest | |||||
Raw | 0.74170 | 0.73610 | 0.73468 | 0.73433 | 0.73424 |
Tweaked | 0.94809 | 0.95050 | 0.95206 | 0.95249 | 0.95270 |
Centroid | 0.36786 | 0.30111 | 0.24662 | 0.20203 | 0.16550 |
Largest distance from centroid to center for primary cells divided | |||||
by cell radius | |||||
Raw | 0.09710 | 0.09710 | 0.09710 | 0.09710 | 0.09710 |
Tweaked | 0.04250 | 0.04000 | 0.03899 | 0.03865 | 0.03857 |
Centroid | 0.00000 | 0.00000 | 0.00000 | 0.00000 | 0.00000 |
Largest distance from centroid to center for momentum cells divided | |||||
by cell radius | |||||
Raw | 0.28473 | 0.28571 | 0.28595 | 0.28601 | 0.28603 |
Tweaked | 0.28461 | 0.28568 | 0.28594 | 0.28601 | 0.28603 |
Centroid | 0.00000 | 0.00000 | 0.00000 | 0.00000 | 0.00000 |
Starting from the raw grid, reposition and optimize the location of the cell centers producing a tweaked grid. For both the raw and tweaked grids, arc edges of primary cells are the perpendicular bisectors of nearby primary cell centers. The centroid grid's primary cell centers and corners are also repositioned from raw grid locations, but primary cell edges are neither perpendicular nor bisectors of primary center arcs. For the raw and tweaked grids, cell centers do not coincide with the cell centroid for neither primary nor momentum cells. For the centroid grid, centers and centroids coincide for both primary and momentum cells (see Table 1). The centroid grid here is different from the centroidal Voronoi tessellation grid of which had only primary cell coincidence and different from the spherical centroidal barycenter method of which had only momentum cell coincidence. Each icosahedral model, IB or IK, may use any grid; a capital letter (R indicates raw, T indicates tweaked, and C indicates centroid) is affixed to a model's label that show the grid. IKC works poorly.
Table 1 shows various properties of the three grids for grid levels 4 through 8. A significant property is “smallest arc length from primary cell corner to D divided by half of ArcA length”; ArcA is between two primary cell corners and D is the intersection of ArcA and the arc between the primary centers. The raw grid value in Table 1 stays at 81%, while the tweaked grid converges to unity with increasing resolution. For this reason, IKT is superior to IKR. IB performs edge computations using only values of the two primary cells, ignoring the fact that D is not the center of ArcA. IK, CSK, and the icosahedral model of use additional primary cell data to compute cell edge values, but this makes things more difficult when applying such models to an ocean domain.
Considering the most extreme momentum cells in Table 1, the raw grid
triangular momentum cells of model IB are more equilateral than are those of
the tweaked grid. Momentum cells are more important for model IB, and
consequently IBR is as good as IBT. An expanded version of Table 1 with
additional parameters is available at
The time scheme is leap-frog initialized every 8 to 10 time steps by forward–backward steps. Alignment of A (Sect. 3.1) is performed after every step. The geometry subroutine is complex, but the computational subroutines are simple because angular momentum components are treated identically and use the same lines of code. is computed using two-point second-order differencing. Some momentum computations use upstream differencing. This causes the flow to be stable but slightly diffusive. However, no other smoothing or filtering subroutines are needed. Computations are performed as locally as possible, and consequently the icosahedral models are suitable for an ocean domain or step-mountain atmosphere.
For model IB, the unadjusted is computed using second-order
differencing, but implementing the stability adjustment (Sect. 3.3) adds
complexity to the code. When computing ,
A is a mixture of half second-order and half linear upstream
advection. Unlike IK and the unfiltered lat–long B-grid scheme of
, model IB seldom generates alternating patterns in the
height field. The Fortran source code for IB is available at
Model IK uses at primary grid cell corners interpolated from its value of the three primary cells touching the corner. Different interpolation formulas were tested, but Eq. (3.5a) of was deemed best.
4 Test case resultsThe following two lat–long climate models, reduced to one layer for the shallow water equations, were applied to the test cases below. Arakawa's second-order B-grid (velocity components defined at primary cell corners) lat–long model with the NASA Goddard Institute for Space Studies (GISS) ModelE's pole modifications and filters on mass and velocity is labeled LLB. Arakawa's second-order C-grid (velocity components perpendicular to primary cell edges) lat–long model as modified by is labeled LLC, which also applies a filter to velocity components. The symmetric equation models (CSK, IB, and IK) do not apply any external filters to mass or momentum other than alignment. CSK performs more two-point interpolations of variables than do the other models because of its parallelogram-shaped cells; this probably explains CSK's poor performance for some of the tests. IB, the simplest model, has few choices to tune, the main ones being the mixture of second-order versus linear upstream for momentum advection (0.5 and 0.5) and the choice of grid (raw, tweaked, or centroid). The proprietary IK model is more complicated, and the tweaked grid is superior for this model. Table 2 shows the abbreviations and grids of the models used below.
Symmetric equation models IBR, IBT, IBC, IKT, and CSK are represented; IKR and IKC are not, being worse than IKT. Each model was tested with different initial conditions and different horizontal resolutions that approximate , , , and ; the symmetric models were tested at in addition. Approximately uses 64 primary cells along the triangular edge of an icosahedron, 88 cells along the edge of a cube face, and 180 latitude bands for LL models; for other resolutions, these numbers are doubled or halved.
Table 2
Abbreviations, number of primary cells at resolution, and model description.
Abbreviation | No. of cells | Model description |
---|---|---|
IBR | icosahedral raw grid, momentum cells centered at primary corners | |
IBT | icosahedral tweaked grid, momentum cells centered at primary corners | |
IBC | icosahedral centroid grid, momentum cells centered at primary corners | |
IKR | proprietary icosahedral raw grid | |
IKT | proprietary icosahedral tweaked grid | |
CSK | proprietary gnomonic cubed-sphere grid | |
LLB | lat–long Arakawa B grid | |
LLC | lat–long Arakawa C grid |
Using the parameters of Test Case 2 of , a perfect model would maintain the initial mass and velocity fields indefinitely. For a second-order model, the mass and velocity errors should decrease by a factor of 4 when doubling the horizontal resolution. Figure 4 shows the area-weighted root mean square norm of the mass field after 5 days of integration. This figure may be compared to Fig. 2 of and to Fig. 3 of , whose data are averaged over the first 5 days. Both older icosahedral models, LLB and LLC, show error reduction factors of about 4 for doubling resolution. Models IBR and IBC show factors close to 3 that decrease with finer resolution but increase with less upstream advection of momentum. IKT and CSK show impressive reduction factors of 6 and 5, respectively. As mentioned in the third paragraph of Sect. 3.5, with finer resolution the intersection point D gets closer to the center of primary cell edge arc for model IKT; this increases the precision of this model.
Figure 4
Mass field error as function of grid level for solid body rotation initial conditions without bottom topography on day 5. Black line shows ideal mass error: factor of 4 error reduction for doubling horizontal resolution. Models represented are IBR, IBC, IKT, CSK, LLB, and LLC. For last three models, grid level is computed as , where is the number of primary grid cells.
[Figure omitted. See PDF]
Figure 5 shows the and norms as a function of time for the first 5 days of the resolution models IBR, IKT, CSK, and LLC. For all resolutions of the symmetric equation models, the mass field error increases linearly with time; the error after 50 days is nearly 10 times that after 5 days. For most resolutions of LLC, the mass field error after 80 days is the same as the error after 5 days. This is also the case for coarsest resolutions, and , of LLB, but resolution LLB diverges after 78 days for any reasonable time step and resolution produces polar instabilities although it survives for 100 days and beyond. The present symmetric models of Fig. 5 can be compared to Fig. 8 of that shows smaller errors, Fig. 2 of that shows larger errors, and Fig. 2 of that is comparable to IBR. The older models show less error growth with increasing time. Both the present LLC and the C-grid model of at resolution show occasional instabilities that do not affect the long-term error growth.
In general, the mass field error of IBR is less than that of IBT, often exceeding more than 10 % for the coarser resolutions, but closer to 1 % for resolution. All of the symmetric equation models use some amount of upstream advection of momentum. This causes a continual loss of total energy and of structure to the prognostic variables, and is the reason for the continual degradation of the norms in time. The Arakawa B-grid and C-grid schemes are designed to approximately conserve total energy.
Figure 5Mass field errors and as function of time for solid body rotation initial conditions without bottom topography. Models represented are IBR, IKT, CSK, and LLC at resolution.
[Figure omitted. See PDF]
Figure 6Horizontal plots of for models IBR, IBC, IKT, CSK, LLB, and LLC at resolution after 45 days of integration starting from Rossby–Haurwitz wave 3 conditions.
[Figure omitted. See PDF]
4.2 Rossby–Haurwitz wave 3 (RH3)For cubed-sphere models that initialize from repetitive wave 4 initial
conditions, each of the four wavelengths lies above the same grid arrangement
and copies remain identical when the wave's axis passes through the center of
a cube face as is the case for CSK. The same statement applies to icosahedral
models with wave 5 initial conditions when the axis passes through a vertex
of the icosahedron as is the case for IB and IK. The initial conditions used
here are Rossby–Haurwitz wave 3, 3 being relatively prime to both 4 and 5.
With wave 3, separate wavelengths diverge among themselves for models CSK,
IB, and IK, and there is more variety in the errors that occur. Plots (not
displayed) show that CSK for Rossby–Haurwitz wave 4 and IB or IK for
Rossby–Haurwitz wave 5 maintain their wavelength shape, but other situations
do not. Some results of CSK and IBR for Rossby–Haurwitz waves 3, 4, and 5 are
shown at
Figure 6 shows horizontal plots of () after 45 days of integration at resolution for six models: IBR, IBC, IKT, CSK, LLB, and LLC. Not displayed is model IBT, which no longer has three peaks at resolution but is comparable to IBR for finer resolutions. Although IBC has destroyed the pattern for resolution, it actually looks better than IBR for after 45 days. CSK performed well for SBR initial conditions, but it is the worst model for RH3, being unable to maintain the RH3 pattern for 45 days except for resolution. Its reduced quality is partially caused by the grid edge lines not being perpendicular. LLB at resolution is beginning to develop alternating patterns in the orange color of Fig. 6, but LLB is excellent for finer resolutions.
Table 3
Relative change (%) of specific kinetic energy for wave numbers 0 and 3 and total energy for various resolutions and models IBR, IBT, IBC, IKT, CSK, LLB, LLC, and National Center for Atmospheric Research spectral transform model at T42 resolution (Hack and Jakob, 1992) after 40 days of integration. Initial conditions are Rossby–Haurwitz wave 3. “Diverge” means the simulation diverged.
Specific kinetic energy change (%) for wave number 0 | |||||
---|---|---|---|---|---|
Model | |||||
IBR | |||||
IBT | |||||
IBC | |||||
IKT | |||||
CSK | |||||
LLB | diverge | ||||
LLC | diverge | ||||
T42 | |||||
Specific kinetic energy change (%) for wave number 3 | |||||
IBR | |||||
IBT | |||||
IBC | |||||
IKT | |||||
CSK | |||||
LLB | diverge | ||||
LLC | diverge | ||||
T42 | |||||
Total energy change (%) | |||||
IBR | |||||
IBT | |||||
IBC | |||||
IKT | |||||
CSK | |||||
LLB | diverge | ||||
LLC | diverge | ||||
T42 |
Table 3 shows the change in spectral specific kinetic energy for wave numbers 0 and 3 and the change in total energy for models IBR, IBT, IBC, IKT, CSK, LLB, LLC, and National Center for Atmospheric Research spectral transform model (STSWM) at T42 resolution after 40 days of integration. Icosahedral and cubed-sphere output was interpolated to a high-resolution lat–long grid before performing spectral decomposition. For each model's finest resolution, the reduction of wave 3 energy is between 0 and 5.6 %. Courser resolutions show greater reductions in wave 3 energy and CSK is less similar to the high-resolution results than are the icosahedral models. All of the symmetric models have some amount of upstream advection of momentum which reduces (kinetic and) total energy, as shown in Table 3. Model IB has more total energy loss than other models, but it is smoother and more stable.
Except for LLC, which maintains its pattern well for 100 days, the other resolution models deviate from the wave 3 pattern after different numbers of days: IBR – 45, IBT – 45, IBC – 37, IKT – 50, CSK – 26, and LLB – 63. Both LLB and LLC models diverge in the first day of integration, but all other models and resolutions survive for at least 100 days; the final pattern is smooth but may be unrecognizable.
4.3 Initial solid body rotation but with Earth's bottom topography (SBRZ)The initial velocity is eastward, 50 m s at the Equator multiplied by cosine of latitude. The initial global mean height field top is 10 000 m with the latitudinal distribution to maintain itself were there no bottom topography. But is reduced by the Earth's bottom topography which has peaks as high as 5600 m. SBRZ is a more realistic and severe than Test Case 5 of because it has faster initial velocity, higher mountains, and much larger topography gradients that increase with finer resolution, particularly at the Andes. In Williamson, topography gradients are independent of resolution. Greater accelerations by the pressure gradient force partially explain why the time step is not inversely proportional to the linear horizontal resolution.
Although the lat–long models use Fourier polar filters on east–west mass flux and pressure gradient force and other filters on prognostic variables, the symmetric equation models do not. The stability of IB, IK, and CSK is maintained by using the proper amount of linear upstream advection of momentum.
For the videos discussed later, the leap-frog time step of each model is interrupted every eight time steps, and is an integral division of 900 s, the video time step. Table 4 shows, for each model and resolution, the largest time step for which the model survives for 50 days without major instabilities or after what day the model diverged. Time steps were limited to be greater than or equal to one-third that of IBR for the same approximate resolution. All IB models are stable. IBC requires smaller time steps than IBR or IBT because IBC has some smaller grid cells; this discrepancy increases with resolution, as shown in Table 4. IK models are not as stable as IB and require time steps that are half that of IB for finer resolutions. Except for , LLC diverges for any time step during the 50 days. LLB diverges for resolutions and , and requires very short time steps for resolution.
Table 5 shows the change in kinetic energy after 50 days of integration for different models and resolutions. For resolutions or finer, the kinetic energy for all models that survive is within 5 % of the original value. Kinetic energy is not a conserved quantity, but for coarse-resolution models, its numerical reduction coincides with the washing out of highs and lows of the height field, as shown in the videos discussed subsequently.
Table 4
For each model and approximate horizontal resolution, the largest dynamical time step, half of leap-frog time step, in seconds for which the model survives for 50 days without major instabilities, or after what day the model diverged (in parentheses), for solid body rotation initial conditions with Earth's bottom topography.
Model | |||||
---|---|---|---|---|---|
IBR | 450 | 225 | 112.5 | 56.25 | 28.125 |
IBT | 450 | 225 | 112.5 | 56.25 | 28.125 |
IBC | 225 | 150 | 75 | 37.5 | 15 |
IKT | 450 | 150 | 56.25 | 30 | 12.5 |
CSK | 225 | 150 | 90 | 45 | 22.5 |
LLB | (8) | 150 | 37.5 | (27) | |
LLC | 225 | (26) | (9) | (8) |
Percentage change in kinetic energy for different models and resolutions after 50 days of integration from solid body rotation initial conditions with Earth's bottom topography. “Diverge” means the simulation diverged.
Model | |||||
---|---|---|---|---|---|
IBR | |||||
IBT | |||||
IBC | |||||
IKT | |||||
CSK | |||||
LLB | diverge | diverge | |||
LLC | diverge | diverge | diverge |
Figure 7 shows horizontal plots of for resolutions and , and models IBR, IKT, and CSK after 34 days of integration. IBT and IBC are not displayed, but their plots are similar to IBR. Models IKT and CSK display alternating patterns aligned with grid lines in South America. This occurs for both and resolutions but is more difficult to see for because of the small size of the printed page. For models shown in Fig. 7, IBR is most similar to the models. There is discrepancy among the non-displayed symmetric models after 50 days; IBR and IKT are more similar to each other than to CSK. Non-displayed LLB diverges at resolution, but at , it is similar to IBR.
Figure 7Horizontal plots of for models IBR, IKT, and CSK and resolutions and after 34 days of integration starting from 50 m s eastward velocity multiplied by cosine of latitude, global mean height field top of 10 000 m but latitudinal distribution, and Earth's fixed bottom topography (Test Case 3 SBRZ).
[Figure omitted. See PDF]
Videos of 50 simulated days for models IBR, IKT, CSK, LLB, and LLC are
displayable of limited quality on YouTube for all resolutions
(
This paper presents symmetric calculus operators on the surface of a sphere that are projected from three-dimensional Cartesian formulas. Symmetric equations are simplified by using specific angular momentum on the unit sphere, A, instead of velocity. Components of A align with the fixed orthogonal axes, whereas the velocity unit vectors U, V, and W are not orthogonal and vary with location. A is continuous everywhere, whereas , , and are discontinuous at their respective poles. A simplifies the equation for horizontal velocity S (Eq. 2.6) and several formulas in Sect. 2.2. Advection of A does not use the metric term, a correction term needed when advection is applied to velocity or linear momentum on the sphere. Applications of Green's theorem invoke the elegant formulas: Eq. (3.14) for the pressure gradient force, and Eqs. (3.17) and (3.19) for advection. All components of relative angular momentum, , are conserved without time truncation errors by the flux form advection (except for alignment) used by the symmetric models; LLC conserves the north–south axis component of relative angular momentum by advection, but other components and models lack conservation.
Summarizing the results from the test cases, no one model is clearly superior in all tests for all resolutions and times of integration.
-
Solid body rotation without bottom topography (SBR). For most resolutions, icosahedral models have the lowest relative mass error at day 5 of the simulation (Fig. 4). The Arakawa C-grid model, LLC, maintains the same mass field error after 80 days that it had after 5 days, whereas the symmetric equation models all have mass field errors that increase linearly with time. LLC must be considered best for this test.
-
Rossby–Haurwitz wave 3 (RH3). Large losses of wave number 3 kinetic energy after 40 days (Table 3) show model deficiencies of which CSK is the most egregious. LLC maintains the wave 3 shape longer than the other models (Fig. 6) and again is the best. For Rossby–Haurwitz wave 4, CSK maintains the wavelength shape better than IBR does, while for Rossby–Haurwitz wave 5, IBR is superior to CSK for longer integrations (
https://aom.giss.nasa.gov under “RHn”). -
Initial solid body rotation with Earth's topography (SBRZ). Polar problems cause the lat–long models, LLB and LLC, to diverge for different resolutions including . IKT and CSK to a lesser extent produce linear alternating patterns that are much diminished in IBR (Fig. 7 and the videos). IBR and IBT use a longer time step (Table 4) than do other models, and, after 34 days, IBR is more similar to the higher-resolution models than are IKT and CSK (Fig. 7). The icosahedral B-grid models, IBR and IBK, are best.
The SBRZ test is the most difficult but the most realistic test. Given that these one-layer models will be the basis for multi-layer climate models with realistic topography, IB models must be considered the best overall. Parallelogram-shaped grid cells in CSK with non-perpendicular grid line edges lasting over large swaths of the globe cause a systematic error in numerical flow, most noticeably evident in the RH3 test case. also conclude that “the hexagonal icosahedron gives the most accurate results” for several test cases. Although IKT's reduction factor of 6 for doubling resolution with SBR initial conditions is impressive, it generates frequent alternating linear patterns for SBRZ conditions, as shown in the YouTube videos. The test cases are inadequate for one-layer models that will be expanded to climate models simulating Earth; Williamson's Test Case 5 is much less demanding than using SBRZ. Grid imprinting errors in IB and IK are comparable to errors reported by other researchers ; the errors are not worse than would occur using two horizontal velocity components.
The symmetric equation models presented here use the smallest sensible grid cell stencil needed for a computation. Enlarging the stencil, as used by , may improve the results for tests SBR and RH3 by using fourth-order differencing or other methods, but in ocean domains or step-mountain atmospheres, large stencils require many different formulas for flow near ocean coastlines, based on their shape, and each formula is different from that used in the interior. CSK, with its parallelogram-shaped cells, has more difficulty in conforming to an ocean domain than do the icosahedral models.
As noted in Sect. 3.5, IB uses only two adjacent primary cell centers when performing computations on their common edge, even though point D is not the center of the primary cell edge. Except for the stability requirement of mass fluxes entering momentum cells (Sect. 3.3 and Fig. 3), the computational subroutines of IB are extremely simple. There are no separate lines of code for angular momentum; all components use the same lines. IK is slightly more complicated, but CSK is worse, requiring frequent interpolation to position variables.
Flux form velocity, represented by two horizontal components, has significant problems where the coordinates become discontinuous. An improvement has been to use forms of the shallow water equations where scalar quantities such as potential vorticity, specific kinetic energy, divergence, stream function, and velocity potential are continuous over the whole sphere and from which the local horizontal velocity can be resurrected, or integrated using the manipulated scalar quantities. Deficiencies of these methods are complexity of understanding and computer coding. This paper presents another method: vector angular momentum is continuous over the whole sphere and its application via the symmetric equations is simpler than using velocity. Each component of relative angular momentum is conserved by flux form advection without discontinuities. Further work is needed to determine the practical advantages that one scheme may have over others.
Code availability
Fortran source code for model GISS:IB is available at
Appendix A
Equivalence between new and old forms for
A8
Appendix B Closed form integration along an arcUsing the notation for F, , and of Sect. 3.2, Assume that was not constant throughout the arc but instead was a linearly function of from to . Then, the arc integral of Eq. (3.13) with included is B3 where is the value of at the center of the arc from to . As the resolution of the grid becomes finer, approaches and approaches , and the integral of Eq. (B3) approaches , which is the result of Eq. (3.13) multiplied by .
Using Eq. (B3) instead of Eq. (3.13), the formula of Eq. (3.14) is replaced with
Author contributions
Most of the formulas and equations of Sect. 2 have probably been known for at least two centuries, but were rederived from scratch by the authors. Use of three horizontal components, vector angular momentum instead of velocity, and the combination of both is new. The Fortran programs used for this paper are original and were written from scratch.
Competing interests
The authors declare that they have no conflict of interest.
Acknowledgements
The origins of this paper came from discussions with Maxwell Kelley in 2012 and 2013. He has made contributions to the present paper, and models IK and CSK are based on his ideas that may be published in the future. The authors thank Ross Heikes of Colorado State University for the tweaked grid locations. Rainer Bleck was helpful with knowledge of other icosahedral models. Robert Schmunk assisted in creating the YouTube video files. The paper was significantly improved by the editorial process of Monthly Weather Review.
Climate modeling at GISS is supported by the NASA Modeling, Analysis, and Prediction program, and resources supporting this work were provided by the NASA High-End Computing Program through the NASA Center for Climate Simulation at Goddard Space Flight Center. Edited by: Paul Ullrich Reviewed by: two anonymous referees
You have requested "on-the-fly" machine translation of selected content from our databases. This functionality is provided solely for your convenience and is in no way intended to replace human translation. Show full disclaimer
Neither ProQuest nor its licensors make any representations or warranties with respect to the translations. The translations are automatically generated "AS IS" and "AS AVAILABLE" and are not retained in our systems. PROQUEST AND ITS LICENSORS SPECIFICALLY DISCLAIM ANY AND ALL EXPRESS OR IMPLIED WARRANTIES, INCLUDING WITHOUT LIMITATION, ANY WARRANTIES FOR AVAILABILITY, ACCURACY, TIMELINESS, COMPLETENESS, NON-INFRINGMENT, MERCHANTABILITY OR FITNESS FOR A PARTICULAR PURPOSE. Your use of the translations is subject to all use restrictions contained in your Electronic Products License Agreement and by using the translation functionality you agree to forgo any and all claims against ProQuest or its licensors for your use of the translation functionality and any output derived there from. Hide full disclaimer
© 2018. This work is published under https://creativecommons.org/licenses/by/4.0/ (the “License”). Notwithstanding the ProQuest Terms and Conditions, you may use this content in accordance with the terms of the License.
Abstract
Standard vector calculus formulas of Cartesian three space are projected onto the surface of a sphere. This produces symmetric equations with three nonindependent horizontal velocity components. Each orthogonal axis has a velocity component that rotates around its axis (eastward velocity rotates around the north–south axis) and a specific angular momentum component that is the product of the velocity component multiplied by the cosine of axis' latitude. Angular momentum components align with the fixed axes and simplify several formulas, whereas the rotating velocity components are not orthogonal and vary with location. Three symmetric coordinates allow vector resolution and calculus operations continuously over the whole spherical surface, which is not possible with only two coordinates. The symmetric equations are applied to one-layer shallow water models on cubed-sphere and icosahedral grids, the latter being computationally simple and applicable to an ocean domain. Model results are presented for three different initial conditions and five different resolutions.
You have requested "on-the-fly" machine translation of selected content from our databases. This functionality is provided solely for your convenience and is in no way intended to replace human translation. Show full disclaimer
Neither ProQuest nor its licensors make any representations or warranties with respect to the translations. The translations are automatically generated "AS IS" and "AS AVAILABLE" and are not retained in our systems. PROQUEST AND ITS LICENSORS SPECIFICALLY DISCLAIM ANY AND ALL EXPRESS OR IMPLIED WARRANTIES, INCLUDING WITHOUT LIMITATION, ANY WARRANTIES FOR AVAILABILITY, ACCURACY, TIMELINESS, COMPLETENESS, NON-INFRINGMENT, MERCHANTABILITY OR FITNESS FOR A PARTICULAR PURPOSE. Your use of the translations is subject to all use restrictions contained in your Electronic Products License Agreement and by using the translation functionality you agree to forgo any and all claims against ProQuest or its licensors for your use of the translation functionality and any output derived there from. Hide full disclaimer