diff --git a/dumux/common/properties.hh b/dumux/common/properties.hh index bb621833bca72d58f16784e279faae04df419e0b..48f80f8e46b4a71a43f32a9e92024ba80036c7b0 100644 --- a/dumux/common/properties.hh +++ b/dumux/common/properties.hh @@ -276,6 +276,8 @@ struct SherwoodFormulation { using type = UndefinedProperty; }; template<class TypeTag, class MyTypeTag> struct NormalizePressure { using type = UndefinedProperty; }; //!< Returns whether to normalize the pressure term in the momentum balance or not +template<class TypeTag, class MyTypeTag> +struct ViscousFluxType { using type = UndefinedProperty; }; //!< The type for the calculation of the (turbulent) viscous (momentum) fluxes ///////////////////////////////////////////////////////////// // Properties used by multidomain simulations diff --git a/dumux/flux/CMakeLists.txt b/dumux/flux/CMakeLists.txt index 76b85c4062d2e079da6bdad8aa441d944dba9d4b..203eb2d8b5c55a2df92e9f820c140d3a9c50e1c2 100644 --- a/dumux/flux/CMakeLists.txt +++ b/dumux/flux/CMakeLists.txt @@ -20,6 +20,7 @@ maxwellstefandiffusioncoefficients.hh maxwellstefanslaw.hh referencesystemformulation.hh shallowwaterflux.hh +shallowwaterviscousflux.hh stationaryvelocityfield.hh traits.hh upwindscheme.hh diff --git a/dumux/flux/shallowwater/riemannproblem.hh b/dumux/flux/shallowwater/riemannproblem.hh index 5c3b8391504fc49665f515ebfa3b94c7c18e6c4c..8cd66120757eb7844dcbb8b99184daa9425a6d0b 100644 --- a/dumux/flux/shallowwater/riemannproblem.hh +++ b/dumux/flux/shallowwater/riemannproblem.hh @@ -38,18 +38,17 @@ namespace ShallowWater { * * * Riemann problem applies the hydrostatic reconstruction, uses the - * Riemann invariants to transform the two-dimensional problem to an - * one-dimensional problem and solves this new problem, and rotates - * the problem back. Further it applies an flux limiter for the water - * flux handle drying of elements. + * Riemann invariants to transform the two-dimensional problem to a + * one-dimensional problem, solves this new problem, and rotates + * the problem back. Further it applies a flux limiter for the water + * flux to handle drying elements. * The correction of the bed slope source term leads to a - * non-symmetric flux term at the interface for the momentum equations - * since DuMuX computes the fluxes twice from each side this does not + * non-symmetric flux term at the interface for the momentum equations. + * Since DuMuX computes the fluxes twice from each side this does not * matter. * - * So far we have only the exact Riemann solver, and the reconstruction - * after Audusse but further solvers and reconstructions ca be - * implemented. + * So far this implements the exact Riemann solver (with reconstruction + * after Audusse). * * The computed water flux (localFlux[0]) is given in m^2/s, the * momentum fluxes (localFlux[1], localFlux[2]) are given in m^3/s^2. diff --git a/dumux/flux/shallowwaterviscousflux.hh b/dumux/flux/shallowwaterviscousflux.hh new file mode 100644 index 0000000000000000000000000000000000000000..3e8d84ac5a2b684a564dfc419b5e6fec4dd81aba --- /dev/null +++ b/dumux/flux/shallowwaterviscousflux.hh @@ -0,0 +1,215 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 3 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * \ingroup Flux + * \copydoc Dumux::ShallowWaterViscousMomentumFlux + */ +#ifndef DUMUX_FLUX_SHALLOW_WATER_VISCOUS_FLUX_HH +#define DUMUX_FLUX_SHALLOW_WATER_VISCOUS_FLUX_HH + +#include <cmath> +#include <algorithm> +#include <utility> +#include <dumux/flux/fluxvariablescaching.hh> + +namespace Dumux { + +/*! + * \ingroup Flux + * \brief Computes the shallow water viscous momentum flux due to (turbulent) viscosity + * by adding all surrounding shear stresses. + * For now implemented strictly for 2D depth-averaged models (i.e. 3 equations) + */ +template<class PrimaryVariables, class NumEqVector, typename std::enable_if_t<NumEqVector::size() == 3, int> = 0> +class ShallowWaterViscousFlux +{ + +public: + + using Cache = FluxVariablesCaching::EmptyDiffusionCache; + using CacheFiller = FluxVariablesCaching::EmptyCacheFiller; + /*! + * \ingroup Flux + * \brief Compute the viscous momentum flux contribution from the interface + * shear stress + * + * The viscous momentum flux + * \f[ + * \int \int_{V} \mathbf{\nabla} \cdot \nu_t h \mathbf{\nabla} \mathbf{u} dV + * \f] + * is re-written using Gauss' divergence theorem to: + * \f[ + * \int_{S_f} \nu_t h \mathbf{\nabla} \mathbf{u} \cdot \mathbf{n_f} dS + * \f] + * + * \todo The implementation now is the simplest one involving + * only direct neighbours. This implementation is not complete/ + * correct on non-orthogonal meshes. A more complete implementation + * with a more elaborate stencil that also takes into account + * the non-orthogonal contributions can be considered at a later stage. + */ + template<class Problem, class FVElementGeometry, class ElementVolumeVariables> + static NumEqVector flux(const Problem& problem, + const typename FVElementGeometry::GridGeometry::GridView::template Codim<0>::Entity& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const typename FVElementGeometry::SubControlVolumeFace& scvf) + { + using Scalar = typename PrimaryVariables::value_type; + + NumEqVector localFlux(0.0); + + // Get the inside and outside volume variables + const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; + const auto& outsideVolVars = elemVolVars[scvf.outsideScvIdx()]; + + const auto& insideScv = fvGeometry.scv(scvf.insideScvIdx()); + const auto& outsideScv = fvGeometry.scv(scvf.outsideScvIdx()); + + const auto [gradU, gradV] = [&]() + { + // The left (inside) and right (outside) states + const auto velocityXLeft = insideVolVars.velocity(0); + const auto velocityYLeft = insideVolVars.velocity(1); + const auto velocityXRight = outsideVolVars.velocity(0); + const auto velocityYRight = outsideVolVars.velocity(1); + + // Compute the velocity gradients normal to the face + // Factor that takes the direction of the unit vector into account + const auto& cellCenterToCellCenter = outsideScv.center() - insideScv.center(); + const auto distance = cellCenterToCellCenter.two_norm(); + const auto& unitNormal = scvf.unitOuterNormal(); + const auto direction = (unitNormal*cellCenterToCellCenter)/distance; + return std::make_pair( + (velocityXRight-velocityXLeft)*direction/distance, + (velocityYRight-velocityYLeft)*direction/distance + ); + }(); + + // Use a harmonic average of the depth at the interface. + const auto waterDepthLeft = insideVolVars.waterDepth(); + const auto waterDepthRight = outsideVolVars.waterDepth(); + const auto averageDepth = 2.0*(waterDepthLeft*waterDepthRight)/(waterDepthLeft + waterDepthRight); + + // compute the turbulent viscosity contribution + const Scalar turbViscosity = [&,gradU=gradU,gradV=gradV]() + { + // The (constant) background turbulent viscosity + static const auto turbBGViscosity = getParam<Scalar>("ShallowWater.TurbulentViscosity", 1.0e-6); + + // Check whether the mixing-length turbulence model is used + static const auto useMixingLengthTurbulenceModel = getParam<bool>("ShallowWater.UseMixingLengthTurbulenceModel", false); + + // constant eddy viscosity equal to the prescribed background eddy viscosity + if (!useMixingLengthTurbulenceModel) + return turbBGViscosity; + + // turbulence model based on mixing length + // Compute the turbulent viscosity using a combined horizonal/vertical mixing length approach + // Turbulence coefficients: vertical (Elder like) and horizontal (Smagorinsky like) + static const auto turbConstV = getParam<Scalar>("ShallowWater.VerticalCoefficientOfMixingLengthModel", 1.0); + static const auto turbConstH = getParam<Scalar>("ShallowWater.HorizontalCoefficientOfMixingLengthModel", 0.1); + + /** The vertical (Elder-like) contribution to the turbulent viscosity scales with water depth \f[ h \f] and shear velocity \f[ u_{*} \f] : + * + * \f[ + * \nu_t^v = c^v \frac{\kappa}{6} u_{*} h + * \f] + */ + constexpr Scalar kappa = 0.41; + // Compute the average shear velocity on the face + const Scalar ustar = [&]() + { + // Get the bottom shear stress in the two adjacent cells + // Note that element is not needed in spatialParams().frictionLaw (should be removed). For now we simply pass the same element twice + const auto& bottomShearStressInside = problem.spatialParams().frictionLaw(element, insideScv).shearStress(insideVolVars); + const auto& bottomShearStressOutside = problem.spatialParams().frictionLaw(element, outsideScv).shearStress(outsideVolVars); + const auto bottomShearStressInsideMag = bottomShearStressInside.two_norm(); + const auto bottomShearStressOutsideMag = bottomShearStressOutside.two_norm(); + + // Use a harmonic average of the viscosity and the depth at the interface. + using std::max; + const auto averageBottomShearStress = 2.0*(bottomShearStressInsideMag*bottomShearStressOutsideMag) + / max(1.0e-8,bottomShearStressInsideMag + bottomShearStressOutsideMag); + + // Shear velocity possibly needed in mixing-length turbulence model in the computation of the diffusion flux + using std::sqrt; + return sqrt(averageBottomShearStress); + }(); + + const auto turbViscosityV = turbConstV * (kappa/6.0) * ustar * averageDepth; + + /** The horizontal (Smagorinsky-like) contribution to the turbulent viscosity scales with the water depth (squared) + * and the magnitude of the stress (rate-of-strain) tensor: + * + * \f[ + * nu_t^h = (c^h h)^2 \sqrt{ 2\left(\frac{\partial u}{\partial x}\right)^2 + \left(\frac{\partial u}{\partial y} + \frac{\partial v}{\partial x}\right)^2 + 2\left(\frac{\partial v}{\partial y}\right)^2 } + * \f] + * + * However, based on the velocity vectors in the direct neighbours of the volume face, it is not possible to compute all components of the stress tensor. + * Only the gradients of u and v in the direction of the vector between the cell centres is available. + * To avoid the reconstruction of the full velocity gradient tensor based on a larger stencil, + * the horizontal contribution to the eddy viscosity (in the mixing-length model) is computed using only the velocity gradients normal to the face: + * + * \f[ + * \frac{\partial u}{\partial n} , \frac{\partial v}{\partial n} + * \f] + * + * In other words, the present approximation of the horizontal contribution to the turbulent viscosity reduces to: + * + * \f[ + * nu_t^h = (c^h h)^2 \sqrt{ 2\left(\frac{\partial u}{\partial n}\right)^2 + 2\left(\frac{\partial v}{\partial n}\right)^2 } + * \f] + * + It should be noted that this simplified approach is formally inconsistent and will result in a turbulent viscosity that is dependent on the grid (orientation). + */ + using std::sqrt; + const auto mixingLengthSquared = turbConstH * turbConstH * averageDepth * averageDepth; + const auto turbViscosityH = mixingLengthSquared * sqrt(2.0*gradU*gradU + 2.0*gradV*gradV); + + // Total turbulent viscosity + return turbBGViscosity + sqrt(turbViscosityV*turbViscosityV + turbViscosityH*turbViscosityH); + }(); + + // Compute the viscous momentum fluxes + const auto uViscousFlux = turbViscosity * averageDepth * gradU; + const auto vViscousFlux = turbViscosity * averageDepth * gradV; + + // compute the mobility of the flux with the fluxlimiter + static const auto upperWaterDepthFluxLimiting = getParam<double>("FluxLimiterLET.UpperWaterDepth", 1e-3); + static const auto lowerWaterDepthFluxLimiting = getParam<double>("FluxLimiterLET.LowerWaterDepth", 1e-5); + + const auto limitingDepth = (waterDepthLeft + waterDepthRight) * 0.5; + const auto mobility = ShallowWater::fluxLimiterLET(limitingDepth, + limitingDepth, + upperWaterDepthFluxLimiting, + lowerWaterDepthFluxLimiting); + + localFlux[0] = 0.0; + localFlux[1] = -uViscousFlux * mobility * scvf.area(); + localFlux[2] = -vViscousFlux * mobility * scvf.area(); + + return localFlux; + } +}; + +} // end namespace Dumux + +#endif diff --git a/dumux/freeflow/shallowwater/boundaryfluxes.hh b/dumux/freeflow/shallowwater/boundaryfluxes.hh index b5b3da9a9a1d480bba193e3913d7493e8a718d23..739a338ed438560371d5ebef8dc79318a1012ca7 100644 --- a/dumux/freeflow/shallowwater/boundaryfluxes.hh +++ b/dumux/freeflow/shallowwater/boundaryfluxes.hh @@ -5,7 +5,7 @@ * * * This program is free software: you can redistribute it and/or modify * * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * + * the Free Software Foundation, either version 3 of the License, or * * (at your option) any later version. * * * * This program is distributed in the hope that it will be useful, * @@ -32,14 +32,14 @@ #include <array> #include <cmath> +#include <algorithm> -namespace Dumux { -namespace ShallowWater { +namespace Dumux::ShallowWater { /*! * \brief Compute the outer cell state for fixed water depth boundary. * - * \param waterDepthBoundary Discharge per meter at the boundary face [m^2/s] + * \param waterDepthBoundary Water depth at the boundary face [m^2/s] * \param waterDepthInside Water depth in the inner cell [m] * \param velocityXInside Velocity in x-direction in the inner cell [m/s] * \param velocityYInside Velocity in y-direction in the inner cell [m/s] @@ -127,7 +127,98 @@ std::array<Scalar, 3> fixedDischargeBoundary(const Scalar dischargeBoundary, return cellStateOutside; } -} // end namespace ShallowWater -} // end namespace Dumux +/*! + * \brief Compute the viscosity/diffusive flux at a rough wall boundary using no-slip formulation. + * + * \param alphaWall Roughness parameter: alphaWall=0.0 means full slip, alphaWall=1.0 means no slip, 0.0<alphaWall<1.0 means partial slip [-] + * \param turbulentViscosity Turbulent viscosity [m^2/s] + * \param state Primary variables (water depth, velocities) + * \param cellCenterToBoundaryFaceCenter Cell-center to boundary distance + * \param unitNormal Normal vector of the boundary face + */ +template<class PrimaryVariables, class Scalar, class GlobalPosition> +std::array<Scalar, 3> noslipWallBoundary(const Scalar alphaWall, + const Scalar turbulentViscosity, + const PrimaryVariables& state, + const GlobalPosition& cellCenterToBoundaryFaceCenter, + const GlobalPosition& unitNormal) +{ + // only impose if abs(alphaWall) > 0 + using std::abs; + if (abs(alphaWall) <= 1.0e-9) + return {}; + + const auto waterDepth = state[0]; + // regularization: Set gradients to zero for drying cell + // Use LET-limiter instead for differentiability? + if (waterDepth <= 0.001) + return {}; + + const auto xVelocity = state[1]; + const auto yVelocity = state[2]; + const auto distance = cellCenterToBoundaryFaceCenter.two_norm(); + + // Compute the velocity gradients + // Outside - inside cell: therefore the minus-sign + // Only when cell contains sufficient water. + const auto gradU = -alphaWall * xVelocity/distance; + const auto gradV = -alphaWall * yVelocity/distance; + + // Factor that takes the direction of the unit vector into account + const auto direction = (unitNormal*cellCenterToBoundaryFaceCenter)/distance; + + // Compute the viscosity/diffusive fluxes at the rough wall + return { + 0.0, + -turbulentViscosity*waterDepth*gradU*direction, + -turbulentViscosity*waterDepth*gradV*direction + }; +} + +/*! + * \brief Compute the viscosity/diffusive flux at a rough wall boundary using Nikuradse formulation. + * + * \param ksWall Nikuradse roughness height for the wall [m] + * \param state the primary variable state (water depth, velocities) + * \param cellCenterToBoundaryFaceCenter Cell-center to boundary distance + * \param unitNormal Normal vector of the boundary face + */ +template<class PrimaryVariables, class Scalar, class GlobalPosition> +std::array<Scalar, 3> nikuradseWallBoundary(const Scalar ksWall, + const PrimaryVariables& state, + const GlobalPosition& cellCenterToBoundaryFaceCenter, + const GlobalPosition& unitNormal) +{ + // only impose if abs(ksWall) > 0 + using std::abs; + if (abs(ksWall) <= 1.0e-9) + return {}; + + using std::hypot; + const Scalar xVelocity = state[1]; + const Scalar yVelocity = state[2]; + const Scalar velocityMagnitude = hypot(xVelocity, yVelocity); + const Scalar distance = cellCenterToBoundaryFaceCenter.two_norm(); + const Scalar y0w = ksWall/30.0; + constexpr Scalar kappa2 = 0.41*0.41; + + // should distance/y0w be limited to not become too small? + using std::log; using std::max; + const auto logYPlus = log(distance/y0w+1.0); + const auto fac = kappa2*velocityMagnitude / max(1.0e-3,logYPlus*logYPlus); + + // Factor that takes the direction of the unit vector into account + const auto direction = (unitNormal*cellCenterToBoundaryFaceCenter)/distance; + + // wall shear stress vector + const auto tauWx = direction*fac*xVelocity; + const auto tauWy = direction*fac*yVelocity; + + // Compute the viscosity/diffusive fluxes at the rough wall + const auto waterDepth = state[0]; + return {0.0, waterDepth*tauWx, waterDepth*tauWy}; +} + +} // end namespace Dumux::ShallowWater #endif diff --git a/dumux/freeflow/shallowwater/fluxvariables.hh b/dumux/freeflow/shallowwater/fluxvariables.hh index 57daf7e066ace07e733ed4a1838519d24ca66842..1b70f8f767cf011fc24ca85766c1d70a1990dd02 100644 --- a/dumux/freeflow/shallowwater/fluxvariables.hh +++ b/dumux/freeflow/shallowwater/fluxvariables.hh @@ -45,7 +45,7 @@ class ShallowWaterFluxVariables using ModelTraits = GetPropType<TypeTag, Properties::ModelTraits>; using NumEqVector = GetPropType<TypeTag, Properties::NumEqVector>; using AdvectionType = GetPropType<TypeTag, Properties::AdvectionType>; - //using DiffusionType = GetPropType<TypeTag, Properties::DiffusionType>; + using ViscousFluxType = GetPropType<TypeTag, Properties::ViscousFluxType>; using GridVariables = GetPropType<TypeTag, Properties::GridVariables>; using GridVolumeVariables = typename GridVariables::GridVolumeVariables; @@ -58,7 +58,6 @@ class ShallowWaterFluxVariables using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; static constexpr bool enableAdvection = ModelTraits::enableAdvection(); - static constexpr bool enableDiffusion = ModelTraits::enableDiffusion(); public: @@ -79,20 +78,17 @@ public: } /*! - * \brief Returns the diffusive flux (e.g. diffusion of tracer) + * \brief Returns the viscous momentum flux * */ - NumEqVector diffusiveFlux(const Problem& problem, - const Element& element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolumeFace& scvf) const + NumEqVector viscousFlux(const Problem& problem, + const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf) const { - // TODO: add diffusive flux (e.g. tracer and viscosity) - if (enableDiffusion) - return NumEqVector(0.0); - - return NumEqVector(0.0); + // Add viscous momentum flux + return ViscousFluxType::flux(problem, element, fvGeometry, elemVolVars, scvf); } }; diff --git a/dumux/freeflow/shallowwater/localresidual.hh b/dumux/freeflow/shallowwater/localresidual.hh index c186b5b06478d5324485e4ae69e57e57193fade5..bfcc6d193e8d9f2ae5324e9fe8264cbdd721652c 100644 --- a/dumux/freeflow/shallowwater/localresidual.hh +++ b/dumux/freeflow/shallowwater/localresidual.hh @@ -78,7 +78,7 @@ public: } /*! - * \brief Evaluate the mass flux over a face of a sub control volume + * \brief Evaluate the mass/momentum flux over a face of a sub control volume * * \param problem The problem * \param element The current element. @@ -97,7 +97,11 @@ public: NumEqVector flux(0.0); FluxVariables fluxVars; flux += fluxVars.advectiveFlux(problem, element, fvGeometry, elemVolVars, scvf); - flux += fluxVars.diffusiveFlux(problem, element, fvGeometry, elemVolVars, scvf); + + // Compute viscous momentum flux contribution if required + static const bool enableViscousFlux = getParam<bool>("ShallowWater.EnableViscousFlux", false); + if (enableViscousFlux) + flux += fluxVars.viscousFlux(problem, element, fvGeometry, elemVolVars, scvf); return flux; } }; diff --git a/dumux/freeflow/shallowwater/model.hh b/dumux/freeflow/shallowwater/model.hh index 15094351f5c3e88940df38810b157b02add33165..bf2a9d745656ef3d89c75f8237cfa9c6748bc601 100644 --- a/dumux/freeflow/shallowwater/model.hh +++ b/dumux/freeflow/shallowwater/model.hh @@ -66,6 +66,7 @@ #include <dumux/common/properties/model.hh> #include <dumux/flux/shallowwaterflux.hh> +#include <dumux/flux/shallowwaterviscousflux.hh> #include <dumux/flux/fluxvariablescaching.hh> #include "localresidual.hh" @@ -89,9 +90,6 @@ struct ShallowWaterModelTraits //! Enable advection static constexpr bool enableAdvection() { return true; } - - //! Enable diffusion - static constexpr bool enableDiffusion() { return false; } }; /*! @@ -160,7 +158,9 @@ template<class TypeTag> struct AdvectionType<TypeTag, TTag::ShallowWater> { using type = ShallowWaterFlux< GetPropType<TypeTag, Properties::NumEqVector> >; }; -//template<class TypeTag> struct DiffusionType<TypeTag, TTag::ShallowWater> {using type = ShallowWaterExactRiemannSolver<TypeTag>;}; +template<class TypeTag> +struct ViscousFluxType<TypeTag, TTag::ShallowWater> +{ using type = ShallowWaterViscousFlux< GetPropType<TypeTag, Properties::PrimaryVariables>, GetPropType<TypeTag, Properties::NumEqVector> >; }; } // end properties } // end namespace Dumux diff --git a/dumux/freeflow/shallowwater/volumevariables.hh b/dumux/freeflow/shallowwater/volumevariables.hh index 7aec82fa097de143a5c9be862c4d05aa55101263..6cf905fa083ecf4b09ee4badf1aeaf04c62c9fea 100644 --- a/dumux/freeflow/shallowwater/volumevariables.hh +++ b/dumux/freeflow/shallowwater/volumevariables.hh @@ -57,6 +57,10 @@ public: Scalar extrusionFactor() const { return 1.0; } + //! Return the vector of primary variables + const PrimaryVariables& priVars() const + { return priVars_; } + /*! * \brief Return water detph h inside the sub-control volume. * diff --git a/test/freeflow/shallowwater/CMakeLists.txt b/test/freeflow/shallowwater/CMakeLists.txt index a2d8ca961e08fead0abf1e2a91fc8b5a7a16bef4..2f2fec8b7675709ea0dcec2a628829e39c12f97d 100644 --- a/test/freeflow/shallowwater/CMakeLists.txt +++ b/test/freeflow/shallowwater/CMakeLists.txt @@ -1,3 +1,4 @@ add_subdirectory(bowl) add_subdirectory(dambreak) +add_subdirectory(poiseuilleflow) add_subdirectory(roughchannel) diff --git a/test/freeflow/shallowwater/poiseuilleflow/CMakeLists.txt b/test/freeflow/shallowwater/poiseuilleflow/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..c8ed563ddab4827c65ceffdaad0c424de17d8ff0 --- /dev/null +++ b/test/freeflow/shallowwater/poiseuilleflow/CMakeLists.txt @@ -0,0 +1,48 @@ +dune_symlink_to_source_files(FILES "params.input") + +dumux_add_test(NAME test_shallowwater_poiseuilleflow + SOURCES main.cc + LABELS shallowwater + COMPILE_DEFINITIONS GRIDTYPE=Dune::YaspGrid<2,Dune::EquidistantOffsetCoordinates<double,2>> + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_shallowwater_poiseuilleflow-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/poiseuilleflow-00007.vtu + --zeroThreshold {"velocityY":1e-14} + --command "${CMAKE_CURRENT_BINARY_DIR}/test_shallowwater_poiseuilleflow params.input") + +dumux_add_test(NAME test_shallowwater_poiseuilleflow_parallel + TARGET test_shallowwater_poiseuilleflow + LABELS shallowwater + CMAKE_GUARD MPI_FOUND + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_shallowwater_poiseuilleflow-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/s0002-poiseuilleflow-parallel-00007.pvtu + --zeroThreshold {"velocityY":1e-14,"process rank":100} + --command "${MPIEXEC} -np 2 ${CMAKE_CURRENT_BINARY_DIR}/test_shallowwater_poiseuilleflow params.input -Problem.Name poiseuilleflow-parallel") + +dumux_add_test(NAME test_shallowwater_poiseuilleflow_unstructured + SOURCES main.cc + LABELS shallowwater + CMAKE_GUARD dune-uggrid_FOUND + COMPILE_DEFINITIONS GRIDTYPE=Dune::UGGrid<2> + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_shallowwater_poiseuilleflow_unstructured-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/poiseuilleflow-unstructured-00007.vtu + --zeroThreshold {"velocityY":1e-14} + --command "${CMAKE_CURRENT_BINARY_DIR}/test_shallowwater_poiseuilleflow_unstructured params.input -Problem.Name poiseuilleflow-unstructured -Grid.File grids/irregular_grid_10m.dgf") + +dumux_add_test(NAME test_shallowwater_poiseuilleflow_unstructured_parallel + TARGET test_shallowwater_poiseuilleflow_unstructured + LABELS shallowwater + CMAKE_GUARD "( MPI_FOUND AND dune-uggrid_FOUND )" + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_shallowwater_poiseuilleflow_unstructured-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/s0002-poiseuilleflow-unstructured-parallel-00007.pvtu + --zeroThreshold {"velocityY":1e-14,"process rank":100} + --command "${MPIEXEC} -np 2 ${CMAKE_CURRENT_BINARY_DIR}/test_shallowwater_poiseuilleflow_unstructured params.input -Problem.Name poiseuilleflow-unstructured-parallel -Grid.File grids/irregular_grid_10m.dgf") + +dune_symlink_to_source_files(FILES "grids") diff --git a/test/freeflow/shallowwater/poiseuilleflow/grids/irregular_grid_10m.dgf b/test/freeflow/shallowwater/poiseuilleflow/grids/irregular_grid_10m.dgf new file mode 100644 index 0000000000000000000000000000000000000000..a1a6fbaf46d2762ae20522f44537dd7866ea8096 --- /dev/null +++ b/test/freeflow/shallowwater/poiseuilleflow/grids/irregular_grid_10m.dgf @@ -0,0 +1,932 @@ +DGF +Vertex % the vertices of the grid +0.0 -50.0 % vertex 0 +400.0 -50.0 % vertex 1 +400.0 50.0 % vertex 2 +0.0 50.0 % vertex 3 +200.0 -50.0 % vertex 4 +400.0 0.0 % vertex 5 +200.0 50.0 % vertex 6 +0.0 0.0 % vertex 7 +100.0 -50.0 % vertex 8 +300.0 -50.0 % vertex 9 +400.0 -25.0 % vertex 10 +400.0 25.0 % vertex 11 +300.0 50.0 % vertex 12 +100.0 50.0 % vertex 13 +0.0 25.0 % vertex 14 +0.0 -25.0 % vertex 15 +50.0 -50.0 % vertex 16 +150.0 -50.0 % vertex 17 +250.0 -50.0 % vertex 18 +350.0 -50.0 % vertex 19 +400.0 -37.5 % vertex 20 +400.0 -12.5 % vertex 21 +400.0 12.5 % vertex 22 +400.0 37.5 % vertex 23 +350.0 50.0 % vertex 24 +250.0 50.0 % vertex 25 +150.0 50.0 % vertex 26 +50.0 50.0 % vertex 27 +0.0 37.5 % vertex 28 +0.0 12.5 % vertex 29 +0.0 -12.5 % vertex 30 +0.0 -37.5 % vertex 31 +25.0 -50.0 % vertex 32 +75.0 -50.0 % vertex 33 +125.0 -50.0 % vertex 34 +175.0 -50.0 % vertex 35 +225.0 -50.0 % vertex 36 +275.0 -50.0 % vertex 37 +325.0 -50.0 % vertex 38 +375.0 -50.0 % vertex 39 +375.0 50.0 % vertex 40 +325.0 50.0 % vertex 41 +275.0 50.0 % vertex 42 +225.0 50.0 % vertex 43 +175.0 50.0 % vertex 44 +125.0 50.0 % vertex 45 +75.0 50.0 % vertex 46 +25.0 50.0 % vertex 47 +12.5 -50.0 % vertex 48 +37.5 -50.0 % vertex 49 +62.5 -50.0 % vertex 50 +87.5 -50.0 % vertex 51 +112.5 -50.0 % vertex 52 +137.5 -50.0 % vertex 53 +162.5 -50.0 % vertex 54 +187.5 -50.0 % vertex 55 +212.5 -50.0 % vertex 56 +237.5 -50.0 % vertex 57 +262.5 -50.0 % vertex 58 +287.5 -50.0 % vertex 59 +312.5 -50.0 % vertex 60 +337.5 -50.0 % vertex 61 +362.5 -50.0 % vertex 62 +387.5 -50.0 % vertex 63 +387.5 50.0 % vertex 64 +362.5 50.0 % vertex 65 +337.5 50.0 % vertex 66 +312.5 50.0 % vertex 67 +287.5 50.0 % vertex 68 +262.5 50.0 % vertex 69 +237.5 50.0 % vertex 70 +212.5 50.0 % vertex 71 +187.5 50.0 % vertex 72 +162.5 50.0 % vertex 73 +137.5 50.0 % vertex 74 +112.5 50.0 % vertex 75 +87.5 50.0 % vertex 76 +62.5 50.0 % vertex 77 +37.5 50.0 % vertex 78 +12.5 50.0 % vertex 79 +18.3013 39.8584 % vertex 80 +10.955 19.119500000000002 % vertex 81 +30.8449 38.956599999999995 % vertex 82 +68.687 39.1991 % vertex 83 +68.7694 -39.1695 % vertex 84 +81.2612 -39.1704 % vertex 85 +81.2255 39.18429999999999 % vertex 86 +93.7496 39.1763 % vertex 87 +118.7499 39.17529999999999 % vertex 88 +118.7509 -39.1746 % vertex 89 +131.2504 -39.1748 % vertex 90 +131.2499 39.1751 % vertex 91 +143.75 39.175 % vertex 92 +168.75 39.175 % vertex 93 +168.75 -39.175 % vertex 94 +181.25 -39.175 % vertex 95 +181.25 39.175 % vertex 96 +193.75 39.175 % vertex 97 +218.75 39.175 % vertex 98 +218.75 -39.175 % vertex 99 +231.25 -39.175 % vertex 100 +231.25 39.175 % vertex 101 +243.7499 39.175 % vertex 102 +268.7496 39.1747 % vertex 103 +268.75 -39.175 % vertex 104 +281.25 -39.1751 % vertex 105 +281.249 39.1743 % vertex 106 +293.7477 39.1733 % vertex 107 +318.7382 39.167199999999994 % vertex 108 +318.7552 -39.178 % vertex 109 +331.3224 -39.1993 % vertex 110 +331.2298 39.1639 % vertex 111 +343.742 39.1806 % vertex 112 +369.1121 38.889399999999995 % vertex 113 +389.0289 19.018699999999995 % vertex 114 +389.2322 6.203000000000003 % vertex 115 +389.2514 -6.3536 % vertex 116 +356.3962 -39.1194 % vertex 117 +369.1934 -38.963 % vertex 118 +381.7195 -39.8624 % vertex 119 +389.9164 -31.6719 % vertex 120 +389.0716 -19.1293 % vertex 121 +381.6789 39.8125 % vertex 122 +389.8813 31.616699999999994 % vertex 123 +356.28 39.0805 % vertex 124 +343.8535 -39.2066 % vertex 125 +306.2502 -39.175399999999996 % vertex 126 +306.2446 39.1712 % vertex 127 +293.75 -39.175200000000004 % vertex 128 +256.25 -39.175 % vertex 129 +256.2498 39.174899999999994 % vertex 130 +243.75 -39.175 % vertex 131 +206.25 -39.175 % vertex 132 +206.25 39.175 % vertex 133 +193.75 -39.175 % vertex 134 +156.2501 -39.175 % vertex 135 +156.25 39.175 % vertex 136 +143.7502 -39.1749 % vertex 137 +106.2522 -39.174 % vertex 138 +106.2497 39.1756 % vertex 139 +93.7551 -39.1726 % vertex 140 +56.2586 -39.1839 % vertex 141 +10.7792 -6.2194999999999965 % vertex 142 +43.7066 -39.0721 % vertex 143 +30.8768 -38.903 % vertex 144 +10.1142 -31.6235 % vertex 145 +18.315 -39.8192 % vertex 146 +10.9712 -19.0335 % vertex 147 +10.7716 6.339199999999998 % vertex 148 +56.1822 39.2024 % vertex 149 +43.6513 39.113200000000006 % vertex 150 +10.1027 31.6674 % vertex 151 +337.4302 28.307900000000004 % vertex 152 +350.1703 -28.4805 % vertex 153 +391.8053 41.8036 % vertex 154 +378.2853 12.2273 % vertex 155 +287.4978 28.348399999999998 % vertex 156 +237.4999 28.349999999999994 % vertex 157 +187.5 28.349999999999994 % vertex 158 +137.5 28.350099999999998 % vertex 159 +87.497 28.3545 % vertex 160 +62.5665 -28.3266 % vertex 161 +21.6843 12.494300000000003 % vertex 162 +21.2113 0.1407999999999987 % vertex 163 +62.319 28.433800000000005 % vertex 164 +8.1884 41.8103 % vertex 165 +23.1716 26.715999999999994 % vertex 166 +75.0301 -28.3361 % vertex 167 +74.8951 28.374300000000005 % vertex 168 +112.502 -28.349 % vertex 169 +112.4997 28.3506 % vertex 170 +125.0008 -28.3496 % vertex 171 +124.9999 28.350300000000004 % vertex 172 +162.5001 -28.35 % vertex 173 +162.5 28.349999999999994 % vertex 174 +175.0 -28.35 % vertex 175 +175.0 28.349999999999994 % vertex 176 +212.5 -28.35 % vertex 177 +212.5 28.349999999999994 % vertex 178 +225.0 -28.35 % vertex 179 +225.0 28.349999999999994 % vertex 180 +262.5 -28.35 % vertex 181 +262.4996 28.3497 % vertex 182 +275.0 -28.3501 % vertex 183 +274.9991 28.349400000000003 % vertex 184 +312.4999 -28.351 % vertex 185 +312.4868 28.340500000000006 % vertex 186 +325.0934 -28.3708 % vertex 187 +324.9682 28.327799999999996 % vertex 188 +376.7748 26.5655 % vertex 189 +376.8849 -26.7299 % vertex 190 +362.66 -28.0665 % vertex 191 +391.8223 -41.8097 % vertex 192 +378.3769 -12.520499999999998 % vertex 193 +362.4387 27.877899999999997 % vertex 194 +378.8275 -0.1747000000000014 % vertex 195 +337.7323 -28.4402 % vertex 196 +349.9237 28.387699999999995 % vertex 197 +299.9946 28.346100000000007 % vertex 198 +287.5 -28.3502 % vertex 199 +300.0 -28.3505 % vertex 200 +249.9999 28.349900000000005 % vertex 201 +237.5 -28.35 % vertex 202 +250.0 -28.35 % vertex 203 +200.0 28.349999999999994 % vertex 204 +187.5 -28.35 % vertex 205 +200.0 -28.35 % vertex 206 +150.0 28.349999999999994 % vertex 207 +137.5003 -28.3498 % vertex 208 +150.0001 -28.3499 % vertex 209 +99.9992 28.351600000000005 % vertex 210 +87.5124 -28.344 % vertex 211 +100.0051 -28.3475 % vertex 212 +37.4449 28.052000000000007 % vertex 213 +50.0781 -28.4135 % vertex 214 +37.5263 -27.9324 % vertex 215 +8.1858 -41.7943 % vertex 216 +23.2131 -26.5943 % vertex 217 +21.721 -12.2637 % vertex 218 +49.936 28.4683 % vertex 219 +106.2524 -17.5238 % vertex 220 +156.2501 -17.525 % vertex 221 +206.25 -17.525 % vertex 222 +256.25 -17.525 % vertex 223 +306.25 -17.525799999999997 % vertex 224 +44.3158 -18.0269 % vertex 225 +44.1972 18.194000000000003 % vertex 226 +93.7562 -17.5218 % vertex 227 +56.4592 -17.3662 % vertex 228 +68.3923 17.544300000000007 % vertex 229 +81.2499 17.529799999999994 % vertex 230 +68.8038 -17.490699999999997 % vertex 231 +143.7502 -17.524900000000002 % vertex 232 +106.2497 17.525800000000004 % vertex 233 +118.7499 17.5253 % vertex 234 +131.2499 17.525099999999995 % vertex 235 +118.7509 -17.524500000000003 % vertex 236 +193.75 -17.525 % vertex 237 +156.25 17.525000000000006 % vertex 238 +168.75 17.525000000000006 % vertex 239 +181.25 17.525000000000006 % vertex 240 +168.75 -17.525 % vertex 241 +243.75 -17.525 % vertex 242 +206.25 17.525000000000006 % vertex 243 +218.75 17.525000000000006 % vertex 244 +231.25 17.525000000000006 % vertex 245 +218.75 -17.525 % vertex 246 +293.75 -17.5253 % vertex 247 +256.2498 17.524900000000002 % vertex 248 +268.7496 17.524699999999996 % vertex 249 +281.249 17.524299999999997 % vertex 250 +268.75 -17.525 % vertex 251 +306.2435 17.5201 % vertex 252 +318.7318 17.510800000000003 % vertex 253 +331.1925 17.476200000000006 % vertex 254 +318.7499 -17.5283 % vertex 255 +355.5431 17.828500000000005 % vertex 256 +356.0584 -18.2105 % vertex 257 +366.9986 16.515699999999995 % vertex 258 +368.8495 5.2353999999999985 % vertex 259 +368.9695 -5.839700000000001 % vertex 260 +344.3216 -17.8399 % vertex 261 +331.6322 -17.5439 % vertex 262 +343.5249 17.311000000000007 % vertex 263 +281.25 -17.525100000000002 % vertex 264 +293.7475 17.523200000000003 % vertex 265 +231.25 -17.525 % vertex 266 +243.7499 17.525000000000006 % vertex 267 +181.25 -17.525 % vertex 268 +193.75 17.525000000000006 % vertex 269 +131.2504 -17.5248 % vertex 270 +143.75 17.525000000000006 % vertex 271 +81.2671 -17.5154 % vertex 272 +93.7493 17.527 % vertex 273 +32.8684 16.8639 % vertex 274 +32.9672 -16.5845 % vertex 275 +31.184 -5.291499999999999 % vertex 276 +55.8215 17.814400000000006 % vertex 277 +31.1277 5.786299999999997 % vertex 278 +75.0 6.700000000000003 % vertex 279 +112.5 -6.700000000000003 % vertex 280 +162.5 6.700000000000003 % vertex 281 +212.5 6.700000000000003 % vertex 282 +262.5 6.700000000000003 % vertex 283 +312.5 6.700000000000003 % vertex 284 +367.2567 -16.8956 % vertex 285 +351.4402 -7.979799999999997 % vertex 286 +349.5601 5.1655000000000015 % vertex 287 +262.5 -6.700000000000003 % vertex 288 +212.5 -6.700000000000003 % vertex 289 +162.5 -6.700000000000003 % vertex 290 +112.5 6.700000000000003 % vertex 291 +62.5 -6.700000000000003 % vertex 292 +49.0159 7.832500000000003 % vertex 293 +40.2337 0.5698000000000008 % vertex 294 +87.5 -6.700000000000003 % vertex 295 +75.0 -6.700000000000003 % vertex 296 +100.0 -6.700000000000003 % vertex 297 +125.0 6.700000000000003 % vertex 298 +150.0 -6.700000000000003 % vertex 299 +175.0 6.700000000000003 % vertex 300 +187.5 -6.700000000000003 % vertex 301 +175.0 -6.700000000000003 % vertex 302 +200.0 -6.700000000000003 % vertex 303 +225.0 6.700000000000003 % vertex 304 +250.0 -6.700000000000003 % vertex 305 +275.0 6.700000000000003 % vertex 306 +300.0 -6.700000000000003 % vertex 307 +325.0 6.700000000000003 % vertex 308 +312.5 -6.700000000000003 % vertex 309 +359.916 -0.6762999999999977 % vertex 310 +337.5 6.700000000000003 % vertex 311 +325.0 -6.700000000000003 % vertex 312 +338.8961 -6.384500000000003 % vertex 313 +275.0 -6.700000000000003 % vertex 314 +287.5 -6.700000000000003 % vertex 315 +300.0 6.700000000000003 % vertex 316 +287.5 6.700000000000003 % vertex 317 +225.0 -6.700000000000003 % vertex 318 +237.5 -6.700000000000003 % vertex 319 +250.0 6.700000000000003 % vertex 320 +237.5 6.700000000000003 % vertex 321 +200.0 6.700000000000003 % vertex 322 +187.5 6.700000000000003 % vertex 323 +125.0 -6.700000000000003 % vertex 324 +137.5 -6.700000000000003 % vertex 325 +150.0 6.700000000000003 % vertex 326 +137.5 6.700000000000003 % vertex 327 +100.0 6.700000000000003 % vertex 328 +87.5 6.700000000000003 % vertex 329 +61.0683 6.413699999999999 % vertex 330 +50.4908 -5.2393 % vertex 331 +39.843 -9.398000000000003 % vertex 332 +39.5844 9.940800000000003 % vertex 333 +360.5904 -10.006500000000003 % vertex 334 +360.1003 9.359900000000003 % vertex 335 +# +SIMPLEX % a simplex grid +79 80 47 % triangle 0 , vertices 79 , 80 , 47 +79 3 165 % triangle 1 , vertices 79 , 3 , 165 +165 28 151 % triangle 2 , vertices 165 , 28 , 151 +151 14 81 % triangle 3 , vertices 151 , 14 , 81 +86 76 46 % triangle 4 , vertices 86 , 76 , 46 +84 50 33 % triangle 5 , vertices 84 , 50 , 33 +85 84 33 % triangle 6 , vertices 85 , 84 , 33 +76 87 13 % triangle 7 , vertices 76 , 87 , 13 +87 76 86 % triangle 8 , vertices 87 , 76 , 86 +91 74 45 % triangle 9 , vertices 91 , 74 , 45 +138 52 89 % triangle 10 , vertices 138 , 52 , 89 +90 89 34 % triangle 11 , vertices 90 , 89 , 34 +74 92 26 % triangle 12 , vertices 74 , 92 , 26 +92 74 91 % triangle 13 , vertices 92 , 74 , 91 +96 72 44 % triangle 14 , vertices 96 , 72 , 44 +135 54 94 % triangle 15 , vertices 135 , 54 , 94 +95 94 35 % triangle 16 , vertices 95 , 94 , 35 +72 97 6 % triangle 17 , vertices 72 , 97 , 6 +97 72 96 % triangle 18 , vertices 97 , 72 , 96 +101 70 43 % triangle 19 , vertices 101 , 70 , 43 +132 56 99 % triangle 20 , vertices 132 , 56 , 99 +100 99 36 % triangle 21 , vertices 100 , 99 , 36 +70 102 25 % triangle 22 , vertices 70 , 102 , 25 +102 70 101 % triangle 23 , vertices 102 , 70 , 101 +106 68 42 % triangle 24 , vertices 106 , 68 , 42 +129 58 104 % triangle 25 , vertices 129 , 58 , 104 +105 104 37 % triangle 26 , vertices 105 , 104 , 37 +68 107 12 % triangle 27 , vertices 68 , 107 , 12 +107 68 106 % triangle 28 , vertices 107 , 68 , 106 +111 66 41 % triangle 29 , vertices 111 , 66 , 41 +126 60 109 % triangle 30 , vertices 126 , 60 , 109 +110 109 38 % triangle 31 , vertices 110 , 109 , 38 +66 112 24 % triangle 32 , vertices 66 , 112 , 24 +152 112 111 % triangle 33 , vertices 152 , 112 , 111 +122 64 40 % triangle 34 , vertices 122 , 64 , 40 +22 11 114 % triangle 35 , vertices 22 , 11 , 114 +124 24 112 % triangle 36 , vertices 124 , 24 , 112 +115 22 114 % triangle 37 , vertices 115 , 22 , 114 +262 187 196 % triangle 38 , vertices 262 , 187 , 196 +125 61 19 % triangle 39 , vertices 125 , 61 , 19 +62 118 117 % triangle 40 , vertices 62 , 118 , 117 +119 118 39 % triangle 41 , vertices 119 , 118 , 39 +63 1 192 % triangle 42 , vertices 63 , 1 , 192 +119 39 63 % triangle 43 , vertices 119 , 39 , 63 +192 20 120 % triangle 44 , vertices 192 , 20 , 120 +154 23 2 % triangle 45 , vertices 154 , 23 , 2 +123 11 23 % triangle 46 , vertices 123 , 11 , 23 +154 64 122 % triangle 47 , vertices 154 , 64 , 122 +115 114 155 % triangle 48 , vertices 115 , 114 , 155 +61 110 38 % triangle 49 , vertices 61 , 110 , 38 +128 59 9 % triangle 50 , vertices 128 , 59 , 9 +198 127 107 % triangle 51 , vertices 198 , 127 , 107 +59 105 37 % triangle 52 , vertices 59 , 105 , 37 +131 57 18 % triangle 53 , vertices 131 , 57 , 18 +201 130 102 % triangle 54 , vertices 201 , 130 , 102 +57 100 36 % triangle 55 , vertices 57 , 100 , 36 +134 55 4 % triangle 56 , vertices 134 , 55 , 4 +204 133 97 % triangle 57 , vertices 204 , 133 , 97 +55 95 35 % triangle 58 , vertices 55 , 95 , 35 +137 53 17 % triangle 59 , vertices 137 , 53 , 17 +207 136 92 % triangle 60 , vertices 207 , 136 , 92 +53 90 34 % triangle 61 , vertices 53 , 90 , 34 +140 51 8 % triangle 62 , vertices 140 , 51 , 8 +210 139 87 % triangle 63 , vertices 210 , 139 , 87 +51 85 33 % triangle 64 , vertices 51 , 85 , 33 +164 83 149 % triangle 65 , vertices 164 , 83 , 149 +144 49 143 % triangle 66 , vertices 144 , 49 , 143 +166 151 81 % triangle 67 , vertices 166 , 151 , 81 +142 7 30 % triangle 68 , vertices 142 , 7 , 30 +147 15 145 % triangle 69 , vertices 147 , 15 , 145 +216 31 0 % triangle 70 , vertices 216 , 31 , 0 +145 15 31 % triangle 71 , vertices 145 , 15 , 31 +216 145 31 % triangle 72 , vertices 216 , 145 , 31 +142 30 147 % triangle 73 , vertices 142 , 30 , 147 +29 81 14 % triangle 74 , vertices 29 , 81 , 14 +162 148 163 % triangle 75 , vertices 162 , 148 , 163 +168 86 83 % triangle 76 , vertices 168 , 86 , 83 +151 80 165 % triangle 77 , vertices 151 , 80 , 165 +150 27 78 % triangle 78 , vertices 150 , 27 , 78 +82 78 47 % triangle 79 , vertices 82 , 78 , 47 +82 47 80 % triangle 80 , vertices 82 , 47 , 80 +81 29 148 % triangle 81 , vertices 81 , 29 , 148 +166 81 162 % triangle 82 , vertices 166 , 81 , 162 +83 77 149 % triangle 83 , vertices 83 , 77 , 149 +83 46 77 % triangle 84 , vertices 83 , 46 , 77 +49 16 143 % triangle 85 , vertices 49 , 16 , 143 +86 46 83 % triangle 86 , vertices 86 , 46 , 83 +141 16 50 % triangle 87 , vertices 141 , 16 , 50 +161 141 84 % triangle 88 , vertices 161 , 141 , 84 +85 51 140 % triangle 89 , vertices 85 , 51 , 140 +86 168 160 % triangle 90 , vertices 86 , 168 , 160 +139 75 13 % triangle 91 , vertices 139 , 75 , 13 +233 170 210 % triangle 92 , vertices 233 , 170 , 210 +88 45 75 % triangle 93 , vertices 88 , 45 , 75 +172 91 88 % triangle 94 , vertices 172 , 91 , 88 +89 52 34 % triangle 95 , vertices 89 , 52 , 34 +91 45 88 % triangle 96 , vertices 91 , 45 , 88 +138 8 52 % triangle 97 , vertices 138 , 8 , 52 +169 138 89 % triangle 98 , vertices 169 , 138 , 89 +90 53 137 % triangle 99 , vertices 90 , 53 , 137 +91 172 159 % triangle 100 , vertices 91 , 172 , 159 +136 73 26 % triangle 101 , vertices 136 , 73 , 26 +238 174 207 % triangle 102 , vertices 238 , 174 , 207 +93 44 73 % triangle 103 , vertices 93 , 44 , 73 +176 96 93 % triangle 104 , vertices 176 , 96 , 93 +94 54 35 % triangle 105 , vertices 94 , 54 , 35 +96 44 93 % triangle 106 , vertices 96 , 44 , 93 +135 17 54 % triangle 107 , vertices 135 , 17 , 54 +173 135 94 % triangle 108 , vertices 173 , 135 , 94 +95 55 134 % triangle 109 , vertices 95 , 55 , 134 +96 176 158 % triangle 110 , vertices 96 , 176 , 158 +133 71 6 % triangle 111 , vertices 133 , 71 , 6 +243 178 204 % triangle 112 , vertices 243 , 178 , 204 +98 43 71 % triangle 113 , vertices 98 , 43 , 71 +180 101 98 % triangle 114 , vertices 180 , 101 , 98 +99 56 36 % triangle 115 , vertices 99 , 56 , 36 +101 43 98 % triangle 116 , vertices 101 , 43 , 98 +132 4 56 % triangle 117 , vertices 132 , 4 , 56 +177 132 99 % triangle 118 , vertices 177 , 132 , 99 +100 57 131 % triangle 119 , vertices 100 , 57 , 131 +101 180 157 % triangle 120 , vertices 101 , 180 , 157 +130 69 25 % triangle 121 , vertices 130 , 69 , 25 +248 182 201 % triangle 122 , vertices 248 , 182 , 201 +103 42 69 % triangle 123 , vertices 103 , 42 , 69 +184 106 103 % triangle 124 , vertices 184 , 106 , 103 +104 58 37 % triangle 125 , vertices 104 , 58 , 37 +106 42 103 % triangle 126 , vertices 106 , 42 , 103 +129 18 58 % triangle 127 , vertices 129 , 18 , 58 +181 129 104 % triangle 128 , vertices 181 , 129 , 104 +105 59 128 % triangle 129 , vertices 105 , 59 , 128 +106 184 156 % triangle 130 , vertices 106 , 184 , 156 +127 67 12 % triangle 131 , vertices 127 , 67 , 12 +252 186 198 % triangle 132 , vertices 252 , 186 , 198 +108 41 67 % triangle 133 , vertices 108 , 41 , 67 +188 111 108 % triangle 134 , vertices 188 , 111 , 108 +109 60 38 % triangle 135 , vertices 109 , 60 , 38 +111 41 108 % triangle 136 , vertices 111 , 41 , 108 +126 9 60 % triangle 137 , vertices 126 , 9 , 60 +185 126 109 % triangle 138 , vertices 185 , 126 , 109 +110 61 125 % triangle 139 , vertices 110 , 61 , 125 +111 188 152 % triangle 140 , vertices 111 , 188 , 152 +124 65 24 % triangle 141 , vertices 124 , 65 , 24 +113 40 65 % triangle 142 , vertices 113 , 40 , 65 +112 66 111 % triangle 143 , vertices 112 , 66 , 111 +124 113 65 % triangle 144 , vertices 124 , 113 , 65 +115 5 22 % triangle 145 , vertices 115 , 5 , 22 +123 189 114 % triangle 146 , vertices 123 , 189 , 114 +116 21 5 % triangle 147 , vertices 116 , 21 , 5 +190 121 193 % triangle 148 , vertices 190 , 121 , 193 +121 10 21 % triangle 149 , vertices 121 , 10 , 21 +116 5 115 % triangle 150 , vertices 116 , 5 , 115 +117 19 62 % triangle 151 , vertices 117 , 19 , 62 +190 119 120 % triangle 152 , vertices 190 , 119 , 120 +125 19 117 % triangle 153 , vertices 125 , 19 , 117 +191 153 117 % triangle 154 , vertices 191 , 153 , 117 +118 62 39 % triangle 155 , vertices 118 , 62 , 39 +119 192 120 % triangle 156 , vertices 119 , 192 , 120 +191 117 118 % triangle 157 , vertices 191 , 117 , 118 +190 118 119 % triangle 158 , vertices 190 , 118 , 119 +120 20 10 % triangle 159 , vertices 120 , 20 , 10 +121 21 116 % triangle 160 , vertices 121 , 21 , 116 +121 120 10 % triangle 161 , vertices 121 , 120 , 10 +154 2 64 % triangle 162 , vertices 154 , 2 , 64 +122 40 113 % triangle 163 , vertices 122 , 40 , 113 +189 155 114 % triangle 164 , vertices 189 , 155 , 114 +123 114 11 % triangle 165 , vertices 123 , 114 , 11 +189 122 113 % triangle 166 , vertices 189 , 122 , 113 +190 285 191 % triangle 167 , vertices 190 , 285 , 191 +185 109 187 % triangle 168 , vertices 185 , 109 , 187 +194 113 124 % triangle 169 , vertices 194 , 113 , 124 +128 9 126 % triangle 170 , vertices 128 , 9 , 126 +188 108 186 % triangle 171 , vertices 188 , 108 , 186 +127 12 107 % triangle 172 , vertices 127 , 12 , 107 +127 108 67 % triangle 173 , vertices 127 , 108 , 67 +183 104 105 % triangle 174 , vertices 183 , 104 , 105 +199 105 128 % triangle 175 , vertices 199 , 105 , 128 +131 18 129 % triangle 176 , vertices 131 , 18 , 129 +184 103 182 % triangle 177 , vertices 184 , 103 , 182 +130 25 102 % triangle 178 , vertices 130 , 25 , 102 +130 103 69 % triangle 179 , vertices 130 , 103 , 69 +179 99 100 % triangle 180 , vertices 179 , 99 , 100 +202 100 131 % triangle 181 , vertices 202 , 100 , 131 +134 4 132 % triangle 182 , vertices 134 , 4 , 132 +180 98 178 % triangle 183 , vertices 180 , 98 , 178 +133 6 97 % triangle 184 , vertices 133 , 6 , 97 +133 98 71 % triangle 185 , vertices 133 , 98 , 71 +175 94 95 % triangle 186 , vertices 175 , 94 , 95 +205 95 134 % triangle 187 , vertices 205 , 95 , 134 +137 17 135 % triangle 188 , vertices 137 , 17 , 135 +176 93 174 % triangle 189 , vertices 176 , 93 , 174 +136 26 92 % triangle 190 , vertices 136 , 26 , 92 +136 93 73 % triangle 191 , vertices 136 , 93 , 73 +171 89 90 % triangle 192 , vertices 171 , 89 , 90 +208 90 137 % triangle 193 , vertices 208 , 90 , 137 +140 8 138 % triangle 194 , vertices 140 , 8 , 138 +172 88 170 % triangle 195 , vertices 172 , 88 , 170 +139 13 87 % triangle 196 , vertices 139 , 13 , 87 +139 88 75 % triangle 197 , vertices 139 , 88 , 75 +167 84 85 % triangle 198 , vertices 167 , 84 , 85 +211 85 140 % triangle 199 , vertices 211 , 85 , 140 +141 50 84 % triangle 200 , vertices 141 , 50 , 84 +214 141 161 % triangle 201 , vertices 214 , 141 , 161 +143 16 141 % triangle 202 , vertices 143 , 16 , 141 +219 149 150 % triangle 203 , vertices 219 , 149 , 150 +217 146 144 % triangle 204 , vertices 217 , 146 , 144 +144 32 49 % triangle 205 , vertices 144 , 32 , 49 +275 217 215 % triangle 206 , vertices 275 , 217 , 215 +216 48 146 % triangle 207 , vertices 216 , 48 , 146 +146 32 144 % triangle 208 , vertices 146 , 32 , 144 +147 30 15 % triangle 209 , vertices 147 , 30 , 15 +217 147 145 % triangle 210 , vertices 217 , 147 , 145 +146 48 32 % triangle 211 , vertices 146 , 48 , 32 +218 163 142 % triangle 212 , vertices 218 , 163 , 142 +145 146 217 % triangle 213 , vertices 145 , 146 , 217 +148 7 142 % triangle 214 , vertices 148 , 7 , 142 +148 29 7 % triangle 215 , vertices 148 , 29 , 7 +219 213 226 % triangle 216 , vertices 219 , 213 , 226 +149 77 27 % triangle 217 , vertices 149 , 77 , 27 +150 78 82 % triangle 218 , vertices 150 , 78 , 82 +150 149 27 % triangle 219 , vertices 150 , 149 , 27 +151 166 80 % triangle 220 , vertices 151 , 166 , 80 +151 28 14 % triangle 221 , vertices 151 , 28 , 14 +187 109 110 % triangle 222 , vertices 187 , 109 , 110 +197 124 112 % triangle 223 , vertices 197 , 124 , 112 +196 110 125 % triangle 224 , vertices 196 , 110 , 125 +153 125 117 % triangle 225 , vertices 153 , 125 , 117 +154 122 123 % triangle 226 , vertices 154 , 122 , 123 +154 123 23 % triangle 227 , vertices 154 , 123 , 23 +195 116 115 % triangle 228 , vertices 195 , 116 , 115 +189 113 194 % triangle 229 , vertices 189 , 113 , 194 +156 107 106 % triangle 230 , vertices 156 , 107 , 106 +181 104 183 % triangle 231 , vertices 181 , 104 , 183 +157 102 101 % triangle 232 , vertices 157 , 102 , 101 +177 99 179 % triangle 233 , vertices 177 , 99 , 179 +158 97 96 % triangle 234 , vertices 158 , 97 , 96 +173 94 175 % triangle 235 , vertices 173 , 94 , 175 +159 92 91 % triangle 236 , vertices 159 , 92 , 91 +169 89 171 % triangle 237 , vertices 169 , 89 , 171 +160 87 86 % triangle 238 , vertices 160 , 87 , 86 +161 84 167 % triangle 239 , vertices 161 , 84 , 167 +231 167 272 % triangle 240 , vertices 231 , 167 , 272 +214 143 141 % triangle 241 , vertices 214 , 143 , 141 +164 149 219 % triangle 242 , vertices 164 , 149 , 219 +162 81 148 % triangle 243 , vertices 162 , 81 , 148 +213 82 166 % triangle 244 , vertices 213 , 82 , 166 +163 148 142 % triangle 245 , vertices 163 , 148 , 142 +225 214 228 % triangle 246 , vertices 225 , 214 , 228 +168 83 164 % triangle 247 , vertices 168 , 83 , 164 +165 80 79 % triangle 248 , vertices 165 , 80 , 79 +165 3 28 % triangle 249 , vertices 165 , 3 , 28 +213 150 82 % triangle 250 , vertices 213 , 150 , 82 +166 82 80 % triangle 251 , vertices 166 , 82 , 80 +279 230 229 % triangle 252 , vertices 279 , 230 , 229 +167 85 211 % triangle 253 , vertices 167 , 85 , 211 +273 210 160 % triangle 254 , vertices 273 , 210 , 160 +228 161 231 % triangle 255 , vertices 228 , 161 , 231 +270 171 208 % triangle 256 , vertices 270 , 171 , 208 +212 140 138 % triangle 257 , vertices 212 , 140 , 138 +234 170 233 % triangle 258 , vertices 234 , 170 , 233 +170 88 139 % triangle 259 , vertices 170 , 88 , 139 +297 227 220 % triangle 260 , vertices 297 , 227 , 220 +171 90 208 % triangle 261 , vertices 171 , 90 , 208 +271 207 159 % triangle 262 , vertices 271 , 207 , 159 +220 169 236 % triangle 263 , vertices 220 , 169 , 236 +241 175 268 % triangle 264 , vertices 241 , 175 , 268 +209 137 135 % triangle 265 , vertices 209 , 137 , 135 +239 174 238 % triangle 266 , vertices 239 , 174 , 238 +174 93 136 % triangle 267 , vertices 174 , 93 , 136 +300 240 239 % triangle 268 , vertices 300 , 240 , 239 +175 95 205 % triangle 269 , vertices 175 , 95 , 205 +269 204 158 % triangle 270 , vertices 269 , 204 , 158 +221 173 241 % triangle 271 , vertices 221 , 173 , 241 +266 179 202 % triangle 272 , vertices 266 , 179 , 202 +206 134 132 % triangle 273 , vertices 206 , 134 , 132 +244 178 243 % triangle 274 , vertices 244 , 178 , 243 +178 98 133 % triangle 275 , vertices 178 , 98 , 133 +304 245 244 % triangle 276 , vertices 304 , 245 , 244 +179 100 202 % triangle 277 , vertices 179 , 100 , 202 +267 201 157 % triangle 278 , vertices 267 , 201 , 157 +222 177 246 % triangle 279 , vertices 222 , 177 , 246 +264 183 199 % triangle 280 , vertices 264 , 183 , 199 +203 131 129 % triangle 281 , vertices 203 , 131 , 129 +249 182 248 % triangle 282 , vertices 249 , 182 , 248 +182 103 130 % triangle 283 , vertices 182 , 103 , 130 +306 250 249 % triangle 284 , vertices 306 , 250 , 249 +183 105 199 % triangle 285 , vertices 183 , 105 , 199 +265 198 156 % triangle 286 , vertices 265 , 198 , 156 +223 181 251 % triangle 287 , vertices 223 , 181 , 251 +196 187 110 % triangle 288 , vertices 196 , 187 , 110 +200 128 126 % triangle 289 , vertices 200 , 128 , 126 +253 186 252 % triangle 290 , vertices 253 , 186 , 252 +186 108 127 % triangle 291 , vertices 186 , 108 , 127 +308 254 253 % triangle 292 , vertices 308 , 254 , 253 +196 125 153 % triangle 293 , vertices 196 , 125 , 153 +263 197 152 % triangle 294 , vertices 263 , 197 , 152 +224 185 255 % triangle 295 , vertices 224 , 185 , 255 +258 189 194 % triangle 296 , vertices 258 , 189 , 194 +189 123 122 % triangle 297 , vertices 189 , 123 , 122 +190 120 121 % triangle 298 , vertices 190 , 120 , 121 +257 153 191 % triangle 299 , vertices 257 , 153 , 191 +191 118 190 % triangle 300 , vertices 191 , 118 , 190 +195 115 155 % triangle 301 , vertices 195 , 115 , 155 +192 119 63 % triangle 302 , vertices 192 , 119 , 63 +192 1 20 % triangle 303 , vertices 192 , 1 , 20 +193 121 116 % triangle 304 , vertices 193 , 121 , 116 +195 193 116 % triangle 305 , vertices 195 , 193 , 116 +258 155 189 % triangle 306 , vertices 258 , 155 , 189 +259 155 258 % triangle 307 , vertices 259 , 155 , 258 +257 285 334 % triangle 308 , vertices 257 , 285 , 334 +287 256 263 % triangle 309 , vertices 287 , 256 , 263 +255 185 187 % triangle 310 , vertices 255 , 185 , 187 +260 259 310 % triangle 311 , vertices 260 , 259 , 310 +197 112 152 % triangle 312 , vertices 197 , 112 , 152 +197 194 124 % triangle 313 , vertices 197 , 194 , 124 +198 107 156 % triangle 314 , vertices 198 , 107 , 156 +198 186 127 % triangle 315 , vertices 198 , 186 , 127 +305 223 288 % triangle 316 , vertices 305 , 223 , 288 +265 156 250 % triangle 317 , vertices 265 , 156 , 250 +200 126 185 % triangle 318 , vertices 200 , 126 , 185 +200 199 128 % triangle 319 , vertices 200 , 199 , 128 +201 102 157 % triangle 320 , vertices 201 , 102 , 157 +201 182 130 % triangle 321 , vertices 201 , 182 , 130 +323 240 300 % triangle 322 , vertices 323 , 240 , 300 +267 157 245 % triangle 323 , vertices 267 , 157 , 245 +203 129 181 % triangle 324 , vertices 203 , 129 , 181 +203 202 131 % triangle 325 , vertices 203 , 202 , 131 +204 97 158 % triangle 326 , vertices 204 , 97 , 158 +204 178 133 % triangle 327 , vertices 204 , 178 , 133 +299 221 290 % triangle 328 , vertices 299 , 221 , 290 +269 158 240 % triangle 329 , vertices 269 , 158 , 240 +206 132 177 % triangle 330 , vertices 206 , 132 , 177 +206 205 134 % triangle 331 , vertices 206 , 205 , 134 +207 92 159 % triangle 332 , vertices 207 , 92 , 159 +207 174 136 % triangle 333 , vertices 207 , 174 , 136 +298 235 234 % triangle 334 , vertices 298 , 235 , 234 +271 159 235 % triangle 335 , vertices 271 , 159 , 235 +209 135 173 % triangle 336 , vertices 209 , 135 , 173 +209 208 137 % triangle 337 , vertices 209 , 208 , 137 +210 87 160 % triangle 338 , vertices 210 , 87 , 160 +210 170 139 % triangle 339 , vertices 210 , 170 , 139 +332 225 331 % triangle 340 , vertices 332 , 225 , 331 +273 160 230 % triangle 341 , vertices 273 , 160 , 230 +212 138 169 % triangle 342 , vertices 212 , 138 , 169 +212 211 140 % triangle 343 , vertices 212 , 211 , 140 +219 150 213 % triangle 344 , vertices 219 , 150 , 213 +213 166 274 % triangle 345 , vertices 213 , 166 , 274 +274 162 278 % triangle 346 , vertices 274 , 162 , 278 +215 144 143 % triangle 347 , vertices 215 , 144 , 143 +215 143 214 % triangle 348 , vertices 215 , 143 , 214 +218 217 275 % triangle 349 , vertices 218 , 217 , 275 +216 0 48 % triangle 350 , vertices 216 , 0 , 48 +216 146 145 % triangle 351 , vertices 216 , 146 , 145 +217 144 215 % triangle 352 , vertices 217 , 144 , 215 +275 276 218 % triangle 353 , vertices 275 , 276 , 218 +218 147 217 % triangle 354 , vertices 218 , 147 , 217 +218 142 147 % triangle 355 , vertices 218 , 142 , 147 +229 168 164 % triangle 356 , vertices 229 , 168 , 164 +229 277 330 % triangle 357 , vertices 229 , 277 , 330 +227 211 212 % triangle 358 , vertices 227 , 211 , 212 +220 212 169 % triangle 359 , vertices 220 , 212 , 169 +232 208 209 % triangle 360 , vertices 232 , 208 , 209 +221 209 173 % triangle 361 , vertices 221 , 209 , 173 +237 205 206 % triangle 362 , vertices 237 , 205 , 206 +222 206 177 % triangle 363 , vertices 222 , 206 , 177 +242 202 203 % triangle 364 , vertices 242 , 202 , 203 +223 203 181 % triangle 365 , vertices 223 , 203 , 181 +247 199 200 % triangle 366 , vertices 247 , 199 , 200 +224 200 185 % triangle 367 , vertices 224 , 200 , 185 +225 215 214 % triangle 368 , vertices 225 , 215 , 214 +277 164 219 % triangle 369 , vertices 277 , 164 , 219 +276 275 332 % triangle 370 , vertices 276 , 275 , 332 +229 164 277 % triangle 371 , vertices 229 , 164 , 277 +227 212 220 % triangle 372 , vertices 227 , 212 , 220 +273 233 210 % triangle 373 , vertices 273 , 233 , 210 +278 294 333 % triangle 374 , vertices 278 , 294 , 333 +228 214 161 % triangle 375 , vertices 228 , 214 , 161 +277 219 226 % triangle 376 , vertices 277 , 219 , 226 +230 160 168 % triangle 377 , vertices 230 , 160 , 168 +230 168 229 % triangle 378 , vertices 230 , 168 , 229 +272 296 231 % triangle 379 , vertices 272 , 296 , 231 +296 279 292 % triangle 380 , vertices 296 , 279 , 292 +231 161 167 % triangle 381 , vertices 231 , 161 , 167 +232 209 221 % triangle 382 , vertices 232 , 209 , 221 +271 238 207 % triangle 383 , vertices 271 , 238 , 207 +297 280 291 % triangle 384 , vertices 297 , 280 , 291 +234 172 170 % triangle 385 , vertices 234 , 172 , 170 +327 271 235 % triangle 386 , vertices 327 , 271 , 235 +235 159 172 % triangle 387 , vertices 235 , 159 , 172 +235 172 234 % triangle 388 , vertices 235 , 172 , 234 +270 208 232 % triangle 389 , vertices 270 , 208 , 232 +270 236 171 % triangle 390 , vertices 270 , 236 , 171 +236 169 171 % triangle 391 , vertices 236 , 169 , 171 +237 206 222 % triangle 392 , vertices 237 , 206 , 222 +269 243 204 % triangle 393 , vertices 269 , 243 , 204 +299 290 281 % triangle 394 , vertices 299 , 290 , 281 +239 176 174 % triangle 395 , vertices 239 , 176 , 174 +300 239 281 % triangle 396 , vertices 300 , 239 , 281 +240 158 176 % triangle 397 , vertices 240 , 158 , 176 +240 176 239 % triangle 398 , vertices 240 , 176 , 239 +268 302 241 % triangle 399 , vertices 268 , 302 , 241 +302 281 290 % triangle 400 , vertices 302 , 281 , 290 +241 173 175 % triangle 401 , vertices 241 , 173 , 175 +242 203 223 % triangle 402 , vertices 242 , 203 , 223 +267 248 201 % triangle 403 , vertices 267 , 248 , 201 +303 289 282 % triangle 404 , vertices 303 , 289 , 282 +244 180 178 % triangle 405 , vertices 244 , 180 , 178 +304 282 289 % triangle 406 , vertices 304 , 282 , 289 +245 157 180 % triangle 407 , vertices 245 , 157 , 180 +245 180 244 % triangle 408 , vertices 245 , 180 , 244 +266 202 242 % triangle 409 , vertices 266 , 202 , 242 +266 246 179 % triangle 410 , vertices 266 , 246 , 179 +246 177 179 % triangle 411 , vertices 246 , 177 , 179 +247 200 224 % triangle 412 , vertices 247 , 200 , 224 +265 252 198 % triangle 413 , vertices 265 , 252 , 198 +305 288 283 % triangle 414 , vertices 305 , 288 , 283 +249 184 182 % triangle 415 , vertices 249 , 184 , 182 +316 265 317 % triangle 416 , vertices 316 , 265 , 317 +250 156 184 % triangle 417 , vertices 250 , 156 , 184 +250 184 249 % triangle 418 , vertices 250 , 184 , 249 +264 199 247 % triangle 419 , vertices 264 , 199 , 247 +264 251 183 % triangle 420 , vertices 264 , 251 , 183 +251 181 183 % triangle 421 , vertices 251 , 181 , 183 +312 308 284 % triangle 422 , vertices 312 , 308 , 284 +253 188 186 % triangle 423 , vertices 253 , 188 , 186 +311 263 254 % triangle 424 , vertices 311 , 263 , 254 +254 152 188 % triangle 425 , vertices 254 , 152 , 188 +254 188 253 % triangle 426 , vertices 254 , 188 , 253 +255 187 262 % triangle 427 , vertices 255 , 187 , 262 +261 153 257 % triangle 428 , vertices 261 , 153 , 257 +307 247 224 % triangle 429 , vertices 307 , 247 , 224 +260 195 259 % triangle 430 , vertices 260 , 195 , 259 +256 194 197 % triangle 431 , vertices 256 , 194 , 197 +259 258 335 % triangle 432 , vertices 259 , 258 , 335 +261 196 153 % triangle 433 , vertices 261 , 196 , 153 +258 194 256 % triangle 434 , vertices 258 , 194 , 256 +259 195 155 % triangle 435 , vertices 259 , 195 , 155 +334 285 260 % triangle 436 , vertices 334 , 285 , 260 +260 193 195 % triangle 437 , vertices 260 , 193 , 195 +310 286 334 % triangle 438 , vertices 310 , 286 , 334 +285 190 193 % triangle 439 , vertices 285 , 190 , 193 +262 196 261 % triangle 440 , vertices 262 , 196 , 261 +263 311 287 % triangle 441 , vertices 263 , 311 , 287 +312 255 262 % triangle 442 , vertices 312 , 255 , 262 +313 287 311 % triangle 443 , vertices 313 , 287 , 311 +263 152 254 % triangle 444 , vertices 263 , 152 , 254 +263 256 197 % triangle 445 , vertices 263 , 256 , 197 +314 288 251 % triangle 446 , vertices 314 , 288 , 251 +315 306 314 % triangle 447 , vertices 315 , 306 , 314 +316 284 252 % triangle 448 , vertices 316 , 284 , 252 +317 306 315 % triangle 449 , vertices 317 , 306 , 315 +318 289 246 % triangle 450 , vertices 318 , 289 , 246 +319 304 318 % triangle 451 , vertices 319 , 304 , 318 +320 283 248 % triangle 452 , vertices 320 , 283 , 248 +321 304 319 % triangle 453 , vertices 321 , 304 , 319 +268 205 237 % triangle 454 , vertices 268 , 205 , 237 +268 175 205 % triangle 455 , vertices 268 , 175 , 205 +322 282 243 % triangle 456 , vertices 322 , 282 , 243 +301 268 237 % triangle 457 , vertices 301 , 268 , 237 +324 280 236 % triangle 458 , vertices 324 , 280 , 236 +325 298 324 % triangle 459 , vertices 325 , 298 , 324 +326 281 238 % triangle 460 , vertices 326 , 281 , 238 +327 298 325 % triangle 461 , vertices 327 , 298 , 325 +272 211 227 % triangle 462 , vertices 272 , 211 , 227 +272 167 211 % triangle 463 , vertices 272 , 167 , 211 +328 291 233 % triangle 464 , vertices 328 , 291 , 233 +295 272 227 % triangle 465 , vertices 295 , 272 , 227 +274 226 213 % triangle 466 , vertices 274 , 226 , 213 +274 166 162 % triangle 467 , vertices 274 , 166 , 162 +275 215 225 % triangle 468 , vertices 275 , 215 , 225 +276 163 218 % triangle 469 , vertices 276 , 163 , 218 +333 274 278 % triangle 470 , vertices 333 , 274 , 278 +278 162 163 % triangle 471 , vertices 278 , 162 , 163 +330 279 229 % triangle 472 , vertices 330 , 279 , 229 +331 330 293 % triangle 473 , vertices 331 , 330 , 293 +333 226 274 % triangle 474 , vertices 333 , 226 , 274 +278 163 276 % triangle 475 , vertices 278 , 163 , 276 +292 228 231 % triangle 476 , vertices 292 , 228 , 231 +329 273 230 % triangle 477 , vertices 329 , 273 , 230 +280 220 236 % triangle 478 , vertices 280 , 220 , 236 +324 298 291 % triangle 479 , vertices 324 , 298 , 291 +281 239 238 % triangle 480 , vertices 281 , 239 , 238 +290 221 241 % triangle 481 , vertices 290 , 221 , 241 +282 244 243 % triangle 482 , vertices 282 , 244 , 243 +289 222 246 % triangle 483 , vertices 289 , 222 , 246 +283 249 248 % triangle 484 , vertices 283 , 249 , 248 +288 223 251 % triangle 485 , vertices 288 , 223 , 251 +284 253 252 % triangle 486 , vertices 284 , 253 , 252 +307 224 309 % triangle 487 , vertices 307 , 224 , 309 +285 193 260 % triangle 488 , vertices 285 , 193 , 260 +285 257 191 % triangle 489 , vertices 285 , 257 , 191 +312 262 313 % triangle 490 , vertices 312 , 262 , 313 +286 261 257 % triangle 491 , vertices 286 , 261 , 257 +311 254 308 % triangle 492 , vertices 311 , 254 , 308 +335 258 256 % triangle 493 , vertices 335 , 258 , 256 +306 249 283 % triangle 494 , vertices 306 , 249 , 283 +305 242 223 % triangle 495 , vertices 305 , 242 , 223 +318 246 266 % triangle 496 , vertices 318 , 246 , 266 +303 237 222 % triangle 497 , vertices 303 , 237 , 222 +302 300 281 % triangle 498 , vertices 302 , 300 , 281 +299 232 221 % triangle 499 , vertices 299 , 232 , 221 +291 234 233 % triangle 500 , vertices 291 , 234 , 233 +329 279 295 % triangle 501 , vertices 329 , 279 , 295 +296 295 279 % triangle 502 , vertices 296 , 295 , 279 +330 277 293 % triangle 503 , vertices 330 , 277 , 293 +331 228 292 % triangle 504 , vertices 331 , 228 , 292 +293 277 226 % triangle 505 , vertices 293 , 277 , 226 +294 278 276 % triangle 506 , vertices 294 , 278 , 276 +332 275 225 % triangle 507 , vertices 332 , 275 , 225 +328 233 273 % triangle 508 , vertices 328 , 233 , 273 +329 297 328 % triangle 509 , vertices 329 , 297 , 328 +296 272 295 % triangle 510 , vertices 296 , 272 , 295 +296 292 231 % triangle 511 , vertices 296 , 292 , 231 +297 220 280 % triangle 512 , vertices 297 , 220 , 280 +297 295 227 % triangle 513 , vertices 297 , 295 , 227 +298 234 291 % triangle 514 , vertices 298 , 234 , 291 +324 236 270 % triangle 515 , vertices 324 , 236 , 270 +326 238 271 % triangle 516 , vertices 326 , 238 , 271 +324 270 325 % triangle 517 , vertices 324 , 270 , 325 +302 301 300 % triangle 518 , vertices 302 , 301 , 300 +322 269 323 % triangle 519 , vertices 322 , 269 , 323 +322 243 269 % triangle 520 , vertices 322 , 243 , 269 +323 269 240 % triangle 521 , vertices 323 , 269 , 240 +302 268 301 % triangle 522 , vertices 302 , 268 , 301 +302 290 241 % triangle 523 , vertices 302 , 290 , 241 +303 222 289 % triangle 524 , vertices 303 , 222 , 289 +303 301 237 % triangle 525 , vertices 303 , 301 , 237 +320 267 321 % triangle 526 , vertices 320 , 267 , 321 +304 244 282 % triangle 527 , vertices 304 , 244 , 282 +320 248 267 % triangle 528 , vertices 320 , 248 , 267 +318 266 319 % triangle 529 , vertices 318 , 266 , 319 +306 283 288 % triangle 530 , vertices 306 , 283 , 288 +314 251 264 % triangle 531 , vertices 314 , 251 , 264 +316 252 265 % triangle 532 , vertices 316 , 252 , 265 +314 264 315 % triangle 533 , vertices 314 , 264 , 315 +308 253 284 % triangle 534 , vertices 308 , 253 , 284 +309 255 312 % triangle 535 , vertices 309 , 255 , 312 +309 284 307 % triangle 536 , vertices 309 , 284 , 307 +309 224 255 % triangle 537 , vertices 309 , 224 , 255 +335 256 287 % triangle 538 , vertices 335 , 256 , 287 +310 287 286 % triangle 539 , vertices 310 , 287 , 286 +313 286 287 % triangle 540 , vertices 313 , 286 , 287 +313 311 312 % triangle 541 , vertices 313 , 311 , 312 +312 311 308 % triangle 542 , vertices 312 , 311 , 308 +312 284 309 % triangle 543 , vertices 312 , 284 , 309 +313 261 286 % triangle 544 , vertices 313 , 261 , 286 +313 262 261 % triangle 545 , vertices 313 , 262 , 261 +317 307 316 % triangle 546 , vertices 317 , 307 , 316 +314 306 288 % triangle 547 , vertices 314 , 306 , 288 +315 247 307 % triangle 548 , vertices 315 , 247 , 307 +315 264 247 % triangle 549 , vertices 315 , 264 , 247 +317 315 307 % triangle 550 , vertices 317 , 315 , 307 +316 307 284 % triangle 551 , vertices 316 , 307 , 284 +317 250 306 % triangle 552 , vertices 317 , 250 , 306 +317 265 250 % triangle 553 , vertices 317 , 265 , 250 +321 305 320 % triangle 554 , vertices 321 , 305 , 320 +318 304 289 % triangle 555 , vertices 318 , 304 , 289 +319 242 305 % triangle 556 , vertices 319 , 242 , 305 +319 266 242 % triangle 557 , vertices 319 , 266 , 242 +321 319 305 % triangle 558 , vertices 321 , 319 , 305 +320 305 283 % triangle 559 , vertices 320 , 305 , 283 +321 245 304 % triangle 560 , vertices 321 , 245 , 304 +321 267 245 % triangle 561 , vertices 321 , 267 , 245 +323 301 303 % triangle 562 , vertices 323 , 301 , 303 +322 303 282 % triangle 563 , vertices 322 , 303 , 282 +323 303 322 % triangle 564 , vertices 323 , 303 , 322 +323 300 301 % triangle 565 , vertices 323 , 300 , 301 +327 299 326 % triangle 566 , vertices 327 , 299 , 326 +324 291 280 % triangle 567 , vertices 324 , 291 , 280 +325 232 299 % triangle 568 , vertices 325 , 232 , 299 +325 270 232 % triangle 569 , vertices 325 , 270 , 232 +327 325 299 % triangle 570 , vertices 327 , 325 , 299 +326 299 281 % triangle 571 , vertices 326 , 299 , 281 +327 235 298 % triangle 572 , vertices 327 , 235 , 298 +327 326 271 % triangle 573 , vertices 327 , 326 , 271 +329 295 297 % triangle 574 , vertices 329 , 295 , 297 +328 297 291 % triangle 575 , vertices 328 , 297 , 291 +329 230 279 % triangle 576 , vertices 329 , 230 , 279 +329 328 273 % triangle 577 , vertices 329 , 328 , 273 +330 331 292 % triangle 578 , vertices 330 , 331 , 292 +330 292 279 % triangle 579 , vertices 330 , 292 , 279 +331 293 294 % triangle 580 , vertices 331 , 293 , 294 +331 225 228 % triangle 581 , vertices 331 , 225 , 228 +332 331 294 % triangle 582 , vertices 332 , 331 , 294 +332 294 276 % triangle 583 , vertices 332 , 294 , 276 +333 294 293 % triangle 584 , vertices 333 , 294 , 293 +333 293 226 % triangle 585 , vertices 333 , 293 , 226 +334 260 310 % triangle 586 , vertices 334 , 260 , 310 +334 286 257 % triangle 587 , vertices 334 , 286 , 257 +335 287 310 % triangle 588 , vertices 335 , 287 , 310 +335 310 259 % triangle 589 , vertices 335 , 310 , 259 +# +# dgf/irregular_grid_10m.dgf diff --git a/test/freeflow/shallowwater/poiseuilleflow/main.cc b/test/freeflow/shallowwater/poiseuilleflow/main.cc new file mode 100644 index 0000000000000000000000000000000000000000..932bb3d1fb4e3f76a74eb9f8e6f0cb4e59e02c5b --- /dev/null +++ b/test/freeflow/shallowwater/poiseuilleflow/main.cc @@ -0,0 +1,155 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 3 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ + +#include <config.h> +#include <iostream> + +#include <dune/common/parallel/mpihelper.hh> + +#include <dumux/common/properties.hh> +#include <dumux/common/parameters.hh> +#include <dumux/common/dumuxmessage.hh> + +#include <dumux/linear/linearsolvertraits.hh> +#include <dumux/linear/amgbackend.hh> +#include <dumux/nonlinear/newtonsolver.hh> +#include <dumux/assembly/fvassembler.hh> + +#include <dumux/io/vtkoutputmodule.hh> + +#include <dumux/io/grid/gridmanager_yasp.hh> +#include <dumux/io/grid/gridmanager_ug.hh> + +#include "properties.hh" + +int main(int argc, char** argv) +{ + using namespace Dumux; + + const auto& mpiHelper = Dune::MPIHelper::instance(argc, argv); + + // parse command line arguments and input file + Parameters::init(argc, argv); + + // the property tag + using TypeTag = Properties::TTag::PoiseuilleFlow; + + // create grid + GridManager<GetPropType<TypeTag, Properties::Grid>> gridManager; + gridManager.init(); + const auto& leafGridView = gridManager.grid().leafGridView(); + + using GridGeometry = GetPropType<TypeTag, Properties::GridGeometry>; + auto gridGeometry = std::make_shared<GridGeometry>(leafGridView); + gridGeometry->update(); + + // problem, in which we define the boundary and initial conditions. + using Problem = GetPropType<TypeTag, Properties::Problem>; + auto problem = std::make_shared<Problem>(gridGeometry); + + using SolutionVector = GetPropType<TypeTag, Properties::SolutionVector>; + SolutionVector x; + problem->applyInitialSolution(x); + auto xOld = x; + + using GridVariables = GetPropType<TypeTag, Properties::GridVariables>; + auto gridVariables = std::make_shared<GridVariables>(problem, gridGeometry); + gridVariables->init(x); + + // We then initialize the predefined model-specific output vtk output. + using IOFields = GetPropType<TypeTag, Properties::IOFields>; + + VtkOutputModule<GridVariables, SolutionVector> vtkWriter(*gridVariables,x, problem->name()); + vtkWriter.addField(problem->getExactWaterDepth(), "exactWaterDepth"); + vtkWriter.addField(problem->getExactVelocityX(), "exactVelocityX"); + vtkWriter.addField(problem->getExactVelocityY(), "exactVelocityY"); + problem->updateAnalyticalSolution(); + IOFields::initOutputModule(vtkWriter); + vtkWriter.write(0.0); + + // instantiate time loop + // get some time loop parameters + using Scalar = GetPropType<TypeTag, Properties::Scalar>; + const auto tEnd = getParam<Scalar>("TimeLoop.TEnd"); + const auto maxDt = getParam<Scalar>("TimeLoop.MaxTimeStepSize"); + const auto dt = getParam<Scalar>("TimeLoop.DtInitial"); + auto timeLoop = std::make_shared<CheckPointTimeLoop<Scalar>>(0, dt, tEnd); + timeLoop->setMaxTimeStepSize(maxDt); + + if (hasParam("TimeLoop.PrintoutTimes")) + { + const auto timeLoopPrintoutTimes = getParam<std::vector<double>>("TimeLoop.PrintoutTimes"); + timeLoop->setCheckPoint(timeLoopPrintoutTimes); + } + + timeLoop->setCheckPoint(tEnd); + + // assembler & solver + using Assembler = FVAssembler<TypeTag, DiffMethod::numeric>; + auto assembler = std::make_shared<Assembler>(problem, gridGeometry, gridVariables, timeLoop, xOld); + + using LinearSolver = AMGBiCGSTABBackend<LinearSolverTraits<GridGeometry>>; + auto linearSolver = std::make_shared<LinearSolver>(leafGridView, gridGeometry->dofMapper()); + + using NewtonSolver = Dumux::NewtonSolver<Assembler, LinearSolver>; + NewtonSolver nonLinearSolver(assembler, linearSolver); + + // time loop + timeLoop->start(); do + { + nonLinearSolver.solve(x, *timeLoop); + + // update the analytical solution + problem->updateAnalyticalSolution(); + + // make the new solution the old solution + xOld = x; + gridVariables->advanceTimeStep(); + + // advance to the time loop to the next step + timeLoop->advanceTimeStep(); + + // write vtk output + if (timeLoop->isCheckPoint()) + vtkWriter.write(timeLoop->time()); + + // report statistics of this time step + timeLoop->reportTimeStep(); + + // set new dt as suggested by newton controller + timeLoop->setTimeStepSize(nonLinearSolver.suggestTimeStepSize(timeLoop->timeStepSize())); + + + } while (!timeLoop->finished()); + + timeLoop->finalize(leafGridView.comm()); + + //////////////////////////////////////////////////////////// + // finalize, print dumux message to say goodbye + //////////////////////////////////////////////////////////// + + // print dumux end message + if (mpiHelper.rank() == 0) + { + Parameters::print(); + DumuxMessage::print(/*firstCall=*/false); + } + + return 0; +} diff --git a/test/freeflow/shallowwater/poiseuilleflow/params.input b/test/freeflow/shallowwater/poiseuilleflow/params.input new file mode 100755 index 0000000000000000000000000000000000000000..d513f42c9a96b0aaa8cab00401c7200b3f674770 --- /dev/null +++ b/test/freeflow/shallowwater/poiseuilleflow/params.input @@ -0,0 +1,25 @@ +[Problem] +Name = poiseuilleflow +BedSlope = 0.00005 # [-] slope of the bed in m/m (positive downwards) +Gravity = 9.81 # [m/s^2] gravitational acceleration +Discharge = -4.0875 # [m^2/s] discharge per meter at the inflow boundary +HBoundary = 10.0 # [m] water depth at the ouflow boundary +EnableViscousFlux = true +TurbulentViscosity = 0.1 # [m^2/s] turbulent viscosity +WallFrictionLaw = noslip # Type of wall friction law: "noslip" or "nikuradse" +AlphaWall = 1.0 # [-] wall roughness parameter; alphaWall=0 : full slip, 0<alphaWall<1 : partial slip, alphaWall=1 : no slip +KsWall = 50.0 # [m] wall roughness height (Nikuradse equivalent) + +[TimeLoop] +TEnd = 2880.0 # [s] +MaxTimeStepSize = 120.0 # [s] +DtInitial = 1.0 # [s] +PrintoutTimes = 180 360 720 980 1440 2160 2880 + +[Grid] +LowerLeft = 0.0 -50.0 +UpperRight = 400.0 50.0 +Cells = 20 20 + +[Newton] +EnablePartialReassembly = true diff --git a/test/freeflow/shallowwater/poiseuilleflow/problem.hh b/test/freeflow/shallowwater/poiseuilleflow/problem.hh new file mode 100644 index 0000000000000000000000000000000000000000..eba86644aa90f25c76c2fb976b0159f358784283 --- /dev/null +++ b/test/freeflow/shallowwater/poiseuilleflow/problem.hh @@ -0,0 +1,375 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 3 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ + +#ifndef DUMUX_POISEUILLE_FLOW_TEST_PROBLEM_HH +#define DUMUX_POISEUILLE_FLOW_TEST_PROBLEM_HH + +#include <dumux/common/properties.hh> +#include <dumux/common/parameters.hh> +#include <dumux/freeflow/shallowwater/problem.hh> +#include <dumux/freeflow/shallowwater/boundaryfluxes.hh> + +#include <algorithm> +#include <cctype> + +namespace Dumux { + +/*! + * \ingroup ShallowWaterTests + * \brief A simple test for the 2D flow in a channel with rough side walls (Poiseuille flow). + * + * The domain has a length L = 400 meters long and a width W = 100 meters. + * The domain extent is from (x,y) = (0.0, -50.0) to (400.0, 50.0), i.e. the channel centreline is at y = 0. + * The bed level is sloped from z = -9.98 (x = 0) to z = -10.0 meters (x = L). + * The initital water depth corresponds to the analytical solution: + * having a slope equal to \f$ ib = d \Theta / L \f$ , where \f$ d \Theta \f$ is the water level difference between upstream and downstream: \f$ d \Theta \f$ = 0.02 m (positive downwards). + * With L = 400 m, the slope is ib = 0.00005 m/m, resulting in a constant water depth along the channel of H = 10.0 m. + + * At the west/left (inflow) boundary a discharge is prescribed of \f$ Q_{in} = -408.75 m^3/s \f$ or \f$ q_{in} = 4.0875 m^2/s \f$ per meter. + * At the east/right (outflow) boundary a fixed water level is prescribed of \f$ \Theta \f$ = 0.0 m. + * The south and north boundaries are set to roughwall type boundaries, + * with a coefficient alphaWall = 1.0, where: + * alphaWall = 0.0: full slip (smooth wall) + * 0.0 <alphaWall < 1.0: partial slip (partially-rough wall) + * alphaWall = 1.0: no slip (fully-rough wall) + * Additionally these (south and north) boundaries are (automatically) set to no-flow boundaries. + + * The flow in the channel experiences two forces: + * 1) the pressure gradient, driving the flow downstream + * 2) the wall roughness, + + * It can be verified that this force balance reduces the momentum equation in X-direction to: + * + \f[ + \frac{\partial p}{\partial x} = \nu_T \frac{\partial^2 u}{\partial y^2} + \f] + * where \f$ \nu_T \f$ is the turbulent viscosity. + * + * This ordinary differential equation can be solved (applying the boundary conditions to obtain the integration constants), + * resulting in a parabolic velocity profile in lateral direction (over the width of the channel): + * + \f[ + u(y) = \frac{g d \Theta}{8 \nu_T L} \left(4y^2 - W^2\right) + \f] + * + * where y the coordinate in lateral direction. + * The velocity has a maximum value at y = 0: + \f[ + u_{max} = \frac{g d \Theta W^2}{8 \nu_T L} + \f] + * + * Therefore \f$ u_{max} \f$ can be calculated to be: + * + \f[ + u_{max} = \frac{9.81*0.02*100^2}{8*0.1*400} = 6.13125 m/s + \f] + * + The formula for \f$ u(y) \f$ is also used to calculate the analytic solution. + * It should be noted that u = f(x) and that v = 0 in the whole domain (in the final steady state). + * Therefore the momentum advection/convection terms should be zero for this test, as: + * \f$ u \partial u / \partial x = v \partial u / \partial y = u \partial v / \partial x = v \partial v / \partial y = 0 \f$ + * + * This problem uses the \ref ShallowWaterModel + */ +template<class TypeTag> +class PoiseuilleFlowProblem +: public ShallowWaterProblem<TypeTag> +{ + using ParentType = ShallowWaterProblem<TypeTag>; + using PrimaryVariables = GetPropType<TypeTag, Properties::PrimaryVariables>; + using BoundaryTypes = Dumux::BoundaryTypes<GetPropType<TypeTag, Properties::ModelTraits>::numEq()>; + using Scalar = GetPropType<TypeTag, Properties::Scalar>; + using Indices = typename GetPropType<TypeTag, Properties::ModelTraits>::Indices; + using GridGeometry = GetPropType<TypeTag, Properties::GridGeometry>; + using NeumannFluxes = GetPropType<TypeTag, Properties::NumEqVector>; + using ElementVolumeVariables = typename GetPropType<TypeTag, Properties::GridVolumeVariables>::LocalView; + using GridVariables = GetPropType<TypeTag, Properties::GridVariables>; + using ElementFluxVariablesCache = typename GridVariables::GridFluxVariablesCache::LocalView; + using VolumeVariables = typename ElementVolumeVariables::VolumeVariables; + using FVElementGeometry = typename GetPropType<TypeTag, Properties::GridGeometry>::LocalView; + using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; + using GridView = typename GetPropType<TypeTag, Properties::GridGeometry>::GridView; + using Element = typename GridView::template Codim<0>::Entity; + using GlobalPosition = typename Element::Geometry::GlobalCoordinate; + using NumEqVector = GetPropType<TypeTag, Properties::NumEqVector>; + using SubControlVolume = typename FVElementGeometry::SubControlVolume; + +public: + PoiseuilleFlowProblem(std::shared_ptr<const GridGeometry> gridGeometry) + : ParentType(gridGeometry) + { + name_ = getParam<std::string>("Problem.Name"); + exactWaterDepth_.resize(gridGeometry->numDofs(), 0.0); + exactVelocityX_.resize(gridGeometry->numDofs(), 0.0); + exactVelocityY_.resize(gridGeometry->numDofs(), 0.0); + bedSlope_ = getParam<Scalar>("Problem.BedSlope"); + discharge_ = getParam<Scalar>("Problem.Discharge"); + hBoundary_ = getParam<Scalar>("Problem.HBoundary"); + enableViscousFlux_ = getParam<bool>("Problem.EnableViscousFlux", false); + turbViscosity_ = getParam<Scalar>("Problem.TurbulentViscosity"); + alphaWall_ = getParam<Scalar>("Problem.AlphaWall"); + ksWall_ = getParam<Scalar>("Problem.KsWall"); + wallFrictionLawType_ = getParam<std::string>("Problem.WallFrictionLaw"); + // Make the wallFrictionLawType_ lower case + std::transform(wallFrictionLawType_.begin(), wallFrictionLawType_.end(), wallFrictionLawType_.begin(), [](unsigned char c){ return std::tolower(c); }); + } + + //! Get the analytical water depth + const std::vector<Scalar>& getExactWaterDepth() const + { return exactWaterDepth_; } + + //! Get the analytical U-velocity + const std::vector<Scalar>& getExactVelocityX() const + { return exactVelocityX_; } + + //! Get the analytical V-velocity + const std::vector<Scalar>& getExactVelocityY() const + { return exactVelocityY_; } + + //! Update the analytical solution + void updateAnalyticalSolution() + { + for (const auto& element : elements(this->gridGeometry().gridView())) + { + const auto eIdx = this->gridGeometry().elementMapper().index(element); + const auto& globalPos = element.geometry().center(); + const auto gravity = this->spatialParams().gravity(globalPos); + const Scalar y = globalPos[1]; + const Scalar width = this->gridGeometry().bBoxMax()[1] - this->gridGeometry().bBoxMin()[1]; + const Scalar h = hBoundary_; + const Scalar u = -(gravity*bedSlope_/(8.0*turbViscosity_)) * (4.0*y*y - width*width); + exactWaterDepth_[eIdx] = h; + exactVelocityX_[eIdx] = u; + exactVelocityY_[eIdx] = 0.0; + } + } + + const std::string& name() const + { return name_; } + + /*! + * \name Boundary conditions + */ + // \{ + + /*! + * \brief Specifies which kind of boundary condition should be + * used for which equation on a given boundary segment. + * + * \param globalPos The position for which the boundary type is set + */ + BoundaryTypes boundaryTypesAtPos(const GlobalPosition &globalPos) const + { + BoundaryTypes bcTypes; + bcTypes.setAllNeumann(); + return bcTypes; + } + + /*! + * \brief Specifies the neumann boundary + * + * We need the Riemann invariants to compute the values depending of the boundary type. + * Since we use a weak imposition we do not have a dirichlet value. We impose fluxes + * based on q, h, etc. computed with the Riemann invariants + */ + NeumannFluxes neumann(const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const ElementFluxVariablesCache& elemFluxVarsCache, + const SubControlVolumeFace& scvf) const + { + NeumannFluxes values(0.0); + + const auto& insideScv = fvGeometry.scv(scvf.insideScvIdx()); + const auto& insideVolVars = elemVolVars[insideScv]; + const auto& unitNormal = scvf.unitOuterNormal(); + const auto gravity = this->spatialParams().gravity(scvf.center()); + std::array<Scalar, 3> boundaryStateVariables; + + // impose discharge at the left side + if (scvf.center()[0] < this->gridGeometry().bBoxMin()[0] + eps_) + { + // Prescribe the exact q-distribution long the inflow boundaryStateVariables + // based on the parabolic u-profile: + // q(y) = (g*H*ib/(8*nu_T)) * (4*y^2^-W^2) + // Note the opposite sign to the velocity u, due to the fact that it is an inflow discharge + const auto y = scvf.center()[1]; + const auto width = this->gridGeometry().bBoxMax()[1] - this->gridGeometry().bBoxMin()[1]; + const auto h = hBoundary_; + // Now compute a weighted average between the constant q (from input) and the parabolic q from the analytical solution + // based on the prescribed alphaWall + const auto q_in0 = (gravity*h*bedSlope_/(8.0*turbViscosity_)) * (4.0*y*y - width*width); + const auto q_in1 = discharge_; + const auto q_in = (1.0-alphaWall_)*q_in1 + alphaWall_*q_in0; + boundaryStateVariables = ShallowWater::fixedDischargeBoundary(q_in, + insideVolVars.waterDepth(), + insideVolVars.velocity(0), + insideVolVars.velocity(1), + gravity, + unitNormal); + } + // impose water depth at the right side + else if (scvf.center()[0] > this->gridGeometry().bBoxMax()[0] - eps_) + { + boundaryStateVariables = ShallowWater::fixedWaterDepthBoundary(hBoundary_, + insideVolVars.waterDepth(), + insideVolVars.velocity(0), + insideVolVars.velocity(1), + gravity, + unitNormal); + } + // no flow boundary + else + { + // For the rough side walls of type no-slip we prescribe a slip condition based on alphaWall + // for smooth closed walls we prescribed a full-slip condition (zero-roughness) + + // Get inside velocity components in cell face coordinates (t,n) using normal vector unitNormal + // Note that the first component is the normal component + // since we are rotating to the normal vector coordinate system + const Scalar insideVelocityNWall = insideVolVars.velocity(0)*unitNormal[0] + insideVolVars.velocity(1)*unitNormal[1]; + const Scalar insideVelocityTWall = -insideVolVars.velocity(0)*unitNormal[1] + insideVolVars.velocity(1)*unitNormal[0]; + + // Initialisation of outside velocities + auto outsideVelocityNWall = insideVelocityNWall; + auto outsideVelocityTWall = insideVelocityTWall; + + // Now set the outside (ghost cell) velocities based on the chosen slip condition + if ((scvf.center()[1] < this->gridGeometry().bBoxMin()[1] + eps_ || scvf.center()[1] > this->gridGeometry().bBoxMax()[1] - eps_) && (wallFrictionLawType_ == "noslip" || wallFrictionLawType_ == "nikuradse")) + { + // Set the outside state using the no-slip wall roughness conditions based on alphaWall + // alphaWall = 0.0: full slip (wall tangential velocity equals inside tangential velocity) + // alphaWall = 1.0: no slip (wall tangential velocity=0.0: point mirroring of the velocity) + // 0.0 < alphaWall < 1.0: 'partial' slip. + // e.g. for alphaWall = 0.5 the wall tangential velocity is half the inside tangential velocity. + outsideVelocityNWall = -insideVelocityNWall; + outsideVelocityTWall = (1.0 - 2.0*alphaWall_)*insideVelocityTWall; + } + else + { + // Set the outside state using the full-slip wall roughness conditions (line mirroring in the boundary face) + // Only mirror the normal component + outsideVelocityNWall = -insideVelocityNWall; + outsideVelocityTWall = insideVelocityTWall; + } + // Rotate back to cartesian coordinate system + const Scalar outsideVelocityXWall = outsideVelocityNWall*unitNormal[0] - outsideVelocityTWall*unitNormal[1]; + const Scalar outsideVelocityYWall = outsideVelocityNWall*unitNormal[1] + outsideVelocityTWall*unitNormal[0]; + + boundaryStateVariables[0] = insideVolVars.waterDepth(); + boundaryStateVariables[1] = outsideVelocityXWall; + boundaryStateVariables[2] = outsideVelocityYWall; + + } + + auto riemannFlux = ShallowWater::riemannProblem(insideVolVars.waterDepth(), + boundaryStateVariables[0], + insideVolVars.velocity(0), + boundaryStateVariables[1], + insideVolVars.velocity(1), + boundaryStateVariables[2], + insideVolVars.bedSurface(), + insideVolVars.bedSurface(), + gravity, + unitNormal); + + values[Indices::massBalanceIdx] = riemannFlux[0]; + values[Indices::velocityXIdx] = riemannFlux[1]; + values[Indices::velocityYIdx] = riemannFlux[2]; + + // Addition of viscosity/diffusive flux rough wall boundaries + // No-slip wall (with coefficient alphaWall): + // Compute wall shear stress using turbulent viscosity and local velocity gradient + // Assume velocity gradient (in cell adjacent to wall) equal to alphaWall*(0 - u_c) + std::array<Scalar, 3> roughWallFlux{}; + if (scvf.center()[1] < this->gridGeometry().bBoxMin()[1] + eps_ || scvf.center()[1] > this->gridGeometry().bBoxMax()[1] - eps_) + { + // Distance vector between the inside cell center and the boundary face center + const auto& cellCenterToBoundaryFaceCenter = scvf.center() - insideScv.center(); + + // The left (inside) state vector + const auto& leftState = insideVolVars.priVars(); + + if (wallFrictionLawType_ == "noslip") + { + roughWallFlux = ShallowWater::noslipWallBoundary(alphaWall_, + turbViscosity_, + leftState, + cellCenterToBoundaryFaceCenter, + unitNormal); + } + else if (wallFrictionLawType_ == "nikuradse") + { + roughWallFlux = ShallowWater::nikuradseWallBoundary(ksWall_, + leftState, + cellCenterToBoundaryFaceCenter, + unitNormal); + } + } + + values[Indices::massBalanceIdx] += roughWallFlux[0]; + values[Indices::velocityXIdx] += roughWallFlux[1]; + values[Indices::velocityYIdx] += roughWallFlux[2]; + + return values; + } + + // \} + + /*! + * \brief Evaluate the initial values for a control volume. + * \param globalPos The position for which the boundary type is set + */ + PrimaryVariables initialAtPos(const GlobalPosition &globalPos) const + { + PrimaryVariables values(0.0); + + // Set the initial values to the analytical solution + const auto gravity = this->spatialParams().gravity(globalPos); + const auto width = this->gridGeometry().bBoxMax()[1] - this->gridGeometry().bBoxMin()[1]; + + values[0] = hBoundary_; + values[1] = -(gravity*bedSlope_/(8.0*turbViscosity_)) * (4.0*globalPos[1]*globalPos[1] - width*width); + values[2] = 0.0; + + return values; + }; + +private: + + std::vector<Scalar> exactWaterDepth_; + std::vector<Scalar> exactVelocityX_; + std::vector<Scalar> exactVelocityY_; + + Scalar hBoundary_; // water level at the outflow boundary + Scalar bedSlope_; // bed slope (positive downwards) + Scalar discharge_; // discharge at the inflow boundary + Scalar alphaWall_; // wall roughness coefficient for no-slip type wall roughness + Scalar ksWall_; // Nikuradse wall roughness height for Nikuradse type wall roughness + bool enableViscousFlux_; // switch for enabling viscous (turbulent) momentum flux computation + Scalar turbViscosity_; // turbulent viscosity + std::string wallFrictionLawType_; // wall friction law type + + static constexpr Scalar eps_ = 1.0e-6; + std::string name_; +}; + +} //end namespace Dumux + +#endif diff --git a/test/freeflow/shallowwater/poiseuilleflow/properties.hh b/test/freeflow/shallowwater/poiseuilleflow/properties.hh new file mode 100644 index 0000000000000000000000000000000000000000..7a1312806db3f73387c050b11cdf0a10f45eb37b --- /dev/null +++ b/test/freeflow/shallowwater/poiseuilleflow/properties.hh @@ -0,0 +1,68 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 3 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ + +#ifndef DUMUX_POISEUILLE_FLOW_TEST_PROPERTIES_HH +#define DUMUX_POISEUILLE_FLOW_TEST_PROPERTIES_HH + +#include <dumux/common/properties.hh> +#include <dumux/freeflow/shallowwater/model.hh> +#include <dumux/discretization/cctpfa.hh> + +#if HAVE_UG +#include <dune/grid/uggrid.hh> +#else +#include <dune/grid/yaspgrid.hh> +#endif + +#include "problem.hh" +#include "spatialparams.hh" + +namespace Dumux::Properties { + +namespace TTag { +struct PoiseuilleFlow { using InheritsFrom = std::tuple<ShallowWater, CCTpfaModel>; }; +} // namespace TTag + +template<class TypeTag> +struct Grid<TypeTag, TTag::PoiseuilleFlow> { using type = GRIDTYPE; }; + +template<class TypeTag> +struct Problem<TypeTag, TTag::PoiseuilleFlow> { using type = Dumux::PoiseuilleFlowProblem<TypeTag> ; }; + +template<class TypeTag> +struct SpatialParams<TypeTag, TTag::PoiseuilleFlow> +{ +private: + using GridGeometry = GetPropType<TypeTag, Properties::GridGeometry>; + using Scalar = GetPropType<TypeTag, Properties::Scalar>; + using ElementVolumeVariables = typename GetPropType<TypeTag, Properties::GridVolumeVariables>::LocalView; + using VolumeVariables = typename ElementVolumeVariables::VolumeVariables; + +public: + using type = PoiseuilleFlowSpatialParams<GridGeometry, Scalar, VolumeVariables>; +}; + +template<class TypeTag> +struct EnableGridVolumeVariablesCache<TypeTag, TTag::PoiseuilleFlow> { static constexpr bool value = false; }; +template<class TypeTag> +struct EnableGridGeometryCache<TypeTag, TTag::PoiseuilleFlow> { static constexpr bool value = true; }; + +} // end namespace Dumux::Properties + +#endif diff --git a/test/freeflow/shallowwater/poiseuilleflow/spatialparams.hh b/test/freeflow/shallowwater/poiseuilleflow/spatialparams.hh new file mode 100644 index 0000000000000000000000000000000000000000..eb35e02a1f3dfef7566f3b49250d379054430ad6 --- /dev/null +++ b/test/freeflow/shallowwater/poiseuilleflow/spatialparams.hh @@ -0,0 +1,93 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 3 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * \ingroup ShallowWaterTests + * \brief The spatial parameters for the Poiseuille flow problem. + */ +#ifndef DUMUX_POISEUILLE_FLOW_SPATIAL_PARAMETERS_HH +#define DUMUX_POISEUILLE_FLOW_SPATIAL_PARAMETERS_HH + +#include <dumux/common/exceptions.hh> +#include <dumux/common/parameters.hh> + +#include <dumux/material/spatialparams/fv.hh> +#include <dumux/material/fluidmatrixinteractions/frictionlaws/frictionlaw.hh> + +namespace Dumux { + +/*! + * \ingroup ShallowWaterTests + * \brief The spatial parameters class for the Poiseuille flow test. + * + */ +template<class GridGeometry, class Scalar, class VolumeVariables> +class PoiseuilleFlowSpatialParams +: public FVSpatialParams<GridGeometry, Scalar, + PoiseuilleFlowSpatialParams<GridGeometry, Scalar, VolumeVariables>> +{ + using ThisType = PoiseuilleFlowSpatialParams<GridGeometry, Scalar, VolumeVariables>; + using ParentType = FVSpatialParams<GridGeometry, Scalar, ThisType>; + using GridView = typename GridGeometry::GridView; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename FVElementGeometry::SubControlVolume; + using Element = typename GridView::template Codim<0>::Entity; + using GlobalPosition = typename Element::Geometry::GlobalCoordinate; + +public: + PoiseuilleFlowSpatialParams(std::shared_ptr<const GridGeometry> gridGeometry) + : ParentType(gridGeometry) + { + gravity_ = getParam<Scalar>("Problem.Gravity"); + bedSlope_ = getParam<Scalar>("Problem.BedSlope"); + hBoundary_ = getParam<Scalar>("Problem.HBoundary"); + } + + Scalar gravity(const GlobalPosition& globalPos) const + { return gravity_; } + + Scalar gravity() const + { return gravity_; } + + const FrictionLaw<VolumeVariables>& + frictionLaw(const Element& element, const SubControlVolume& scv) const + { + DUNE_THROW(Dune::NotImplemented, "No friction law is implemented for this test!"); + } + + //! Define the bed surface + Scalar bedSurface(const Element& element, const SubControlVolume& scv) const + { + const Scalar length = this->gridGeometry().bBoxMax()[0] - this->gridGeometry().bBoxMin()[0]; + // The bed level sloped downwards from the left boundary to the right boundary + // The water level boundary condition hBoundary_ is specified at the right boundary + const Scalar leftBedLevel = - hBoundary_ + length*bedSlope_; + // todo depends on index e.g. eIdx = scv.elementIndex(); + return leftBedLevel - element.geometry().center()[0] * bedSlope_; + } + +private: + Scalar gravity_; + Scalar bedSlope_; + Scalar hBoundary_; +}; + +} // end namespace Dumux + +#endif diff --git a/test/references/test_ff_shallowwater_poiseuilleflow-reference.vtu b/test/references/test_ff_shallowwater_poiseuilleflow-reference.vtu new file mode 100755 index 0000000000000000000000000000000000000000..1daf0b2a45b62437a91440f281dab5cfa06f7b03 --- /dev/null +++ b/test/references/test_ff_shallowwater_poiseuilleflow-reference.vtu @@ -0,0 +1,658 @@ +<?xml version="1.0"?> +<VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian"> + <UnstructuredGrid> + <Piece NumberOfCells="400" NumberOfPoints="441"> + <CellData Scalars="waterDepth"> + <DataArray type="Float32" Name="waterDepth" NumberOfComponents="1" format="ascii"> + 10.0438 10.0389 10.0346 10.0307 10.0269 10.0235 10.0203 10.0173 10.0146 10.0122 10.0099 10.0079 + 10.0061 10.0046 10.0032 10.0021 10.0012 10.0006 10.0002 10.0001 10.0384 10.034 10.0301 10.0264 + 10.023 10.0198 10.0169 10.0142 10.0117 10.0095 10.0074 10.0056 10.004 10.0027 10.0015 10.0006 + 9.99996 9.9996 9.99956 9.99989 10.0382 10.0337 10.0298 10.0261 10.0227 10.0195 10.0165 10.0139 + 10.0114 10.0092 10.0072 10.0054 10.0038 10.0024 10.0013 10.0005 9.99986 9.99954 9.99954 9.99991 + 10.0381 10.0336 10.0297 10.026 10.0226 10.0194 10.0165 10.0138 10.0114 10.0091 10.0071 10.0053 + 10.0038 10.0024 10.0013 10.0005 9.99986 9.99955 9.99956 9.99994 10.0381 10.0336 10.0297 10.026 + 10.0226 10.0194 10.0165 10.0138 10.0113 10.0091 10.0071 10.0053 10.0038 10.0024 10.0013 10.0005 + 9.99987 9.99957 9.99959 9.99997 10.0381 10.0336 10.0297 10.026 10.0226 10.0194 10.0165 10.0138 + 10.0113 10.0091 10.0071 10.0053 10.0038 10.0024 10.0013 10.0005 9.99989 9.9996 9.99962 10 + 10.0381 10.0336 10.0297 10.026 10.0226 10.0194 10.0165 10.0138 10.0114 10.0091 10.0071 10.0053 + 10.0038 10.0024 10.0013 10.0005 9.99991 9.99962 9.99965 10 10.038 10.0335 10.0297 10.026 + 10.0226 10.0194 10.0165 10.0138 10.0114 10.0091 10.0071 10.0053 10.0038 10.0025 10.0014 10.0005 + 9.99993 9.99964 9.99968 10.0001 10.038 10.0335 10.0297 10.026 10.0226 10.0194 10.0165 10.0138 + 10.0114 10.0091 10.0071 10.0053 10.0038 10.0025 10.0014 10.0005 9.99994 9.99965 9.99969 10.0001 + 10.038 10.0335 10.0297 10.026 10.0226 10.0194 10.0165 10.0138 10.0114 10.0091 10.0071 10.0053 + 10.0038 10.0025 10.0014 10.0005 9.99994 9.99966 9.9997 10.0001 10.038 10.0335 10.0297 10.026 + 10.0226 10.0194 10.0165 10.0138 10.0114 10.0091 10.0071 10.0053 10.0038 10.0025 10.0014 10.0005 + 9.99994 9.99966 9.9997 10.0001 10.038 10.0335 10.0297 10.026 10.0226 10.0194 10.0165 10.0138 + 10.0114 10.0091 10.0071 10.0053 10.0038 10.0025 10.0014 10.0005 9.99994 9.99965 9.99969 10.0001 + 10.038 10.0335 10.0297 10.026 10.0226 10.0194 10.0165 10.0138 10.0114 10.0091 10.0071 10.0053 + 10.0038 10.0025 10.0014 10.0005 9.99993 9.99964 9.99968 10.0001 10.0381 10.0336 10.0297 10.026 + 10.0226 10.0194 10.0165 10.0138 10.0114 10.0091 10.0071 10.0053 10.0038 10.0024 10.0013 10.0005 + 9.99991 9.99962 9.99965 10 10.0381 10.0336 10.0297 10.026 10.0226 10.0194 10.0165 10.0138 + 10.0113 10.0091 10.0071 10.0053 10.0038 10.0024 10.0013 10.0005 9.99989 9.9996 9.99962 10 + 10.0381 10.0336 10.0297 10.026 10.0226 10.0194 10.0165 10.0138 10.0113 10.0091 10.0071 10.0053 + 10.0038 10.0024 10.0013 10.0005 9.99987 9.99957 9.99959 9.99997 10.0381 10.0336 10.0297 10.026 + 10.0226 10.0194 10.0165 10.0138 10.0114 10.0091 10.0071 10.0053 10.0038 10.0024 10.0013 10.0005 + 9.99986 9.99955 9.99956 9.99994 10.0382 10.0337 10.0298 10.0261 10.0227 10.0195 10.0165 10.0139 + 10.0114 10.0092 10.0072 10.0054 10.0038 10.0024 10.0013 10.0005 9.99986 9.99954 9.99954 9.99991 + 10.0384 10.034 10.0301 10.0264 10.023 10.0198 10.0169 10.0142 10.0117 10.0095 10.0074 10.0056 + 10.004 10.0027 10.0015 10.0006 9.99996 9.9996 9.99956 9.99989 10.0438 10.0389 10.0346 10.0307 + 10.0269 10.0235 10.0203 10.0173 10.0146 10.0122 10.0099 10.0079 10.0061 10.0046 10.0032 10.0021 + 10.0012 10.0006 10.0002 10.0001 + </DataArray> + <DataArray type="Float32" Name="velocityX" NumberOfComponents="1" format="ascii"> + 0.570598 0.532182 0.495822 0.461666 0.429639 0.399645 0.371588 0.345378 0.320932 0.298179 0.27706 0.257532 + 0.239574 0.223194 0.208433 0.195379 0.18418 0.175056 0.168326 0.164422 1.69356 1.69586 1.69738 1.69846 + 1.6992 1.69964 1.69984 1.69985 1.6997 1.69944 1.6991 1.69871 1.69831 1.69793 1.69761 1.69736 + 1.6972 1.69713 1.69709 1.69697 2.67225 2.67727 2.6817 2.68582 2.68967 2.69325 2.69657 2.69964 + 2.70248 2.70508 2.70746 2.70963 2.71158 2.71331 2.71484 2.71614 2.71719 2.71797 2.71844 2.71852 + 3.52806 3.53408 3.53948 3.54456 3.54932 3.55379 3.55796 3.56185 3.56546 3.5688 3.57187 3.57468 + 3.57722 3.5795 3.58151 3.58321 3.58461 3.58565 3.5863 3.58648 4.26156 4.26827 4.27432 4.28004 + 4.28542 4.29047 4.2952 4.29961 4.30372 4.30753 4.31104 4.31426 4.31719 4.31981 4.32212 4.32411 + 4.32573 4.32697 4.32776 4.32805 4.87278 4.88 4.88654 4.89273 4.89856 4.90405 4.90919 4.914 + 4.91848 4.92264 4.92649 4.93002 4.93323 4.93613 4.93868 4.94088 4.9427 4.94409 4.945 4.94539 + 5.36176 5.36937 5.37625 5.3828 5.38898 5.3948 5.40026 5.40537 5.41013 5.41457 5.41867 5.42244 + 5.42588 5.42898 5.43173 5.4341 5.43606 5.43758 5.43861 5.43909 5.72851 5.73641 5.74356 5.75038 + 5.75682 5.76289 5.76859 5.77393 5.77891 5.78355 5.78785 5.7918 5.79542 5.79868 5.80157 5.80408 + 5.80617 5.80779 5.8089 5.80945 5.97303 5.98115 5.98851 5.99553 6.00217 6.00842 6.0143 6.01981 + 6.02496 6.02975 6.03419 6.03829 6.04203 6.04541 6.04842 6.05103 6.0532 6.0549 6.05608 6.05668 + 6.09533 6.10362 6.11112 6.11828 6.12507 6.13146 6.13746 6.14309 6.14835 6.15326 6.1578 6.16199 + 6.16583 6.16929 6.17238 6.17505 6.17729 6.17904 6.18026 6.18089 6.09533 6.10362 6.11112 6.11828 + 6.12507 6.13146 6.13746 6.14309 6.14835 6.15326 6.1578 6.16199 6.16583 6.16929 6.17238 6.17505 + 6.17729 6.17904 6.18026 6.18089 5.97303 5.98115 5.98851 5.99553 6.00217 6.00842 6.0143 6.01981 + 6.02496 6.02975 6.03419 6.03829 6.04203 6.04541 6.04842 6.05103 6.0532 6.0549 6.05608 6.05668 + 5.72851 5.73641 5.74356 5.75038 5.75682 5.76289 5.76859 5.77393 5.77891 5.78355 5.78785 5.7918 + 5.79542 5.79868 5.80157 5.80408 5.80617 5.80779 5.8089 5.80945 5.36176 5.36937 5.37625 5.3828 + 5.38898 5.3948 5.40026 5.40537 5.41013 5.41457 5.41867 5.42244 5.42588 5.42898 5.43173 5.4341 + 5.43606 5.43758 5.43861 5.43909 4.87278 4.88 4.88654 4.89273 4.89856 4.90405 4.90919 4.914 + 4.91848 4.92264 4.92649 4.93002 4.93323 4.93613 4.93868 4.94088 4.9427 4.94409 4.945 4.94539 + 4.26156 4.26827 4.27432 4.28004 4.28542 4.29047 4.2952 4.29961 4.30372 4.30753 4.31104 4.31426 + 4.31719 4.31981 4.32212 4.32411 4.32573 4.32697 4.32776 4.32805 3.52806 3.53408 3.53948 3.54456 + 3.54932 3.55379 3.55796 3.56185 3.56546 3.5688 3.57187 3.57468 3.57722 3.5795 3.58151 3.58321 + 3.58461 3.58565 3.5863 3.58648 2.67225 2.67727 2.6817 2.68582 2.68967 2.69325 2.69657 2.69964 + 2.70248 2.70508 2.70746 2.70963 2.71158 2.71331 2.71484 2.71614 2.71719 2.71797 2.71844 2.71852 + 1.69356 1.69586 1.69738 1.69846 1.6992 1.69964 1.69984 1.69985 1.6997 1.69944 1.6991 1.69871 + 1.69831 1.69793 1.69761 1.69736 1.6972 1.69713 1.69709 1.69697 0.570598 0.532182 0.495822 0.461666 + 0.429639 0.399645 0.371588 0.345378 0.320932 0.298179 0.27706 0.257532 0.239574 0.223194 0.208433 0.195379 + 0.18418 0.175056 0.168326 0.164422 + </DataArray> + <DataArray type="Float32" Name="velocityY" NumberOfComponents="1" format="ascii"> + 0.00499194 0.00474375 0.00445909 0.00418193 0.00391701 0.00366474 0.00342457 0.00319561 0.00297669 0.00276633 0.00256267 0.00236333 + 0.00216528 0.00196457 0.00175616 0.00153354 0.00128839 0.00101014 0.000685497 0.000298046 0.0097797 0.00938867 0.00887758 0.00836547 + 0.00786903 0.00739111 0.0069316 0.00648935 0.00606248 0.00564835 0.00524347 0.0048432 0.00444156 0.00403087 0.00360147 0.00314129 + 0.00263562 0.00206696 0.00141519 0.000658398 0.00906953 0.00883394 0.00841621 0.00797547 0.00753949 0.00711406 0.00670021 0.00629745 + 0.0059044 0.00551884 0.00513757 0.00475629 0.00436939 0.00396977 0.00354871 0.00309586 0.00259947 0.00204708 0.00142698 0.000730897 + 0.00803948 0.00789666 0.00754562 0.00716098 0.00677746 0.00640246 0.00603733 0.00568167 0.00533423 0.00499295 0.00465495 0.00431636 + 0.00397216 0.00361608 0.00324051 0.00283658 0.00239446 0.00190421 0.00135734 0.000749758 0.00690329 0.00682828 0.0065414 0.006215 + 0.005887 0.00556573 0.00525281 0.00494797 0.00465011 0.00435745 0.00406747 0.00377683 0.00348121 0.00317524 0.00285247 0.00250542 + 0.00212594 0.00170605 0.00123938 0.000723979 0.00570802 0.00567913 0.00545267 0.00518573 0.00491547 0.00465035 0.00439203 0.00414038 + 0.00389448 0.00365284 0.00341337 0.00317329 0.00292903 0.00267617 0.0024094 0.00212264 0.00180931 0.00146308 0.0010792 0.000656877 + 0.00447728 0.00447568 0.0043051 0.0040977 0.00388636 0.00367874 0.0034764 0.00327928 0.00308667 0.00289739 0.00270979 0.0025217 + 0.0023303 0.00213213 0.00192307 0.00169838 0.00145299 0.0011821 0.000882223 0.00055314 0.00322262 0.00323295 0.00311406 0.0029659 + 0.00281414 0.00266488 0.0025194 0.00237767 0.00223919 0.0021031 0.00196823 0.00183298 0.00169534 0.00155284 0.00140249 0.00124093 + 0.00106454 0.00086995 0.000654747 0.000418948 0.00194808 0.00195893 0.00188863 0.00179952 0.00170792 0.00161777 0.00152989 0.00144428 + 0.00136063 0.00127843 0.00119696 0.00111526 0.00103212 0.000946026 0.000855198 0.000757599 0.000651071 0.000533585 0.000403732 0.000261561 + 0.000652989 0.000657381 0.000634073 0.000604278 0.0005736 0.000543394 0.000513948 0.000485262 0.000457235 0.000429694 0.000402396 0.00037502 + 0.000347159 0.00031831 0.000287873 0.000255168 0.000219473 0.000180114 0.000136622 8.9017e-05 -0.000652989 -0.000657381 -0.000634073 -0.000604278 + -0.0005736 -0.000543394 -0.000513948 -0.000485262 -0.000457235 -0.000429694 -0.000402396 -0.00037502 -0.000347159 -0.00031831 -0.000287873 -0.000255168 + -0.000219473 -0.000180114 -0.000136622 -8.9017e-05 -0.00194808 -0.00195893 -0.00188863 -0.00179952 -0.00170792 -0.00161777 -0.00152989 -0.00144428 + -0.00136063 -0.00127843 -0.00119696 -0.00111526 -0.00103212 -0.000946026 -0.000855198 -0.000757599 -0.000651071 -0.000533585 -0.000403732 -0.000261561 + -0.00322262 -0.00323295 -0.00311406 -0.0029659 -0.00281414 -0.00266488 -0.0025194 -0.00237767 -0.00223919 -0.0021031 -0.00196823 -0.00183298 + -0.00169534 -0.00155284 -0.00140249 -0.00124093 -0.00106454 -0.00086995 -0.000654747 -0.000418948 -0.00447728 -0.00447568 -0.0043051 -0.0040977 + -0.00388636 -0.00367874 -0.0034764 -0.00327928 -0.00308667 -0.00289739 -0.00270979 -0.0025217 -0.0023303 -0.00213213 -0.00192307 -0.00169838 + -0.00145299 -0.0011821 -0.000882223 -0.00055314 -0.00570802 -0.00567913 -0.00545267 -0.00518573 -0.00491547 -0.00465035 -0.00439203 -0.00414038 + -0.00389448 -0.00365284 -0.00341337 -0.00317329 -0.00292903 -0.00267617 -0.0024094 -0.00212264 -0.00180931 -0.00146308 -0.0010792 -0.000656877 + -0.00690329 -0.00682828 -0.0065414 -0.006215 -0.005887 -0.00556573 -0.00525281 -0.00494797 -0.00465011 -0.00435745 -0.00406747 -0.00377683 + -0.00348121 -0.00317524 -0.00285247 -0.00250542 -0.00212594 -0.00170605 -0.00123938 -0.000723979 -0.00803948 -0.00789666 -0.00754562 -0.00716098 + -0.00677746 -0.00640246 -0.00603733 -0.00568167 -0.00533423 -0.00499295 -0.00465495 -0.00431636 -0.00397216 -0.00361608 -0.00324051 -0.00283658 + -0.00239446 -0.00190421 -0.00135734 -0.000749758 -0.00906953 -0.00883394 -0.00841621 -0.00797547 -0.00753949 -0.00711406 -0.00670021 -0.00629745 + -0.0059044 -0.00551884 -0.00513757 -0.00475629 -0.00436939 -0.00396977 -0.00354871 -0.00309586 -0.00259947 -0.00204708 -0.00142698 -0.000730897 + -0.0097797 -0.00938867 -0.00887758 -0.00836547 -0.00786903 -0.00739111 -0.0069316 -0.00648935 -0.00606248 -0.00564835 -0.00524347 -0.0048432 + -0.00444156 -0.00403087 -0.00360147 -0.00314129 -0.00263562 -0.00206696 -0.00141519 -0.000658398 -0.00499194 -0.00474375 -0.00445909 -0.00418193 + -0.00391701 -0.00366474 -0.00342457 -0.00319561 -0.00297669 -0.00276633 -0.00256267 -0.00236333 -0.00216528 -0.00196457 -0.00175616 -0.00153354 + -0.00128839 -0.00101014 -0.000685497 -0.000298046 + </DataArray> + <DataArray type="Float32" Name="bedSurface" NumberOfComponents="1" format="ascii"> + -9.9805 -9.9815 -9.9825 -9.9835 -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 + -9.9925 -9.9935 -9.9945 -9.9955 -9.9965 -9.9975 -9.9985 -9.9995 -9.9805 -9.9815 -9.9825 -9.9835 + -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 -9.9925 -9.9935 -9.9945 -9.9955 + -9.9965 -9.9975 -9.9985 -9.9995 -9.9805 -9.9815 -9.9825 -9.9835 -9.9845 -9.9855 -9.9865 -9.9875 + -9.9885 -9.9895 -9.9905 -9.9915 -9.9925 -9.9935 -9.9945 -9.9955 -9.9965 -9.9975 -9.9985 -9.9995 + -9.9805 -9.9815 -9.9825 -9.9835 -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 + -9.9925 -9.9935 -9.9945 -9.9955 -9.9965 -9.9975 -9.9985 -9.9995 -9.9805 -9.9815 -9.9825 -9.9835 + -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 -9.9925 -9.9935 -9.9945 -9.9955 + -9.9965 -9.9975 -9.9985 -9.9995 -9.9805 -9.9815 -9.9825 -9.9835 -9.9845 -9.9855 -9.9865 -9.9875 + -9.9885 -9.9895 -9.9905 -9.9915 -9.9925 -9.9935 -9.9945 -9.9955 -9.9965 -9.9975 -9.9985 -9.9995 + -9.9805 -9.9815 -9.9825 -9.9835 -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 + -9.9925 -9.9935 -9.9945 -9.9955 -9.9965 -9.9975 -9.9985 -9.9995 -9.9805 -9.9815 -9.9825 -9.9835 + -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 -9.9925 -9.9935 -9.9945 -9.9955 + -9.9965 -9.9975 -9.9985 -9.9995 -9.9805 -9.9815 -9.9825 -9.9835 -9.9845 -9.9855 -9.9865 -9.9875 + -9.9885 -9.9895 -9.9905 -9.9915 -9.9925 -9.9935 -9.9945 -9.9955 -9.9965 -9.9975 -9.9985 -9.9995 + -9.9805 -9.9815 -9.9825 -9.9835 -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 + -9.9925 -9.9935 -9.9945 -9.9955 -9.9965 -9.9975 -9.9985 -9.9995 -9.9805 -9.9815 -9.9825 -9.9835 + -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 -9.9925 -9.9935 -9.9945 -9.9955 + -9.9965 -9.9975 -9.9985 -9.9995 -9.9805 -9.9815 -9.9825 -9.9835 -9.9845 -9.9855 -9.9865 -9.9875 + -9.9885 -9.9895 -9.9905 -9.9915 -9.9925 -9.9935 -9.9945 -9.9955 -9.9965 -9.9975 -9.9985 -9.9995 + -9.9805 -9.9815 -9.9825 -9.9835 -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 + -9.9925 -9.9935 -9.9945 -9.9955 -9.9965 -9.9975 -9.9985 -9.9995 -9.9805 -9.9815 -9.9825 -9.9835 + -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 -9.9925 -9.9935 -9.9945 -9.9955 + -9.9965 -9.9975 -9.9985 -9.9995 -9.9805 -9.9815 -9.9825 -9.9835 -9.9845 -9.9855 -9.9865 -9.9875 + -9.9885 -9.9895 -9.9905 -9.9915 -9.9925 -9.9935 -9.9945 -9.9955 -9.9965 -9.9975 -9.9985 -9.9995 + -9.9805 -9.9815 -9.9825 -9.9835 -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 + -9.9925 -9.9935 -9.9945 -9.9955 -9.9965 -9.9975 -9.9985 -9.9995 -9.9805 -9.9815 -9.9825 -9.9835 + -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 -9.9925 -9.9935 -9.9945 -9.9955 + -9.9965 -9.9975 -9.9985 -9.9995 -9.9805 -9.9815 -9.9825 -9.9835 -9.9845 -9.9855 -9.9865 -9.9875 + -9.9885 -9.9895 -9.9905 -9.9915 -9.9925 -9.9935 -9.9945 -9.9955 -9.9965 -9.9975 -9.9985 -9.9995 + -9.9805 -9.9815 -9.9825 -9.9835 -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 + -9.9925 -9.9935 -9.9945 -9.9955 -9.9965 -9.9975 -9.9985 -9.9995 -9.9805 -9.9815 -9.9825 -9.9835 + -9.9845 -9.9855 -9.9865 -9.9875 -9.9885 -9.9895 -9.9905 -9.9915 -9.9925 -9.9935 -9.9945 -9.9955 + -9.9965 -9.9975 -9.9985 -9.9995 + </DataArray> + <DataArray type="Float32" Name="freeSurface" NumberOfComponents="1" format="ascii"> + 0.0632555 0.0574413 0.0521476 0.0471551 0.0424374 0.037984 0.0337875 0.0298407 0.0261366 0.0226688 0.0194311 0.0164189 + 0.0136288 0.0110597 0.00871302 0.00659373 0.00471057 0.00307672 0.0017099 0.000631746 0.0579472 0.0525023 0.0475601 0.0428941 + 0.0384809 0.0343122 0.030382 0.0266848 0.0232153 0.0199688 0.0169414 0.0141308 0.0115371 0.0091633 0.00701646 0.00510906 + 0.00346033 0.00209789 0.0010595 0.000394563 0.057694 0.0522164 0.0472572 0.0425755 0.0381523 0.0339791 0.0300493 0.0263569 + 0.0228962 0.0196623 0.0166512 0.013861 0.0112918 0.00894681 0.00683353 0.00496428 0.00335753 0.00203882 0.00104146 0.000406576 + 0.0576254 0.0521491 0.0472048 0.0425264 0.0381046 0.0339324 0.0300037 0.0263127 0.0228538 0.0196221 0.0166139 0.0138273 + 0.0112626 0.00892335 0.00681699 0.00495597 0.00335868 0.00205029 0.00106322 0.000436854 0.0575885 0.0521112 0.0471869 0.0425133 + 0.038093 0.0339215 0.0299935 0.0263031 0.0228449 0.0196142 0.0166074 0.0138226 0.0112602 0.00892408 0.0068217 0.00496564 + 0.0033743 0.00207266 0.00109266 0.00047257 0.0575674 0.0520852 0.0471832 0.0425147 0.0380954 0.0339241 0.029996 0.0263056 + 0.0228475 0.0196171 0.0166108 0.013827 0.0112662 0.0089322 0.00683276 0.00498051 0.00339387 0.00209771 0.00112356 0.000508827 + 0.0575542 0.0520648 0.047185 0.0425216 0.0381032 0.0339318 0.0300034 0.0263127 0.0228544 0.019624 0.016618 0.0138347 + 0.011275 0.00894255 0.00684537 0.00499614 0.00341329 0.0021216 0.00115228 0.000542036 0.0575445 0.052047 0.047187 0.0425282 + 0.0381107 0.0339392 0.0300106 0.0263196 0.0228611 0.0196305 0.0166247 0.0138418 0.0112828 0.00895166 0.00685624 0.00500937 + 0.00342951 0.00214137 0.00117592 0.00056931 0.0575351 0.052031 0.0471858 0.0425307 0.038114 0.0339426 0.0300138 0.0263227 + 0.0228642 0.0196337 0.0166281 0.0138456 0.0112873 0.00895707 0.006863 0.00501791 0.00344029 0.0021548 0.00119225 0.000588442 + 0.0575243 0.0520164 0.0471795 0.0425267 0.0381107 0.0339396 0.0300111 0.0263202 0.0228619 0.0196317 0.0166264 0.0138444 + 0.0112866 0.00895718 0.0068641 0.00502025 0.00344413 0.00216039 0.00119976 0.000597897 0.0575243 0.0520164 0.0471795 0.0425267 + 0.0381107 0.0339396 0.0300111 0.0263202 0.0228619 0.0196317 0.0166264 0.0138444 0.0112866 0.00895718 0.0068641 0.00502025 + 0.00344413 0.00216039 0.00119976 0.000597897 0.0575351 0.052031 0.0471858 0.0425307 0.038114 0.0339426 0.0300138 0.0263227 + 0.0228642 0.0196337 0.0166281 0.0138456 0.0112873 0.00895707 0.006863 0.00501791 0.00344029 0.0021548 0.00119225 0.000588442 + 0.0575445 0.052047 0.047187 0.0425282 0.0381107 0.0339392 0.0300106 0.0263196 0.0228611 0.0196305 0.0166247 0.0138418 + 0.0112828 0.00895166 0.00685624 0.00500937 0.00342951 0.00214137 0.00117592 0.00056931 0.0575542 0.0520648 0.047185 0.0425216 + 0.0381032 0.0339318 0.0300034 0.0263127 0.0228544 0.019624 0.016618 0.0138347 0.011275 0.00894255 0.00684537 0.00499614 + 0.00341329 0.0021216 0.00115228 0.000542036 0.0575674 0.0520852 0.0471832 0.0425147 0.0380954 0.0339241 0.029996 0.0263056 + 0.0228475 0.0196171 0.0166108 0.013827 0.0112662 0.0089322 0.00683276 0.00498051 0.00339387 0.00209771 0.00112356 0.000508827 + 0.0575885 0.0521112 0.0471869 0.0425133 0.038093 0.0339215 0.0299935 0.0263031 0.0228449 0.0196142 0.0166074 0.0138226 + 0.0112602 0.00892408 0.0068217 0.00496564 0.0033743 0.00207266 0.00109266 0.00047257 0.0576254 0.0521491 0.0472048 0.0425264 + 0.0381046 0.0339324 0.0300037 0.0263127 0.0228538 0.0196221 0.0166139 0.0138273 0.0112626 0.00892335 0.00681699 0.00495597 + 0.00335868 0.00205029 0.00106322 0.000436854 0.057694 0.0522164 0.0472572 0.0425755 0.0381523 0.0339791 0.0300493 0.0263569 + 0.0228962 0.0196623 0.0166512 0.013861 0.0112918 0.00894681 0.00683353 0.00496428 0.00335753 0.00203882 0.00104146 0.000406576 + 0.0579472 0.0525023 0.0475601 0.0428941 0.0384809 0.0343122 0.030382 0.0266848 0.0232153 0.0199688 0.0169414 0.0141308 + 0.0115371 0.0091633 0.00701646 0.00510906 0.00346033 0.00209789 0.0010595 0.000394563 0.0632555 0.0574413 0.0521476 0.0471551 + 0.0424374 0.037984 0.0337875 0.0298407 0.0261366 0.0226688 0.0194311 0.0164189 0.0136288 0.0110597 0.00871302 0.00659373 + 0.00471057 0.00307672 0.0017099 0.000631746 + </DataArray> + <DataArray type="Float32" Name="process rank" NumberOfComponents="1" format="ascii"> + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 + </DataArray> + <DataArray type="Float32" Name="exactWaterDepth" NumberOfComponents="1" format="ascii"> + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 + </DataArray> + <DataArray type="Float32" Name="exactVelocityX" NumberOfComponents="1" format="ascii"> + 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 + 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 1.70142 1.70142 1.70142 1.70142 + 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 + 1.70142 1.70142 1.70142 1.70142 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 + 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 + 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 + 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 4.27655 4.27655 4.27655 4.27655 + 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 + 4.27655 4.27655 4.27655 4.27655 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 + 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 + 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 + 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.74805 5.74805 5.74805 5.74805 + 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 + 5.74805 5.74805 5.74805 5.74805 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 + 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 + 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 + 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 + 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 6.11592 + 6.11592 6.11592 6.11592 6.11592 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 + 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 5.9933 + 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 + 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.74805 5.38017 5.38017 5.38017 5.38017 + 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 5.38017 + 5.38017 5.38017 5.38017 5.38017 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 + 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 4.88967 + 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 + 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 4.27655 3.5408 3.5408 3.5408 3.5408 + 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 3.5408 + 3.5408 3.5408 3.5408 3.5408 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 + 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 2.68242 + 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 + 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 1.70142 0.597797 0.597797 0.597797 0.597797 + 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 0.597797 + 0.597797 0.597797 0.597797 0.597797 + </DataArray> + <DataArray type="Float32" Name="exactVelocityY" NumberOfComponents="1" format="ascii"> + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 + </DataArray> + </CellData> + <Points> + <DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii"> + 0 -50 0 20 -50 0 0 -45 0 20 -45 0 + 40 -50 0 40 -45 0 60 -50 0 60 -45 0 + 80 -50 0 80 -45 0 100 -50 0 100 -45 0 + 120 -50 0 120 -45 0 140 -50 0 140 -45 0 + 160 -50 0 160 -45 0 180 -50 0 180 -45 0 + 200 -50 0 200 -45 0 220 -50 0 220 -45 0 + 240 -50 0 240 -45 0 260 -50 0 260 -45 0 + 280 -50 0 280 -45 0 300 -50 0 300 -45 0 + 320 -50 0 320 -45 0 340 -50 0 340 -45 0 + 360 -50 0 360 -45 0 380 -50 0 380 -45 0 + 400 -50 0 400 -45 0 0 -40 0 20 -40 0 + 40 -40 0 60 -40 0 80 -40 0 100 -40 0 + 120 -40 0 140 -40 0 160 -40 0 180 -40 0 + 200 -40 0 220 -40 0 240 -40 0 260 -40 0 + 280 -40 0 300 -40 0 320 -40 0 340 -40 0 + 360 -40 0 380 -40 0 400 -40 0 0 -35 0 + 20 -35 0 40 -35 0 60 -35 0 80 -35 0 + 100 -35 0 120 -35 0 140 -35 0 160 -35 0 + 180 -35 0 200 -35 0 220 -35 0 240 -35 0 + 260 -35 0 280 -35 0 300 -35 0 320 -35 0 + 340 -35 0 360 -35 0 380 -35 0 400 -35 0 + 0 -30 0 20 -30 0 40 -30 0 60 -30 0 + 80 -30 0 100 -30 0 120 -30 0 140 -30 0 + 160 -30 0 180 -30 0 200 -30 0 220 -30 0 + 240 -30 0 260 -30 0 280 -30 0 300 -30 0 + 320 -30 0 340 -30 0 360 -30 0 380 -30 0 + 400 -30 0 0 -25 0 20 -25 0 40 -25 0 + 60 -25 0 80 -25 0 100 -25 0 120 -25 0 + 140 -25 0 160 -25 0 180 -25 0 200 -25 0 + 220 -25 0 240 -25 0 260 -25 0 280 -25 0 + 300 -25 0 320 -25 0 340 -25 0 360 -25 0 + 380 -25 0 400 -25 0 0 -20 0 20 -20 0 + 40 -20 0 60 -20 0 80 -20 0 100 -20 0 + 120 -20 0 140 -20 0 160 -20 0 180 -20 0 + 200 -20 0 220 -20 0 240 -20 0 260 -20 0 + 280 -20 0 300 -20 0 320 -20 0 340 -20 0 + 360 -20 0 380 -20 0 400 -20 0 0 -15 0 + 20 -15 0 40 -15 0 60 -15 0 80 -15 0 + 100 -15 0 120 -15 0 140 -15 0 160 -15 0 + 180 -15 0 200 -15 0 220 -15 0 240 -15 0 + 260 -15 0 280 -15 0 300 -15 0 320 -15 0 + 340 -15 0 360 -15 0 380 -15 0 400 -15 0 + 0 -10 0 20 -10 0 40 -10 0 60 -10 0 + 80 -10 0 100 -10 0 120 -10 0 140 -10 0 + 160 -10 0 180 -10 0 200 -10 0 220 -10 0 + 240 -10 0 260 -10 0 280 -10 0 300 -10 0 + 320 -10 0 340 -10 0 360 -10 0 380 -10 0 + 400 -10 0 0 -5 0 20 -5 0 40 -5 0 + 60 -5 0 80 -5 0 100 -5 0 120 -5 0 + 140 -5 0 160 -5 0 180 -5 0 200 -5 0 + 220 -5 0 240 -5 0 260 -5 0 280 -5 0 + 300 -5 0 320 -5 0 340 -5 0 360 -5 0 + 380 -5 0 400 -5 0 0 0 0 20 0 0 + 40 0 0 60 0 0 80 0 0 100 0 0 + 120 0 0 140 0 0 160 0 0 180 0 0 + 200 0 0 220 0 0 240 0 0 260 0 0 + 280 0 0 300 0 0 320 0 0 340 0 0 + 360 0 0 380 0 0 400 0 0 0 5 0 + 20 5 0 40 5 0 60 5 0 80 5 0 + 100 5 0 120 5 0 140 5 0 160 5 0 + 180 5 0 200 5 0 220 5 0 240 5 0 + 260 5 0 280 5 0 300 5 0 320 5 0 + 340 5 0 360 5 0 380 5 0 400 5 0 + 0 10 0 20 10 0 40 10 0 60 10 0 + 80 10 0 100 10 0 120 10 0 140 10 0 + 160 10 0 180 10 0 200 10 0 220 10 0 + 240 10 0 260 10 0 280 10 0 300 10 0 + 320 10 0 340 10 0 360 10 0 380 10 0 + 400 10 0 0 15 0 20 15 0 40 15 0 + 60 15 0 80 15 0 100 15 0 120 15 0 + 140 15 0 160 15 0 180 15 0 200 15 0 + 220 15 0 240 15 0 260 15 0 280 15 0 + 300 15 0 320 15 0 340 15 0 360 15 0 + 380 15 0 400 15 0 0 20 0 20 20 0 + 40 20 0 60 20 0 80 20 0 100 20 0 + 120 20 0 140 20 0 160 20 0 180 20 0 + 200 20 0 220 20 0 240 20 0 260 20 0 + 280 20 0 300 20 0 320 20 0 340 20 0 + 360 20 0 380 20 0 400 20 0 0 25 0 + 20 25 0 40 25 0 60 25 0 80 25 0 + 100 25 0 120 25 0 140 25 0 160 25 0 + 180 25 0 200 25 0 220 25 0 240 25 0 + 260 25 0 280 25 0 300 25 0 320 25 0 + 340 25 0 360 25 0 380 25 0 400 25 0 + 0 30 0 20 30 0 40 30 0 60 30 0 + 80 30 0 100 30 0 120 30 0 140 30 0 + 160 30 0 180 30 0 200 30 0 220 30 0 + 240 30 0 260 30 0 280 30 0 300 30 0 + 320 30 0 340 30 0 360 30 0 380 30 0 + 400 30 0 0 35 0 20 35 0 40 35 0 + 60 35 0 80 35 0 100 35 0 120 35 0 + 140 35 0 160 35 0 180 35 0 200 35 0 + 220 35 0 240 35 0 260 35 0 280 35 0 + 300 35 0 320 35 0 340 35 0 360 35 0 + 380 35 0 400 35 0 0 40 0 20 40 0 + 40 40 0 60 40 0 80 40 0 100 40 0 + 120 40 0 140 40 0 160 40 0 180 40 0 + 200 40 0 220 40 0 240 40 0 260 40 0 + 280 40 0 300 40 0 320 40 0 340 40 0 + 360 40 0 380 40 0 400 40 0 0 45 0 + 20 45 0 40 45 0 60 45 0 80 45 0 + 100 45 0 120 45 0 140 45 0 160 45 0 + 180 45 0 200 45 0 220 45 0 240 45 0 + 260 45 0 280 45 0 300 45 0 320 45 0 + 340 45 0 360 45 0 380 45 0 400 45 0 + 0 50 0 20 50 0 40 50 0 60 50 0 + 80 50 0 100 50 0 120 50 0 140 50 0 + 160 50 0 180 50 0 200 50 0 220 50 0 + 240 50 0 260 50 0 280 50 0 300 50 0 + 320 50 0 340 50 0 360 50 0 380 50 0 + 400 50 0 + </DataArray> + </Points> + <Cells> + <DataArray type="Int32" Name="connectivity" NumberOfComponents="1" format="ascii"> + 0 1 3 2 1 4 5 3 4 6 7 5 + 6 8 9 7 8 10 11 9 10 12 13 11 + 12 14 15 13 14 16 17 15 16 18 19 17 + 18 20 21 19 20 22 23 21 22 24 25 23 + 24 26 27 25 26 28 29 27 28 30 31 29 + 30 32 33 31 32 34 35 33 34 36 37 35 + 36 38 39 37 38 40 41 39 2 3 43 42 + 3 5 44 43 5 7 45 44 7 9 46 45 + 9 11 47 46 11 13 48 47 13 15 49 48 + 15 17 50 49 17 19 51 50 19 21 52 51 + 21 23 53 52 23 25 54 53 25 27 55 54 + 27 29 56 55 29 31 57 56 31 33 58 57 + 33 35 59 58 35 37 60 59 37 39 61 60 + 39 41 62 61 42 43 64 63 43 44 65 64 + 44 45 66 65 45 46 67 66 46 47 68 67 + 47 48 69 68 48 49 70 69 49 50 71 70 + 50 51 72 71 51 52 73 72 52 53 74 73 + 53 54 75 74 54 55 76 75 55 56 77 76 + 56 57 78 77 57 58 79 78 58 59 80 79 + 59 60 81 80 60 61 82 81 61 62 83 82 + 63 64 85 84 64 65 86 85 65 66 87 86 + 66 67 88 87 67 68 89 88 68 69 90 89 + 69 70 91 90 70 71 92 91 71 72 93 92 + 72 73 94 93 73 74 95 94 74 75 96 95 + 75 76 97 96 76 77 98 97 77 78 99 98 + 78 79 100 99 79 80 101 100 80 81 102 101 + 81 82 103 102 82 83 104 103 84 85 106 105 + 85 86 107 106 86 87 108 107 87 88 109 108 + 88 89 110 109 89 90 111 110 90 91 112 111 + 91 92 113 112 92 93 114 113 93 94 115 114 + 94 95 116 115 95 96 117 116 96 97 118 117 + 97 98 119 118 98 99 120 119 99 100 121 120 + 100 101 122 121 101 102 123 122 102 103 124 123 + 103 104 125 124 105 106 127 126 106 107 128 127 + 107 108 129 128 108 109 130 129 109 110 131 130 + 110 111 132 131 111 112 133 132 112 113 134 133 + 113 114 135 134 114 115 136 135 115 116 137 136 + 116 117 138 137 117 118 139 138 118 119 140 139 + 119 120 141 140 120 121 142 141 121 122 143 142 + 122 123 144 143 123 124 145 144 124 125 146 145 + 126 127 148 147 127 128 149 148 128 129 150 149 + 129 130 151 150 130 131 152 151 131 132 153 152 + 132 133 154 153 133 134 155 154 134 135 156 155 + 135 136 157 156 136 137 158 157 137 138 159 158 + 138 139 160 159 139 140 161 160 140 141 162 161 + 141 142 163 162 142 143 164 163 143 144 165 164 + 144 145 166 165 145 146 167 166 147 148 169 168 + 148 149 170 169 149 150 171 170 150 151 172 171 + 151 152 173 172 152 153 174 173 153 154 175 174 + 154 155 176 175 155 156 177 176 156 157 178 177 + 157 158 179 178 158 159 180 179 159 160 181 180 + 160 161 182 181 161 162 183 182 162 163 184 183 + 163 164 185 184 164 165 186 185 165 166 187 186 + 166 167 188 187 168 169 190 189 169 170 191 190 + 170 171 192 191 171 172 193 192 172 173 194 193 + 173 174 195 194 174 175 196 195 175 176 197 196 + 176 177 198 197 177 178 199 198 178 179 200 199 + 179 180 201 200 180 181 202 201 181 182 203 202 + 182 183 204 203 183 184 205 204 184 185 206 205 + 185 186 207 206 186 187 208 207 187 188 209 208 + 189 190 211 210 190 191 212 211 191 192 213 212 + 192 193 214 213 193 194 215 214 194 195 216 215 + 195 196 217 216 196 197 218 217 197 198 219 218 + 198 199 220 219 199 200 221 220 200 201 222 221 + 201 202 223 222 202 203 224 223 203 204 225 224 + 204 205 226 225 205 206 227 226 206 207 228 227 + 207 208 229 228 208 209 230 229 210 211 232 231 + 211 212 233 232 212 213 234 233 213 214 235 234 + 214 215 236 235 215 216 237 236 216 217 238 237 + 217 218 239 238 218 219 240 239 219 220 241 240 + 220 221 242 241 221 222 243 242 222 223 244 243 + 223 224 245 244 224 225 246 245 225 226 247 246 + 226 227 248 247 227 228 249 248 228 229 250 249 + 229 230 251 250 231 232 253 252 232 233 254 253 + 233 234 255 254 234 235 256 255 235 236 257 256 + 236 237 258 257 237 238 259 258 238 239 260 259 + 239 240 261 260 240 241 262 261 241 242 263 262 + 242 243 264 263 243 244 265 264 244 245 266 265 + 245 246 267 266 246 247 268 267 247 248 269 268 + 248 249 270 269 249 250 271 270 250 251 272 271 + 252 253 274 273 253 254 275 274 254 255 276 275 + 255 256 277 276 256 257 278 277 257 258 279 278 + 258 259 280 279 259 260 281 280 260 261 282 281 + 261 262 283 282 262 263 284 283 263 264 285 284 + 264 265 286 285 265 266 287 286 266 267 288 287 + 267 268 289 288 268 269 290 289 269 270 291 290 + 270 271 292 291 271 272 293 292 273 274 295 294 + 274 275 296 295 275 276 297 296 276 277 298 297 + 277 278 299 298 278 279 300 299 279 280 301 300 + 280 281 302 301 281 282 303 302 282 283 304 303 + 283 284 305 304 284 285 306 305 285 286 307 306 + 286 287 308 307 287 288 309 308 288 289 310 309 + 289 290 311 310 290 291 312 311 291 292 313 312 + 292 293 314 313 294 295 316 315 295 296 317 316 + 296 297 318 317 297 298 319 318 298 299 320 319 + 299 300 321 320 300 301 322 321 301 302 323 322 + 302 303 324 323 303 304 325 324 304 305 326 325 + 305 306 327 326 306 307 328 327 307 308 329 328 + 308 309 330 329 309 310 331 330 310 311 332 331 + 311 312 333 332 312 313 334 333 313 314 335 334 + 315 316 337 336 316 317 338 337 317 318 339 338 + 318 319 340 339 319 320 341 340 320 321 342 341 + 321 322 343 342 322 323 344 343 323 324 345 344 + 324 325 346 345 325 326 347 346 326 327 348 347 + 327 328 349 348 328 329 350 349 329 330 351 350 + 330 331 352 351 331 332 353 352 332 333 354 353 + 333 334 355 354 334 335 356 355 336 337 358 357 + 337 338 359 358 338 339 360 359 339 340 361 360 + 340 341 362 361 341 342 363 362 342 343 364 363 + 343 344 365 364 344 345 366 365 345 346 367 366 + 346 347 368 367 347 348 369 368 348 349 370 369 + 349 350 371 370 350 351 372 371 351 352 373 372 + 352 353 374 373 353 354 375 374 354 355 376 375 + 355 356 377 376 357 358 379 378 358 359 380 379 + 359 360 381 380 360 361 382 381 361 362 383 382 + 362 363 384 383 363 364 385 384 364 365 386 385 + 365 366 387 386 366 367 388 387 367 368 389 388 + 368 369 390 389 369 370 391 390 370 371 392 391 + 371 372 393 392 372 373 394 393 373 374 395 394 + 374 375 396 395 375 376 397 396 376 377 398 397 + 378 379 400 399 379 380 401 400 380 381 402 401 + 381 382 403 402 382 383 404 403 383 384 405 404 + 384 385 406 405 385 386 407 406 386 387 408 407 + 387 388 409 408 388 389 410 409 389 390 411 410 + 390 391 412 411 391 392 413 412 392 393 414 413 + 393 394 415 414 394 395 416 415 395 396 417 416 + 396 397 418 417 397 398 419 418 399 400 421 420 + 400 401 422 421 401 402 423 422 402 403 424 423 + 403 404 425 424 404 405 426 425 405 406 427 426 + 406 407 428 427 407 408 429 428 408 409 430 429 + 409 410 431 430 410 411 432 431 411 412 433 432 + 412 413 434 433 413 414 435 434 414 415 436 435 + 415 416 437 436 416 417 438 437 417 418 439 438 + 418 419 440 439 + </DataArray> + <DataArray type="Int32" Name="offsets" NumberOfComponents="1" format="ascii"> + 4 8 12 16 20 24 28 32 36 40 44 48 + 52 56 60 64 68 72 76 80 84 88 92 96 + 100 104 108 112 116 120 124 128 132 136 140 144 + 148 152 156 160 164 168 172 176 180 184 188 192 + 196 200 204 208 212 216 220 224 228 232 236 240 + 244 248 252 256 260 264 268 272 276 280 284 288 + 292 296 300 304 308 312 316 320 324 328 332 336 + 340 344 348 352 356 360 364 368 372 376 380 384 + 388 392 396 400 404 408 412 416 420 424 428 432 + 436 440 444 448 452 456 460 464 468 472 476 480 + 484 488 492 496 500 504 508 512 516 520 524 528 + 532 536 540 544 548 552 556 560 564 568 572 576 + 580 584 588 592 596 600 604 608 612 616 620 624 + 628 632 636 640 644 648 652 656 660 664 668 672 + 676 680 684 688 692 696 700 704 708 712 716 720 + 724 728 732 736 740 744 748 752 756 760 764 768 + 772 776 780 784 788 792 796 800 804 808 812 816 + 820 824 828 832 836 840 844 848 852 856 860 864 + 868 872 876 880 884 888 892 896 900 904 908 912 + 916 920 924 928 932 936 940 944 948 952 956 960 + 964 968 972 976 980 984 988 992 996 1000 1004 1008 + 1012 1016 1020 1024 1028 1032 1036 1040 1044 1048 1052 1056 + 1060 1064 1068 1072 1076 1080 1084 1088 1092 1096 1100 1104 + 1108 1112 1116 1120 1124 1128 1132 1136 1140 1144 1148 1152 + 1156 1160 1164 1168 1172 1176 1180 1184 1188 1192 1196 1200 + 1204 1208 1212 1216 1220 1224 1228 1232 1236 1240 1244 1248 + 1252 1256 1260 1264 1268 1272 1276 1280 1284 1288 1292 1296 + 1300 1304 1308 1312 1316 1320 1324 1328 1332 1336 1340 1344 + 1348 1352 1356 1360 1364 1368 1372 1376 1380 1384 1388 1392 + 1396 1400 1404 1408 1412 1416 1420 1424 1428 1432 1436 1440 + 1444 1448 1452 1456 1460 1464 1468 1472 1476 1480 1484 1488 + 1492 1496 1500 1504 1508 1512 1516 1520 1524 1528 1532 1536 + 1540 1544 1548 1552 1556 1560 1564 1568 1572 1576 1580 1584 + 1588 1592 1596 1600 + </DataArray> + <DataArray type="UInt8" Name="types" NumberOfComponents="1" format="ascii"> + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 + </DataArray> + </Cells> + </Piece> + </UnstructuredGrid> +</VTKFile> diff --git a/test/references/test_ff_shallowwater_poiseuilleflow_unstructured-reference.vtu b/test/references/test_ff_shallowwater_poiseuilleflow_unstructured-reference.vtu new file mode 100755 index 0000000000000000000000000000000000000000..2c3c0a8373e062785628f9b3a1edc9b15468f5a3 --- /dev/null +++ b/test/references/test_ff_shallowwater_poiseuilleflow_unstructured-reference.vtu @@ -0,0 +1,821 @@ +<?xml version="1.0"?> +<VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian"> + <UnstructuredGrid> + <Piece NumberOfCells="590" NumberOfPoints="336"> + <CellData Scalars="waterDepth"> + <DataArray type="Float32" Name="waterDepth" NumberOfComponents="1" format="ascii"> + 9.75487 9.65042 9.72923 9.8883 9.8213 9.83524 9.83264 9.81938 9.82015 9.81438 9.82409 9.82167 + 9.81262 9.81343 9.80696 9.81514 9.81318 9.80497 9.80589 9.79876 9.80786 9.80628 9.79659 9.79762 + 9.79199 9.80213 9.80094 9.7919 9.79188 9.79658 9.79764 9.79638 9.7993 9.79776 9.81311 9.95232 + 9.8022 9.96312 9.80004 9.79468 9.79879 9.80011 9.79761 9.79696 9.92223 9.93223 9.97414 9.80794 + 9.92447 9.7959 9.79938 9.79156 9.80048 9.80421 9.79407 9.80565 9.81054 9.80309 9.81236 9.81841 + 9.81126 9.82065 9.8282 9.81831 9.83124 9.82276 9.83122 9.81499 10.1042 9.8927 9.6453 9.81381 + 9.73333 10.0335 9.99768 9.90624 9.82128 9.70634 9.82145 9.83323 9.79586 10.0307 9.84186 9.82391 + 9.82317 9.83252 9.82228 9.83317 9.83298 9.82947 9.81982 9.81771 9.81774 9.81607 9.81494 9.823 + 9.81516 9.82551 9.82331 9.81938 9.81398 9.81079 9.81041 9.80891 9.80735 9.81428 9.80787 9.81629 + 9.81474 9.81131 9.80632 9.80294 9.80235 9.80087 9.7986 9.80718 9.79975 9.80881 9.80777 9.8048 + 9.79746 9.79437 9.79496 9.79283 9.79139 9.80164 9.79236 9.80288 9.80238 9.79982 9.79132 9.7926 + 9.79534 9.79416 9.79488 9.7971 9.79522 9.79829 9.79825 9.79522 9.7965 9.80579 9.82411 9.79776 + 9.81529 9.9619 9.89853 9.96031 9.91234 9.94849 9.96914 9.79328 9.83248 9.79395 9.79013 9.80297 + 9.85804 9.78724 9.81768 9.96824 9.96029 9.95703 9.81059 9.81791 9.92104 9.96285 9.83514 9.8468 + 9.79782 9.80552 9.79875 9.79386 9.79216 9.79326 9.80129 9.80026 9.80341 9.792 9.79545 9.79358 + 9.80626 9.80487 9.80954 9.79975 9.80388 9.80184 9.81286 9.81107 9.81721 9.80832 9.81164 9.80978 + 9.821 9.81881 9.82667 9.81572 9.81842 9.81681 9.83089 9.82832 9.83531 9.83592 9.83282 9.82615 + 9.81365 9.8487 9.81404 9.74135 9.80902 10.0003 9.82362 9.76583 9.90858 9.7842 10.0838 10.1031 + 9.82985 9.82349 9.81913 9.82281 9.77395 9.81119 9.79693 9.79572 9.79443 9.78619 9.87315 9.93598 + 9.94281 9.82513 9.79111 9.80135 9.79628 9.80659 9.80525 9.81344 9.81313 9.8218 9.81984 9.829 + 9.82638 9.83395 9.82642 9.91551 9.79542 9.94626 9.83071 9.8215 9.73347 9.64352 9.82462 9.80093 + 9.81808 9.82873 9.81918 9.82272 9.81925 9.82575 9.81706 9.81666 9.82317 9.81956 9.81237 9.82186 + 9.81176 9.81673 9.80965 9.80933 9.80827 9.81159 9.80437 9.81367 9.80509 9.80937 9.80166 9.80088 + 9.80076 9.80511 9.7965 9.80662 9.80065 9.80358 9.79484 9.7924 9.79566 9.80031 9.79393 9.80119 + 9.79598 9.79927 9.79722 9.7928 9.80528 9.79241 9.8105 9.80002 9.85875 9.8477 9.88803 9.81499 + 9.80985 9.94121 9.79367 9.92318 9.91878 9.93859 9.88844 9.91499 9.86382 9.83233 9.80001 9.88302 + 9.79861 9.80235 9.79136 9.79218 9.80033 9.79415 9.79856 9.79937 9.79517 9.79335 9.80779 9.79786 + 9.8025 9.80375 9.8042 9.802 9.81357 9.8057 9.80817 9.80983 9.81215 9.81026 9.81583 9.81354 + 9.81539 9.81743 9.81885 9.81737 9.80526 9.81964 9.82415 9.82657 9.82556 9.80669 9.79251 9.8342 + 9.83351 9.79291 9.65203 9.71489 9.8048 9.79641 9.84825 9.92 9.82118 9.81854 9.82582 9.82362 + 9.81718 9.81519 9.80975 9.8081 9.80378 9.80258 9.79999 9.79973 9.83663 9.82387 9.78134 9.81812 + 9.82393 9.81859 9.76853 9.8367 9.82113 9.81965 9.81791 9.82492 9.81969 9.82782 9.81564 9.81162 + 9.82039 9.81608 9.81392 9.81427 9.81541 9.81767 9.81973 9.82139 9.80827 9.80368 9.81276 9.80842 + 9.80981 9.80639 9.80771 9.81124 9.8105 9.81328 9.80234 9.79615 9.80542 9.80035 9.80316 9.79838 + 9.79974 9.80361 9.80505 9.80654 9.79936 9.79508 9.79953 9.79388 9.79695 9.7935 9.79413 9.79959 + 9.80025 9.80153 9.80533 9.79794 9.8146 9.80204 9.80093 9.80142 9.81479 9.79969 9.91319 9.82751 + 9.89087 9.80321 9.84831 9.91756 9.88794 9.91318 9.85676 9.88108 9.8026 9.82635 9.80443 9.8304 + 9.80769 9.82101 9.79935 9.79773 9.79898 9.79738 9.80449 9.80162 9.79738 9.80107 9.80999 9.81147 + 9.80383 9.80947 9.81937 9.81625 9.81137 9.81555 9.82565 9.82778 9.81865 9.82477 9.80996 9.78819 + 9.81525 9.82727 9.77784 9.8253 9.8141 9.81224 9.80351 9.81007 9.82115 9.82002 9.82115 9.8175 + 9.81012 9.81311 9.8025 9.80603 9.79624 9.80062 9.79974 9.80008 9.91129 9.83869 9.81025 9.82837 + 9.81118 9.87152 9.7966 9.80173 9.80441 9.80774 9.81001 9.81512 9.81754 9.82052 9.82136 9.8088 + 9.81046 9.81919 9.78561 9.80652 9.81896 9.82048 9.82344 9.82086 9.8213 9.82289 9.81737 9.81913 + 9.81193 9.81749 9.80863 9.80587 9.80437 9.80635 9.80976 9.8115 9.80626 9.80798 9.79882 9.80215 + 9.79739 9.80288 9.79793 9.79983 9.79703 9.79887 9.80278 9.80331 9.80102 9.80122 9.84607 9.85384 + 9.83136 9.8149 9.81259 9.80415 9.82279 9.81189 9.79815 9.79866 9.799 9.79945 9.79823 9.80002 + 9.79639 9.7958 9.79953 9.80359 9.80157 9.803 9.80018 9.79879 9.80055 9.799 9.80683 9.8049 + 9.80623 9.80804 9.8137 9.81815 9.81552 9.81711 9.81435 9.81227 9.8154 9.81346 9.82129 9.81972 + 9.8202 9.82011 9.81128 9.81694 9.7877 9.83078 9.80166 9.77301 9.79462 9.79906 9.88468 9.84918 + 9.84723 9.8821 + </DataArray> + <DataArray type="Float32" Name="velocityX" NumberOfComponents="1" format="ascii"> + 0.817704 0.764109 2.9304 4.61579 0.986715 1.15627 1.15962 0.978532 0.984485 0.952715 1.14995 1.14364 + 0.945817 0.951 0.929787 1.11959 1.11015 0.925729 0.929459 0.916578 1.07799 1.06598 0.914935 0.917431 + 0.927345 1.02585 1.01125 0.939519 0.936962 1.00557 0.968006 0.954968 1.03902 3.63 1.20668 5.09284 + 1.06774 5.45813 5.20346 0.93417 0.949035 0.97378 0.913275 0.99053 3.32471 2.00243 4.17705 1.18487 + 5.49593 0.946393 0.986995 3.57463 1.00197 1.04483 3.51895 1.05785 1.09284 3.47778 1.10323 1.13048 + 3.4597 1.13813 1.15529 3.45421 1.15796 3.44497 1.18957 4.70005 5.9732 4.6316 1.48986 3.80712 + 2.95383 5.73245 5.27027 6.10648 3.45562 2.99894 1.03926 1.0846 1.02008 5.72249 5.32591 0.998396 + 0.99155 1.17036 0.990852 1.1406 3.54386 1.15882 3.45626 0.969189 5.16411 0.960511 3.45528 1.14493 + 0.95836 1.15072 3.56751 1.1364 3.45732 0.939729 5.1754 0.934395 3.46684 1.11298 0.933797 1.12207 + 3.57483 1.10006 3.4699 0.922156 5.19687 0.919087 3.49456 1.07017 0.919515 1.08182 3.57024 1.05328 + 3.50128 0.915438 5.22261 0.919437 3.54616 1.01679 0.92624 1.03112 3.55343 0.996319 3.55593 0.956251 + 5.24002 0.978053 3.6086 0.9599 0.997833 0.972597 3.52915 0.94208 3.62624 1.07776 1.15652 1.02896 + 1.13346 5.53479 4.80475 5.53048 5.31975 5.06943 5.67934 0.925018 3.75467 0.931314 3.65201 0.956944 + 3.41691 3.6898 3.8071 4.10603 5.44698 4.68636 1.15181 1.18199 5.33926 4.73075 3.91003 5.21834 + 3.52915 3.80023 0.981594 3.60453 0.952158 0.972263 3.54737 3.54092 1.0399 3.54164 0.916894 0.919674 + 3.56725 3.56344 1.08934 3.49088 0.925638 0.92231 3.57476 3.57395 1.12835 3.46568 0.944496 0.938776 + 3.57058 3.57277 1.15516 3.45605 0.975671 0.966615 3.55189 3.55838 1.15222 3.53161 1.15757 3.43255 + 3.61666 1.19373 5.23716 0.869814 1.11929 5.26887 4.71209 0.894275 6.11802 3.62873 6.08793 5.97386 + 5.10848 1.00251 1.06814 1.02236 3.59298 3.80813 3.52423 3.67722 3.52648 3.56943 3.52678 3.43608 + 5.70521 3.95876 3.56012 3.55252 3.50578 3.57044 3.47167 3.57612 3.45713 3.56991 3.455 3.5483 + 5.22303 3.50055 3.44117 5.83608 3.52595 6.22429 5.20792 3.4535 0.805311 1.49013 3.46408 3.57881 + 5.85671 3.55554 5.16324 5.22484 5.24108 3.56345 5.1658 3.45432 5.90253 3.57268 5.1716 5.23643 + 5.24855 3.57416 5.17786 3.46294 5.87904 3.57578 5.19085 5.24731 5.24518 3.57245 5.20043 3.48535 + 5.89666 3.56715 5.21622 5.24875 5.23149 3.55882 5.22664 3.53248 5.91076 3.54635 5.23739 5.23994 + 3.52641 3.53456 5.24291 3.59042 5.89812 3.54326 5.23701 5.21994 5.25532 3.86069 4.76583 5.17297 + 3.85802 5.73105 0.956393 1.81848 5.4879 5.73079 5.36799 5.75983 5.78247 5.85065 5.21333 5.82891 + 3.65155 3.76736 3.57068 3.58648 5.93463 5.23692 3.53416 3.54 3.51382 3.52762 5.8813 5.21365 + 3.55814 3.56304 3.4754 3.48235 5.92004 5.18822 3.57295 3.57472 3.45941 3.46221 5.86252 5.1705 + 3.57572 3.57459 3.456 3.45562 5.91071 5.1644 3.56619 3.56141 3.45523 5.18908 5.91079 3.52139 + 3.51524 5.39701 0.805882 3.01997 3.57004 5.94494 5.35432 5.84403 5.16461 5.86108 5.22957 5.23411 + 5.24364 5.24563 5.24805 5.24772 5.2428 5.23974 5.22646 5.22089 5.16216 5.14576 5.95031 5.16329 + 5.23217 5.16464 6.08942 5.21708 5.13813 5.16396 5.16594 5.89687 6.00866 5.22249 5.24548 5.17387 + 6.01233 5.16577 5.86638 5.16836 5.16773 5.24308 5.24009 5.23794 5.24924 5.19419 6.02847 5.17979 + 5.87677 5.18511 5.18265 5.92409 6.03152 5.24705 5.24321 5.22033 6.04358 5.20308 6.04608 5.20957 + 5.2069 5.24578 5.24763 5.24681 5.22606 5.2405 6.05538 5.22843 5.91209 5.23344 5.23223 5.2313 + 5.23595 5.23596 6.04281 5.24139 5.88326 5.24226 5.24502 5.21236 5.17976 5.92726 5.79917 5.21272 + 5.78222 5.18941 5.26064 5.75408 5.78365 5.75575 5.89871 5.34739 5.20129 5.88083 5.9121 6.00681 + 5.24954 5.2226 5.93419 6.05839 5.91008 6.0585 5.93233 6.04992 5.90707 6.0514 5.24917 5.24782 + 5.89045 5.92658 5.90906 6.01961 5.87276 6.02143 5.22732 5.22465 5.85826 5.8987 5.16196 5.36716 + 5.21203 6.19806 5.91598 6.1864 5.862 6.03753 5.81463 6.21786 5.9008 5.85478 5.90685 6.01734 + 5.87463 5.92134 5.89245 5.93075 5.90839 5.93344 5.90766 5.92609 5.76225 5.22232 5.90618 5.83067 + 5.89167 5.79804 5.90989 5.93358 5.93229 5.92877 6.03329 5.91799 5.85907 6.0086 6.00808 5.86586 + 5.91323 5.84395 6.24252 5.85878 5.85673 6.01008 5.89781 5.89864 5.90485 5.90075 5.86088 5.91079 + 5.87069 5.91293 6.03551 5.88585 5.88815 5.8835 5.92589 5.92325 5.93044 5.92831 5.9033 5.89469 + 5.90516 5.93366 6.05699 5.93241 5.91112 5.9328 5.90428 5.91892 6.05191 5.9215 5.83007 5.95172 + 5.97469 6.0235 6.03457 6.04815 5.86808 5.88292 6.05699 6.05707 5.93032 5.93045 6.05784 6.05492 + 5.91173 5.91196 6.05423 6.04727 5.93436 5.93315 6.053 6.05497 5.89897 5.90105 6.03926 6.04238 + 6.04088 6.03724 6.02531 6.01555 5.9166 5.91452 6.02358 6.02695 5.86454 5.86853 6.0089 6.0108 + 5.85533 5.85596 6.02115 6.01104 6.06213 5.9015 6.08592 6.11197 6.06809 5.84993 5.87091 5.80531 + 5.87541 5.84123 + </DataArray> + <DataArray type="Float32" Name="velocityY" NumberOfComponents="1" format="ascii"> + 0.00251791 -0.025476 -0.100295 -0.0710016 -0.000262602 -0.000799188 -0.000553708 -0.000422915 -0.00699533 -0.000388443 0.00506151 0.00585426 + -0.00034576 -0.00584848 -0.000239962 0.00768196 0.00821138 -0.000215153 -0.00353691 -0.000146061 0.00974428 0.0102863 -0.000108158 -0.00155379 + 0.000287153 0.0119115 0.0123139 0.000466161 0.0100102 0.00116924 0.0105395 0.0111993 0.00147587 0.0346572 0.00253899 0.239728 + 0.032071 0.0866622 0.00113691 0.000560141 -0.0270955 -0.0267581 0.0026784 -0.00146557 -0.0942325 0.677418 0.376614 -0.0475522 + 0.136436 0.000629278 0.000735064 0.0157022 0.0007396 0.000684451 0.00173003 0.000658817 0.000583819 -0.00257303 0.000556878 0.000463003 + -0.00525927 0.000421818 0.000215209 -0.00869119 8.0353e-06 -0.00881043 0.0267157 -0.202426 0.054413 0.00859449 0.720442 0.454642 + 0.0522763 -0.00481941 -0.298807 -0.0104686 -0.00629254 -0.299829 -0.00264818 0.0121284 0.218647 -0.0634898 0.0541223 -0.00851678 + -0.000519376 0.0018726 -0.00405723 0.00160796 -0.0156969 0.00262652 -0.00862307 -0.000468164 -0.00885838 -0.000431528 -0.00700986 0.000372591 + -0.00658043 0.000311053 0.00466941 0.00653799 -0.00591093 -0.000307858 -0.00254011 -0.000273066 -0.00378403 0.000528286 -0.0039823 0.00049807 + 0.00811675 0.00872926 -0.00107555 -0.000193316 0.00360939 -0.000170783 -0.00125821 0.000633485 -0.00226902 0.000608807 0.0107167 0.0108536 + 0.00538436 -1.53777e-05 0.0135841 0.000126927 0.00818566 0.000727312 0.00644774 0.000708116 0.0134478 0.0124331 0.0181428 0.000664295 + 0.0294731 0.000894658 0.0253596 0.000609435 0.0228079 0.000697159 0.0116736 0.0101292 0.0432176 0.00175665 0.00403349 0.0276369 + 0.065552 0.0810963 0.357726 -0.0708432 -0.0973897 -0.2386 0.00756505 0.000421601 -0.0974656 0.00764399 -0.0694922 -0.00137561 + -0.332596 -0.0089073 -0.215624 -0.391169 -0.075429 -0.174411 -0.00254178 0.0385522 0.110503 0.178367 0.226816 -0.0820101 + 0.0130717 0.04526 0.0119509 0.0339414 0.0138138 0.0180449 0.0139543 0.0141557 0.0114097 0.0142654 0.000234956 0.00317859 + 0.0113949 0.0121075 0.00923114 0.00338957 -0.00314177 -0.0027285 0.00878576 0.00944128 0.00714106 -0.00233048 -0.00518927 -0.0045753 + 0.00575687 0.00664743 0.00409617 -0.0073324 -0.00788669 -0.00730194 -0.00266649 0.00125097 -0.0138585 -0.0304272 0.0240826 -0.0190916 + -0.0879529 -0.0150645 -0.0975792 -0.102714 -0.2452 0.233299 0.148935 -0.00404129 -0.0541104 -0.134883 -0.0352434 -0.124677 + 0.00445071 -0.0017279 -0.0432975 -0.0295458 0.0893872 -0.512048 0.00850523 0.0221476 0.00880481 0.0189191 0.338276 0.0968113 + 0.00854156 0.187152 0.0118438 0.0176213 -0.00027188 0.0132401 -0.00316288 0.00901094 -0.00608986 0.00404204 -0.00894157 -0.0121304 + -0.0117539 0.00740155 -0.00615789 -0.115534 -0.0473726 -0.0345182 -0.0624345 -0.00219612 0.0731534 -0.761155 -0.0256913 0.0538911 + -0.0136803 -0.0035929 -0.0104341 -0.0199751 0.00465282 0.00328744 -0.00777443 -0.00790742 -0.00386877 0.00551666 -0.00392841 0.000641846 + 0.00974488 0.00741225 -0.000354472 -0.00450791 0.00306258 0.0100844 0.00190203 0.00813733 0.01528 0.0100733 0.00696554 -0.0019514 + 0.0109785 0.0143997 0.0105558 0.0142475 0.0199964 0.0128092 0.017703 0.00478383 0.0225307 0.0182112 0.0248499 0.0209446 + 0.00715398 0.0136649 0.0335764 0.019938 0.0385298 -0.0138508 0.0713942 0.0197974 0.107919 0.110766 -0.359686 -0.0370181 + -0.168314 0.0323128 0.0666842 -0.729706 -0.125889 -0.0125528 0.169104 0.0547382 -0.0413304 0.0762964 0.0129822 0.0200511 + 0.06085 0.110986 0.0224295 0.0274603 0.0212364 0.024717 0.0163082 0.0180421 0.00787607 0.0107913 0.00538284 0.0118097 + 0.0166627 0.015566 0.000292735 0.00175883 0.00563379 0.003304 0.0121504 0.0111134 -0.00461442 -0.00344481 -0.00473492 -0.0037166 + 0.0079202 0.00677798 -0.00971362 -0.0086689 -0.0855658 -0.0114066 0.00226919 2.23356e-05 -0.0401801 0.0557328 0.0863226 0.00359763 + 0.0167373 -0.0254457 0.0254816 0.26103 0.00980146 -0.142098 -0.111357 0.0497862 -0.00645453 -0.00715831 -0.00219112 0.000657558 + 0.00616255 0.0075208 0.0113507 0.0125857 0.0166924 0.0180198 0.019942 0.0182455 -0.0379279 -0.002853 -0.0828273 0.00163641 + -0.00221299 -0.0096933 0.0441977 -0.0351652 0.0160601 -0.011661 -0.0111383 -0.0135909 -0.01628 -0.0143264 0.00655184 -0.00199028 + -0.00524914 -0.00719143 -0.00264552 -0.00546622 -0.00563277 0.00486259 0.0029484 0.00285197 0.0127167 0.00510544 0.00400176 -0.0012227 + 0.00342596 0.000294426 0.00152054 0.00914869 0.00630778 0.00882873 0.0193497 0.0146672 0.0116517 0.00547793 0.0120244 0.00777015 + 0.00918866 0.0176744 0.0159277 0.0138827 0.0223758 0.0286701 0.0206782 0.0170068 0.0272477 0.0207655 0.0210972 0.0229206 + 0.0222677 0.0191996 0.0285728 0.0352571 0.0460199 0.0440699 0.0409896 0.0123472 -0.0245279 0.0238135 0.0149218 0.0724291 + 0.0656522 -0.0185332 0.122273 0.0389402 -0.0463828 -0.0147639 -0.0239036 -0.155522 0.000260056 0.0485657 0.0143888 0.0303706 + 0.0544639 0.0669382 0.0233033 0.024559 0.0301578 0.0251897 0.0149013 0.0160507 0.0188688 0.0155346 0.0112383 0.0101258 + 0.00903965 0.0107705 -0.000602939 -9.88466e-05 0.00118482 -0.000787417 -0.00607898 -0.00661082 -0.00777721 -0.00786426 0.00014417 -0.0315102 + -0.0405171 -0.0286881 0.0266002 -0.0354425 -0.0146625 -0.013633 0.0425281 -0.0295994 -0.0232185 -0.0116099 -0.000830236 -0.00311805 + 0.000919771 0.00731713 0.00869838 0.0140529 0.0193512 0.0215835 0.0333148 0.0255592 -0.0330846 -0.093297 0.0159251 -0.0319671 + 0.0378424 0.0725589 0.0216758 0.0197677 0.0159275 0.0123951 0.00538287 0.00561486 -0.00724663 -0.0121397 -0.0129301 0.00466061 + -0.0263194 0.00865816 -0.0268773 -0.0893964 -0.00932645 -0.00873868 -0.0115962 -0.0181562 -0.00358413 -0.00704461 -0.00493439 0.00170464 + -0.000728761 0.0017601 0.00796265 0.00736856 0.00686041 0.00494842 0.00947242 0.0076962 0.0129301 0.0112222 0.0163565 0.0111076 + 0.0164976 0.0171083 0.0220048 0.0231744 0.0292314 0.0249073 0.0323908 0.0224754 0.0275705 0.0217293 0.0625172 0.00904689 + 0.00398844 0.0252281 0.0341837 0.024478 0.000618327 -0.00631774 0.0270237 0.0230715 0.0256969 0.0240801 0.0258106 0.0292932 + 0.024601 0.0258426 0.0179206 0.0137605 0.0191575 0.0179135 0.0180445 0.019265 0.0137235 0.0136999 0.00977738 0.00979012 + 0.00917407 0.0072308 0.00141752 -0.00236689 0.00383448 0.00377244 0.00206798 0.00189551 -0.00257343 -0.000369174 -0.0088296 -0.00758861 + -0.0123259 -0.0098498 -0.0269523 -0.0175074 -0.0127781 -0.0488433 -0.0492934 -0.0923768 0.0140162 0.0419827 -0.013328 -0.0258424 + 0.0549112 0.0426945 + </DataArray> + <DataArray type="Float32" Name="bedSurface" NumberOfComponents="1" format="ascii"> + -9.98093 -9.98034 -9.9803 -9.98035 -9.98406 -9.98344 -9.98375 -9.98469 -9.98438 -9.98656 -9.98563 -9.98625 + -9.98719 -9.98687 -9.98906 -9.98812 -9.98875 -9.98969 -9.98938 -9.99156 -9.99063 -9.99125 -9.99219 -9.99187 + -9.99406 -9.99312 -9.99375 -9.99469 -9.99438 -9.99656 -9.99563 -9.99625 -9.99719 -9.99687 -9.99907 -9.99982 + -9.9975 -9.99964 -9.99657 -9.99719 -9.99813 -9.99876 -9.99966 -9.99907 -9.9997 -9.99986 -9.99983 -9.99935 + -9.99928 -9.99656 -9.99469 -9.995 -9.99406 -9.99219 -9.9925 -9.99156 -9.98969 -9.99 -9.98906 -9.98719 + -9.9875 -9.98656 -9.98469 -9.985 -9.98406 -9.98312 -9.98187 -9.98074 -9.98018 -9.98035 -9.98014 -9.98017 + -9.9803 -9.98036 -9.98018 -9.98089 -9.98375 -9.98061 -9.98219 -9.98156 -9.98124 -9.98036 -9.98093 -9.98312 + -9.98344 -9.98219 -9.98375 -9.98281 -9.98313 -9.98438 -9.98406 -9.98531 -9.98531 -9.98594 -9.98625 -9.98594 + -9.98625 -9.98531 -9.98563 -9.98687 -9.98656 -9.98781 -9.98781 -9.98844 -9.98875 -9.98844 -9.98875 -9.98781 + -9.98812 -9.98938 -9.98906 -9.99031 -9.99031 -9.99094 -9.99125 -9.99094 -9.99125 -9.99031 -9.99063 -9.99187 + -9.99156 -9.99281 -9.99281 -9.99344 -9.99375 -9.99344 -9.99375 -9.99281 -9.99312 -9.99438 -9.99406 -9.99531 + -9.99531 -9.99594 -9.99625 -9.99594 -9.99625 -9.99531 -9.99563 -9.99688 -9.99656 -9.99781 -9.99844 -9.99687 + -9.99813 -9.99982 -9.99926 -9.99982 -9.99907 -9.99982 -9.99964 -9.99782 -9.99914 -9.9975 -9.99782 -9.99844 + -9.99939 -9.99814 -9.9988 -9.99983 -9.99964 -9.99965 -9.99965 -9.99876 -9.99907 -9.99965 -9.99879 -9.99845 + -9.99594 -9.99813 -9.995 -9.99594 -9.995 -9.99562 -9.99375 -9.99438 -9.9925 -9.99344 -9.9925 -9.99312 + -9.99125 -9.99187 -9.99 -9.99094 -9.99 -9.99063 -9.98875 -9.98938 -9.9875 -9.98844 -9.9875 -9.98812 + -9.98625 -9.98687 -9.985 -9.98594 -9.985 -9.98563 -9.98375 -9.98438 -9.98313 -9.98281 -9.9825 -9.9825 + -9.98121 -9.98156 -9.98156 -9.98065 -9.98124 -9.98018 -9.98074 -9.98093 -9.9809 -9.98086 -9.98036 -9.98018 + -9.98219 -9.98281 -9.98187 -9.9825 -9.98086 -9.98017 -9.99625 -9.9975 -9.99688 -9.99751 -9.99939 -9.99969 + -9.99929 -9.99847 -9.99438 -9.99344 -9.99187 -9.99094 -9.98938 -9.98844 -9.98687 -9.98594 -9.98438 -9.98344 + -9.98375 -9.9825 -9.98281 -9.98072 -9.98152 -9.98071 -9.98251 -9.98343 -9.98065 -9.98014 -9.98187 -9.9812 + -9.98374 -9.98406 -9.98469 -9.98313 -9.98656 -9.985 -9.98563 -9.98563 -9.985 -9.98656 -9.98719 -9.98563 + -9.98875 -9.9875 -9.98812 -9.98812 -9.98875 -9.98906 -9.98969 -9.98812 -9.99156 -9.99 -9.99063 -9.99063 + -9.99125 -9.99156 -9.99219 -9.99063 -9.99406 -9.9925 -9.99312 -9.99312 -9.99375 -9.99406 -9.99469 -9.99312 + -9.99657 -9.995 -9.99562 -9.99562 -9.99625 -9.9972 -9.99718 -9.99562 -9.99844 -9.99914 -9.99926 -9.99782 + -9.99848 -9.99911 -9.99935 -9.99986 -9.99928 -9.99911 -9.9987 -9.99857 -9.99806 -9.99748 -9.99594 -9.9983 + -9.99718 -9.99781 -9.99469 -9.99531 -9.99281 -9.99438 -9.99531 -9.99469 -9.99219 -9.99281 -9.98906 -9.99187 + -9.99281 -9.99219 -9.98969 -9.99031 -9.98781 -9.98938 -9.99031 -9.98969 -9.98719 -9.98781 -9.98625 -9.98687 + -9.98781 -9.98719 -9.98469 -9.98531 -9.98224 -9.98438 -9.98531 -9.98469 -9.98218 -9.98156 -9.98143 -9.98187 + -9.98219 -9.9813 -9.98034 -9.98061 -9.98153 -9.98143 -9.98093 -9.98072 -9.98343 -9.98309 -9.98469 -9.98531 + -9.98719 -9.98781 -9.98969 -9.99031 -9.99219 -9.99281 -9.99469 -9.99531 -9.9822 -9.9828 -9.98173 -9.98311 + -9.985 -9.985 -9.98185 -9.98282 -9.9825 -9.98406 -9.98374 -9.98375 -9.98354 -9.98344 -9.9875 -9.9875 + -9.98542 -9.98594 -9.98687 -9.98656 -9.98625 -9.98687 -9.98625 -9.98594 -9.99 -9.99 -9.98792 -9.98844 + -9.98844 -9.98906 -9.98875 -9.98875 -9.98833 -9.98844 -9.9925 -9.9925 -9.99042 -9.99094 -9.99083 -9.99156 + -9.99125 -9.99187 -9.99125 -9.99094 -9.995 -9.995 -9.99292 -9.99344 -9.99469 -9.99406 -9.99375 -9.99438 + -9.99375 -9.99344 -9.99604 -9.99594 -9.99687 -9.99656 -9.99625 -9.99626 -9.99751 -9.995 -9.99861 -9.9978 + -9.99827 -9.9972 -9.99808 -9.99877 -9.99828 -9.99877 -9.99787 -9.99871 -9.99689 -9.99718 -9.99626 -9.9971 + -9.99687 -9.99748 -9.99344 -9.99396 -9.99531 -9.99417 -9.99094 -9.99146 -9.99281 -9.99167 -9.98938 -9.98906 + -9.99031 -9.98938 -9.98594 -9.98646 -9.98781 -9.98667 -9.98438 -9.98406 -9.98531 -9.98438 -9.98191 -9.9813 + -9.98191 -9.98124 -9.98173 -9.98123 -9.98341 -9.98268 -9.98194 -9.98139 -9.98313 -9.98438 -9.98563 -9.98604 + -9.98812 -9.98812 -9.99063 -9.99063 -9.99312 -9.99312 -9.99562 -9.99531 -9.99858 -9.9981 -9.99659 -9.99753 + -9.99656 -9.99804 -9.99344 -9.9925 -9.99125 -9.99 -9.98854 -9.9875 -9.98563 -9.98417 -9.98396 -9.98277 + -9.98282 -9.98248 -9.98171 -9.98195 -9.985 -9.98479 -9.98406 -9.98344 -9.98531 -9.98469 -9.98594 -9.98625 + -9.9875 -9.98656 -9.98896 -9.98969 -9.99 -9.98938 -9.98906 -9.98844 -9.99031 -9.98969 -9.99219 -9.99094 + -9.9925 -9.99156 -9.99333 -9.99375 -9.995 -9.99406 -9.99594 -9.99594 -9.99542 -9.99562 -9.99775 -9.99768 + -9.99733 -9.99669 -9.99646 -9.99583 -9.99724 -9.99691 -9.99479 -9.99354 -9.99469 -9.99438 -9.99458 -9.99521 + -9.99406 -9.99438 -9.99229 -9.99104 -9.99219 -9.99187 -9.99208 -9.99271 -9.99156 -9.99187 -9.98958 -9.99021 + -9.98979 -9.98917 -9.98729 -9.98583 -9.98719 -9.98687 -9.98708 -9.98771 -9.98656 -9.98719 -9.98458 -9.98521 + -9.98406 -9.98469 -9.9829 -9.98331 -9.98233 -9.98252 -9.98218 -9.98185 -9.98215 -9.98221 -9.99816 -9.9978 + -9.99783 -9.99815 + </DataArray> + <DataArray type="Float32" Name="freeSurface" NumberOfComponents="1" format="ascii"> + -0.226055 -0.329927 -0.251078 -0.0920554 -0.162761 -0.148203 -0.151108 -0.165311 -0.164227 -0.17218 -0.161536 -0.164583 + -0.174567 -0.173441 -0.1821 -0.172982 -0.175572 -0.184718 -0.18348 -0.1928 -0.182763 -0.184971 -0.195596 -0.194257 + -0.202077 -0.190995 -0.192812 -0.202789 -0.202497 -0.199983 -0.197985 -0.199871 -0.197892 -0.199115 -0.185957 -0.0474962 + -0.195302 -0.0365133 -0.196538 -0.202511 -0.199348 -0.198656 -0.202043 -0.202105 -0.0774653 -0.0676287 -0.0256925 -0.191414 + -0.0748028 -0.200667 -0.195303 -0.203439 -0.193581 -0.187976 -0.198426 -0.185916 -0.179147 -0.186913 -0.176701 -0.168774 + -0.176243 -0.165917 -0.156488 -0.166688 -0.152823 -0.160359 -0.150652 -0.165744 0.124035 -0.0876461 -0.33484 -0.166361 + -0.246973 0.0530964 0.0174972 -0.0746566 -0.162465 -0.274274 -0.160735 -0.148327 -0.185373 0.0503039 -0.139073 -0.159216 + -0.160268 -0.149667 -0.161466 -0.149641 -0.150151 -0.154903 -0.164239 -0.167606 -0.167572 -0.169863 -0.171313 -0.162935 + -0.171092 -0.159807 -0.16232 -0.167498 -0.172578 -0.177019 -0.177398 -0.179531 -0.1814 -0.174158 -0.180883 -0.171518 + -0.173382 -0.178064 -0.182738 -0.187373 -0.187959 -0.190066 -0.192645 -0.183756 -0.191501 -0.181499 -0.182858 -0.18708 + -0.194107 -0.198441 -0.19785 -0.20061 -0.202356 -0.191801 -0.201386 -0.189936 -0.19074 -0.194551 -0.202743 -0.202716 + -0.19997 -0.20178 -0.201374 -0.198839 -0.20103 -0.197024 -0.197376 -0.201655 -0.20006 -0.192028 -0.174336 -0.199115 + -0.182838 -0.0379158 -0.100734 -0.0395067 -0.0867359 -0.0513289 -0.0304961 -0.204531 -0.166667 -0.203554 -0.207686 -0.19547 + -0.141356 -0.210902 -0.18112 -0.0315951 -0.0393478 -0.0426161 -0.189068 -0.180856 -0.078029 -0.036797 -0.163649 -0.15165 + -0.198121 -0.192606 -0.19625 -0.202074 -0.202844 -0.202367 -0.192464 -0.194117 -0.189087 -0.201437 -0.197048 -0.19955 + -0.184986 -0.187008 -0.18046 -0.191186 -0.186117 -0.18879 -0.175894 -0.178308 -0.170294 -0.18012 -0.175861 -0.178343 + -0.165251 -0.168064 -0.158332 -0.170215 -0.166583 -0.168811 -0.152856 -0.156053 -0.14781 -0.146898 -0.149679 -0.156345 + -0.167552 -0.132853 -0.167518 -0.239302 -0.172222 0.0201482 -0.157118 -0.215099 -0.0723187 -0.19666 0.103423 0.122921 + -0.152338 -0.159322 -0.162742 -0.159684 -0.206908 -0.168979 -0.199326 -0.201775 -0.202454 -0.211312 -0.126242 -0.0637195 + -0.0564808 -0.173342 -0.203269 -0.192087 -0.195596 -0.184348 -0.184124 -0.174997 -0.173746 -0.164139 -0.164537 -0.15444 + -0.157377 -0.148553 -0.156386 -0.0652173 -0.186103 -0.0344532 -0.151805 -0.161934 -0.247177 -0.336617 -0.157245 -0.18028 + -0.165665 -0.155333 -0.165506 -0.160407 -0.167314 -0.159255 -0.168562 -0.168961 -0.161825 -0.167001 -0.174817 -0.163763 + -0.176987 -0.170773 -0.178472 -0.178794 -0.18048 -0.177476 -0.185316 -0.174458 -0.186472 -0.18063 -0.188964 -0.189749 + -0.190494 -0.186449 -0.195686 -0.184002 -0.193415 -0.188924 -0.19829 -0.200722 -0.198088 -0.193752 -0.200762 -0.191933 + -0.200593 -0.19573 -0.198406 -0.202829 -0.190969 -0.204784 -0.186679 -0.1956 -0.139684 -0.151434 -0.111232 -0.182828 + -0.188632 -0.0579009 -0.205677 -0.0766827 -0.0804966 -0.0605186 -0.110261 -0.0835837 -0.134246 -0.165151 -0.195932 -0.115274 + -0.198578 -0.195461 -0.203326 -0.203128 -0.19248 -0.200226 -0.196756 -0.195317 -0.197016 -0.199462 -0.181269 -0.194016 + -0.190315 -0.188438 -0.185492 -0.188315 -0.174245 -0.183677 -0.182147 -0.179855 -0.175036 -0.177555 -0.170423 -0.173333 + -0.172425 -0.169758 -0.165834 -0.167943 -0.176983 -0.164732 -0.161165 -0.158118 -0.15662 -0.174863 -0.188919 -0.147673 + -0.148681 -0.188392 -0.328311 -0.265717 -0.176729 -0.185025 -0.132679 -0.0607206 -0.162247 -0.164545 -0.158863 -0.161694 + -0.170003 -0.172622 -0.179942 -0.182213 -0.188412 -0.190231 -0.194698 -0.195587 -0.145564 -0.158932 -0.200396 -0.164986 + -0.161075 -0.16641 -0.213317 -0.146116 -0.161374 -0.164408 -0.165837 -0.158835 -0.163855 -0.155616 -0.17186 -0.175884 + -0.165024 -0.169854 -0.172952 -0.172291 -0.170838 -0.16921 -0.166522 -0.164548 -0.181726 -0.186318 -0.175157 -0.180015 + -0.178623 -0.182674 -0.181044 -0.177509 -0.177834 -0.17516 -0.190161 -0.196353 -0.184997 -0.190583 -0.187672 -0.193181 + -0.191515 -0.188261 -0.186203 -0.1844 -0.195638 -0.199917 -0.193384 -0.199554 -0.197735 -0.200563 -0.199617 -0.19478 + -0.193505 -0.191911 -0.190712 -0.197996 -0.182273 -0.194524 -0.195322 -0.194836 -0.182718 -0.19531 -0.0854166 -0.170287 + -0.107395 -0.193999 -0.149776 -0.081203 -0.110342 -0.0855913 -0.141107 -0.117626 -0.19429 -0.170828 -0.191823 -0.166704 + -0.189178 -0.176476 -0.194089 -0.196226 -0.196332 -0.196789 -0.186452 -0.189838 -0.195432 -0.1906 -0.179384 -0.177594 + -0.186484 -0.17991 -0.16657 -0.170212 -0.176445 -0.171118 -0.158723 -0.156279 -0.166665 -0.159605 -0.171947 -0.193103 + -0.16666 -0.153965 -0.203883 -0.155935 -0.169307 -0.170431 -0.178433 -0.171322 -0.161975 -0.164354 -0.164475 -0.168537 + -0.178003 -0.175015 -0.188122 -0.184595 -0.196889 -0.192503 -0.195889 -0.195237 -0.0872835 -0.15941 -0.186343 -0.169163 + -0.18538 -0.126527 -0.196835 -0.190771 -0.186836 -0.182265 -0.178531 -0.172383 -0.168081 -0.163651 -0.162602 -0.173969 + -0.172367 -0.163291 -0.196097 -0.175437 -0.166042 -0.164311 -0.160624 -0.162581 -0.164016 -0.161801 -0.168567 -0.167125 + -0.175565 -0.169077 -0.180327 -0.183821 -0.185627 -0.183027 -0.179301 -0.176936 -0.184055 -0.181706 -0.193363 -0.188787 + -0.195115 -0.188686 -0.1954 -0.193923 -0.197967 -0.195191 -0.193152 -0.192624 -0.194392 -0.194406 -0.151681 -0.143839 + -0.165972 -0.181786 -0.183865 -0.191684 -0.174458 -0.185025 -0.196638 -0.194886 -0.19569 -0.19492 -0.196356 -0.195192 + -0.197674 -0.198572 -0.192764 -0.187452 -0.190619 -0.188875 -0.191908 -0.193913 -0.191015 -0.192876 -0.182754 -0.185306 + -0.183559 -0.181129 -0.173592 -0.167679 -0.171671 -0.169763 -0.172733 -0.175438 -0.171163 -0.173732 -0.163289 -0.165485 + -0.163864 -0.164574 -0.171621 -0.166368 -0.194632 -0.151736 -0.180512 -0.208841 -0.187526 -0.183151 -0.113483 -0.14862 + -0.150599 -0.116051 + </DataArray> + <DataArray type="Float32" Name="process rank" NumberOfComponents="1" format="ascii"> + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 + </DataArray> + <DataArray type="Float32" Name="exactWaterDepth" NumberOfComponents="1" format="ascii"> + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 + </DataArray> + <DataArray type="Float32" Name="exactVelocityX" NumberOfComponents="1" format="ascii"> + 0.801049 0.651231 2.77513 4.5661 0.852307 0.853429 1.64287 0.852913 1.64142 0.853004 1.64226 1.6422 + 0.853012 1.64215 0.853012 1.64216 1.64216 0.853012 1.64216 0.853012 1.64216 1.64216 0.853012 1.64216 + 0.853065 1.64216 1.64215 0.853141 1.64233 0.853854 1.64192 1.64025 0.852587 3.03163 0.804547 5.26079 + 1.64838 5.7435 4.62469 0.850615 1.66086 1.60884 0.651277 0.800744 2.77489 1.57521 3.71746 1.41079 + 5.74909 0.851169 0.852997 3.02941 0.853004 0.853012 3.02888 0.853012 0.853012 3.02887 0.853012 0.85302 + 3.02887 0.853027 0.853194 3.02866 0.853361 3.02099 1.66835 4.49442 6.03576 4.57147 1.57586 3.71711 + 2.77875 5.74286 5.25768 6.03314 3.02551 2.63097 0.857699 0.869565 1.60957 5.73862 5.20411 1.63856 + 0.851184 0.860814 1.63982 0.852337 3.03003 1.64265 3.62443 0.852967 4.62983 0.852989 3.02883 0.853042 + 1.64213 0.853088 3.02901 1.64218 3.6264 0.853012 4.62995 0.853012 3.02887 0.853012 1.64216 0.853012 + 3.02887 1.64216 3.62643 0.853012 4.62995 0.853012 3.02887 0.853012 1.64216 0.853012 3.02887 1.64216 + 3.62643 0.85302 4.62997 0.853035 3.02896 0.853012 1.64223 0.853012 3.02887 1.64214 3.62658 0.8533 + 4.63069 0.853604 3.03126 0.852784 1.64348 0.852982 3.02861 1.63825 3.63036 0.860177 0.874653 1.64255 + 1.66871 6.03593 4.50716 6.03439 5.20252 5.25738 6.13124 0.857228 3.50003 1.64384 3.63731 0.86908 + 2.63048 3.06083 3.09508 3.71463 5.73811 4.56551 0.651749 1.61751 5.22051 4.57236 3.11162 4.73067 + 3.62513 3.07823 1.64212 3.62849 1.64255 1.64297 3.02886 3.02884 1.64216 3.62649 1.64217 1.64219 + 3.02887 3.02887 1.64216 3.62643 1.64216 1.64216 3.02887 3.02887 1.64217 3.62643 1.64216 1.64216 + 3.02893 3.0289 1.6424 3.62636 1.64203 1.6421 3.03026 3.02962 1.64192 3.62386 1.64873 3.02399 + 3.1088 0.873623 4.75327 1.41097 1.61609 5.26033 4.50503 0.804036 6.03957 3.51218 6.13125 6.03454 + 4.61009 0.850934 1.66174 1.64457 3.50123 3.71486 3.02607 3.03184 3.02037 3.02267 2.63735 2.7786 + 6.13122 3.7575 3.0291 3.62642 3.02887 3.62643 3.02887 3.62643 3.02886 3.62652 3.02799 3.62866 + 5.03792 3.03064 3.61442 5.73873 3.73753 6.13123 5.02183 3.61951 1.40701 1.57474 3.0624 3.09647 + 5.65572 3.62771 4.62962 5.04339 4.62998 3.02921 5.03586 3.02878 5.65637 3.62647 4.62995 5.03601 + 5.03592 3.02888 5.03592 3.02887 5.65627 3.62643 4.62995 5.03592 4.62995 3.02887 5.03592 3.02887 + 5.65627 3.62643 4.62996 5.03592 4.62994 3.02887 5.03594 3.02891 5.65629 3.6264 4.63025 5.03592 + 3.61935 3.0288 5.03691 3.03009 5.6577 3.61323 4.63877 5.03574 4.75916 3.51444 4.49323 4.60833 + 3.73575 6.04043 1.40677 1.57478 5.73769 6.03237 5.29766 5.81664 5.57667 5.68858 4.62894 6.1308 + 3.62636 3.65399 3.6268 3.62732 5.87064 5.03606 3.62633 3.62638 3.62643 3.62645 5.87064 5.03592 + 3.62643 3.62643 3.62643 3.62643 5.87064 5.03592 3.62643 3.62643 3.62642 3.62643 5.65626 5.03591 + 3.62643 3.62645 3.62604 3.62628 5.84051 5.03553 3.62666 3.627 3.63903 4.73302 5.79468 3.07478 + 3.65025 5.29362 0.652468 2.63709 3.75257 5.81365 5.21799 5.74771 4.62479 5.65576 4.63042 4.63014 + 4.62997 4.62996 4.62995 4.62995 4.62995 4.62995 4.62991 4.62986 4.62397 4.61 5.86473 5.02232 + 5.03616 5.03577 6.05888 4.63475 4.9984 4.62859 5.03425 5.65726 6.11902 4.63285 5.03593 5.03592 + 6.11902 4.6299 5.65626 4.62993 5.0359 5.03594 5.03596 4.63003 5.03592 5.03592 6.11902 4.62995 + 5.87064 4.62995 5.03592 5.65627 6.11902 4.62995 5.03592 5.03593 6.11902 4.62995 6.11902 4.62995 + 5.03592 5.03592 5.03592 4.62995 5.03586 5.03629 6.11902 4.63 5.87067 4.63007 5.03597 5.0359 + 5.03591 4.62995 6.11902 4.63181 5.66223 4.63452 5.03886 5.03443 4.9965 5.65624 6.13108 4.63524 + 5.8675 4.60821 5.07624 6.04981 5.83912 6.03763 6.03634 5.27223 5.02122 5.89928 5.65576 6.12306 + 5.04643 5.03152 5.87064 6.11902 5.87073 6.11902 5.87064 6.11902 5.87064 6.11902 5.03592 4.62995 + 5.87064 5.65627 5.87065 6.11902 5.87064 6.11902 5.03657 4.63115 5.87063 5.65656 5.04592 5.27442 + 5.0653 6.04861 5.84181 6.03878 5.87512 6.10914 5.57947 6.13114 5.66065 5.65611 5.6563 6.11902 + 5.65627 5.65627 5.65627 5.65627 5.65627 5.65627 5.6567 5.87063 5.79254 5.04376 5.87562 5.60297 + 5.87146 5.61076 5.87065 5.65627 5.65627 5.65627 6.11902 5.65627 5.65624 6.11902 6.11902 5.85115 + 5.89722 5.6075 6.13094 5.60346 5.6562 6.11902 5.8708 5.87122 5.87066 5.8707 5.87064 5.65628 + 5.65627 5.87065 6.11902 5.87064 5.65627 5.65627 5.87064 5.87064 5.87064 5.87064 5.87064 5.87064 + 5.65627 5.87064 6.11902 5.65626 5.65642 5.87064 5.87088 5.87059 6.11902 5.65617 5.846 6.12793 + 6.10819 6.12014 6.11902 6.11902 5.84864 5.65585 6.11902 6.11902 5.87064 5.65626 6.11902 6.11902 + 5.87066 5.65632 6.11902 6.11902 5.87064 5.65627 6.11902 6.11902 5.87064 5.65627 6.11902 6.11902 + 6.11902 6.11902 6.11902 6.11902 5.87064 5.65627 6.11902 6.11902 5.87064 5.87064 6.11902 6.11902 + 5.87056 5.87061 6.12293 6.12004 6.12852 5.68135 6.07732 6.07692 6.03956 5.77873 6.05686 5.77422 + 6.07899 6.07846 + </DataArray> + <DataArray type="Float32" Name="exactVelocityY" NumberOfComponents="1" format="ascii"> + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 + </DataArray> + </CellData> + <Points> + <DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii"> + 12.5 50 0 18.3013 39.8584 0 25 50 0 0 50 0 + 8.1884 41.8103 0 0 37.5 0 10.1027 31.6674 0 0 25 0 + 10.955 19.1195 0 81.2255 39.1843 0 87.5 50 0 75 50 0 + 68.7694 -39.1695 0 62.5 -50 0 75 -50 0 81.2612 -39.1704 0 + 93.7496 39.1763 0 100 50 0 131.25 39.1751 0 137.5 50 0 + 125 50 0 106.252 -39.174 0 112.5 -50 0 118.751 -39.1746 0 + 131.25 -39.1748 0 125 -50 0 143.75 39.175 0 150 50 0 + 181.25 39.175 0 187.5 50 0 175 50 0 156.25 -39.175 0 + 162.5 -50 0 168.75 -39.175 0 181.25 -39.175 0 175 -50 0 + 193.75 39.175 0 200 50 0 231.25 39.175 0 237.5 50 0 + 225 50 0 206.25 -39.175 0 212.5 -50 0 218.75 -39.175 0 + 231.25 -39.175 0 225 -50 0 243.75 39.175 0 250 50 0 + 281.249 39.1743 0 287.5 50 0 275 50 0 256.25 -39.175 0 + 262.5 -50 0 268.75 -39.175 0 281.25 -39.1751 0 275 -50 0 + 293.748 39.1733 0 300 50 0 331.23 39.1639 0 337.5 50 0 + 325 50 0 306.25 -39.1754 0 312.5 -50 0 318.755 -39.178 0 + 331.322 -39.1993 0 325 -50 0 343.742 39.1806 0 350 50 0 + 337.43 28.3079 0 381.679 39.8125 0 387.5 50 0 375 50 0 + 400 12.5 0 400 25 0 389.029 19.0187 0 356.28 39.0805 0 + 389.232 6.203 0 331.632 -17.5439 0 325.093 -28.3708 0 337.732 -28.4402 0 + 343.853 -39.2066 0 337.5 -50 0 350 -50 0 362.5 -50 0 + 369.193 -38.963 0 356.396 -39.1194 0 381.72 -39.8624 0 375 -50 0 + 387.5 -50 0 400 -50 0 391.822 -41.8097 0 400 -37.5 0 + 389.916 -31.6719 0 391.805 41.8036 0 400 37.5 0 400 50 0 + 389.881 31.6167 0 378.285 12.2273 0 293.75 -39.1752 0 287.5 -50 0 + 300 -50 0 299.995 28.3461 0 306.245 39.1712 0 243.75 -39.175 0 + 237.5 -50 0 250 -50 0 250 28.3499 0 256.25 39.1749 0 + 193.75 -39.175 0 187.5 -50 0 200 -50 0 200 28.35 0 + 206.25 39.175 0 143.75 -39.1749 0 137.5 -50 0 150 -50 0 + 150 28.35 0 156.25 39.175 0 93.7551 -39.1726 0 87.5 -50 0 + 100 -50 0 99.9992 28.3516 0 106.25 39.1756 0 62.319 28.4338 0 + 68.687 39.1991 0 56.1822 39.2024 0 30.8768 -38.903 0 37.5 -50 0 + 43.7066 -39.0721 0 23.1716 26.716 0 10.7792 -6.2195 0 0 0 0 + 0 -12.5 0 10.9712 -19.0335 0 0 -25 0 10.1142 -31.6235 0 + 8.1858 -41.7943 0 0 -37.5 0 0 -50 0 0 12.5 0 + 21.6843 12.4943 0 10.7716 6.3392 0 21.2113 0.1408 0 74.8951 28.3743 0 + 43.6513 39.1132 0 50 50 0 37.5 50 0 30.8449 38.9566 0 + 62.5 50 0 50 -50 0 56.2586 -39.1839 0 62.5665 -28.3266 0 + 87.497 28.3545 0 112.5 50 0 106.25 17.5258 0 112.5 28.3506 0 + 118.75 39.1753 0 125 28.3503 0 112.502 -28.349 0 137.5 28.3501 0 + 162.5 50 0 156.25 17.525 0 162.5 28.35 0 168.75 39.175 0 + 175 28.35 0 162.5 -28.35 0 187.5 28.35 0 212.5 50 0 + 206.25 17.525 0 212.5 28.35 0 218.75 39.175 0 225 28.35 0 + 212.5 -28.35 0 237.5 28.35 0 262.5 50 0 256.25 17.5249 0 + 262.5 28.3497 0 268.75 39.1747 0 274.999 28.3494 0 262.5 -28.35 0 + 287.498 28.3484 0 312.5 50 0 306.243 17.5201 0 312.487 28.3405 0 + 318.738 39.1672 0 324.968 28.3278 0 312.5 -28.351 0 362.5 50 0 + 369.112 38.8894 0 400 0 0 376.775 26.5655 0 389.251 -6.3536 0 + 400 -12.5 0 376.885 -26.7299 0 389.072 -19.1293 0 378.377 -12.5205 0 + 400 -25 0 362.66 -28.0665 0 350.17 -28.4805 0 367.257 -16.8956 0 + 362.439 27.8779 0 275 -28.3501 0 287.5 -28.3502 0 225 -28.35 0 + 237.5 -28.35 0 175 -28.35 0 187.5 -28.35 0 125.001 -28.3496 0 + 137.5 -28.3498 0 75.0301 -28.3361 0 87.5124 -28.344 0 50.0781 -28.4135 0 + 49.936 28.4683 0 23.2131 -26.5943 0 18.315 -39.8192 0 25 -50 0 + 32.9672 -16.5845 0 37.5263 -27.9324 0 12.5 -50 0 21.721 -12.2637 0 + 37.4449 28.052 0 44.1972 18.194 0 349.924 28.3877 0 378.828 -0.1747 0 + 68.8038 -17.4907 0 81.2671 -17.5154 0 44.3158 -18.0269 0 56.4592 -17.3662 0 + 75 6.7 0 81.2499 17.5298 0 68.3923 17.5443 0 93.7493 17.527 0 + 131.25 -17.5248 0 100.005 -28.3475 0 118.75 17.5253 0 100 -6.7 0 + 93.7562 -17.5218 0 106.252 -17.5238 0 143.75 17.525 0 118.751 -17.5245 0 + 168.75 -17.525 0 181.25 -17.525 0 150 -28.3499 0 168.75 17.525 0 + 175 6.7 0 181.25 17.525 0 193.75 17.525 0 156.25 -17.525 0 + 231.25 -17.525 0 200 -28.35 0 218.75 17.525 0 225 6.7 0 + 231.25 17.525 0 243.75 17.525 0 206.25 -17.525 0 218.75 -17.525 0 + 281.25 -17.5251 0 250 -28.35 0 268.75 17.5247 0 275 6.7 0 + 281.249 17.5243 0 293.747 17.5232 0 256.25 -17.525 0 268.75 -17.525 0 + 300 -28.3505 0 318.732 17.5108 0 325 6.7 0 331.193 17.4762 0 + 343.525 17.311 0 306.25 -17.5258 0 318.75 -17.5283 0 366.999 16.5157 0 + 356.058 -18.2105 0 368.849 5.2354 0 360.59 -10.0065 0 349.56 5.1655 0 + 355.543 17.8285 0 368.97 -5.8397 0 359.916 -0.6763 0 250 -6.7 0 + 262.5 -6.7 0 187.5 6.7 0 150 -6.7 0 162.5 -6.7 0 + 125 6.7 0 131.25 17.5251 0 39.843 -9.398 0 50.4908 -5.2393 0 + 32.8684 16.8639 0 31.1277 5.7863 0 31.184 -5.2915 0 55.8215 17.8144 0 + 61.0683 6.4137 0 143.75 -17.5249 0 193.75 -17.525 0 243.75 -17.525 0 + 293.75 -17.5253 0 40.2337 0.5698 0 39.5844 9.9408 0 75 -6.7 0 + 62.5 -6.7 0 112.5 -6.7 0 112.5 6.7 0 137.5 6.7 0 + 162.5 6.7 0 175 -6.7 0 200 -6.7 0 212.5 -6.7 0 + 212.5 6.7 0 262.5 6.7 0 300 6.7 0 287.5 6.7 0 + 325 -6.7 0 312.5 6.7 0 337.5 6.7 0 344.322 -17.8399 0 + 300 -6.7 0 360.1 9.3599 0 351.44 -7.9798 0 338.896 -6.3845 0 + 275 -6.7 0 287.5 -6.7 0 225 -6.7 0 237.5 -6.7 0 + 250 6.7 0 237.5 6.7 0 200 6.7 0 187.5 -6.7 0 + 125 -6.7 0 137.5 -6.7 0 150 6.7 0 100 6.7 0 + 87.5 -6.7 0 49.0159 7.8325 0 87.5 6.7 0 312.5 -6.7 0 + </DataArray> + </Points> + <Cells> + <DataArray type="Int32" Name="connectivity" NumberOfComponents="1" format="ascii"> + 0 1 2 0 3 4 4 5 6 6 7 8 + 9 10 11 12 13 14 15 12 14 10 16 17 + 16 10 9 18 19 20 21 22 23 24 23 25 + 19 26 27 26 19 18 28 29 30 31 32 33 + 34 33 35 29 36 37 36 29 28 38 39 40 + 41 42 43 44 43 45 39 46 47 46 39 38 + 48 49 50 51 52 53 54 53 55 49 56 57 + 56 49 48 58 59 60 61 62 63 64 63 65 + 59 66 67 68 66 58 69 70 71 72 73 74 + 75 67 66 76 72 74 77 78 79 80 81 82 + 83 84 85 86 84 87 88 89 90 86 87 88 + 90 91 92 93 94 95 96 73 94 93 70 69 + 76 74 97 81 64 65 98 99 100 101 102 56 + 99 54 55 103 104 105 106 107 46 104 44 45 + 108 109 110 111 112 36 109 34 35 113 114 115 + 116 117 26 114 24 25 118 119 120 121 122 16 + 119 15 14 123 124 125 126 127 128 129 6 8 + 130 131 132 133 134 135 136 137 138 135 134 137 + 136 135 137 130 132 133 139 8 7 140 141 142 + 143 9 124 6 1 4 144 145 146 147 146 2 + 147 2 1 8 139 141 129 8 140 124 148 125 + 124 11 148 127 149 128 9 11 124 150 149 13 + 151 150 12 15 119 118 9 143 152 122 153 17 + 154 155 121 156 20 153 157 18 156 23 22 25 + 18 20 156 21 120 22 158 21 23 24 114 113 + 18 157 159 117 160 27 161 162 116 163 30 160 + 164 28 163 33 32 35 28 30 163 31 115 32 + 165 31 33 34 109 108 28 164 166 112 167 37 + 168 169 111 170 40 167 171 38 170 43 42 45 + 38 40 170 41 110 42 172 41 43 44 104 103 + 38 171 173 107 174 47 175 176 106 177 50 174 + 178 48 177 53 52 55 48 50 177 51 105 52 + 179 51 53 54 99 98 48 178 180 102 181 57 + 182 183 101 184 60 181 185 58 184 63 62 65 + 58 60 184 61 100 62 186 61 63 64 81 80 + 58 185 68 75 187 67 188 71 187 66 59 58 + 75 188 187 76 189 72 96 190 74 191 192 189 + 193 194 195 194 196 192 191 189 76 85 82 83 + 193 86 92 80 82 85 197 198 85 84 83 87 + 86 90 92 197 85 84 193 84 86 92 91 196 + 194 192 191 194 92 196 93 95 70 69 71 188 + 190 97 74 96 74 73 190 69 188 193 199 197 + 186 63 78 200 188 75 98 100 61 185 184 183 + 102 57 56 102 184 181 201 53 54 202 54 98 + 103 105 51 178 177 176 107 47 46 107 177 174 + 203 43 44 204 44 103 108 110 41 171 170 169 + 112 37 36 112 170 167 205 33 34 206 34 108 + 113 115 31 164 163 162 117 27 26 117 163 160 + 207 23 24 208 24 113 118 120 21 157 156 155 + 122 17 16 122 156 153 209 12 15 210 15 118 + 150 13 12 211 150 151 128 149 150 212 125 144 + 213 214 126 126 215 127 216 213 217 136 218 214 + 214 215 126 133 132 134 213 133 135 214 218 215 + 219 142 130 135 214 213 141 131 130 141 139 131 + 212 220 221 125 148 145 144 146 147 144 125 145 + 6 129 1 6 5 7 78 63 64 222 75 66 + 79 64 80 198 80 85 93 69 96 93 96 94 + 223 191 76 190 188 200 180 56 48 179 53 201 + 173 46 38 172 43 203 166 36 28 165 33 205 + 159 26 18 158 23 207 152 16 9 151 12 209 + 224 209 225 211 128 150 123 125 212 140 8 141 + 220 147 129 142 141 130 226 211 227 143 124 123 + 4 1 0 4 3 5 220 144 147 129 147 1 + 228 229 230 209 15 210 231 121 152 227 151 224 + 232 207 208 233 118 21 234 155 154 155 156 122 + 235 236 237 207 24 208 238 116 159 237 158 239 + 240 205 241 242 113 31 243 162 161 162 163 117 + 244 245 243 205 34 206 246 111 166 247 165 240 + 248 203 204 249 108 41 250 169 168 169 170 112 + 251 252 250 203 44 204 253 106 173 254 172 255 + 256 201 202 257 103 51 258 176 175 176 177 107 + 259 260 258 201 54 202 261 101 180 262 179 263 + 79 78 64 264 98 61 265 183 182 183 184 102 + 266 267 265 79 80 198 268 222 68 269 186 270 + 271 190 200 190 96 69 193 92 194 272 198 197 + 197 84 193 223 76 97 90 86 88 90 89 91 + 195 194 191 223 195 191 271 97 190 273 97 271 + 272 199 274 275 276 268 270 186 78 277 273 278 + 222 66 68 222 200 75 101 56 180 101 183 102 + 279 262 280 261 180 260 264 61 186 264 202 98 + 106 46 173 106 176 107 281 245 244 253 173 252 + 257 51 179 257 204 103 111 36 166 111 169 112 + 282 247 283 246 166 245 249 41 172 249 206 108 + 116 26 159 116 162 117 284 285 234 238 159 285 + 242 31 165 242 208 113 121 16 152 121 155 122 + 286 226 287 231 152 229 233 21 158 233 210 118 + 212 144 220 220 129 288 288 140 289 217 126 128 + 217 128 211 219 213 216 136 138 218 136 214 135 + 213 126 217 216 290 219 219 133 213 219 130 133 + 230 143 123 230 291 292 236 210 233 237 233 158 + 293 208 242 247 242 165 294 206 249 254 249 172 + 295 204 257 262 257 179 296 202 264 269 264 186 + 226 217 211 291 123 212 290 216 286 230 123 291 + 236 233 237 231 154 121 289 297 298 227 211 151 + 291 212 221 229 152 143 229 143 230 225 299 224 + 299 228 300 224 151 209 293 242 247 238 161 116 + 235 301 302 234 157 155 303 238 285 285 159 157 + 285 157 234 232 208 293 232 239 207 239 158 207 + 294 249 254 246 168 111 282 283 304 243 164 162 + 244 243 304 245 166 164 245 164 243 241 305 240 + 305 304 283 240 165 205 295 257 262 253 175 106 + 306 307 308 250 171 169 251 308 307 252 173 171 + 252 171 250 248 204 295 248 255 203 255 172 203 + 296 264 269 261 182 101 279 280 309 258 178 176 + 310 261 311 260 180 178 260 178 258 256 202 296 + 256 263 201 263 179 201 312 266 313 265 185 183 + 314 268 267 267 68 185 267 185 265 270 78 77 + 315 198 272 316 296 269 277 223 273 276 200 222 + 273 271 317 315 79 198 271 200 276 273 223 97 + 274 199 277 277 195 223 278 318 274 199 193 195 + 77 79 315 268 314 275 312 270 77 319 275 314 + 268 68 267 268 276 222 320 280 263 321 259 320 + 310 313 182 311 259 321 322 307 255 323 251 322 + 324 309 175 325 251 323 241 206 294 241 205 206 + 326 308 168 327 241 294 328 301 239 329 284 328 + 330 304 161 303 284 329 225 210 236 225 209 210 + 331 302 154 332 225 236 288 221 220 288 129 140 + 216 217 226 290 142 219 298 288 289 289 140 142 + 292 228 230 287 292 333 298 221 288 289 142 290 + 300 227 224 334 231 229 301 237 239 328 284 302 + 304 243 161 283 247 240 308 250 168 307 254 255 + 309 258 175 280 262 263 313 265 182 316 269 335 + 199 195 277 199 272 197 312 77 319 318 315 272 + 314 267 266 317 271 276 259 258 309 279 295 262 + 322 255 248 306 294 254 305 244 304 282 293 247 + 302 234 154 334 228 332 299 332 228 292 291 333 + 287 227 300 333 291 221 297 289 290 286 216 226 + 331 154 231 334 235 331 299 225 332 299 300 224 + 235 237 301 235 332 236 284 234 302 328 239 232 + 330 161 238 328 232 329 305 327 244 326 246 281 + 326 168 246 281 246 245 305 241 327 305 283 240 + 306 254 307 306 327 294 324 253 325 251 250 308 + 324 175 253 322 248 323 259 309 280 320 263 256 + 310 182 261 320 256 321 266 265 313 335 270 312 + 335 313 316 335 269 270 317 276 275 278 275 318 + 319 318 275 319 314 312 312 314 266 312 313 335 + 319 315 318 319 77 315 311 316 310 320 259 280 + 321 296 316 321 256 296 311 321 316 310 316 313 + 311 260 259 311 261 260 325 279 324 322 251 307 + 323 295 279 323 248 295 325 323 279 324 279 309 + 325 252 251 325 253 252 281 327 306 326 306 308 + 281 306 326 281 244 327 303 282 330 328 302 301 + 329 293 282 329 232 293 303 329 282 330 282 304 + 303 285 284 303 330 238 334 332 235 331 235 302 + 334 229 228 334 331 231 292 287 300 292 300 228 + 287 333 297 287 226 227 286 287 297 286 297 290 + 298 297 333 298 333 221 274 277 278 274 318 272 + 317 275 278 317 278 273 + </DataArray> + <DataArray type="Int32" Name="offsets" NumberOfComponents="1" format="ascii"> + 3 6 9 12 15 18 21 24 27 30 33 36 + 39 42 45 48 51 54 57 60 63 66 69 72 + 75 78 81 84 87 90 93 96 99 102 105 108 + 111 114 117 120 123 126 129 132 135 138 141 144 + 147 150 153 156 159 162 165 168 171 174 177 180 + 183 186 189 192 195 198 201 204 207 210 213 216 + 219 222 225 228 231 234 237 240 243 246 249 252 + 255 258 261 264 267 270 273 276 279 282 285 288 + 291 294 297 300 303 306 309 312 315 318 321 324 + 327 330 333 336 339 342 345 348 351 354 357 360 + 363 366 369 372 375 378 381 384 387 390 393 396 + 399 402 405 408 411 414 417 420 423 426 429 432 + 435 438 441 444 447 450 453 456 459 462 465 468 + 471 474 477 480 483 486 489 492 495 498 501 504 + 507 510 513 516 519 522 525 528 531 534 537 540 + 543 546 549 552 555 558 561 564 567 570 573 576 + 579 582 585 588 591 594 597 600 603 606 609 612 + 615 618 621 624 627 630 633 636 639 642 645 648 + 651 654 657 660 663 666 669 672 675 678 681 684 + 687 690 693 696 699 702 705 708 711 714 717 720 + 723 726 729 732 735 738 741 744 747 750 753 756 + 759 762 765 768 771 774 777 780 783 786 789 792 + 795 798 801 804 807 810 813 816 819 822 825 828 + 831 834 837 840 843 846 849 852 855 858 861 864 + 867 870 873 876 879 882 885 888 891 894 897 900 + 903 906 909 912 915 918 921 924 927 930 933 936 + 939 942 945 948 951 954 957 960 963 966 969 972 + 975 978 981 984 987 990 993 996 999 1002 1005 1008 + 1011 1014 1017 1020 1023 1026 1029 1032 1035 1038 1041 1044 + 1047 1050 1053 1056 1059 1062 1065 1068 1071 1074 1077 1080 + 1083 1086 1089 1092 1095 1098 1101 1104 1107 1110 1113 1116 + 1119 1122 1125 1128 1131 1134 1137 1140 1143 1146 1149 1152 + 1155 1158 1161 1164 1167 1170 1173 1176 1179 1182 1185 1188 + 1191 1194 1197 1200 1203 1206 1209 1212 1215 1218 1221 1224 + 1227 1230 1233 1236 1239 1242 1245 1248 1251 1254 1257 1260 + 1263 1266 1269 1272 1275 1278 1281 1284 1287 1290 1293 1296 + 1299 1302 1305 1308 1311 1314 1317 1320 1323 1326 1329 1332 + 1335 1338 1341 1344 1347 1350 1353 1356 1359 1362 1365 1368 + 1371 1374 1377 1380 1383 1386 1389 1392 1395 1398 1401 1404 + 1407 1410 1413 1416 1419 1422 1425 1428 1431 1434 1437 1440 + 1443 1446 1449 1452 1455 1458 1461 1464 1467 1470 1473 1476 + 1479 1482 1485 1488 1491 1494 1497 1500 1503 1506 1509 1512 + 1515 1518 1521 1524 1527 1530 1533 1536 1539 1542 1545 1548 + 1551 1554 1557 1560 1563 1566 1569 1572 1575 1578 1581 1584 + 1587 1590 1593 1596 1599 1602 1605 1608 1611 1614 1617 1620 + 1623 1626 1629 1632 1635 1638 1641 1644 1647 1650 1653 1656 + 1659 1662 1665 1668 1671 1674 1677 1680 1683 1686 1689 1692 + 1695 1698 1701 1704 1707 1710 1713 1716 1719 1722 1725 1728 + 1731 1734 1737 1740 1743 1746 1749 1752 1755 1758 1761 1764 + 1767 1770 + </DataArray> + <DataArray type="UInt8" Name="types" NumberOfComponents="1" format="ascii"> + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 + </DataArray> + </Cells> + </Piece> + </UnstructuredGrid> +</VTKFile>