Procedure | Location | Procedure Type | Description |
---|---|---|---|
AccGrowingDegreeDay | PlantsPhenology | Subroutine | compute accumulated growing degree day (GDD), sum of growing degree day over days. Start accumulate when daily GDD > 0 |
ActualObservations | ObservationalNetworks | Subroutine | count number of observations different from missing data Can optionally return network containing actual measurements. |
AddDays | Chronos | Function | Adds the specified number of days to the value of this instance. |
AddHours | Chronos | Function | Adds the specified number of hours to the value of this instance. |
AddMinutes | Chronos | Function | Adds the specified number of minutes to the value of this instance. |
AddSeconds | Chronos | Function | Adds the specified number of seconds to the value of this instance. If number of seconds is a negative number, the amount is subtracted |
adjustl | iso_varying_string | Interface | |
adjustl_ | iso_varying_string | Function | Adjust the varying string to the left |
AdjustPT | PlantsInterception | Subroutine | Subroutine to adjust the actual evaporation to the intercepted rainfall. The amount of water intercepted by the canopy is going to contribute to the evaporation rate. When calculating the evaporation within a forest, the model tends to remove as much as possible from the water intercepted by the canopy. This step will be carried out before the adjustement of the evapotranspiration to soil moisture. |
adjustr | iso_varying_string | Interface | |
adjustr_ | iso_varying_string | Function | Adjust the varying string to the right |
AGEmod | PlantsModifiers | Function | compute the age modifier. It modulates the maximum potential growth during the different stages of the vegetation life cycle as trees in the early stages are not as vigorous as mature trees |
AirRelativeHumidityInit | AirRelativeHumidity | Subroutine | Initialize air relative humidity |
AirRelativeHumidityRead | AirRelativeHumidity | Subroutine | Read air relative humidity data |
AirTemperatureDailyMaxInit | AirTemperatureDailyMax | Subroutine | Initialize air temperature |
AirTemperatureDailyMaxRead | AirTemperatureDailyMax | Subroutine | Read air temperature data |
AirTemperatureDailyMeanInit | AirTemperatureDailyMean | Subroutine | Initialize air temperature |
AirTemperatureDailyMeanRead | AirTemperatureDailyMean | Subroutine | Read air temperature data |
AirTemperatureDailyMinInit | AirTemperatureDailyMin | Subroutine | Initialize air temperature |
AirTemperatureDailyMinRead | AirTemperatureDailyMin | Subroutine | Read air temperature data |
AirTemperatureInit | AirTemperature | Subroutine | |
AirTemperatureRead | AirTemperature | Subroutine | |
AparCalc | Plants | Function | Computes the absorbed photosynthetically active radiation. The amount of light available for the plant that is going to define its growth rate. The light that the plant could absorb is determined according to the canopy cover. The amount of absorbed photosynthetically active radiation is usually computed following Lambert-Beer law . |
ApplyPlantsManagement | PlantsManagement | Subroutine | Set variables and options to manage plants. Basically two options are available: |
AssignDataFromGrid | ObservationalNetworks | Interface | |
AssignDataFromGridReal | ObservationalNetworks | Subroutine | assign data to a network from grid_real |
AssignGridInteger | GridOperations | Subroutine | assign value of mask integer to mat integer |
AssignGridIntegerReal | GridOperations | Subroutine | assign value of mask integer to mat real |
AssignGridReal | GridOperations | Subroutine | assign value of mask real to mat real |
AssignGridRealInteger | GridOperations | Subroutine | assign value of mask real to mat integer. real numbers are truncated to integer part. |
AssignInteger | GridOperations | Subroutine | assign value to mat |
ASSIGNMENT( = ) | GeoLib | Interface | |
ASSIGNMENT( = ) | Chronos | Interface | |
ASSIGNMENT(=) | GridOperations | Interface | |
assignment(=) | iso_varying_string | Interface | |
AssignReal | GridOperations | Subroutine | assign value to mat |
BarnesOI | SpatialInterpolation | Subroutine | The method constructs a grid of size determined by the distribution of the two dimensional data points. Using this grid, the function values are calculated at each grid point. To do this the method utilises a series of Gaussian functions, given a distance weighting in order to determine the relative importance of any given measurement on the determination of the function values. Correction passes are then made to optimise the function values, by accounting for the spectral response of the interpolated points. |
BasinArea | Morphology | Subroutine | compute basin area (m2) |
BasinCumulate | BasinAverage | Subroutine | cumulate variable along stream network |
BasinDelineate | Morphology | Subroutine | compute mask of river basin given map of flow direction and the coordinate of the outlet point |
BasinMask | Morphology | Subroutine | search for cells included in the river basin |
BasinRasterExport | BasinAverage | Subroutine | delineate and export basin mask |
BearingAngle | GeoLib | Function | Find the bearing angle (radians) between two points in a 2D space, as the angle measured in the clockwise direction from the north line with A as the origin to the line segment AB. Assume radians as input unit for geodetic reference system. |
Beta | RoutingModels | Function | returns the correction factor to be used in MCT algorithm (-) |
BuildReachNetwork | RiverDrainage | Subroutine | Build reaches that compose the river network |
CanopyCover | PlantsAllometrics | Function | compute canopy cover (0-1) |
CastShadow | SolarRadiation | Subroutine | Compute shadow grid |
Catch | LogLib | Subroutine | exception handler |
Celerity | RoutingModels | Function | returns the celerity (m/s) |
CellArea | GridOperations | Interface | |
CellAreaFloat | GridOperations | Function | Description compute area (m2) of a cell of a grid as a function of latitude defined by the position of cell in local coordinate system (row, column). Input grid of type grid_real |
CellAreaInteger | GridOperations | Function | Description compute area (m2) of a cell of a grid as a function of latitude defined by the position of cell in local coordinate system (row, column). Input grid of type grid_integer |
CellIsNoData | GridOperations | Interface | |
CellIsNoDataFloat | GridOperations | Function | return |
CellIsNoDataInteger | GridOperations | Function | returns |
CellIsSpring | Morphology | Function | find the cells that are springs, defined as those cells that have not any other cells upstream |
CellIsValid | GridOperations | Interface | |
CellIsValidFloat | GridOperations | Function | return |
CellIsValidInteger | GridOperations | Function | return |
CellLength | GridOperations | Interface | |
CellLengthFloat | GridOperations | Function | Description compute average length (m) of a cell of a grid as the squareroot of area Input grid of type grid_real |
CellLengthInteger | GridOperations | Function | Description compute average length (m) of a cell of a grid as the squareroot of area Input grid of type grid_integer |
Centroid | Morphology | Interface | |
CentroidGridInteger | Morphology | Subroutine | returns the coordinate of the centroid given a |
CentroidGridReal | Morphology | Subroutine | returns the coordinate of the centroid given a |
ChannelDetachmentRate | Sediment | Function | compute sediment detachment rate per second in channel element (kg/s) using simplified approach by Sun et al. (2002). |
ChannelInitiation | RiverDrainage | Subroutine | Define channel cells. Two methods are possible: |
char | iso_varying_string | Interface | |
char_auto | iso_varying_string | Function | Convert a varying string into a character string (automatic length) |
char_fixed | iso_varying_string | Function | Convert a varying string into a character string (fixed length) |
CheckClosure | IniLib | Subroutine | check if section and subsection still opened |
CheckId | TableLib | Subroutine | |
CheckOutlet | Morphology | Function | if the downstream cell is a nodata value or out of grid space, or points toward the current cell, the current cell is the basin outlet. |
CheckSpecificProperties | Evapotranspiration | Subroutine | check properties for each ET model |
CO2mod | PlantsModifiers | Function | compute CO22 modifier. |
ComputeNetRadiation | SolarRadiation | Subroutine | Compute net radiation |
ComputeSlopeFactor | Sediment | Subroutine | |
ComputeSpatialAverageBalance | SpatialAverage | Subroutine | Compute spatial average of soil water balance variables |
ComputeSpatialAverageCanopy | SpatialAverage | Subroutine | Compute spatial average of canopy interception variables |
ComputeSpatialAverageGlaciers | SpatialAverage | Subroutine | Compute spatial average of glaciers variables |
ComputeSpatialAverageMeteo | SpatialAverage | Subroutine | Compute spatial average of meteorological variables |
ComputeSpatialAveragePlants | SpatialAverage | Subroutine | Compute spatial average of plants variables |
ComputeSpatialAverageSediment | SpatialAverage | Subroutine | Compute spatial average of sediment variables |
ComputeSpatialAverageSnow | SpatialAverage | Subroutine | Compute spatial average of snow variables |
ConfigureExtents | SpatialAverage | Subroutine | Configure extents for computing and storing spatial average values |
ConfluenceIsAround | Morphology | Subroutine | Scan the eigth cells surrounding the center cell (row,col) (neglecting the upstream cell (i,j) ) to find if a confluence is present. The confluence cell must be of the same order or not yet defined. |
Convert | GeoLib | Subroutine | The subroutine converts the current input coordinates in the coordinate system defined by the current input coordinate system parameters and input datum, into output coordinates in the coordinate system defined by the output coordinate system parameters and output datum. |
ConvertGaussBoagaToGeodetic | GeoLib | Subroutine | The subroutine converts Gauss Boaga projection for Italy (easting and northing) coordinates to geodetic (latitude and longitude) coordinates |
ConvertGeodeticToGaussBoaga | GeoLib | Subroutine | The subroutine converts geodetic(latitude and longitude) coordinates to Gauss Boaga (easting and northing) coordinates, according to ROME40 datum for Italy (MonteMario) coordinates. |
ConvertGeodeticToHotine | GeoLib | Subroutine | The subroutine converts geodetic (latitude and longitude) coordinates to Hotine Oblique Mercator projection (easting and northing) |
ConvertGeodeticToSwiss | GeoLib | Subroutine | The subroutine converts geodetic (latitude and longitude) to Swiss Oblique Cylindrical projection(easting and northing) coordinates |
ConvertGeodeticToTransverseMercator | GeoLib | Subroutine | The subroutine converts geodetic(latitude and longitude) coordinates to Transverse Mercator projection (easting and northing) coordinates, according to the current ellipsoid and Transverse Mercator projection coordinates. |
ConvertGeodeticToUTM | GeoLib | Subroutine | The subroutine converts geodetic(latitude and longitude) coordinates to UTM projection (easting and northing) coordinates, according to the current ellipsoid and UTM projection coordinates. |
ConvertHotineToGeodetic | GeoLib | Subroutine | The subroutine converts Hotine Oblique Mercator projection (easting and northing) coordinates to geodetic (latitude and longitude) coordinates |
ConvertSwissToGeodetic | GeoLib | Subroutine | The subroutine converts Swiss Oblique Cylindrical projection (easting and northing) coordinates to geodetic (latitude and longitude) coordinates |
ConvertTransverseMercatorToGeodetic | GeoLib | Subroutine | The subroutine converts Transverse Mercator projection (easting and northing) coordinates to geodetic (latitude and longitude) coordinates, according to the current ellipsoid and Transverse Mercator projection parameters. |
ConvertUTMtoGeodetic | GeoLib | Subroutine | The subroutine converts Universal Transverse Mercator projection (easting and northing) coordinates to geodetic (latitude and longitude) coordinates, according to the current ellipsoid and UTM projection parameters. |
Copy | Chronos | Subroutine | Create an exact copy of |
CopyCRS | GeoLib | Subroutine | copy the content of a |
CopyDatum | GeoLib | Subroutine | Create an exact copy of a datum. |
CopyEllipsoid | GeoLib | Subroutine | Create an exact copy of an ellipsoid. |
CopyNetwork | ObservationalNetworks | Subroutine | make a copy of one observational network |
CountCells | GridStatistics | Interface | |
CountCellsFloat | GridStatistics | Function | count number of cells different from nodata |
CountCellsInteger | GridStatistics | Function | count number of cells different from nodata |
CountReservoirs | Reservoirs | Function | count number of reservoirs in a list |
Covariance | Kriging | Subroutine | Subroutine to calculate a covariance vector from a semivariogram model and a vector of separation distances. |
Covariance2D | Kriging | Subroutine | Subroutine to calculate a covariance matrix of observations from a semivariogram model and a vector of separation distances. |
CriticalVelocity | Sediment | Function | compute critical velocity for incipient motion (m/s) |
CronIsTime | CronSchedule | Function | returns true if it is time to start a process |
CronNextTime | CronSchedule | Function | returns the next time to start a process given the current time |
CronParseString | CronSchedule | Subroutine | parse cron string |
CrownDiameter | PlantsAllometrics | Function | compute crown doameter (m) |
CRSisEqual | GridOperations | Interface | |
CRSisEqual | GeoLib | Function | return .TRUE. if the two coordinate reference systems are equal |
CRSisEqualFloatFloat | GridOperations | Function | return |
CRSisEqualFloatInt | GridOperations | Function | return |
CRSisEqualIntFloat | GridOperations | Function | return |
CRSisEqualIntInt | GridOperations | Function | return |
CurrentDir | FileSys | Function | return current directory |
CurvatureMicroMet | Morphology | Subroutine | Calculate curvature according to method implemented in MICROMET |
DateCheck | Chronos | Subroutine | check that date do not contain errors. |
DateTimeIsDefault | Chronos | Function | Check if datetime is set to default |
DatumIsEqual | GeoLib | Function | return |
DayOfYear | Chronos | Function | Gets the day of the year represented by this instance. Returns 366 for leap years |
DaysInMonth | Chronos | Function | Returns the number of days in the specified month. It accounts for leap years |
DBHDCeff | PlantsAllometrics | Function | Compute the actual ratio DBH-crown diameter: crown/dbh (m/cm) |
DBHvsStemBiomass | PlantsAllometrics | Function | relationship between DBH (Diameter at Brest Height) and stem biomass. |
DecodeEPSG | GeoLib | Function | get EPSG code as input and set coordinate reference system |
DegreeDay | Snow | Function | compute melt rate (m/s) using degreeday temperature based model |
DepthFromArea | RoutingModels | Function | returns water depth given wetted area (m) using Newton-Raphson. |
DepthToDiv | SoilProperties | Function | Return which division corresponds to given depth |
DeriveAspect | Morphology | Subroutine | Aspect identifies the downslope direction of the maximum rate of change in value from each cell to its neighbors. Aspect can be thought of as the slope direction. The values of the output raster will be the compass direction of the aspect. A moving window visits each cell in the input raster and for each cell in the center of the window, an aspect value is calculated using an algorithm that incorporates the values of the cell's eight neighbors. If any neighborhood cells are NoData, they are first assigned the value of the center cell, then the aspect is computed. The cells are identified as letters 'a' to 'i', with 'e' representing the cell for which the aspect is being calculated. The rate of change in the x direction for cell 'e' is calculated with the following algorithm: |
DeriveCurvature | Morphology | Subroutine | Calculates the curvature [1/m] of a raster surface, optionally including profile and plan curvature. If any neighborhood cells are NoData, they are first assigned the value of the center cell. It calculates the second derivative value of the input surface on a cell-by-cell basis. For each cell, a fourth-order polynomial of the form: |
DeriveSlope | Morphology | Subroutine | For each cell, the routine calculates the maximum rate of change in value from that cell to its neighbors. Basically, the maximum change in elevation over the distance between the cell and its eight neighbors identifies the steepest downhill descent from the cell. Conceptually, the routine fits a plane to the z-values of a 3 x 3 cell neighborhood around the processing or center cell. The slope value of this plane is calculated using the average maximum technique. The direction the plane faces is the aspect for the processing cell. If there is a cell location in the neighborhood with a NoData z-value, the z-value of the center cell will be assigned to the location. |
DestroyNetwork | ObservationalNetworks | Subroutine | deallocate space |
DirDelete | FileSys | Subroutine | delete a directory |
DirectionAngle | GeoLib | Function | Find the direction angle (radians) between two points in a 2D space, measured in the clockwise direction. Formula gives values 0°<θ<90° for lines with positive slope and values 90°<θ<180° for lines with negative slope. The result does depend on which point is point 1 and which is point 2. Assume radians as input unit for geodetic reference system. |
DirExists | FileSys | Function | returns TRUE if directory exists |
DirList | FileSys | Subroutine | return a list of files in a directory |
DirNew | FileSys | Subroutine | create a new directory |
DirRename | FileSys | Subroutine | rename a directory |
Discharge | RoutingModels | Function | returns the normal discharge (m3/s) with Chezy equation. |
DischargePointExport | DischargeRouting | Subroutine | Export of point site data |
DischargePointInit | DischargeRouting | Subroutine | Initialize export of point site data |
DischargeRoute | DischargeRouting | Subroutine | route discharge in surface network |
Distance | GeoLib | Function | compute distance between two points in, either, projected or geodetic coordinate reference system |
DistMatrix | Kriging | Subroutine | A subroutine to assemble the global distance. This operation is only carried out once; kriging observations matricies are subsetted from this lookup table to speed up processing. |
DiversionSaveStatus | Diversions | Subroutine | save diversion state variables on file |
DivertFlow | RoutingModels | Subroutine | Discharge routing through diversion. Discharge is split between river and diversion channel |
DomainInit | DomainProperties | Subroutine | Load domain properties |
DoubleToString | StringManipulation | Function | Converts a double precision number in a string Arguments: number number to be converted Result: string |
DownstreamCell | Morphology | Subroutine | returns the position (is,js) of the downstream cell and, optionally, the flow path length, considering cardinal and diagonal direction |
DrainageDensity | Morphology | Function | Drainage Density (1/m) of a basin is the total line length of all streams divided by basin area. If flow accumulation is not given, it is computed from flow direction. If coordinate of closing section is not given drainage density is computed for the entire grid. |
EllipsoidIsEqual | GeoLib | Function | return |
Equality | Chronos | Function | return |
etEnergyBalanceGround | Evapotranspiration | Subroutine | Compute actual evapotranspiration from ground by solving energy balance Original code written by Chiara Corbari and Jacopo Martinelli |
ETinit | Evapotranspiration | Subroutine | Initialize evapotranspiration computation |
ExportBasinAverage | BasinAverage | Subroutine | Export basin averaged values |
ExportGrid | GridLib | Interface | |
ExportGridFloatToESRI_ASCII | GridLib | Subroutine | export grid_real to a ESRI ASCII file. |
ExportGridFloatToESRI_BINARY | GridLib | Subroutine | export grid_real to a ESRI BINARY file. |
ExportGridFloatToFile | GridLib | Subroutine | export grid_real to file. List of supported format: |
ExportGridFloatToNetCDF | GridLib | Subroutine | export grid into netcdf file. Two actions are possible: |
ExportGridIntegerToESRI_ASCII | GridLib | Subroutine | export grid_integer to a ESRI ASCII file. |
ExportGridIntegerToESRI_BINARY | GridLib | Subroutine | export grid_integer to a ESRI BINARY file. |
ExportGridIntegerToFile | GridLib | Subroutine | export grid_integer to file. List of supported format: |
ExportGridIntegerToNetCDF | GridLib | Subroutine | export grid into netcdf file. Two actions are possible: |
ExportMaps | RasterExport | Subroutine | Update and export maps |
ExportReaches | RiverDrainage | Subroutine | Export reaches on file |
ExportShape | RiverDrainage | Subroutine | export shape file of river network |
ExportSpatialAverageBalance | SpatialAverage | Subroutine | Export spatial average of soil balance variables |
ExportSpatialAverageCanopy | SpatialAverage | Subroutine | Export spatial average of canopy interception variables |
ExportSpatialAverageGlaciers | SpatialAverage | Subroutine | Export spatial average of glaciers variables |
ExportSpatialAverageMeteo | SpatialAverage | Subroutine | Export spatial average of meteorological variables |
ExportSpatialAveragePlants | SpatialAverage | Subroutine | Export spatial average of plants variables |
ExportSpatialAverageSediment | SpatialAverage | Subroutine | Export spatial average of sediment variables |
ExportSpatialAverageSnow | SpatialAverage | Subroutine | Export spatial average of snow variables |
extract | iso_varying_string | Interface | |
extract_CH | iso_varying_string | Function | Extract a varying substring from a character string |
extract_VS | iso_varying_string | Function | Extract a varying substring from a varying string |
ExtractBorder | GridOperations | Interface | |
ExtractBorderFloat | GridOperations | Subroutine | Extracts only the cells on the external border. Other cells are
assigned |
ExtractBorderInteger | GridOperations | Subroutine | Extracts only the cells on the external border. Other cells are
assigned |
FallVelocity | Sediment | Function | compute fall velocity of sediment (m/s) |
FAO56PenmanMonteith | Evapotranspiration | Subroutine | Compute potential evapotranspiration with FAO56 Penman-Monteith model for a reference grass "A hypothetical reference crop with an assumed crop height of 0.12 m, a fixed surface resistance of 70 s m-1 and an albedo of 0.23." |
Fconv | Kriging | Function | function called by Simplex |
FileDelete | FileSys | Subroutine | delete a file |
FileExists | FileSys | Function | returns |
FileNew | FileSys | Subroutine | create a new text file |
FileRename | FileSys | Subroutine | rename a file. If renamed file already exists it is not overwritten and warning is raised. |
FileSyncToLastLine | FileSys | Subroutine | synchronize to the last line of formatted file |
FloatToString | StringManipulation | Function | Converts a real number in a string Arguments: number number to be converted Result: string |
FlowAccumulation | Morphology | Subroutine | compute map of flow accumulation (m2) Input grid: flow direction |
Focompu | Kriging | Subroutine | evaluation of the objective function |
ForestToGrid | Plants | Subroutine | fill in a grid with state variable values in forest stands |
GeodeticShiftFromWGS84 | GeoLib | Subroutine | shifts geodetic coordinates relative to WGS84 to geodetic coordinates relative to a given local datum. |
GeodeticShiftToWGS84 | GeoLib | Subroutine | shifts geodetic coordinates relative to a given source datum to geodetic coordinates relative to WGS84. |
GeoInit | GeoLib | Subroutine | Initialize parameters for conversion |
get | iso_varying_string | Interface | |
get_ | iso_varying_string | Subroutine | Read from the default unit into a varying string |
get_set_CH | iso_varying_string | Subroutine | Read from the default unit into a varying string, with a custom character-string separator |
get_set_VS | iso_varying_string | Subroutine | Read from the default unit into a varying string, with a custom varying-string separator |
get_unit | iso_varying_string | Subroutine | Read from the specified unit into a varying string |
get_unit_set_CH | iso_varying_string | Subroutine | Read from the default unit into a varying string, with a custom character-string separator |
get_unit_set_VS | iso_varying_string | Subroutine | Read from the specified unit into a varying string, with a custom varying-string separator |
GetArea | GridOperations | Interface | |
GetAreaOfGridFloat | GridOperations | Function | Description compute area (m2) of grid excluding nodata |
GetAreaOfGridInteger | GridOperations | Function | |
GetBias | GridStatistics | Interface | |
GetBiasFloat | GridStatistics | Function | compute mean Bias between two grids real
optional argument:
|
GetCV | GridStatistics | Interface | |
GetCVofGridFloat | GridStatistics | Function | compute coefficient of variation of grid_real eventually constrained to a mask |
GetDay | Chronos | Function | Gets the day of the datetime represented by this instance |
GetDayOfWeek | Chronos | Function | Gets the day of week (0 - 6) (Sunday to Saturday The formula is: |
GetDiversionById | Diversions | Function | given a list of diversion channels, returns a pointer to one diversion by id |
GetDtGrid | GridLib | Function | |
GetFirstDate | GridLib | Function | given filename of a multidimensional net-cdf file the GetFirstDate function returns the date and time of first grid |
GetGeoreferenceFromNCdataSet | GridLib | Subroutine | read and calculate georeferencing informations from netCDF file. |
GetGridMapping | GridLib | Interface | |
GetGridMappingFloat | GridLib | Function | get grid mapping for a floating point grid |
GetGridMappingInteger | GridLib | Function | get grid mapping for a floating point grid |
GetHour | Chronos | Function | Gets the month of the datetime represented by this instance |
GetIJ | GridOperations | Interface | |
GetIJfloat | GridOperations | Subroutine | returns X and Y coordinate given i and j position in grid(i,j) |
GetIJinteger | GridOperations | Subroutine | returns X and Y coordinate given i and j position in grid(i,j) |
GetMax | GridStatistics | Interface | |
GetMaxOfGridFloat | GridStatistics | Function | compute maximum of grid_real eventually constrained to a mask |
GetMaxOfGridInteger | GridStatistics | Function | compute maximum of grid_integer eventually constrained to a mask |
GetMean | GridStatistics | Interface | |
GetMeanFloat | Statistics | Function | compute mean of a vector of real numbers. If nodata is passed numbers are filetered before computing mean |
GetMeanOfGridFloat | GridStatistics | Function | compute mean of grid_real eventually constrained to a mask |
GetMeanOfGridInteger | GridStatistics | Function | compute mean of grid_integer eventually constrained to a mask |
GetMeanVector | Statistics | Interface | |
GetMin | GridStatistics | Interface | |
GetMinOfGridFloat | GridStatistics | Function | compute minimum of grid_real eventually constrained to a mask |
GetMinOfGridInteger | GridStatistics | Function | compute minimum of grid_integer eventually constrained to a mask |
GetMinute | Chronos | Function | Gets the minute of the datetime represented by this instance |
GetMonth | Chronos | Function | Gets the month of the datetime represented by this instance |
GetNofSections | IniLib | Function | count sections in a ini db |
GetNofSubSections | IniLib | Function | return number of subsections within a section of a ini db |
GetNSE | GridStatistics | Interface | |
GetNSEfloat | GridStatistics | Function | compute Nash and Sutcliffe efficiency index, equivalent to
coefficient of determination.
optional argument:
|
GetOS | FileSys | Function | get operating system |
GetPos | PlantsManagement | Function | return the position in practices array given practice id |
GetR2 | GridStatistics | Interface | |
GetR2float | GridStatistics | Function | compute R2, square of the Pearson correlation coefficient
optional argument:
|
GetReservoirById | Reservoirs | Function | given a list of reservoirs, returns a pointer to one reservoir by id |
GetRMSE | GridStatistics | Interface | |
GetRMSEfloat | GridStatistics | Function | compute Root Mean Square Error between two grids real
optional argument:
|
GetSecond | Chronos | Function | Gets the second of the datetime represented by this instance |
GetStDev | GridStatistics | Interface | |
GetStDevOfGridFloat | GridStatistics | Function | compute unbiased standard deviation of grid_real optionally constrained to a mask |
GetStDevOfGridInteger | GridStatistics | Function | compute unbiased standard deviation of grid_integer optionally constrained to a mask |
GetSum | GridStatistics | Interface | |
GetSumOfGridFloat | GridStatistics | Function | compute sum of grid_real eventually constrained to a mask |
GetSumOfGridInteger | GridStatistics | Function | compute sum of grid_integer eventually constrained to a mask |
GetTimeSteps | GridLib | Interface | |
GetTimeStepsFromFile | GridLib | Function | given filename of a multidimensional net-cdf file the GetTimeStepsFromFile function returns the number of time steps |
GetTimeStepsFromNCid | GridLib | Function | given ncId of a multidimensional net-cdf file the GetTimeStepsFromNCid function returns the number of time steps |
GetTimeZone | Chronos | Function | Gets the string representing time zone of the datetime represented by this instance. Example: '+02:00' |
GetUnit | Utilities | Function | returns a free FORTRAN unit number Discussion: A "free" FORTRAN unit number is an integer between 1 and 999 which is not currently associated with an I/O device. A free FORTRAN unit number is needed in order to open a file with the OPEN command. If IUNIT = 0, then no free FORTRAN unit could be found, although all 999 units were checked (except for units 5 and 6). Otherwise, IUNIT is an integer between 1 and 99, representing a free FORTRAN unit. Note that GetUnit assumes that units 5 and 6 are special, and will never return those values. Adapted from John Burkardt |
GetUnit | LogLib | Function | returns a free FORTRAN unit number Discussion: A "free" FORTRAN unit number is an integer between 1 and 99 which is not currently associated with an I/O device. A free FORTRAN unit number is needed in order to open a file with the OPEN command. If IUNIT = 0, then no free FORTRAN unit could be found, although all 99 units were checked (except for units 5 and 6). Otherwise, IUNIT is an integer between 1 and 99, representing a free FORTRAN unit. Note that GetUnit assumes that units 5 and 6 are special, and will never return those values. Adapted from John Burkardt |
GetXY | GridOperations | Interface | |
GetXYfloat | GridOperations | Subroutine | returns X and Y coordinate given i and j position in grid(i,j) |
GetXYinteger | GridOperations | Subroutine | returns X and Y coordinate given i and j position in grid(i,j) |
GetXYSizesFromFile | GridLib | Subroutine | extraxt the number of columns (x) and rows (y) from netCDF file. |
GetYear | Chronos | Function | Gets the year of the datetime represented by this instance |
GlacierInit | Glacier | Subroutine | Initialize glacier model |
GlacierParameterUpdate | Glacier | Subroutine | update parameter map that change in time |
GlacierPointExport | Glacier | Subroutine | Export of point site data |
GlacierPointInit | Glacier | Subroutine | Initialize export of point site data |
GlacierUpdate | Glacier | Subroutine | compute accumulation and ablation and update water equivalent |
GreaterThan | Chronos | Function | return |
GreaterThanOrEqual | Chronos | Function | return |
GreenAmpt | Infiltration | Function | calculates the actual rate of infiltration (m/s) according to Green-Ampt equation for unsteady rainfall. |
Grid2vector | GridOperations | Interface | |
Grid2vectorFloat | GridOperations | Subroutine | return an array 1D of numbers different than |
Grid2vectorInteger | GridOperations | Subroutine | return an array 1D of numbers different than |
GridByIni | GridOperations | Interface | |
GridByIniFloat | GridOperations | Subroutine | read a |
GridByIniFloatSubSection | GridOperations | Subroutine | read a |
GridByIniInteger | GridOperations | Subroutine | read a |
GridByIniIntegerSubSection | GridOperations | Subroutine | read a |
GridConvert | GridOperations | Interface | |
GridConvertFloat | GridOperations | Subroutine | coordinate conversion of a |
GridConvertInteger | GridOperations | Subroutine | coordinate conversion of a |
GridDestroy | GridLib | Interface | |
GridDestroyFloat | GridLib | Subroutine | deallocate float grid |
GridDestroyInteger | GridLib | Subroutine | deallocate integer grid |
GridResample | GridOperations | Interface | |
GridShift | GridOperations | Interface | |
GroundwaterInit | Groundwater | Subroutine | Initialize groundwater |
GroundwaterOutput | Groundwater | Subroutine | |
GroundwaterOutputInit | Groundwater | Subroutine | Initialize files for exporting output results |
GroundwaterParameterUpdate | Groundwater | Subroutine | update boundary condition map that change in time |
GroundwaterPointExport | Groundwater | Subroutine | Export of point site data |
GroundwaterPointInit | Groundwater | Subroutine | Initialize export of point site data |
GroundwaterRiverInit | Groundwater | Subroutine | Configure river-groundwater interaction |
GroundwaterRiverUpdate | Groundwater | Subroutine | Update river-groundwater exchange fluxes |
GroundwaterUpdate | Groundwater | Subroutine | update groundwater head with Darcy law and mass conservation in two dimensions, with a macrocopic cellular automata approach |
GrowDBH | Plants | Subroutine | update DBH and height tree every new year |
GrowDBHech2o | Plants | Subroutine | update DBH and height tree according to ech2o model by Maneta |
GrowLeaf | Plants | Subroutine | update leaf biomass and leaf area index |
HargreavesSamani | Evapotranspiration | Subroutine | Compute potential evapotranspiration with Hargreaves Samani model at daily time scale |
HargreavesSamaniModified | Evapotranspiration | Subroutine | Compute potential evapotranspiration at daily time scale with Hargreaves Samani model modified by Ravazzani et al. (2012) to include an elevation correction factor |
HeightVsDBH | PlantsAllometrics | Function | relationship between tree height and DBH (Diameter at Brest Height). Implements Chapman-Richards relationship |
HortonOrders | Morphology | Subroutine | returns a grid_integer containing Horton orders. Horton orders are computed on the entire space-filled basin. |
iachar | iso_varying_string | Interface | |
iachar_ | iso_varying_string | Function | Get the position in the ISO 646 collating sequence of a varying string character |
ichar | iso_varying_string | Interface | |
ichar_ | iso_varying_string | Function | Get the position in the processor collating sequence of a varying string character |
IDW | SpatialInterpolation | Subroutine | Inverse Distance Weighted interpolation. Accept as optional argument the power parameter and the number of near observations to included in interpolation. Can use Shepard's method (Shepard 1968) or Franke & Nielson, 1980 |
index | iso_varying_string | Interface | |
index_CH_VS | iso_varying_string | Function | Get the index of a varying substring within a character string |
index_VS_CH | iso_varying_string | Function | Get the index of a character substring within a varying string |
index_VS_VS | iso_varying_string | Function | Get the index of a varying substring within a varying string |
Inequality | Chronos | Function | return |
InfiltrationInit | Infiltration | Subroutine | Initialize evapotranspiration computation |
IniAddLine | IniLib | Subroutine | add a new Key-Val pair |
IniClose | IniLib | Subroutine | close a ini file |
IniCountKeys | IniLib | Function | count Key-Val pair in a file |
IniOpen | IniLib | Interface | |
IniOpenFileName | IniLib | Subroutine | open and read a ini file |
IniOpenFileUnit | IniLib | Subroutine | read a ini file already open |
IniReadDouble | IniLib | Function | read an double precision number corresponding to Key |
IniReadInt | IniLib | Function | read an integer corresponding to Key |
IniReadLogical | IniLib | Function | read a logical value corresponding to Key |
iniReadReal | IniLib | Function | read a real number corresponding to Key |
IniReadString | IniLib | Function | read a string corresponding to Key |
InitBasinAverage | BasinAverage | Subroutine | Initialization of basin average |
InitDischargeRouting | DischargeRouting | Subroutine | Initialize surface routing |
InitDiversions | Diversions | Subroutine | Initialize diversions |
InitRasterExport | RasterExport | Subroutine | Initialization of raster export |
InitReservoirs | Reservoirs | Subroutine | Initialize reservoirs |
InitSoilBalance | SoilBalance | Subroutine | Initialize soil water balance |
InitSpatialAverageBalance | SpatialAverage | Subroutine | Initialization of spatial average of soil balance variables |
InitSpatialAverageCanopy | SpatialAverage | Subroutine | Initialization of spatial average of canopy interception variables |
InitSpatialAverageGlaciers | SpatialAverage | Subroutine | Initialization of spatial average of glaciers variables |
InitSpatialAverageMeteo | SpatialAverage | Subroutine | Initialization of spatial average of meteorological variables |
InitSpatialAveragePlants | SpatialAverage | Subroutine | Initialization of spatial average of plants dynamic variables |
InitSpatialAverageSediment | SpatialAverage | Subroutine | Initialization of spatial average of sediment variables |
InitSpatialAverageSnow | SpatialAverage | Subroutine | Initialization of spatial average of snow variables |
insert | iso_varying_string | Interface | |
insert_CH_CH | iso_varying_string | Function | Insert a character substring into a character string |
insert_CH_VS | iso_varying_string | Function | Insert a varying substring into a character string |
insert_VS_CH | iso_varying_string | Function | Insert a character substring into a varying string |
insert_VS_VS | iso_varying_string | Function | Insert a varying substring into a varying string |
InterceptionInit | PlantsInterception | Subroutine | initialize variables for computing rainfall interception |
Interpolate | MeteoUtilities | Subroutine | interpolate site data to space |
Interpolate | Kriging | Subroutine | A subroutine to predict the data value of an unsampled location, using geostatistical methods. Interpolation is carried out using the 'Ordinary Kriging' method. |
InterrillDetachmentRate | Sediment | Subroutine | compute sediment detachment rate (kg/s). Interril area detachment is considered to be due to the raindrop impact, which breaks the cohesive bonds between particles, making them available for transport. |
inverse | SpatialInterpolation | Subroutine | Inverse matrix Method: Based on Doolittle LU factorization for Ax=b |
IrrigationConfig | Irrigation | Subroutine | configure irrigation |
IrrigationUpdate | Irrigation | Subroutine | update irrigation and write output |
IsLeapYear | Chronos | Function | Returns |
IsOutOfGrid | GridOperations | Interface | |
IsOutOfGridFloat | GridOperations | Function | calculates if cell is out of grid space limits |
IsOutOfGridInteger | GridOperations | Function | calculates if cell is out of grid space limits |
IsUTC | Chronos | Function | Returns true if datetime object is expressed in UTC |
KcUpdate | Evapotranspiration | Subroutine | read new Kc values |
KeepLines | FileSys | Subroutine | Erase lines except the number specified as argument. pos defines wheter kept lines are counted starting from the beginning or from the end of file. Optional argument header defines number of lines at the beginning of the file to be considered as header. Header lines are never deleted. Manipulated file is supposed to be already opened. |
KeyIsPresent | IniLib | Function | return true if key is present, false otherwise |
KillPlants | PlantsMortality | Subroutine | the number of trees is updated considering the mortality of the plants. for each tree that dies, a fraction mi of the mean biomass three types of mortality are considered: |
Krige | Kriging | Subroutine | Interpolate irregularly spaced data using Kriging. The subroutine generates an empirical semivariogram (anisotropy is assumed), fits the best model among spherical, exponential and gaussian. |
KrigingInitialize | Kriging | Subroutine | Initialize variables for kriging |
len | iso_varying_string | Interface | |
len_ | iso_varying_string | Function | Get the length of a varying string |
len_trim | iso_varying_string | Interface | |
len_trim_ | iso_varying_string | Function | Get the trimmed length of a varying string |
LessThan | Chronos | Function | return |
LessThanOrEqual | Chronos | Function | return |
LevelPool | RoutingModels | Subroutine | Discharge routing through reservoir. Given Qin, find Qout and stage References: |
lge | iso_varying_string | Interface | |
lge_CH_VS | iso_varying_string | Function | Compare (LGE) a character string and a varying string |
lge_VS_CH | iso_varying_string | Function | Compare (LGE) a varying string and a character string |
lge_VS_VS | iso_varying_string | Function | Compare (LGE) two varying strings |
lgt | iso_varying_string | Interface | |
lgt_CH_VS | iso_varying_string | Function | Compare (LGT) a character string and a varying string |
lgt_VS_CH | iso_varying_string | Function | Compare (LGT) a varying string and a character string |
lgt_VS_VS | iso_varying_string | Function | Compare (LGT) two varying strings |
LinearInterp | Utilities | Interface | |
LinearInterpFloatDouble | Utilities | Function | calculates linear interpolation between real numbers. Output is a double real |
LinearInterpFloatFloat | Utilities | Function | calculates linear interpolation between real numbers. |
LinearInterpIntFloat | Utilities | Function | calculates linear interpolation between integer numbers with output real. |
LinearRegressionSlope | Statistics | Function | compute slope of linear regression between vector x and y |
lle | iso_varying_string | Interface | |
lle_CH_VS | iso_varying_string | Function | Compare (LLE) a character string and a varying string |
lle_VS_CH | iso_varying_string | Function | Compare (LLE) a varying string and a character string |
lle_VS_VS | iso_varying_string | Function | Compare (LLE) two varying strings |
llt | iso_varying_string | Interface | |
llt_CH_VS | iso_varying_string | Function | Compare (LLT) a character string and a varying string |
llt_VS_CH | iso_varying_string | Function | Compare (LLT) a varying string and a character string |
llt_VS_VS | iso_varying_string | Function | Compare (LLT) two varying strings |
LogInit | LogLib | Subroutine | initialize global parameters |
LogMsg | LogLib | Subroutine | write a formatted string on specified unit- It is called by Catch routine |
LogStop | LogLib | Subroutine | stop logging. If open, close the log file |
LongestFlowLength | Morphology | Function | compute longest flow length (m) |
LongestFlowPathSlope | Morphology | Function | compute slope of longest flow path (m/m) |
LongToString | StringManipulation | Function | Converts a long integer number in a string Arguments: number number to be converted Result: string |
MarkOrderBeginning | RiverDrainage | Subroutine | Define cells where the beginning of a reach of different order takes place. |
Matinv | Kriging | Subroutine | A generic subroutine to invert a square 2D matrix by pivoting ("Gauss-Jordan" method). An n*2,n work array is assembled, with the array of interest on the left half, and the identity matrix on the right half. A check is made to ensure the matrix is invertable, and the matrix inverse is returned, providing the matrix is not singular. The matrix is invertable if, after pivoting and row reduction, the identity matrix shifts to the left half of the work array. Initially the code was written in integer form to avoid fractions in the work array, but numbers rapidly become inconcevably large. The implemented solution therefore works on fractional pivot rows, with pivots factored to leading ones. Double precision arrays have been used to maintain numerical stability. |
MeridionalDistance | GeoLib | Function | Compute the distance in meters along a meridian from equator to given latitude. |
MeteoInit | Meteo | Subroutine | Initialize meteorological forcings |
MeteoPointExport | Meteo | Subroutine | Export of point site data |
MeteoPointInit | Meteo | Subroutine | Initialize export of point site data |
MeteoRead | Meteo | Subroutine | Read meteorological forcings |
MinMaxNormalization | GridStatistics | Interface | |
MinMaxNormalizationFloat | GridStatistics | Subroutine | performs a linear transformation on the original data values.
Suppose that |
MolodenskyShift | GeoLib | Subroutine | shifts geodetic coordinates using the Molodensky method |
MorphologyInit | MorphologicalProperties | Subroutine | Initialize morphological properties |
MuskingumCunge | RoutingModels | Subroutine | Solve Muskingum-Cunge equation. |
MuskingumCungeTodini | RoutingModels | Subroutine | Solve Muskingum-Cunge-Todini equation. When parameters k and x are passed, C1, C2, and C3 are computed using the passed values. When x = 0, linear reservoir model. When x = 0.5 and k = dt translation only |
ncErrorHandler | GridLib | Subroutine | Handle errors from netcdf related operation |
NearestNeighbor | SpatialInterpolation | Subroutine | The nearest neighbor algorithm selects the value of the nearest point and does not consider the values of neighboring points at all, yielding a piecewise-constant interpolant |
NewGrid | GridLib | Interface | |
NewGridFloatAsGridFloat | GridLib | Subroutine | create a new grid_real using an existing grid_real as template |
NewGridFloatAsGridInteger | GridLib | Subroutine | create a new grid_real using an existing grid_integer as template |
NewGridFloatFromESRI_ASCII | GridLib | Subroutine | |
NewGridFloatFromESRI_BINARY | GridLib | Subroutine | read a float grid from a ESRI BINARY file. |
NewGridFloatFromFile | GridLib | Subroutine | read a grid from a file. List of supported format: ESRI_ASCII: ESRI ASCII GRID ESRI_BINARY: ESRI BINARY GRID NET_CDF: NetCDF CF compliant |
NewGridFloatFromNetCDF | GridLib | Subroutine | create a new raster_real reading data from NetCDF file The variable to read can be defined by its current name or the standard_name. The dimensions x and y of the variable is calculated searching from the dimensions of the couple of variables with 'standard_name' equal to 'projection_x_coordinate' and 'projection_y_coordinate' for projected reference systems or 'longitude' and 'latitude' for geographic reference systems or 'grid_longitude' and 'grid_latitude' for rotated pole systems If a comprehensible reference systems is not found a geodetic reference system is supposed. Once the variable is retrieved, offset and scale factor are applied and a check on minimum and maximum valid value is performed. |
NewGridIntegerAsGridFloat | GridLib | Subroutine | create a new grid_integer using an existing grid_real as template |
NewGridIntegerAsGridInteger | GridLib | Subroutine | create a new grid_integer using an existing grid_integer as template |
NewGridIntegerFromESRI_ASCII | GridLib | Subroutine | read a integer grid from a ESRI ASCII file. |
NewGridIntegerFromESRI_BINARY | GridLib | Subroutine | read a integer grid from a ESRI BINARY file. |
NewGridIntegerFromFile | GridLib | Subroutine | read a grid from a file. |
NewGridIntegerFromNetCDF | GridLib | Subroutine | create a new grid_integer reading data from NetCDF file The variable to read can be defined by its current name or the standard_name. The dimensions x and j of the variable is calculated searching from the dimensions of the couple of variables with 'standard_name' equal to 'projection_x_coordinate' and 'projection_y_coordinate' for projected reference systems or 'longitude' and 'latitude' for geographic reference systems or 'grid_longitude' and 'grid_latitude' for rotated pole systems If a comprehensible reference systems is not found a geodetic reference system is supposed. Once the variable is retrieved, offset and scale factor are applied and a check on minimum and maximum valid value is performed. |
NextTime | GridLib | Function | Description returns the time of the next grid in netcdf dataset |
NormalDepth | RoutingModels | Function | returns the normal depth (m) using Newton-Raphson. |
Now | Chronos | Function | Gets a |
Nu | GeoLib | Function | Compute the radius of curvature of the ellipsoid perpendicular to the meridian at given latitude |
Offset | MeteoUtilities | Subroutine | apply offset to a grid_real |
op_assign_CH_VS | iso_varying_string | Subroutine | Assign a varying string to a character string |
op_assign_VS_CH | iso_varying_string | Subroutine | Assign a character string to a varying string |
op_concat_CH_VS | iso_varying_string | Function | Concatenate a character string and a varying string |
op_concat_VS_CH | iso_varying_string | Function | Concatenate a varying string and a character string |
op_concat_VS_VS | iso_varying_string | Function | Concatenate two varying strings |
op_eq_CH_VS | iso_varying_string | Function | Compare (==) a character string and a varying string |
op_eq_VS_CH | iso_varying_string | Function | Compare (==) a varying string and a character string |
op_eq_VS_VS | iso_varying_string | Function | Compare (==) two varying strings |
op_ge_CH_VS | iso_varying_string | Function | Compare (>=) a character string and a varying string |
op_ge_VS_CH | iso_varying_string | Function | Compare (>=) a varying string and a character string |
op_ge_VS_VS | iso_varying_string | Function | Compare (>=) two varying strings |
op_gt_CH_VS | iso_varying_string | Function | Compare (>) a character string and a varying string |
op_gt_VS_CH | iso_varying_string | Function | Compare (>) a varying string and a character string |
op_gt_VS_VS | iso_varying_string | Function | Compare (>) two varying strings |
op_le_CH_VS | iso_varying_string | Function | Compare (<=) a character string and a varying string |
op_le_VS_CH | iso_varying_string | Function | Compare (<=) a varying string and a character string |
op_le_VS_VS | iso_varying_string | Function | Compare (<=) two varying strings |
op_lt_CH_VS | iso_varying_string | Function | Compare (<) a character string and a varying string |
op_lt_VS_CH | iso_varying_string | Function | Compare (<) a varying string and a character string |
op_lt_VS_VS | iso_varying_string | Function | Compare (<) two varying strings |
op_ne_CH_VS | iso_varying_string | Function | Compare (/=) a character string and a varying string |
op_ne_VS_CH | iso_varying_string | Function | Compare (/=) a varying string and a character string |
op_ne_VS_VS | iso_varying_string | Function | Compare (/=) two varying strings |
OPERATOR ( + ) | Chronos | Interface | |
OPERATOR ( - ) | Chronos | Interface | |
OPERATOR ( /= ) | Chronos | Interface | |
OPERATOR ( < ) | Chronos | Interface | |
OPERATOR ( <= ) | Chronos | Interface | |
OPERATOR ( == ) | Chronos | Interface | |
OPERATOR ( > ) | Chronos | Interface | |
OPERATOR ( >= ) | Chronos | Interface | |
OPERATOR (==) | GeoLib | Interface | |
operator(//) | iso_varying_string | Interface | |
operator(/=) | iso_varying_string | Interface | |
operator(<) | iso_varying_string | Interface | |
operator(<=) | iso_varying_string | Interface | |
operator(==) | iso_varying_string | Interface | |
operator(>) | iso_varying_string | Interface | |
operator(>=) | iso_varying_string | Interface | |
OpticalDepth | SolarRadiation | Function | Compute tthe atmospheric optical depth |
OutDiversions | Diversions | Subroutine | write results on files |
OutDiversionsInit | Diversions | Subroutine | initialise files for output |
OutReservoirs | Reservoirs | Subroutine | write results on files |
OutReservoirsInit | Reservoirs | Subroutine | initialise files for output |
PairDirection | Kriging | Subroutine | Compute direction angle between pairs (radians) measured from the x axis anti-clockwise |
PairDistance | Kriging | Subroutine | Compute distance between pairs |
Parse | Chronos | Subroutine | Converts the specified string representation of a
date and time to its |
ParseTime | GridLib | Subroutine | Parse units attribute of time variable Limits: string representing date and time must not contain blanks |
PenmanMonteith | Evapotranspiration | Subroutine | Compute potential evapotranspiration with Penman-Monteith model |
PercolationAndCaprise | SoilBalance | Subroutine | compute percolation and capilalry rise |
Perimeter | Morphology | Function | find the cells that are springs, defined as those cells that have not any other cells upstream |
PETupdate | Evapotranspiration | Subroutine | Compute potential evapotranspiration |
Philip | Infiltration | Function | calculates the actual rate of infiltration (m/s) according to Philip's equation. Use time compression approximation. |
PlantsConfig | Plants | Subroutine | Initialize Plants module |
PlantsGrow | Plants | Subroutine | Update plants state variables |
PlantsParameterUpdate | Plants | Subroutine | update parameter map that change in time |
PrecipitationDailyInit | PrecipitationDaily | Subroutine | Initialize precipitation |
PrecipitationDailyRead | PrecipitationDaily | Subroutine | Read precipitation data |
PrecipitationInit | Precipitation | Subroutine | Initialize precipitation |
PrecipitationRead | Precipitation | Subroutine | Read precipitation data |
PriestleyTaylor | Evapotranspiration | Subroutine | Compute potential evapotranspiration with Priestley-Taylor model |
Psi | SoilProperties | Function | Compute matric potential (m) |
put | iso_varying_string | Interface | |
put_CH | iso_varying_string | Subroutine | Append a character string to the current record of the default unit |
put_line | iso_varying_string | Interface | |
put_line_CH | iso_varying_string | Subroutine | Append a varying string to the current record of the default unit, terminating the record |
put_line_unit_CH | iso_varying_string | Subroutine | Append a varying string to the current record of the specified unit, terminating the record |
put_line_unit_VS | iso_varying_string | Subroutine | Append a varying string to the current record of the specified unit, terminating the record |
put_line_VS | iso_varying_string | Subroutine | Append a varying string to the current record of the default unit, terminating the record |
put_unit_CH | iso_varying_string | Subroutine | Append a character string to the current record of the specified unit |
put_unit_VS | iso_varying_string | Subroutine | Append a varying string to the current record of the specified unit |
put_VS | iso_varying_string | Subroutine | Append a varying string to the current record of the default unit |
ReadData | ObservationalNetworks | Interface | |
ReadDataFileUnit | ObservationalNetworks | Subroutine | read data from file unit. Data spanned on multiple time steps can be aggregated computing average, cumulated, maximum or minimum. Aggregated value is considered as missing if number of actual available observations is less than a given percentage (tresh) |
ReadField | MeteoUtilities | Subroutine | read a time varying field from a netcdf file |
ReadGeometry | Reservoirs | Subroutine | read geometry table |
ReadHydroNetwork | HydroNetwork | Interface | |
ReadMetadata | ObservationalNetworks | Interface | |
ReadMetadataFileName | ObservationalNetworks | Subroutine | read metadata section from file |
ReadMetadataFileUnit | ObservationalNetworks | Subroutine | read metadata section from open unit |
ReadNetworkGroundwater | HydroNetwork | Subroutine | Read network for groundwater-surface interaction from file |
ReadNetworkSediment | HydroNetwork | Subroutine | Read network for sediment routing from file |
ReadNetworkSurfaceFlow | HydroNetwork | Subroutine | Read network for surface flow routing from file |
ReadPointFileBasinAverage | BasinAverage | Subroutine | Read point file |
ReadSoilTypes | Infiltration | Subroutine | read soil types from external file |
ReadSpecies | Plants | Subroutine | read species parameters |
ReadWeir | Diversions | Subroutine | read weir table |
ReadWeir | Reservoirs | Subroutine | read weir table |
Refreezing | Snow | Function | compute refreezing rate (m/s) of the water retained in snowpack |
remove | iso_varying_string | Interface | |
remove_CH | iso_varying_string | Function | Remove a substring from a character string |
remove_VS | iso_varying_string | Function | Remove a substring from a varying string |
repeat | iso_varying_string | Interface | |
repeat_ | iso_varying_string | Function | Concatenate several copies of a varying string |
replace | iso_varying_string | Interface | |
replace_CH_CH_auto | iso_varying_string | Function | Replace part of a character string with a character substring |
replace_CH_CH_CH_target | iso_varying_string | Function | Handle special cases when LEN(target) == 0. Such instances are prohibited by the standard, but since this function is elemental, no error can be thrown. Therefore, it makes sense to handle them in a sensible manner |
replace_CH_CH_fixed | iso_varying_string | Function | Replace part of a character string with a character substring |
replace_CH_CH_VS_target | iso_varying_string | Function | Replace part of a character string with a varying substring, at a location matching a character- string target |
replace_CH_VS_auto | iso_varying_string | Function | Replace part of a character string with a varying substring |
replace_CH_VS_CH_target | iso_varying_string | Function | Replace part of a character string with a character substring, at a location matching a varying- string target |
replace_CH_VS_fixed | iso_varying_string | Function | Replace part of a character string with a varying substring |
replace_CH_VS_VS_target | iso_varying_string | Function | Replace part of a character string with a varying substring, at a location matching a varying- string target |
replace_VS_CH_auto | iso_varying_string | Function | Replace part of a varying string with a character substring |
replace_VS_CH_CH_target | iso_varying_string | Function | Replace part of a varying string with a character substring, at a location matching a character- string target |
replace_VS_CH_fixed | iso_varying_string | Function | Replace part of a varying string with a character substring |
replace_VS_CH_VS_target | iso_varying_string | Function | Replace part of a character string with a varying substring, at a location matching a character- string target |
replace_VS_VS_auto | iso_varying_string | Function | Replace part of a varying string with a varying substring |
replace_VS_VS_CH_target | iso_varying_string | Function | Replace part of a varying string with a character substring, at a location matching a varying- string target |
replace_VS_VS_fixed | iso_varying_string | Function | Replace part of a varying string with a varying substring |
replace_VS_VS_VS_target | iso_varying_string | Function | Replace part of a varying string with a varying substring, at a location matching a varying- string target |
ReplaceChar | StringManipulation | Function | char is replaced with rep |
ResampleFloat | GridOperations | Subroutine | |
ResampleFloatCell | GridOperations | Subroutine | Create a new |
ResampleInteger | GridOperations | Subroutine | |
ResampleIntegerCell | GridOperations | Subroutine | Create a new |
ReservoirReadStatus | Reservoirs | Subroutine | Read reservoir stage and diversion discharge from file |
ReservoirSaveStatus | Reservoirs | Subroutine | Save reservoirs status into file |
Rho | GeoLib | Function | Compute the radius of curvature of the ellipsoid in the plane of the meridian at given latitude |
RungeKutta | RoutingModels | Function | solve mass continuity of reservoir using runge kutta method |
Sat2scn | Infiltration | Subroutine | compute actual soil retention capacity S of the SCS-CN method |
SaveHotStart | Fest | Subroutine | Save state variables for starting a new simulation from the current condition |
Scale | MeteoUtilities | Subroutine | apply scale factor to a grid_real |
scan | iso_varying_string | Interface | |
scan_CH_VS | iso_varying_string | Function | Scan a character string for occurrences of characters in a varying-string set |
scan_VS_CH | iso_varying_string | Function | Scan a varying string for occurrences of characters in a character-string set |
scan_VS_VS | iso_varying_string | Function | Scan a varying string for occurrences of characters in a varying-string set |
ScanDatum | GeoLib | Function | return datum numeric code given a string |
ScanTimeStringAsString | GridLib | Subroutine | scan a string to extract time information as character strings: year, month, day, hour, minute, second, timezone supported formats: |
SCScurveNumber | Infiltration | Function | calculates the actual rate of infiltration (m/s) according to Curve Number model modified for continuous simulation |
SearchDatumByCode | GeoLib | Subroutine | Search for datum parameters using a code. |
SearchEllipsoidByCode | GeoLib | Subroutine | Search for ellipsoid parameters using a code. |
SecondOfYear | Chronos | Function | Gets the second of the year represented by this instance. |
SecondsToEnd | Chronos | Function | Gets the second to the end of the year represented by this instance. |
SectionIsPresent | IniLib | Function | return true if section is present, false otherwise |
SedimentInit | Sediment | Subroutine | Initialize sediment related variables |
SedimentRouting | Sediment | Subroutine | compute sediment routing in channelized drainage network using Muskingum-Cunge method. Interrill erosion is supposed to act as suspended sediment so deposition is not contemplated. Bedload sediment is divided in different grainsize classes and routing is performed for each class separately. Deposition is contemplated comparing sediment discharge to transport capacity. Flow Routing method code remind: 0 --> hillslope, water flow rate is not defined 1,2,3,11,30 --> channel routing, water flow is computed according to different schemes 5 --> Instantaneous mass transferring inside lakes (infinitive celerity) 1000:2000 --> reservoir |
Semivariogram | Kriging | Subroutine | generate a Semivariogram from a given sample. The sample point pairs are ordered into even-width bin, separated by the euclidean distance of the point pairs. The Semivariance in the bin is calculated by the Matheron estimator. If number of lags and lag max distance are not given they are automatically computed or set to default value. |
Separation | Kriging | Subroutine | Subroutine to find the distances between prediction point and observations. Also returns angles if anisotropy present |
SetCoord | GeoLib | Subroutine | assign easting and northing coordinates |
SetCRS | GeoLib | Interface | |
SetCRScoord | GeoLib | Subroutine | Initialize Coordinate Reference System, allocate memory and set parameters
to default value if necessary. subroutine receives as input a |
SetCRSsystem | GeoLib | Subroutine | Initialize Coordinate Reference System, allocate memory and set parameters
to default value if necessary. Subroutine receives as input a |
SetCurrentTime | GridLib | Interface | |
SetCurrentTimeFloat | GridLib | Subroutine | set the current time of a float grid |
SetCurrentTimeInteger | GridLib | Subroutine | set the current time of a integer grid |
SetDailyArray | Diversions | Function | populate array of daily values |
SetDailyArray | Reservoirs | Function | populate array of daily values |
SetDailyArray | Irrigation | Function | populate array of daily values |
SetDay | Chronos | Subroutine | Set the day of the datetime represented by this instance |
SetEsriPeString | GridLib | Interface | |
SetEsriPeStringFloat | GridLib | Subroutine | set the esri pe string of a float grid |
SetEsriPeStringInteger | GridLib | Subroutine | set the esri pe string of a integer grid |
SetFlowDirectionConvention | Morphology | Subroutine | Set flow direction convention: |
SetGaussBoagaParameters | GeoLib | Interface | |
SetGaussBoagaparametersCoord | GeoLib | Subroutine | Set parameters for Gauss Boaga reference system |
SetGaussBoagaparametersSystem | GeoLib | Subroutine | Set parameters for Gauss Boaga reference system |
SetGeodeticParameters | GeoLib | Interface | |
SetGeodeticParametersCoord | GeoLib | Subroutine | Set parameters for Geodetic reference system |
SetGeodeticParametersSystem | GeoLib | Subroutine | Set parameters for Geodetic reference system |
SetHotineParameters | GeoLib | Interface | |
SetHotineParametersCoord | GeoLib | Subroutine | Set parameters for Hotine Oblique Mercator reference system |
SetHotineParametersSystem | GeoLib | Subroutine | Set parameters for Hotine Oblique Mercator reference system |
SetHour | Chronos | Subroutine | Set the hour of the datetime represented by this instance |
SetIC | Plants | Subroutine | set initial condition |
SetInitialCondition | SoilBalance | Subroutine | set initial condition for soilwater balance |
SetLongName | GridLib | Interface | |
SetLongNameFloat | GridLib | Subroutine | set the long name of a float grid |
SetLongNameInteger | GridLib | Subroutine | set the long name of a integer grid |
SetMinute | Chronos | Subroutine | Set the minute of the datetime represented by this instance |
SetMonth | Chronos | Subroutine | Set the month of the datetime represented by this instance |
SetParametersFromDB | Infiltration | Subroutine | set parameter maps from soil database |
SetParametersFromFile | Infiltration | Subroutine | set parameter maps from separate files |
SetPlantsManagement | PlantsManagement | Subroutine | Set variables and options to manage plants. Basically two options are available: |
SetPractice | PlantsManagement | Subroutine | Set management practices to single plant stand |
SetReferenceTime | GridLib | Interface | |
SetReferenceTimeFloat | GridLib | Subroutine | set the reference time of a float grid |
SetReferenceTimeInteger | GridLib | Subroutine | set the reference time of a integer grid |
SetSecond | Chronos | Subroutine | Set the second of the datetime represented by this instance |
SetSpecificProperties | Precipitation | Subroutine | set properties and initialize variables for each interpolation method |
SetSpecificProperties | WindFlux | Subroutine | set properties and initialize variables for each interpolation method |
SetSpecificProperties | AirRelativeHumidity | Subroutine | set properties and initialize variables for each interpolation method |
SetSpecificProperties | AirTemperatureDailyMin | Subroutine | set properties and initialize variables for each interpolation method |
SetSpecificProperties | SolarRadiation | Subroutine | set properties and initialize variables for each interpolation method |
SetSpecificProperties | AirTemperature | Subroutine | |
SetSpecificProperties | AirTemperatureDailyMax | Subroutine | set properties and initialize variables for each interpolation method |
SetSpecificProperties | PrecipitationDaily | Subroutine | set properties and initialize variables for each interpolation method |
SetSpecificProperties | AirTemperatureDailyMean | Subroutine | |
SetStandardName | GridLib | Interface | |
SetStandardNameFloat | GridLib | Subroutine | set the standard name of a float grid |
SetStandardNameInteger | GridLib | Subroutine | set the standard name of a integer grid |
SetSwissParameters | GeoLib | Interface | |
SetSwissParametersCoord | GeoLib | Subroutine | Set parameters for Swiss Oblique Cylindrical reference system |
SetSwissParametersSystem | GeoLib | Subroutine | Set parameters for Swiss Oblique Cylindrical reference system |
SetTimeZone | Chronos | Subroutine | Set the timezone of the datetime represented by this instance |
SetTransverseMercatorParameters | GeoLib | Interface | |
SetTransverseMercatorParametersCoord | GeoLib | Subroutine | Set parameters for Transverse Mercator reference system |
SetTransverseMercatorParametersSystem | GeoLib | Subroutine | Set parameters for Transverse Mercator reference system |
SetUnits | GridLib | Interface | |
SetUnitsFloat | GridLib | Subroutine | set the units of a float grid |
SetUnitsInteger | GridLib | Subroutine | set the units of a integer grid |
SetUTMparameters | GeoLib | Interface | |
SetUTMparametersCoord | GeoLib | Subroutine | Set parameters for Universal Transverse Mercator reference system |
SetUTMparametersSystem | GeoLib | Subroutine | Set parameters for Universal Transverse Mercator reference system |
SetVaryingMode | GridLib | Interface | |
SetVaryingModeFloat | GridLib | Subroutine | set the varying mode of a float grid Possible values: |
SetVaryingModeInteger | GridLib | Subroutine | set the varying mode of a integer grid |
SetWetland | SoilBalance | Subroutine | set wetland for soilwater balance |
SetYear | Chronos | Subroutine | Set the year of the datetime represented by this instance |
ShearVelocity | Sediment | Function | compute shear velocity (m/s) |
ShiftBackWithLapse | MeteoUtilities | Subroutine | Shift back interpolated field to terrain surface |
ShiftInteger | GridOperations | Subroutine | Apply a shift to |
ShiftMeteoWithLapse | MeteoUtilities | Subroutine | shift meteo observations to reference elevation applying lapse rate |
ShiftReal | GridOperations | Subroutine | Apply a shift to |
ShortToString | StringManipulation | Function | Converts a short integer number in a string Arguments: number number to be converted Result: string |
Simplex | Kriging | Subroutine | This subroutine implements the simplex method of function minimization of Nelder and Mead (1965). This ingenious method is efficient for non-linear mini- mization in a multiparameter space but is still easy to program and only requires evaluations of the objective function. The program stops the iterations whenever one of the two following criteria is reached: 1. Convergence is reached 2. The maximum number of iterations is reached. |
SizesOK | DataTypeSizes | Function | Users may call this function once to ensure that the kind parameters the module defines are available with the current compiler. We can't ensure that the two REAL kinds are actually four and eight bytes long, but we can ensure that they are distinct. Early Fortran 90 compilers would sometimes report incorrect results for the bit_size intrinsic, but I haven't seen this in a long time. |
SkyView | SolarRadiation | Subroutine | Compute the maximum angle of sky obstruction along 16 directions |
SnowInit | Snow | Subroutine | Initialize snow model |
SnowParameterUpdate | Snow | Subroutine | update parameter map that change in time |
SnowPointExport | Snow | Subroutine | Export of point site data |
SnowPointInit | Snow | Subroutine | Initialize export of point site data |
SnowUpdate | Snow | Subroutine | compute accumulation and melting and update snow water equivalent |
SolarAzimuth | SolarRadiation | Function | Compute azimuth angle of the Sun's position in the north-clockwise convention |
SolarDeclination | SolarRadiation | Function | Compute solar declination. The declination of the sun is the angle between the equator and a line drawn from the centre of the Earth to the centre of the sun. |
SolarHourAngle | SolarRadiation | Function | Compute the hour angle. the solar hour angle is an expression of time, hour angle is 0.000 degree, with the time before solar noon expressed as negative degrees, and the local time after solar noon expressed as positive degrees. For example, at 10:30 AM local apparent time the hour angle is -22.5 degree (15 degree per hour times 1.5 hours before noon). |
SolarRadiationInit | SolarRadiation | Subroutine | Initialize solar radiation |
SolarRadiationRead | SolarRadiation | Subroutine | Read radiation data |
SolveSoilBalance | SoilBalance | Subroutine | Solve soil water balance |
Sort | SpatialInterpolation | Subroutine | Sort distances in increasing order |
Sort | Kriging | Subroutine | Subroutine to sort a vector of points using the Heap-sort algorithm. Data are sorted by value if flag =1, or by separation distance if flag = 0. Actually, only a pointer is sorted, as this is more efficient. Subroutine Adapted from Numerical Recipes in Fortran 90: Press, Teukolsky, Vetterling and Flannery (1996) pg. 1171 |
Sorted | Kriging | Subroutine | A subroutine to retrieve the nearest neighbors of the estimation location referred to as control points. The observations separation matrix is returned (as a precursor to producing the observations covariance matrix) along with the vector of nearest neighbbors. |
Splash | Fest | Subroutine | |
split | iso_varying_string | Interface | |
split_CH | iso_varying_string | Subroutine | Split a varying string into two verying strings |
split_VS | iso_varying_string | Subroutine | Split a varying string into two verying strings |
SplitNetwork | RiverDrainage | Subroutine | Split channel network where a confluence of two different horton order channels occurs |
StemBiomassVsDBH | PlantsAllometrics | Function | relationship between stem biomass andDBH (Diameter at Brest Height). |
StringCompact | StringManipulation | Function | Converts multiple spaces and tabs to single spaces; deletes control characters; removes initial spaces. Arguments: string String to be treated Result: String compacted |
StringReverse | StringManipulation | Function | Return a string that has all characters in reverse order Arguments: string String to be reversed Result: Reversed string |
StringSplit | StringManipulation | Subroutine | Finds the first instance of a character from 'delims' in the the string 'string'. The characters before the found delimiter are output in 'before'. The characters after the found delimiter are output in 'string'. The optional output character 'sep' contains the found delimiter. Arguments: string String to be treated Result: The characters before the found delimiter, the remainder is output in string |
StringToDouble | StringManipulation | Function | Converts number string to a double precision real number Arguments: string String to be converted Result: double precision real number |
StringToFloat | StringManipulation | Function | Converts number string to a real number Arguments: string String to be converted Result: float number |
StringTokenize | StringManipulation | Subroutine | It is often useful to represent a text as a list of tokens.
The process of breaking a text up into its constituent tokens is known
as tokenization. The subroutine parses the string in input into arguments
args(1), ..., args(nargs) based on the delimiters contained in the string
|
StringToLong | StringManipulation | Function | Converts number string to a long integer Arguments: string String to be converted Result: long integer |
StringToLower | StringManipulation | Function | ! Description: Return a string that has all letters in lower case Arguments: string String to be treated Result: String with letters turned into lower case |
StringToShort | StringManipulation | Function | Converts number string to a short integer Arguments: string String to be converted Result: short integer |
StringToUpper | StringManipulation | Function | Return a string that has all letters in upper case Arguments: string String to be treated Result: String with letters turned into upper case |
SubSectionIsPresent | IniLib | Function | return true if subsection is present in section, false otherwise |
SunElevationAngle | SolarRadiation | Function | Compute the sun elevation angle |
SwapGridIntegerBack | GridLib | Subroutine | transport matrix from grid_integer to netcdf format |
SwapGridIntegerForward | GridLib | Subroutine | transport matrix from netcdf format to grid_integer |
SwapGridRealBack | GridLib | Subroutine | transport matrix from grid_real to netcdf format |
SwapGridRealForward | GridLib | Subroutine | transport matrix from netcdf format to grid_real |
SWCmod | PlantsModifiers | Function | soil water content modifier |
Sync | IniLib | Subroutine | synchronize the window in which searching for the key |
SyncTime | GridLib | Subroutine | Description returns lower bounding time step of a given datetime |
TableCountCols | TableLib | Function | Count the number of columns in a table stored in a collection of lines.
Method:
count the number of tokens included in parentheses [].
Arguments:
|
TableCountRows | TableLib | Function | Count the number of rowss in a table stored in a collection of lines.
Method:
count the number of non blank lines that have not a keyword.
Arguments:
|
TableCreate | TableLib | Subroutine | create a new table from scratch and initialize variables
Arguments:
|
TableExport | TableLib | Interface | |
TableFileSync | TableLib | Function | search the file for beginning of next table defined by keyword Table Start
Arguments:
|
TableFillRow | TableLib | Subroutine | set row content
Arguments:
|
TableGetDouble | TableLib | Subroutine | returns a double from column defined by keyOut corresponding to valueIn
contained in column defined by keyIn.
Arguments:
|
TableGetFloat | TableLib | Subroutine | returns a float from column defined by keyOut corresponding to valueIn
contained in column defined by keyIn.
Arguments:
|
TableGetFloatByString | TableLib | Subroutine | returns a float from column defined by keyOut corresponding to |
TableGetFromFile | TableLib | Subroutine | read a table from specified file. File is not yet open.
If id is not specified, in a file containing multiple tables,
the first table is read
Arguments:
|
TableGetFromUnit | TableLib | Subroutine | read a table from specified file unit. File is already open.
Arguments:
|
TableGetNrows | TableLib | Interface | |
TableGetNumberRows | TableLib | Function | return the number of rows in a table |
TableGetString | TableLib | Subroutine | returns a string from column defined by keyOut corresponding to valueIn
contained in column defined by keyIn.
Arguments:
|
TableGetValue | TableLib | Interface | |
TableNew | TableLib | Interface | |
TableReadContent | TableLib | Subroutine | read the content of the table.
Arguments:
|
TableReadHeader | TableLib | Subroutine | read header of the columns of the table.
Arguments:
|
TableReadId | TableLib | Function | Read the Id of the table. Id is mandatory and must be unique.
Arguments:
|
TableReadTitle | TableLib | Function | Read the title of the table. Title is optional.
Arguments:
|
TableReadUnit | TableLib | Subroutine | read unit of the columns of the table.
Arguments:
|
TableSetColHeader | TableLib | Subroutine | set header of a specified column
Arguments:
|
TableSetColUnit | TableLib | Subroutine | set unit of a specified column
Arguments:
|
TableSetId | TableLib | Subroutine | set table id
Arguments:
|
TableSetRowCol | TableLib | Subroutine | set number of rows and columns and allocate variables
Arguments:
|
TableSetTitle | TableLib | Subroutine | set table title
Arguments:
|
TablesGetDouble | TableLib | Subroutine | returns a double from column defined by keyOut corresponding to valueIn
contained in column defined by keyIn. Table is identified by its id.
Arguments:
|
TablesGetFloat | TableLib | Subroutine | returns a float from column defined by keyOut corresponding to valueIn
contained in column defined by keyIn. Table is identified by its id.
Arguments:
|
TablesGetFloatByString | TableLib | Subroutine | returns a float from column defined by keyOut corresponding to valueIn
(string) contained in column defined by keyIn. Table is identified by its id.
Arguments:
|
TablesGetFromFile | TableLib | Subroutine | read a collection of tables from specified file.
Arguments:
|
TablesGetFromUnit | TableLib | Subroutine | read a collection of tables from specified unit. File is already open.
Arguments:
|
TablesGetIds | TableLib | Function | Return a list of Ids from TableCollection
Arguments:
|
TablesGetNumberRows | TableLib | Function | return the number of rows of a table in a table collection |
TablesGetString | TableLib | Subroutine | returns a string from column defined by keyOut corresponding to valueIn
contained in column defined by keyIn. Table is identified by its id.
Arguments:
|
TableStoreLines | TableLib | Subroutine | read the lines of a table which are stored in an array of strings.
Non significative lines (i.e. comments or blank lines) are ignored.
Subroutine supposes that the cursor is sync to the first line after
the keyword 'Table Start'. hence it is must benn called after
a call to tableFileSync.
Arguments:
|
TablesWriteToFile | TableLib | Subroutine | write a collection of tables on file. If id is present, only the table
corresponding to that id is written.
Arguments:
|
TablesWriteToUnit | TableLib | Subroutine | write a collection of tables on file already open. If id is present,
only the table corresponding to that id is written.
Arguments:
|
TableSyncById | TableLib | Function | returns the position of table in collection of tables identified by id.
Arguments:
|
TableWriteToFile | TableLib | Subroutine | write a table on file.
Arguments:
|
TableWriteToUnit | TableLib | Subroutine | write a table on file taht is already open.
Arguments:
|
TabToSpace | StringManipulation | Function | Tab character is substituted by one blank character Arguments: string String to be processed Result: processed string |
TEMPmod | PlantsModifiers | Function | compute air temperature modifier. The growth and dormant stages of vegetation are related to the annual cycle of air temperature. Maximum growth will happen at optimal temperatures Topt and will stop when temperatures drop below or exceed certain temperature thresholds, Tmin and Tmax, respectively. |
Throughfall | PlantsInterception | Subroutine | calculate the effective rainfall through canopy |
TimeByIndex | GridLib | Function | Description returns time given time index |
TimeDifference | Chronos | Function | calculate the difference in seconds between two date: time1 - time2 |
TimeIndex | GridLib | Function | Calculate the index to extract the corresponding slice from netcdf file. |
TimeStamp | Utilities | Subroutine | prints the current YMDHMS date as a time stamp.
Cursor remains on the same line.
Example: |
TimeStamp | LogLib | Subroutine | prints the current YMDHMS date as a time stamp.
Example: |
TimeToString | Chronos | Subroutine | Converts the value of the current |
TopographicIndex | Morphology | Subroutine | Topographic index |
TopWidth | RoutingModels | Function | returns the topwidth of a triangular, rectangular or trapezoidal cross section |
ToString | StringManipulation | Interface | |
ToUTC | Chronos | Function | Converts the value of the current |
trim | iso_varying_string | Interface | |
trim_ | iso_varying_string | Function | Remove trailing blanks from a varying string |
UniqueValues | GridStatistics | Interface | |
UniqueValuesOfGridInteger | GridStatistics | Subroutine | Description return a vector of distinct values from a grid_integer |
UnsHydCond | SoilProperties | Function | Compute hydraulic conductivity of partially saturated soil (m/s) |
UpdateSoilMoisture | SoilBalance | Subroutine | update soil moisture |
UpstreamCell | Morphology | Subroutine | returns the position (is,js) of the upstream cell and, optionally, the flow path length, considering cardinal and diagonal direction |
UtcNow | Chronos | Function | Gets a |
Valf | Kriging | Function | function called by Simplex |
var_str | iso_varying_string | Interface | |
var_str_ | iso_varying_string | Function | Convert a character string to a varying string |
Varfit | Kriging | Subroutine | Fit model to experimental variogram |
Variogr | Kriging | Subroutine | calculation of the variogram value in 2D |
Velocity | RoutingModels | Function | returns the normal velocity (m/s) with Chezy equation |
verify | iso_varying_string | Interface | |
verify_CH_VS | iso_varying_string | Function | Verify a character string for occurrences of characters in a varying-string set |
verify_VS_CH | iso_varying_string | Function | Verify a varying string for occurrences of characters in a character-string set |
verify_VS_VS | iso_varying_string | Function | Verify a varying string for occurrences of characters in a varying-string set |
VPDmod | PlantsModifiers | Function | compute vapor pressure deficit modifier. |
WetlandIsWet | SoilBalance | Function | return .TRUE. if wetland is flooded |
WettedArea | RoutingModels | Function | returns the wetted area of a triangular, rectangular or trapezoidal cross section |
WettedPerimeter | RoutingModels | Function | returns the wetted perimeter of a triangular, rectangular or trapezoidal cross section |
WindFluxInit | WindFlux | Subroutine | Initialize air temperature |
WindFluxRead | WindFlux | Subroutine | Read wind speed data |
WindGonzalezLongatt | SpatialInterpolation | Subroutine | This subroutine implements the method presented by Gonzalez-Longatt et al. (2015). Zonal and meridional components are computed and then orographic correction is applied. The two components are then re-composed to provide final result. |
WindMicromet | SpatialInterpolation | Subroutine | This subroutine implements the method used in the MICROMET program (see reference). Wind speed is interpolated accounting for wind direction and an empirical weigth that considers slope and curvature (topographic effect) |
WriteData | ObservationalNetworks | Interface | |
WriteDataFileUnit | ObservationalNetworks | Subroutine | write data from file unit. if optional argument init is true a string to initialize data section of file is written |
WriteMetadata | ObservationalNetworks | Interface | |
WriteMetadataFileName | ObservationalNetworks | Subroutine | write metadata section to file TODO: full CRS support |
WriteMetadataFileUnit | ObservationalNetworks | Subroutine | write metadata section to open file unit TODO: full CRS support |
Yang1973 | Sediment | Function | compute sediment transport capacity using Yang (1973) approach (kg/s) limitation: Yang1973 equation can be applied for noncohesive natural beds with particle sizes between 0.062 mm and 2 mm, a specific gravity of 2.65 g/cm3, and a shape factor of 0.7 |
Yang1979 | Sediment | Function | compute sediment transport capacity using Yang (1979) approach (kg/s) limitation: Yang1979 equation can be applied when the dimensionless unit stream power is relatively small with respect to the prevailing value of unit stream power. Used for finer suspended sediment trasnport in the Yellow River with median particle diameter of 0.067 mm. |
ZscoreNormalizationFloat | GridStatistics | Subroutine | also called zero-mean normalization. The values of attribute |