read.swms2d.table {SoPhy}R Documentation

Standard SWMS2D input files

Description

This function reads in the standard SWMS2D input files

Usage

read.swms2d.table(path, selct.in = "SELECTOR.IN", 
                  grid.in = "GRID.IN", atm.in = "ATMOSPH.IN")

Arguments

path directory of the input files
selct.in file name for general input data, see the manuscript of SWMS2D
grid.in file name for information about the finite elements
atm.in file name for atmospheric data

Value

the function returns a list of the following components; see the SWMS2D manual for details

Units c(LUnits, TUnits, MUnits, BUnits), units of length, time, mass.
Kat type of flow system; 0:horizontal, 1:axisymmetric; 2:vertical.
MaxIt maximum number of iteration during any time step.
TolTh maximum desired change of water content.
TolH maximum desired change of pressure head.
lWat logical. If TRUE transient water flow else steady state.
FreeD logicl. TRUE if free drainage at the bottom.
NLay Number of subregions for water balances.
hTab c(hTab1, hTabN), interval of pressure heads within which a table of hydraulic properties is generated.
Par vector of 9 elements or matrix of 9 columns, each row representing a different kind of material.
dt initial time increment.
dtMinMax c(dtmin, dtmax), minimum and maximum permitted time increment.
DMul c(dMul, dMul2), dMul >= 1, dMul2 <= 1; if the number of required iterations is less than 4 or greater than 6 then the next time step is multiplied by dMul and dMul2, respectively.
TPrint vector of increasing print-times.
NP matrix of one or two rows and arbitrary columns; seepage information: each row defines a seepage face, the columns give the node numbers (or are NA).
DrCorr reduction factor for drainage; see the SWMS2d manual
ND vector of up to two elements given the global node number of the drain.
EfDim (length{ND} x 2)-matrix drain information: first column gives the effective diameter; second column gives the dimension of the square in the finite element mesh.
KElDr matrix of length(ND) rows and arbitrary colums; drainage information: each row defines the surrounding finite elements of the drain; values are either the global finite element numbers or NA.
Epsi temporal weighing coefficient: 0: explicit scheme, 0.5:Crank-Nicholson, 1:fully implicit.
lUpW logical. Upstream weighing formalation used if TRUE else Galkerin formulation.
lArtD logical. TRUE if artificial dispersion is to be added to fulfill the stability criterion PeCr.
PeCr Stability criterion, see the SWMS2d manual; zero if lUpW=TRUE.
ChPar vector of 9 element if Par is a vector; other wise (nrow(Par) x 9)-matrix; chemical material properties: bulk density, ionic diffusion coeffcient in free water, longitudinal dispersivity, transverse dispersivity, Freundlich isotherm coefficient, first-order rate constant for dissolved phase, first-order rate constant for solid phase, zero-order rate constant for dissolved phase, zero-order rate constant for solid phase.
KodCB vector of sum(nCodeM[,2]!=0) elements, defining the chemical boundary conditions, see the SWMS2d manual.
cBound vector of six elements: jth element gives the concentration for boundary nodes i with chemical boundary condition abs(KodCB[i])==j.
tPuls time duration of the concentration pulse.
nCodeM matrix of 12 columns and arbitrary number of rows; nCodeM gives the nodal information; the 12 columns contain: (1) nodal number, (2) code giving the boundary condition (see the SWMS2D manual), (3) x-coordinate, (4) z-coordinate, (5) initial pressure head, (6) initial concentration, (7) prescribed recharge or discharge rate, (8) material number, (9) water uptake distribution value, (10) pressure head scaling factor, (11) conductivity scaling factor, (12) water content scaling factor.
KXR matrix of 8 columns and arbitrary rows; gives the finite element information; (1)-(4) give the nodes in counter-clockwise order (last node is repeated if element is a triangle); (5)-(7) give the anisotropy parameters of the conductivity tensor (angle, first and second principal component), (8) subregion number.
Width vector of sum(nCodeM[,2]!=0) elements; width of the boundary associated with the boundary nodes (in the order given by nCodeM).
rLen width of soil surface associated with transpiration.
Node vector of observation nodes for which information is collected at each time level.
SinkF logical; water extraction from the root zone if TRUE.
qGWLF logical; If TRUE then the discharge-groundwater level relationship is used, see the SWMS2d manual.
GWL0L reference position of groundwater table (usually the z-coordinate of the soil surface).
Aqh parameter in the discharge-groundwater level relationship.
Bqh second parameter in the discharge-groundwater level relationship.
tInit starting time of the simulation.
hCritS maximum allowed pressure head at soil surface.
atmosphere matrix of 10 columns and arbitrary rows; each row presents the atmospherical conditions at a certain instance; the columns are (1) the instance at which the time period ends (2) precipitation, (3) solute concentration of rainfall water, (4) potential evaporation rate, (5) potential transpiration rate, (6) absolute value of minimum allowed pressure head at the soil surface, (7) drainage flux across the bottom boundary (for abs(nCodeM[,2])==3), (8) ground water level, (9) concentration of drainage flux (for (abs(nCodeM[,2])==3) & (KodCB<0)) (10) concentration of drainage flux (for (abs(nCodeM[,2])==3) & (KodCB>0)).
root c(P0, P2H, P2L, P3, r2H, r2L) information about water uptake by roots, see the SWMS2D manual.
POptm scalar if Par is a vector, a vector of nrow{Par} elements otherwise; pressure heads, below which roots start to extract water at maximum possible rate.
path the input parameter.
selct.in the input parameter.
grid.in the input parameter.
atm.in the input parameter.

Author(s)

Martin Schlather, martin.schlather@math.uni-goettingen.de http://www.stochastik.math.uni-goettingen.de/institute

References

See Also

swms2d

Examples

##################################################################
##  SWMS2D, Example 1
##################################################################

path <- paste(system.file(package='SoPhy'), 'swms2d', sep="/")
x <- read.swms2d.table(path)
x$TPrint <- seq(10, 5400, 10)
par(cex=1, mar=c(4.2,4,0.2,0.2))

z <- swms2d(x)$hQ[3, , ]
i <- ((length(x$nCodeM$z) / 2):1) * 2 - 1
image(x=c(0, x$TPrint) / 60, y=x$nCodeM$z[i] - max(x$nCodeM$z),
      z=t(z[i, ]), xlab='time [min]', ylab='z [cm]',
      col=grey(seq(1, 0.15, -0.01)), cex.lab=1.5, cex.axis=1.5)

my.legend(0, -max(x$nC$z[i]), zlim=range(z), y.i=0.02,
          col=grey(seq(1,0.15,-0.01)), cex=1.5)

[Package SoPhy version 1.0.34 Index]