| Acc240_Climate_LUNA |
LunaMod |
Subroutine |
|
| Acc24_Climate_LUNA |
LunaMod |
Subroutine |
|
| accumulate |
m_Accumulator |
Interface |
|
| AccumulateFluxes_ED |
EDAccumulateFluxesMod |
Subroutine |
|
| accumulRest |
accumulMod |
Subroutine |
|
| active_pes |
m_GlobalSegMap |
Interface |
|
| add_column |
initSubgridMod |
Subroutine |
|
| add_landunit |
initSubgridMod |
Subroutine |
|
| add_patch |
initSubgridMod |
Subroutine |
|
| add_to_file_list |
pio_msg_mod |
Subroutine |
|
| add_to_iodesc_list |
pio_msg_mod |
Subroutine |
|
| adjust_bounds |
piovdc |
Subroutine |
@brief subroutine checks start/count for out of bounds, adjusts if the start/count is too high,
zeroes start if it is invalid
POST-EFFECTS:
all start/counts are now legal, non-IO tasks have zeroed start counts
@param[in] global_dims int(3) global grid dimensions
@param[in] rank int rank of current MPI task
@param[inout] start int(3) current MPI task global start
@param[inout] count int(3) current MPI task global count |
| AdjustDeltaHeatForDeltaLiq |
TotalWaterAndHeatMod |
Subroutine |
|
| advance_timestep |
RtmTimeManager |
Subroutine |
|
| advance_timestep |
clm_time_manager |
Subroutine |
|
| AerosolFluxes |
AerosolMod |
Subroutine |
|
| AerosolMasses |
AerosolMod |
Subroutine |
|
| allocate_bcin |
FatesInterfaceMod |
Subroutine |
|
| allocate_bcout |
FatesInterfaceMod |
Subroutine |
|
| allocated |
m_List |
Interface |
|
| allocFilters |
filterMod |
Subroutine |
|
| AllReduce |
m_AttrVectReduce |
Interface |
|
| alt_calc |
ActiveLayerMod |
Subroutine |
|
| annual_flux_dribbler_gridcell |
AnnualFluxDribbler |
Function |
|
| annual_flux_dribbler_patch |
AnnualFluxDribbler |
Function |
|
| append |
m_List |
Interface |
|
| appendIAttr |
m_AttrVect |
Interface |
|
| appendRAttr |
m_AttrVect |
Interface |
|
| AppTemp |
HumanIndexMod |
Subroutine |
|
| area_burnt |
SFMainMod |
Subroutine |
currentPatch%AB !daily area burnt (m2)
currentPatch%NF !Daily number of ignitions (lightning and human-caused), adjusted for size of patch. Read more… |
| array_div_vector |
SimpleMathMod |
Interface |
|
| array_div_vector_filter |
SimpleMathMod |
Subroutine |
|
| array_div_vector_nofilter |
SimpleMathMod |
Subroutine |
|
| array_normalization |
SimpleMathMod |
Interface |
|
| array_normalization_2d |
SimpleMathMod |
Subroutine |
|
| array_normalization_2d_filter |
SimpleMathMod |
Subroutine |
|
| AssembleMatrixFromSubmatrices |
SoilTemperatureMod |
Subroutine |
|
| assert_ |
m_die |
Subroutine |
|
| assignment(=) |
m_List |
Interface |
|
| atm2lnd_params_type |
atm2lndType |
Interface |
|
| atm_final_mct |
atm_comp_mct |
Subroutine |
|
| atm_init_mct |
atm_comp_mct |
Subroutine |
|
| atm_run_mct |
atm_comp_mct |
Subroutine |
|
| att_1d_handler |
pio_msg_callbacks.F90 |
Subroutine |
|
| att_handler |
pio_msg_callbacks.F90 |
Subroutine |
|
| auto_get_start_count |
piovdc |
Subroutine |
@brief subroutine that, given a global grid, VDC blocksize, and max # of nioprocs, will
automatically create an VDC optimized IO decomposition that uses the most possible IO tasks
POST-EFFECTS:
Each MPI Task is now either and IO task or a computational task. IO tasks have nonzero start/counts
@param[in] rank int rank of the current MPI task
@param[inout] nioprocs int represents the max possible # of IO procs,
@algorithm will try to get as close as possible to this # and return it in nioprocs
@param[in] blockdims int(3) global grid dimensions represented as VDC blocks
@param[out] start int(3) iostart for the current MPI task
@param[out] count int(3) iocount for the current MPI task
@param[in] bsize int(3) VDC block size |
| average |
m_Accumulator |
Interface |
|
| bad_iotype |
pio_utils |
Subroutine |
@private |
| bagw_allom |
FatesAllometryMod |
Subroutine |
|
| BalanceCheck |
BalanceCheckMod |
Subroutine |
|
| BalanceCheckClean |
BalanceCheckMod |
Subroutine |
|
| BalanceCheckInit |
BalanceCheckMod |
Subroutine |
|
| BandDiagonal |
BandDiagonalMod |
Subroutine |
$ SUBROUTINE SGBSV( N, KL, KU, NRHS, AB, LDAB, IPIV, B, LDB, INFO )
$
$ -- LAPACK driver routine (version 3.1) --
$ Univ. of Tennessee, Univ. of California Berkeley and NAG Ltd..
$ November 2006
$
$ .. Scalar Arguments ..
$ INTEGER INFO, KL, KU, LDAB, LDB, N, NRHS
$ ..
$ .. Array Arguments ..
$ INTEGER IPIV( * )
$ REAL AB( LDAB, * ), B( LDB, * )
$ ..
$
$ Purpose
$ =======
$
$ SGBSV computes the solution to a real system of linear equations
$ A * X = B, where A is a band matrix of order N with KL subdiagonals
$ and KU superdiagonals, and X and B are N-by-NRHS matrices.
$
$ The LU decomposition with partial pivoting and row interchanges is
$ used to factor A as A = L * U, where L is a product of permutation
$ and unit lower triangular matrices with KL subdiagonals, and U is
$ upper triangular with KL+KU superdiagonals. The factored form of A
$ is then used to solve the system of equations A * X = B.
$
$ Arguments
$ =========
$
$ N (input) INTEGER
$ The number of linear equations, i.e., the order of the
$ matrix A. N >= 0.
$
$ KL (input) INTEGER
$ The number of subdiagonals within the band of A. KL >= 0.
$
$ KU (input) INTEGER
$ The number of superdiagonals within the band of A. KU >= 0.
$
$ NRHS (input) INTEGER
$ The number of right hand sides, i.e., the number of columns
$ of the matrix B. NRHS >= 0.
$
$ AB (input/output) REAL array, dimension (LDAB,N)
$ On entry, the matrix A in band storage, in rows KL+1 to
$ 2KL+KU+1; rows 1 to KL of the array need not be set.
$ The j-th column of A is stored in the j-th column of the
$ array AB as follows:
$ AB(KL+KU+1+i-j,j) = A(i,j) for max(1,j-KU)<=i<=min(N,j+KL)
$ On exit, details of the factorization: U is stored as an
$ upper triangular band matrix with KL+KU superdiagonals in
$ rows 1 to KL+KU+1, and the multipliers used during the
$ factorization are stored in rows KL+KU+2 to 2KL+KU+1.
$ See below for further details.
$
$ LDAB (input) INTEGER
$ The leading dimension of the array AB. LDAB >= 2KL+KU+1.
$
$ IPIV (output) INTEGER array, dimension (N)
$ The pivot indices that define the permutation matrix P;
$ row i of the matrix was interchanged with row IPIV(i).
$
$ B (input/output) REAL array, dimension (LDB,NRHS)
$ On entry, the N-by-NRHS right hand side matrix B.
$ On exit, if INFO = 0, the N-by-NRHS solution matrix X.
$
$ LDB (input) INTEGER
$ The leading dimension of the array B. LDB >= max(1,N).
$
$ INFO (output) INTEGER
$ = 0: successful exit
$ < 0: if INFO = -i, the i-th argument had an illegal value
$ > 0: if INFO = i, U(i,i) is exactly zero. The factorization
$ has been completed, but the factor U is exactly
$ singular, and the solution has not been computed.
$
$ Further Details
$ ===============
$
$ The band storage scheme is illustrated by the following example, when
$ M = N = 6, KL = 2, KU = 1:
$
$ On entry: On exit:
$
$ * * * + + + * * * u14 u25 u36
$ * * + + + + * * u13 u24 u35 u46
$ * a12 a23 a34 a45 a56 * u12 u23 u34 u45 u56
$ a11 a22 a33 a44 a55 a66 u11 u22 u33 u44 u55 u66
$ a21 a32 a43 a54 a65 * m21 m32 m43 m54 m65 *
$ a31 a42 a53 a64 * * m31 m42 m53 m64 * *
$
$ Array elements marked * are not used by the routine; elements marked
$ + need not be set on entry, but are required by the routine to store
$ elements of U because of fill-in resulting from the row interchanges. |
| BareGroundFluxes |
BareGroundFluxesMod |
Subroutine |
|
| bareland_normalization |
lnd2glcMod |
Function |
|
| BaseflowSink |
SoilWaterMovementMod |
Subroutine |
|
| bbgw_allom |
FatesAllometryMod |
Subroutine |
|
| bcast |
m_AttrVectComms |
Interface |
|
| Bcast |
m_SparseMatrixComms |
Interface |
|
| bcast |
m_AccumulatorComms |
Interface |
|
| bcast |
m_List |
Interface |
|
| bcast |
m_GeneralGridComms |
Interface |
|
| bcast |
m_String |
Interface |
|
| bcast |
m_GlobalSegMapComms |
Interface |
|
| bdead_allom |
FatesAllometryMod |
Subroutine |
|
| BeginWaterBalance |
BalanceCheckMod |
Subroutine |
|
| bfineroot |
FatesAllometryMod |
Subroutine |
|
| bleaf |
FatesAllometryMod |
Subroutine |
|
| blmax_allom |
FatesAllometryMod |
Subroutine |
|
| bounds |
m_GlobalMap |
Interface |
|
| bsap_allom |
FatesAllometryMod |
Subroutine |
|
| bstore_allom |
FatesAllometryMod |
Subroutine |
|
| btran_ed |
EDBtranMod |
Subroutine |
|
| btran_sal_stress_fates |
FatesBstressMod |
Subroutine |
|
| BuildingTemperature |
UrbBuildTempOleson2015Mod |
Subroutine |
|
| BuildSnowFilter |
SnowHydrologyMod |
Subroutine |
|
| ByColumn |
m_SparseMatrixDecomp |
Interface |
|
| ByRow |
m_SparseMatrixDecomp |
Interface |
|
| C13_init_TimeSeries |
CIsoAtmTimeseriesMod |
Subroutine |
allocate arrays based on size of netcdf timeseries |
| C13TimeSeries |
CIsoAtmTimeseriesMod |
Subroutine |
|
| C14_init_BombSpike |
CIsoAtmTimeseriesMod |
Subroutine |
allocate arrays based on size of netcdf timeseries |
| C14BombSpike |
CIsoAtmTimeseriesMod |
Subroutine |
|
| C14Decay |
CNC14DecayMod |
Subroutine |
|
| c2g |
subgridAveMod |
Interface |
|
| c2g_1d |
subgridAveMod |
Subroutine |
|
| c2g_2d |
subgridAveMod |
Subroutine |
|
| c2l |
subgridAveMod |
Interface |
|
| c2l_1d |
subgridAveMod |
Subroutine |
|
| c2l_2d |
subgridAveMod |
Subroutine |
|
| calc_areaindex |
EDCanopyStructureMod |
Function |
|
| calc_effective_snowporosity |
SoilMoistStressMod |
Subroutine |
|
| calc_effective_soilporosity |
SoilMoistStressMod |
Subroutine |
|
| calc_root_moist_stress |
SoilMoistStressMod |
Subroutine |
|
| calc_soilevap_resis |
SurfaceResistanceMod |
Subroutine |
|
| calc_volumetric_h2oliq |
SoilMoistStressMod |
Subroutine |
|
| calcdisplace |
calcdisplace_mod |
Subroutine |
|
| calcdisplace_box |
calcdisplace_mod |
Subroutine |
|
| CalcStartandCount |
calcdecomp |
Subroutine |
|
| cambial_damage_kill |
SFMainMod |
Subroutine |
routine description.
returns the probability that trees dies due to cambial char
currentPatch%tau_l = duration of lethal stem heating (min). Calculated at patch level. Read more… |
| canopy_spread |
EDCanopyStructureMod |
Subroutine |
|
| canopy_structure |
EDCanopyStructureMod |
Subroutine |
|
| canopy_summarization |
EDCanopyStructureMod |
Subroutine |
|
| CanopyFluxes |
CanopyFluxesMod |
Subroutine |
modify csoilc value (0.004) if the under-canopy is in stable condition Read more… |
| CanopyFluxesReadNML |
CanopyFluxesMod |
Subroutine |
|
| CanopyHydrology |
CanopyHydrologyMod |
Subroutine |
|
| CanopyHydrology_readnl |
CanopyHydrologyMod |
Subroutine |
|
| CanopySunShadeFracs |
SurfaceRadiationMod |
Subroutine |
|
| CanopyTemperature |
CanopyTemperatureMod |
Subroutine |
|
| carea_allom |
FatesAllometryMod |
Subroutine |
|
| catFields |
seq_flds_mod |
Subroutine |
|
| ch4 |
ch4Mod |
Subroutine |
!! Begin biochemistry |
| ch4_init_balance_check |
ch4Mod |
Subroutine |
|
| ch4conrd |
ch4varcon |
Subroutine |
|
| char |
m_String |
Interface |
|
| CharBufferSize |
m_List |
Interface |
|
| charecteristics_of_fuel |
SFMainMod |
Subroutine |
Read more… |
| check_dim |
RtmIO |
Subroutine |
|
| check_fields |
component_type_mod |
Subroutine |
|
| check_hlm_active |
CLMFatesInterfaceMod |
Subroutine |
|
| check_hlm_list |
FatesUtilsMod |
Function |
|
| check_layer_water |
EDBtranMod |
Function |
|
| check_netcdf |
pio_utils |
Subroutine |
|
| check_patch_area |
EDPatchDynamicsMod |
Subroutine |
|
| check_sums_equal_1 |
surfrdUtilsMod |
Subroutine |
|
| check_var |
RtmIO |
Subroutine |
|
| check_var_real |
FatesUtilsMod |
Subroutine |
|
| check_weights |
subgridWeightsMod |
Subroutine |
|
| CheckBounds |
m_SparseMatrix |
Interface |
|
| checkdate |
test.F90 |
Subroutine |
|
| CheckIntegratedAllometries |
FatesAllometryMod |
Subroutine |
|
| CheckMPIreturn |
pio_support |
Subroutine |
|
| CheckUrban |
UrbanParamsType |
Subroutine |
|
| chrget |
m_inpak90 |
Function |
|
| cime_final |
cime_comp_mod |
Subroutine |
|
| cime_init |
cime_comp_mod |
Subroutine |
Component Initialization
Note that within each component initialization, the relevant x_present flag
part of CIMEInit can be modified
By default, all these flags are set to true
The atm can reset the lnd_present, ice_present and ocn_present flags based
on aqua_planet, ideal_phys and adiabatic modes
The stub components will reset the present flags to false, all other
components will set them to true for the purposes of symmetry Read more… |
| cime_pre_init1 |
cime_comp_mod |
Subroutine |
Read more… |
| cime_pre_init2 |
cime_comp_mod |
Subroutine |
mt call shr_mem_init(prt=.true.) Read more… |
| cime_run |
cime_comp_mod |
Subroutine |
Advance Clock
(this is time that models should have before they return
to the driver). Write timestamp and run alarm status Read more… |
| CIsoFlux1 |
CNCIsoFluxMod |
Subroutine |
|
| CIsoFlux2 |
CNCIsoFluxMod |
Subroutine |
|
| CIsoFlux2h |
CNCIsoFluxMod |
Subroutine |
|
| CIsoFlux3 |
CNCIsoFluxMod |
Subroutine |
|
| clean |
m_AttrVect |
Interface |
|
| clean |
m_GlobalMap |
Interface |
|
| clean |
m_Rearranger |
Interface |
|
| clean |
m_List |
Interface |
|
| clean |
m_MCTWorld |
Interface |
|
| clean |
m_Router |
Interface |
|
| clean |
m_Navigator |
Interface |
|
| clean |
m_SparseMatrixPlus |
Interface |
|
| clean |
m_Accumulator |
Interface |
|
| clean |
m_String |
Interface |
|
| Clean |
pftconMod |
Subroutine |
|
| clean |
m_SparseMatrix |
Interface |
|
| clean |
m_GlobalSegMap |
Interface |
|
| clean |
m_GeneralGrid |
Interface |
|
| clean_ |
m_SparseMatrixPlus |
Subroutine |
|
| clean_accum_fields |
accumulMod |
Subroutine |
|
| cleanSharedIndices |
m_AttrVect |
Interface |
|
| cleanSharedIndicesOneType |
m_AttrVect |
Interface |
|
| Clear24_Climate_LUNA |
LunaMod |
Subroutine |
|
| clm_cpl_indices_set |
clm_cpl_indices |
Subroutine |
|
| clm_domain_mct |
ndepStreamMod |
Subroutine |
|
| clm_drv |
clm_driver |
Subroutine |
|
| clm_instInit |
clm_instMod |
Subroutine |
|
| clm_instReadNML |
clm_instMod |
Subroutine |
|
| clm_instRest |
clm_instMod |
Subroutine |
|
| clm_ptrs_check |
initSubgridMod |
Subroutine |
|
| clm_ptrs_compdown |
initSubgridMod |
Subroutine |
|
| clm_varcon_init |
clm_varcon |
Subroutine |
|
| clm_varctl_set |
clm_varctl |
Subroutine |
|
| clm_varpar_init |
clm_varpar |
Subroutine |
|
| close_nf |
ionf_mod |
Function |
|
| clsieee |
m_ioutil |
Subroutine |
|
| clstext |
m_ioutil |
Subroutine |
|
| CNAllocate_Carbon_only |
clm_varctl |
Function |
|
| cnallocate_carbon_only_set |
clm_varctl |
Subroutine |
|
| CNAnnualUpdate |
CNAnnualUpdateMod |
Subroutine |
|
| CNDriverInit |
CNDriverMod |
Subroutine |
|
| CNDriverLeaching |
CNDriverMod |
Subroutine |
|
| CNDriverNoLeaching |
CNDriverMod |
Subroutine |
|
| CNDriverSummarizeFluxes |
CNDriverMod |
Subroutine |
|
| CNDriverSummarizeStates |
CNDriverMod |
Subroutine |
|
| CNDVDriver |
CNDVDriverMod |
Subroutine |
|
| CNDVHist |
CNDVDriverMod |
Subroutine |
|
| cnfire_li2014_type |
CNFireLi2014Mod |
Interface |
|
| cnfire_li2016_type |
CNFireLi2016Mod |
Interface |
|
| cnfire_nofire_type |
CNFireNoFireMod |
Interface |
|
| CNFireEmisUpdate |
CNFireEmissionsMod |
Subroutine |
|
| CNFireReadNML |
CNFireFactoryMod |
Subroutine |
|
| CNFreeLivingFixation |
CNNDynamicsMod |
Subroutine |
|
| CNFUN |
CNFUNMod |
Subroutine |
|
| CNFUNInit |
CNFUNMod |
Subroutine |
|
| CNGapMortality |
CNGapMortalityMod |
Subroutine |
|
| CNGResp |
CNGRespMod |
Subroutine |
|
| CNHarvest |
dynHarvestMod |
Subroutine |
|
| CNMResp |
CNMRespMod |
Subroutine |
|
| CNMRespReadNML |
CNMRespMod |
Subroutine |
|
| CNNDeposition |
CNNDynamicsMod |
Subroutine |
|
| CNNDynamicsReadNML |
CNNDynamicsMod |
Subroutine |
|
| CNNFert |
CNNDynamicsMod |
Subroutine |
|
| CNNFixation |
CNNDynamicsMod |
Subroutine |
|
| CNParamsReadShared |
CNSharedParamsMod |
Subroutine |
|
| CNParamsReadShared_namelist |
CNSharedParamsMod |
Subroutine |
|
| CNParamsReadShared_netcdf |
CNSharedParamsMod |
Subroutine |
|
| CNPhenology |
CNPhenologyMod |
Subroutine |
|
| CNPhenologyInit |
CNPhenologyMod |
Subroutine |
|
| CNPhenologyReadNML |
CNPhenologyMod |
Subroutine |
|
| CNPrecisionControl |
CNPrecisionControlMod |
Subroutine |
|
| CNPrecisionControlReadNML |
CNPrecisionControlMod |
Subroutine |
|
| CNRootDyn |
CNRootDynMod |
Subroutine |
Read more… |
| CNSoyfix |
CNNDynamicsMod |
Subroutine |
|
| CNVegStructUpdate |
CNVegStructUpdateMod |
Subroutine |
|
| col_filter_empty |
filterColMod |
Function |
|
| col_filter_from_filter_and_logical_array |
filterColMod |
Function |
|
| col_filter_from_grcflags_ltypes |
filterColMod |
Function |
|
| col_filter_from_index_array |
filterColMod |
Function |
|
| col_filter_from_logical_array |
filterColMod |
Function |
|
| col_filter_from_logical_array_active_only |
filterColMod |
Function |
|
| col_filter_from_ltypes |
filterColMod |
Function |
|
| col_filter_from_lunflags |
filterColMod |
Function |
|
| col_itype_to_icemec_class |
column_varcon |
Function |
|
| collapse_crop_types |
surfrdUtilsMod |
Subroutine |
|
| column_state_updater_type |
dynColumnStateUpdaterMod |
Interface |
|
| CombineSnowLayers |
SnowHydrologyMod |
Subroutine |
|
| comp_id |
m_GlobalMap |
Interface |
|
| comp_id |
m_GlobalSegMap |
Interface |
|
| component_diag |
component_mod |
Subroutine |
|
| component_exch |
component_mod |
Subroutine |
|
| component_final |
component_mod |
Subroutine |
|
| component_get_c2x_cc |
component_type_mod |
Function |
|
| component_get_c2x_cx |
component_type_mod |
Function |
|
| component_get_cdata_cc |
component_type_mod |
Function |
|
| component_get_dom_cc |
component_type_mod |
Function |
|
| component_get_dom_cx |
component_type_mod |
Function |
|
| component_get_drv2mdl |
component_type_mod |
Function |
|
| component_get_gsmap_cc |
component_type_mod |
Function |
|
| component_get_gsmap_cx |
component_type_mod |
Function |
|
| component_get_iamin_compid |
component_type_mod |
Function |
|
| component_get_iamroot_compid |
component_type_mod |
Function |
|
| component_get_mapper_Cc2x |
component_type_mod |
Function |
|
| component_get_mapper_Cx2c |
component_type_mod |
Function |
|
| component_get_mdl2drv |
component_type_mod |
Function |
|
| component_get_name |
component_type_mod |
Function |
|
| component_get_suffix |
component_type_mod |
Function |
|
| component_get_x2c_cc |
component_type_mod |
Function |
|
| component_get_x2c_cx |
component_type_mod |
Function |
|
| component_init_areacor |
component_mod |
Subroutine |
|
| component_init_aream |
component_mod |
Subroutine |
|
| component_init_cc |
component_mod |
Subroutine |
|
| component_init_cx |
component_mod |
Subroutine |
|
| component_init_pre |
component_mod |
Subroutine |
|
| component_run |
component_mod |
Subroutine |
|
| ComponentNumProcs |
m_MCTWorld |
Interface |
|
| ComponentRootRank |
m_MCTWorld |
Interface |
|
| ComponentToWorldRank |
m_MCTWorld |
Interface |
|
| Compute_EffecRootFrac_And_VertTranSink |
SoilWaterPlantSinkMod |
Subroutine |
|
| Compute_EffecRootFrac_And_VertTranSink_Default |
SoilWaterPlantSinkMod |
Subroutine |
|
| Compute_EffecRootFrac_And_VertTranSink_HydStress |
SoilWaterPlantSinkMod |
Subroutine |
|
| Compute_EffecRootFrac_And_VertTranSink_HydStress_Roads |
SoilWaterPlantSinkMod |
Subroutine |
|
| compute_higher_order_weights |
subgridWeightsMod |
Subroutine |
|
| ComputeGroundHeatFluxAndDeriv |
SoilTemperatureMod |
Subroutine |
|
| ComputeHeatDiffFluxAndFactor |
SoilTemperatureMod |
Subroutine |
|
| ComputeHeatLake |
TotalWaterAndHeatMod |
Subroutine |
|
| ComputeHeatNonLake |
TotalWaterAndHeatMod |
Subroutine |
|
| ComputeLiqIceMassLake |
TotalWaterAndHeatMod |
Subroutine |
|
| ComputeLiqIceMassNonLake |
TotalWaterAndHeatMod |
Subroutine |
|
| ComputeMaxDaylength |
DaylengthMod |
Subroutine |
|
| ComputeRootSoilFlux |
CLMFatesInterfaceMod |
Subroutine |
|
| ComputeSeedAmounts |
CNVegComputeSeedMod |
Subroutine |
|
| ComputeSparsity |
m_SparseMatrix |
Interface |
|
| computestartandcount |
calcdecomp |
Subroutine |
|
| ComputeWaterMassLake |
TotalWaterAndHeatMod |
Subroutine |
|
| ComputeWaterMassNonLake |
TotalWaterAndHeatMod |
Subroutine |
|
| concatenate |
m_List |
Interface |
|
| control_init |
controlMod |
Subroutine |
|
| control_print |
controlMod |
Subroutine |
|
| control_setNL |
controlMod |
Subroutine |
|
| control_spmd |
controlMod |
Subroutine |
|
| convert_cft_to_pft |
surfrdUtilsMod |
Subroutine |
|
| convertgauss |
convertgauss.F90 |
Subroutine |
|
| convertPOPT |
convertPOPT.F90 |
Subroutine |
Read more… |
| Copy |
m_AttrVect |
Interface |
|
| copy |
m_List |
Interface |
|
| Copy |
m_ACTEST |
Interface |
|
| Copy |
m_SparseMatrix |
Interface |
|
| copy |
m_GlobalSegMap |
Interface |
|
| Copy |
m_AVTEST |
Interface |
|
| copy_cohort |
EDCohortDynamicsMod |
Subroutine |
|
| copy_pio_var |
pio_nf_utils |
Interface |
|
| count_cohorts |
EDCohortDynamicsMod |
Subroutine |
|
| coupler |
coupler.F90 |
Subroutine |
!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! Read more… |
| cplfin |
coupler |
Subroutine |
|
| cplinit |
coupler |
Subroutine |
!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! Read more… |
| cplrun |
coupler |
Subroutine |
! END OF RUN !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! |
| create_and_init_ozone_type |
OzoneFactoryMod |
Function |
|
| create_cnfire_method |
CNFireFactoryMod |
Function |
|
| create_cohort |
EDCohortDynamicsMod |
Subroutine |
***/
Define cohort state variable
***/ |
| create_dyn_file |
test_dynVarShared |
Function |
|
| create_file_handler |
pio_msg_callbacks.F90 |
Subroutine |
|
| create_interp_multilevel_split_type |
initInterpMultilevelSplit |
Function |
|
| create_multilevel_interp_no_levclasses |
multilevel_interp_factory |
Function |
|
| create_multilevel_interp_with_levclasses |
multilevel_interp_factory |
Function |
|
| create_nf |
ionf_mod |
Function |
|
| create_nutrient_competition_method |
NutrientCompetitionFactoryMod |
Function |
|
| create_patch |
EDPatchDynamicsMod |
Subroutine |
|
| create_soil_water_retention_curve |
SoilWaterRetentionCurveFactoryMod |
Function |
|
| crop_patch_exists |
subgridMod |
Function |
|
| crown_damage |
SFMainMod |
Subroutine |
Read more… |
| crown_scorching |
SFMainMod |
Subroutine |
currentPatch%SH !average scorch height for the patch(m)
currentPatch%FI average fire intensity of flaming front during day. kW/m. Read more… |
| CrownDepth |
FatesAllometryMod |
Subroutine |
|
| CStateUpdate0 |
CNCStateUpdate1Mod |
Subroutine |
|
| CStateUpdate1 |
CNCStateUpdate1Mod |
Subroutine |
|
| CStateUpdate2 |
CNCStateUpdate2Mod |
Subroutine |
|
| CStateUpdate2h |
CNCStateUpdate2Mod |
Subroutine |
|
| CStateUpdate3 |
CNCStateUpdate3Mod |
Subroutine |
|
| CStateUpdateDynPatch |
CNCStateUpdate1Mod |
Subroutine |
|
| datm_comp_final |
datm_comp_mod |
Subroutine |
|
| datm_comp_init |
datm_comp_mod |
Subroutine |
|
| datm_comp_run |
datm_comp_mod |
Subroutine |
|
| datm_shr_CORE2getFactors |
datm_shr_mod |
Subroutine |
|
| datm_shr_eSat |
datm_shr_mod |
Function |
|
| datm_shr_getNextRadCDay |
datm_shr_mod |
Function |
|
| datm_shr_read_namelists |
datm_shr_mod |
Subroutine |
|
| datm_shr_TN460getFactors |
datm_shr_mod |
Subroutine |
|
| daylength |
DaylengthMod |
Function |
|
| DeallocateCohort |
EDCohortDynamicsMod |
Subroutine |
|
| decay_coeff_kn |
FatesAllometryMod |
Function |
|
| decomp_rate_constants_bgc |
SoilBiogeochemDecompCascadeBGCMod |
Subroutine |
|
| decomp_rate_constants_cn |
SoilBiogeochemDecompCascadeCNMod |
Subroutine |
use separate (possibly equal) t funcs above and below freezing point
t_scalar(c,1)=t_scalar(c,1) + (1.5((t_soisno(c,j)-(SHR_CONST_TKFRZ+25._r8))/10._r8))*fr(c,j)
use separate (possibly equal) t funcs above and below freezing point
t_scalar(c,j)= (1.5((t_soisno(c,j)-(SHR_CONST_TKFRZ+25._r8))/10._r8)) |
| DecompCascadeBGCreadNML |
SoilBiogeochemDecompCascadeBGCMod |
Subroutine |
|
| decompInit_clumps |
decompInitMod |
Subroutine |
|
| decompInit_glcp |
decompInitMod |
Subroutine |
|
| decompInit_lnd |
decompInitMod |
Subroutine |
|
| decompInit_lnd3D |
decompInitMod |
Subroutine |
|
| delete_from_file_list |
pio_msg_mod |
Subroutine |
|
| delete_from_iodesc_list |
pio_msg_mod |
Function |
|
| depvel_compute |
DryDepVelocity |
Subroutine |
Read more… |
| die |
m_dropdead |
Interface |
|
| die |
m_die |
Interface |
|
| diex |
m_die |
Interface |
|
| dims |
m_GeneralGrid |
Interface |
|
| dis_coi |
HumanIndexMod |
Subroutine |
|
| dis_coiS |
HumanIndexMod |
Subroutine |
|
| disturbance_rates |
EDPatchDynamicsMod |
Subroutine |
|
| DivideSnowLayers |
SnowHydrologyMod |
Subroutine |
|
| do_soil_resistance_sl14 |
SurfaceResistanceMod |
Function |
|
| do_soilevap_beta |
SurfaceResistanceMod |
Function |
|
| domain_check |
domainMod |
Subroutine |
|
| domain_clean |
domainMod |
Subroutine |
|
| domain_init |
domainMod |
Subroutine |
|
| downscale_forcings |
atm2lndMod |
Subroutine |
|
| dstfin |
dstmodel |
Subroutine |
!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! |
| dstinit |
dstmodel |
Subroutine |
!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! Read more… |
| dstrun |
dstmodel |
Subroutine |
|
| dump_cohort |
EDTypesMod |
Subroutine |
|
| dump_cohort_hydr |
EDTypesMod |
Subroutine |
|
| dump_patch |
EDTypesMod |
Subroutine |
|
| dump_site |
EDTypesMod |
Subroutine |
|
| DustDryDep |
DUSTMod |
Subroutine |
|
| DustEmission |
DUSTMod |
Subroutine |
|
| dyn_cnbal_col |
dynConsBiogeochemMod |
Subroutine |
|
| dyn_cnbal_patch |
dynConsBiogeochemMod |
Subroutine |
|
| dyn_ED |
dynEDMod |
Subroutine |
|
| dyn_file_type |
dynFileMod |
Interface |
|
| dyn_hwcontent_final |
dynConsBiogeophysMod |
Subroutine |
|
| dyn_hwcontent_init |
dynConsBiogeophysMod |
Subroutine |
|
| dynamics_driv |
CLMFatesInterfaceMod |
Subroutine |
|
| dynCNDV_init |
dynCNDVMod |
Subroutine |
|
| dynCNDV_interp |
dynCNDVMod |
Subroutine |
|
| dyncrop_init |
dyncropFileMod |
Subroutine |
|
| dyncrop_interp |
dyncropFileMod |
Subroutine |
|
| dynHarvest_init |
dynHarvestMod |
Subroutine |
|
| dynHarvest_interp |
dynHarvestMod |
Subroutine |
|
| dynpft_init |
dynpftFileMod |
Subroutine |
|
| dynpft_interp |
dynpftFileMod |
Subroutine |
|
| dynSubgrid_driver |
dynSubgridDriverMod |
Subroutine |
|
| dynSubgrid_init |
dynSubgridDriverMod |
Subroutine |
|
| dynSubgrid_wrapup_weight_changes |
dynSubgridDriverMod |
Subroutine |
|
| dynSubgridControl_init |
dynSubgridControlMod |
Subroutine |
|
| ed_ecosystem_dynamics |
EDMainMod |
Subroutine |
Fire, growth, biogeochemistry. Read more… |
| ED_Norman_Radiation |
EDSurfaceRadiationMod |
Subroutine |
|
| ED_SunShadeFracs |
EDSurfaceRadiationMod |
Subroutine |
|
| ed_update_site |
EDMainMod |
Subroutine |
|
| EDBGCDyn |
EDBGCDynMod |
Subroutine |
|
| EDBGCDynSummary |
EDBGCDynMod |
Subroutine |
|
| endrun |
abortutils |
Interface |
|
| ESMF_AlarmCreate |
ESMF_AlarmClockMod |
Function |
|
| ESMF_AlarmDestroy |
ESMF_AlarmMod |
Subroutine |
|
| ESMF_AlarmDisable |
ESMF_AlarmMod |
Subroutine |
|
| ESMF_AlarmEnable |
ESMF_AlarmMod |
Subroutine |
|
| ESMF_AlarmGet |
ESMF_AlarmMod |
Subroutine |
|
| ESMF_AlarmIsRinging |
ESMF_AlarmMod |
Function |
|
| ESMF_AlarmPrint |
ESMF_AlarmMod |
Subroutine |
|
| ESMF_AlarmRingerOff |
ESMF_AlarmMod |
Subroutine |
|
| ESMF_AlarmRingerOn |
ESMF_AlarmMod |
Subroutine |
|
| ESMF_AlarmSet |
ESMF_AlarmMod |
Subroutine |
|
| ESMF_AlarmValidate |
ESMF_AlarmMod |
Subroutine |
|
| ESMF_AttributeCopy |
ESMF_BaseMod |
Subroutine |
|
| ESMF_AttributeCopyAll |
ESMF_BaseMod |
Subroutine |
|
| ESMF_AttributeGet |
ESMF_BaseMod |
Subroutine |
|
| ESMF_AttributeGetbyNumber |
ESMF_BaseMod |
Subroutine |
|
| ESMF_AttributeGetCount |
ESMF_BaseMod |
Subroutine |
|
| ESMF_AttributeGetList |
ESMF_BaseMod |
Subroutine |
|
| ESMF_AttributeGetNameList |
ESMF_BaseMod |
Subroutine |
|
| ESMF_AttributeGetObjectList |
ESMF_BaseMod |
Subroutine |
|
| ESMF_AttributeSet |
ESMF_BaseMod |
Subroutine |
|
| ESMF_AttributeSetList |
ESMF_BaseMod |
Subroutine |
|
| ESMF_AttributeSetObjectList |
ESMF_BaseMod |
Subroutine |
|
| ESMF_AxisIndexGet |
ESMF_BaseMod |
Subroutine |
|
| ESMF_CalendarCreate |
ESMF_CalendarMod |
Function |
|
| ESMF_CalendarInitialized |
ESMF_CalendarMod |
Function |
|
| ESMF_ClockAddAlarm |
ESMF_ClockMod |
Subroutine |
|
| ESMF_ClockAdvance |
ESMF_ClockMod |
Subroutine |
|
| ESMF_ClockCreate |
ESMF_ClockMod |
Function |
|
| ESMF_ClockDestroy |
ESMF_ClockMod |
Subroutine |
|
| ESMF_ClockGet |
ESMF_ClockMod |
Subroutine |
|
| ESMF_ClockGetAlarmList |
ESMF_ClockMod |
Subroutine |
|
| ESMF_ClockIsStopTime |
ESMF_ClockMod |
Function |
|
| ESMF_ClockPrint |
ESMF_ClockMod |
Subroutine |
|
| ESMF_ClockSet |
ESMF_ClockMod |
Subroutine |
|
| ESMF_ClockStopTimeDisable |
ESMF_ClockMod |
Subroutine |
|
| ESMF_ClockValidate |
ESMF_ClockMod |
Subroutine |
|
| ESMF_DataTypeString |
ESMF_BaseMod |
Subroutine |
|
| ESMF_Finalize |
ESMF_Stubs |
Subroutine |
|
| ESMF_GetName |
ESMF_BaseMod |
Subroutine |
|
| ESMF_GetPointer |
ESMF_BaseMod |
Function |
|
| ESMF_Initialize |
ESMF_Stubs |
Subroutine |
|
| ESMF_IsInitialized |
ESMF_Stubs |
Function |
|
| ESMF_LogWrite |
ESMF_Stubs |
Subroutine |
|
| ESMF_SetName |
ESMF_BaseMod |
Subroutine |
|
| ESMF_SetNullPointer |
ESMF_BaseMod |
Subroutine |
|
| ESMF_SetPointer |
ESMF_BaseMod |
Subroutine |
|
| ESMF_setYearWidth |
ESMF_TimeMod |
Subroutine |
|
| ESMF_StatusString |
ESMF_BaseMod |
Subroutine |
|
| ESMF_TimeCopy |
ESMF_TimeMod |
Subroutine |
|
| ESMF_TimeEQ |
ESMF_TimeMod |
Function |
|
| ESMF_TimeGE |
ESMF_TimeMod |
Function |
|
| ESMF_TimeGet |
ESMF_TimeMod |
Subroutine |
|
| ESMF_TimeGT |
ESMF_TimeMod |
Function |
|
| ESMF_TimeInc |
ESMF_TimeMod |
Function |
|
| ESMF_TimeIntervalAbsValue |
ESMF_TimeIntervalMod |
Function |
|
| ESMF_TimeIntervalDIVQuot |
ESMF_TimeIntervalMod |
Function |
|
| ESMF_TimeIntervalGet |
ESMF_TimeIntervalMod |
Subroutine |
|
| ESMF_TimeIntervalIsPositive |
ESMF_TimeIntervalMod |
Function |
|
| ESMF_TimeIntervalNegAbsValue |
ESMF_TimeIntervalMod |
Function |
|
| ESMF_TimeIntervalPrint |
ESMF_TimeIntervalMod |
Subroutine |
|
| ESMF_TimeIntervalSet |
ESMF_TimeIntervalMod |
Subroutine |
|
| ESMF_TimeLE |
ESMF_TimeMod |
Function |
|
| ESMF_TimeLT |
ESMF_TimeMod |
Function |
|
| ESMF_TimeNE |
ESMF_TimeMod |
Function |
|
| ESMF_TimePrint |
ESMF_TimeMod |
Subroutine |
|
| ESMF_TimeSet |
ESMF_TimeMod |
Subroutine |
|
| esp_final_mct |
esp_comp_mct |
Subroutine |
|
| esp_init_mct |
esp_comp_mct |
Subroutine |
|
| esp_run_mct |
esp_comp_mct |
Subroutine |
|
| Establishment |
CNDVEstablishmentMod |
Subroutine |
|
| Euler |
FatesIntegratorsMod |
Subroutine |
|
| Euler |
MOSART_physics_mod |
Subroutine |
|
| EvaluateAndCorrectDBH |
EDCohortDynamicsMod |
Subroutine |
|
| ExchangeMap |
m_ExchangeMaps |
Interface |
|
| exportGlobalColumnIndices |
m_SparseMatrix |
Interface |
|
| exportGlobalRowIndices |
m_SparseMatrix |
Interface |
|
| exportIAttr |
m_AttrVect |
Interface |
|
| exportIAttr |
m_Accumulator |
Interface |
|
| exportIAttr |
m_GeneralGrid |
Interface |
|
| exportIList |
m_AttrVect |
Interface |
|
| exportIListToChar |
m_AttrVect |
Interface |
|
| exportLocalColumnIndices |
m_SparseMatrix |
Interface |
|
| exportLocalRowIndices |
m_SparseMatrix |
Interface |
|
| exportMatrixElements |
m_SparseMatrix |
Interface |
|
| exportRAttr |
m_AttrVect |
Interface |
|
| exportRAttr |
m_Accumulator |
Interface |
|
| exportRAttr |
m_GeneralGrid |
Interface |
|
| exportRList |
m_AttrVect |
Interface |
|
| exportRListToChar |
m_AttrVect |
Interface |
|
| exportStrategyToChar |
m_SparseMatrixPlus |
Interface |
|
| exportStrategyToChar_ |
m_SparseMatrixPlus |
Function |
|
| exportToChar |
m_List |
Interface |
|
| exportToString |
m_List |
Interface |
|
| extract_accum_field |
accumulMod |
Interface |
|
| fates_endrun |
FatesGlobals |
Subroutine |
|
| fates_global_verbose |
FatesGlobals |
Function |
|
| fates_log |
FatesGlobals |
Function |
|
| FatesCheckParams |
EDPftvarcon |
Subroutine |
|
| FatesGlobalsInit |
FatesGlobals |
Subroutine |
|
| FatesInterfaceInit |
FatesInterfaceMod |
Subroutine |
|
| FatesParamsInit |
EDParamsMod |
Subroutine |
|
| FatesPlantRespPhotosynthDrive |
FATESPlantRespPhotosynthMod |
Subroutine |
|
| FatesReadParameters |
CLMFatesParamInterfaceMod |
Subroutine |
|
| FatesReadPFTs |
CLMFatesParamInterfaceMod |
Subroutine |
|
| FatesReceiveParams |
EDParamsMod |
Subroutine |
|
| FatesRegisterParams |
EDParamsMod |
Subroutine |
|
| FatesReportParameters |
FatesInterfaceMod |
Subroutine |
|
| FatesReportParams |
EDParamsMod |
Subroutine |
|
| FatesReportPFTParams |
EDPftvarcon |
Subroutine |
|
| fc_gather_fp |
m_FcComms |
Subroutine |
|
| fc_gather_int |
m_FcComms |
Subroutine |
|
| fc_gatherv_fp |
m_FcComms |
Subroutine |
|
| fc_gatherv_int |
m_FcComms |
Subroutine |
|
| Filename_base |
m_Filename |
Interface |
|
| Filename_dir |
m_Filename |
Interface |
|
| FileResolv |
m_FileResolv |
Subroutine |
|
| finalize_handler |
pio_msg_callbacks.F90 |
Subroutine |
|
| find_group_name |
perf_utils |
Subroutine |
|
| find_nlgroup_name |
clm_nlUtilsMod |
Subroutine |
|
| find_var_on_file |
ncdio_utils |
Subroutine |
|
| fire_danger_index |
SFMainMod |
Subroutine |
currentSite%acc_NI is the accumulated Nesterov fire danger index Read more… |
| fire_emis_factors_get |
FireEmisFactorsMod |
Subroutine |
|
| fire_emis_factors_init |
FireEmisFactorsMod |
Subroutine |
|
| fire_intensity |
SFMainMod |
Subroutine |
returns the updated currentPatch%FI value for each patch. Read more… |
| fire_model |
SFMainMod |
Subroutine |
|
| flow_ci |
m_flow |
Interface |
|
| flow_co |
m_flow |
Interface |
|
| flow_flush |
m_flow |
Interface |
|
| flow_reset |
m_flow |
Interface |
|
| fltget |
m_inpak90 |
Interface |
|
| FluxIntoLitterPools |
EDPhysiologyMod |
Subroutine |
|
| for_test_set_curr_date |
clm_time_manager |
Subroutine |
|
| ForceDBH |
FatesAllometryMod |
Subroutine |
|
| fraction_to_string |
MeatMod |
Subroutine |
|
| fraction_to_stringi8 |
MeatMod |
Subroutine |
|
| Fractionation |
PhotosynthesisMod |
Subroutine |
USES: |
| freedecomp_handler |
pio_msg_callbacks.F90 |
Subroutine |
|
| FreshSnowRadius |
SnowSnicarMod |
Function |
|
| FrictionVelocity |
FrictionVelocityMod |
Subroutine |
|
| FrictionVelReadNML |
FrictionVelocityMod |
Subroutine |
|
| fuse_cohorts |
EDCohortDynamicsMod |
Subroutine |
|
| fuse_patches |
EDPatchDynamicsMod |
Subroutine |
|
| gather |
m_AttrVectComms |
Interface |
|
| Gather |
m_SparseMatrixComms |
Interface |
|
| gather |
m_AccumulatorComms |
Interface |
|
| gather |
m_GeneralGridComms |
Interface |
|
| gather_data_to_master |
spmdGathScatMod |
Interface |
|
| gcd |
calcdisplace_mod |
Interface |
|
| GCDblocksize |
calcdisplace_mod |
Subroutine |
|
| GenTraceBackString |
m_TraceBack |
Interface |
|
| get |
m_List |
Interface |
|
| get |
m_Navigator |
Interface |
|
| get_active_suction_layers |
EDBtranMod |
Subroutine |
|
| get_age_class_index |
FatesSizeAgeTypeIndicesMod |
Function |
|
| get_agepft_class_index |
FatesSizeAgeTypeIndicesMod |
Function |
|
| get_beg |
decompMod |
Function |
|
| get_calday |
clm_time_manager |
Function |
!!!!!!!!!!!! WARNING HACK TO ENABLE Gregorian CALENDAR WITH SHR_ORB !!!!!!!!!!!!!!!!!!!!
!! The following hack fakes day 366 by reusing day 365. This is just because the !!!!!!
!! current shr_orb_decl calculation can't handle days > 366. !!!!!!
!! Dani Bundy-Coleman and Erik Kluzek Aug/2008 !!!!!!
!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
!!!!!!!!!!!! END HACK TO ENABLE Gregorian CALENDAR WITH SHR_ORB !!!!!!!!!!!!!!!!!!!!!!!! |
| get_calendar |
RtmTimeManager |
Function |
|
| get_calendar |
clm_time_manager |
Function |
|
| get_clmlevel_gsize |
decompMod |
Function |
|
| get_clmlevel_gsmap |
decompMod |
Subroutine |
|
| get_clock |
RtmTimeManager |
Subroutine |
|
| get_clock |
clm_time_manager |
Subroutine |
|
| get_clump_bounds |
decompMod |
Interface |
|
| get_curr_calday |
clm_time_manager |
Function |
!!!!!!!!!!!! WARNING HACK TO ENABLE Gregorian CALENDAR WITH SHR_ORB !!!!!!!!!!!!!!!!!!!!
!! The following hack fakes day 366 by reusing day 365. This is just because the !!!!!!
!! current shr_orb_decl calculation can't handle days > 366. !!!!!!
!! Dani Bundy-Coleman and Erik Kluzek Aug/2008 !!!!!!
!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!
!!!!!!!!!!!! END HACK TO ENABLE Gregorian CALENDAR WITH SHR_ORB !!!!!!!!!!!!!!!!!!!!!!!! |
| get_curr_date |
RtmTimeManager |
Subroutine |
|
| get_curr_date |
clm_time_manager |
Subroutine |
|
| get_curr_ESMF_Time |
clm_time_manager |
Function |
|
| get_curr_time |
RtmTimeManager |
Subroutine |
|
| get_curr_time |
clm_time_manager |
Subroutine |
|
| get_curr_yearfrac |
clm_time_manager |
Function |
|
| get_days_per_year |
clm_time_manager |
Function |
|
| get_do_harvest |
dynSubgridControlMod |
Function |
|
| get_do_transient_crops |
dynSubgridControlMod |
Function |
|
| get_do_transient_pfts |
dynSubgridControlMod |
Function |
|
| get_driver_start_ymd |
clm_time_manager |
Function |
|
| get_end |
decompMod |
Function |
|
| get_fcblocksize |
m_FcComms |
Function |
|
| get_filename |
RtmFileUtils |
Function |
|
| get_filename |
fileutils |
Function |
|
| get_flanduse_timeseries |
dynSubgridControlMod |
Function |
|
| get_for_testing_allow_non_annual_changes |
dynSubgridControlMod |
Function |
|
| get_for_testing_zero_dynbal_fluxes |
dynSubgridControlMod |
Function |
|
| get_height_index |
FatesSizeAgeTypeIndicesMod |
Function |
|
| get_index |
mutils |
Subroutine |
|
| get_indices |
m_List |
Interface |
|
| get_ipedof |
FuncPedotransferMod |
Function |
|
| get_landunit_weight |
subgridWeightsMod |
Function |
|
| get_local_time |
clm_time_manager |
Function |
|
| get_local_timestep_time |
clm_time_manager |
Function |
|
| get_nstep |
RtmTimeManager |
Function |
|
| get_nstep |
clm_time_manager |
Function |
|
| get_nstep_since_startup_or_lastDA_restart_or_pause |
clm_time_manager |
Function |
|
| get_perp_date |
clm_time_manager |
Subroutine |
|
| get_prev_date |
RtmTimeManager |
Subroutine |
|
| get_prev_date |
clm_time_manager |
Subroutine |
|
| get_prev_time |
RtmTimeManager |
Subroutine |
|
| get_prev_time |
clm_time_manager |
Subroutine |
|
| get_prev_yearfrac |
clm_time_manager |
Function |
|
| get_proc_bounds |
decompMod |
Interface |
|
| get_proc_clumps |
decompMod |
Function |
|
| get_proc_global |
decompMod |
Subroutine |
|
| get_proc_total |
decompMod |
Subroutine |
|
| get_rad_step_size |
clm_time_manager |
Function |
|
| get_ref_date |
RtmTimeManager |
Subroutine |
|
| get_ref_date |
clm_time_manager |
Subroutine |
|
| get_rest_date |
clm_time_manager |
Subroutine |
|
| get_size_class_index |
FatesSizeAgeTypeIndicesMod |
Function |
|
| get_sizeage_class_index |
FatesSizeAgeTypeIndicesMod |
Function |
|
| get_sizeagepft_class_index |
FatesSizeAgeTypeIndicesMod |
Function |
|
| get_spinup_latitude_term |
SoilBiogeochemStateType |
Function |
|
| get_start_date |
RtmTimeManager |
Subroutine |
|
| get_start_date |
clm_time_manager |
Subroutine |
|
| get_step_size |
RtmTimeManager |
Function |
|
| get_step_size |
clm_time_manager |
Function |
|
| get_step_size_real |
clm_time_manager |
Function |
|
| get_timemgr_defaults |
clm_time_manager |
Subroutine |
|
| getavu |
RtmFileUtils |
Function |
|
| getavu |
fileutils |
Function |
|
| GetBalanceCheckSkipSteps |
BalanceCheckMod |
Function |
|
| GetCoordVal |
PRTGenericMod |
Function |
|
| getdatetime |
getdatetime.F90 |
Subroutine |
|
| getdatetime |
RtmDateTime |
Subroutine |
|
| GetDecompyFrac |
EDPftvarcon |
Function |
|
| getfil |
RtmFileUtils |
Subroutine |
|
| getfil |
fileutils |
Subroutine |
|
| GetGlobalIndex |
GetGlobalValuesMod |
Function |
|
| GetGlobalWrite |
GetGlobalValuesMod |
Subroutine |
|
| getIList |
m_AttrVect |
Interface |
|
| getIList |
m_Accumulator |
Interface |
|
| getIListToChar |
m_AttrVect |
Interface |
|
| getRList |
m_AttrVect |
Interface |
|
| getRList |
m_Accumulator |
Interface |
|
| getRListToChar |
m_AttrVect |
Interface |
|
| GetSharedListIndices |
m_List |
Interface |
|
| getstr |
m_inpak90 |
Subroutine |
|
| getwrd |
m_inpak90 |
Subroutine |
|
| glc_all_elevclass_strings |
glc_elevclass_mod |
Function |
|
| glc_elevclass_as_string |
glc_elevclass_mod |
Function |
|
| glc_elevclass_clean |
glc_elevclass_mod |
Subroutine |
|
| glc_elevclass_init |
glc_elevclass_mod |
Interface |
|
| glc_elevclasses_are_same |
initInterpUtils |
Function |
|
| glc_errcode_to_string |
glc_elevclass_mod |
Function |
|
| glc_final_mct |
glc_comp_mct |
Subroutine |
|
| glc_get_elevation_class |
glc_elevclass_mod |
Subroutine |
|
| glc_get_elevclass_bounds |
glc_elevclass_mod |
Function |
|
| glc_get_num_elevation_classes |
glc_elevclass_mod |
Function |
|
| glc_init_mct |
glc_comp_mct |
Subroutine |
|
| glc_mean_elevation_virtual |
glc_elevclass_mod |
Function |
|
| glc_run_mct |
glc_comp_mct |
Subroutine |
|
| global_col_range |
m_SparseMatrix |
Interface |
|
| global_row_range |
m_SparseMatrix |
Interface |
|
| GlobalMapToGlobalSegMap |
m_ConvertMaps |
Interface |
|
| GlobalNumElements |
m_SparseMatrix |
Interface |
|
| GlobalReduce |
m_AttrVectReduce |
Interface |
|
| GlobalSegMapToGlobalMap |
m_ConvertMaps |
Interface |
|
| GlobalStorage |
m_GlobalSegMap |
Interface |
|
| GlobalToLocalIndex |
m_GlobalToLocal |
Interface |
|
| GlobalToLocalIndices |
m_GlobalToLocal |
Interface |
|
| GlobalToLocalMatrix |
m_GlobalToLocal |
Interface |
|
| GlobalWeightedSumRAttr |
m_AttrVectReduce |
Interface |
|
| gquad |
convertgauss.F90 |
Subroutine |
|
| ground_fuel_consumption |
SFMainMod |
Subroutine |
returns the the hypothetic fuel consumed by the fire Read more… |
| gsize |
m_GlobalMap |
Interface |
|
| gsize |
m_GlobalSegMap |
Interface |
|
| h2d_allom |
FatesAllometryMod |
Subroutine |
|
| h_allom |
FatesAllometryMod |
Subroutine |
|
| haloed |
m_GlobalSegMap |
Interface |
|
| HeatIndex |
HumanIndexMod |
Subroutine |
|
| hillslopeRouting |
MOSART_physics_mod |
Subroutine |
|
| hist_add_subscript |
histFileMod |
Subroutine |
|
| hist_addfld1d |
histFileMod |
Subroutine |
|
| hist_addfld2d |
histFileMod |
Subroutine |
|
| hist_addfld_decomp |
histFileMod |
Subroutine |
|
| hist_htapes_build |
histFileMod |
Subroutine |
|
| hist_htapes_wrapup |
histFileMod |
Subroutine |
|
| hist_printflds |
histFileMod |
Subroutine |
|
| hist_restart_ncd |
histFileMod |
Subroutine |
|
| hist_update_hbuf |
histFileMod |
Subroutine |
|
| hmdex |
HumanIndexMod |
Subroutine |
|
| htapes_fieldlist |
histFileMod |
Subroutine |
|
| HumanIndexReadNML |
HumanIndexMod |
Subroutine |
|
| HydrologyDrainage |
HydrologyDrainageMod |
Subroutine |
|
| HydrologyNoDrainage |
HydrologyNoDrainageMod |
Subroutine |
|
| I90_allLoadF |
m_inpak90 |
Subroutine |
|
| i90_AtoF |
m_inpak90 |
Function |
|
| i90_atoi |
m_inpak90 |
Function |
|
| i90_fullRelease |
m_inpak90 |
Subroutine |
|
| i90_GFloat |
m_inpak90 |
Function |
|
| I90_GInt |
m_inpak90 |
Function |
|
| i90_gline |
m_inpak90 |
Subroutine |
|
| i90_gstr |
m_inpak90 |
Subroutine |
|
| i90_GToken |
m_inpak90 |
Subroutine |
|
| i90_label |
m_inpak90 |
Subroutine |
|
| I90_LoadF |
m_inpak90 |
Subroutine |
|
| I90_Release |
m_inpak90 |
Subroutine |
|
| ice_final_mct |
ice_comp_mct |
Subroutine |
|
| ice_init_mct |
ice_comp_mct |
Subroutine |
|
| ice_run_mct |
ice_comp_mct |
Subroutine |
|
| icemec_class_to_col_itype |
column_varcon |
Function |
|
| ICopy |
m_AttrVect |
Interface |
|
| Identical |
m_GSMapTest |
Interface |
|
| identical |
m_List |
Interface |
|
| Identical |
m_GGRIDTEST |
Interface |
|
| Identical |
m_ACTEST |
Interface |
|
| Identical |
m_SMATTEST |
Interface |
|
| Identical |
m_AVTEST |
Interface |
|
| ImportExport |
m_GGRIDTEST |
Interface |
|
| ImportExport |
m_ACTEST |
Interface |
|
| ImportExport |
m_SMATTEST |
Interface |
|
| ImportExport |
m_AVTEST |
Interface |
|
| importGlobalColumnIndices |
m_SparseMatrix |
Interface |
|
| importGlobalRowIndices |
m_SparseMatrix |
Interface |
|
| importIAttr |
m_AttrVect |
Interface |
|
| importIAttr |
m_Accumulator |
Interface |
|
| importIAttr |
m_GeneralGrid |
Interface |
|
| importLocalColumnIndices |
m_SparseMatrix |
Interface |
|
| importLocalRowIndices |
m_SparseMatrix |
Interface |
|
| importMatrixElements |
m_SparseMatrix |
Interface |
|
| importRAttr |
m_AttrVect |
Interface |
|
| importRAttr |
m_Accumulator |
Interface |
|
| importRAttr |
m_GeneralGrid |
Interface |
|
| increasing |
m_GlobalSegMap |
Interface |
|
| index |
m_List |
Interface |
|
| IndexAttr |
m_GGRIDTEST |
Interface |
|
| IndexAttr |
m_ACTEST |
Interface |
|
| IndexAttr |
m_SMATTEST |
Interface |
|
| IndexAttr |
m_AVTEST |
Interface |
|
| IndexBin |
m_IndexBin_integer |
Interface |
|
| IndexBin |
m_IndexBin_char |
Interface |
|
| IndexBin |
m_IndexBin_logical |
Interface |
|
| IndexedRankMerge |
m_rankMerge |
Interface |
|
| indexIA |
m_AttrVect |
Interface |
|
| indexIA |
m_Accumulator |
Interface |
|
| indexIA |
m_SparseMatrix |
Interface |
|
| indexIA |
m_GeneralGrid |
Interface |
|
| indexRA |
m_AttrVect |
Interface |
|
| indexRA |
m_Accumulator |
Interface |
|
| indexRA |
m_SparseMatrix |
Interface |
|
| indexRA |
m_GeneralGrid |
Interface |
|
| IndexSet |
m_MergeSorts |
Interface |
|
| IndexSort |
m_MergeSorts |
Interface |
|
| init |
m_AttrVect |
Interface |
|
| init |
m_GlobalMap |
Interface |
|
| init |
m_Rearranger |
Interface |
|
| Init |
SurfaceAlbedoType |
Subroutine |
|
| init |
m_List |
Interface |
|
| init |
CLMFatesInterfaceMod |
Subroutine |
|
| Init |
FrictionVelocityMod |
Subroutine |
|
| init |
m_MCTWorld |
Interface |
|
| init |
m_Router |
Interface |
|
| init |
m_Navigator |
Interface |
|
| init |
m_SparseMatrixPlus |
Interface |
|
| init |
m_Accumulator |
Interface |
|
| init |
m_String |
Interface |
|
| Init |
pftconMod |
Subroutine |
|
| init |
m_SparseMatrix |
Interface |
|
| init |
m_GlobalSegMap |
Interface |
|
| Init |
SoilHydrologyType |
Subroutine |
|
| init |
m_GeneralGrid |
Interface |
|
| init_accum_field |
accumulMod |
Subroutine |
|
| init_coldstart |
CLMFatesInterfaceMod |
Subroutine |
|
| init_decomp_cascade_constants |
SoilBiogeochemDecompCascadeConType |
Subroutine |
|
| init_decompcascade_bgc |
SoilBiogeochemDecompCascadeBGCMod |
Subroutine |
|
| init_decompcascade_cn |
SoilBiogeochemDecompCascadeCNMod |
Subroutine |
for terminal pools (i.e. 100% respiration) |
| init_history_io |
CLMFatesInterfaceMod |
Subroutine |
|
| init_hydrology |
init_hydrology.F90 |
Subroutine |
|
| init_patches |
EDInitMod |
Subroutine |
|
| init_pedof |
FuncPedotransferMod |
Subroutine |
|
| init_remote |
m_GlobalMap |
Interface |
|
| init_root_moist_stress |
SoilMoistStressMod |
Subroutine |
|
| init_rootprof |
RootBiophysMod |
Subroutine |
|
| init_site_vars |
EDInitMod |
Subroutine |
|
| init_soil_depths |
CLMFatesInterfaceMod |
Subroutine |
|
| init_soilwater_movement |
SoilWaterMovementMod |
Subroutine |
|
| init_subgrid_weights_mod |
subgridWeightsMod |
Subroutine |
|
| init_vdc2 |
piovdc |
Subroutine |
@brief subroutine that prepares the global grid to be split by the auto_start_count routine
POST-EFFECTS:
A valid IO decomposition is created that can be used with PIO
@param[in] rank int rank of the current
@param[in] data_dims int(3) size of the global grid
@param[in] vdc_bsize int(3) VDC block size
@param[out] iostart int(3) IO start for the current MPI task
@param[out] iocount int(3) IO count for the current MPI task
@param[inout] ioprocs int max # of IO procs, gets returned as the actual # used |
| init_vegrootfr |
RootBiophysMod |
Subroutine |
|
| InitAllocate |
SurfaceAlbedoType |
Subroutine |
|
| InitAllocate |
FrictionVelocityMod |
Subroutine |
|
| InitAllocate |
pftconMod |
Subroutine |
|
| InitAllocate |
SoilHydrologyType |
Subroutine |
|
| initCartesian |
m_GeneralGrid |
Interface |
|
| InitCold |
SurfaceAlbedoType |
Subroutine |
|
| InitCold |
FrictionVelocityMod |
Subroutine |
|
| InitCold |
SoilHydrologyType |
Subroutine |
|
| InitDaylength |
DaylengthMod |
Subroutine |
|
| initdaym |
ESMF_CalendarMod |
Subroutine |
|
| initdecomp_dof_handler |
pio_msg_callbacks.F90 |
Subroutine |
|
| initDistributed_ |
m_SparseMatrixPlus |
Subroutine |
|
| InitForTesting |
pftconMod |
Subroutine |
|
| initFromRoot_ |
m_SparseMatrixPlus |
Subroutine |
|
| initGridcells |
initGridCellsMod |
Subroutine |
|
| InitHistory |
SurfaceAlbedoType |
Subroutine |
|
| InitHistory |
FrictionVelocityMod |
Subroutine |
|
| InitHistory |
SoilHydrologyType |
Subroutine |
|
| InitHydraulicsDerived |
FatesHydraulicsMemMod |
Subroutine |
|
| initial_template_col_crop |
dynInitColumnsMod |
Function |
|
| initialize1 |
clm_initializeMod |
Subroutine |
! TODO - is this needed? |
| initialize2 |
clm_initializeMod |
Subroutine |
|
| initialize_new_columns |
dynInitColumnsMod |
Subroutine |
|
| initialize_sites_by_inventory |
FatesInventoryInitMod |
Subroutine |
|
| initialized |
m_MCTWorld |
Interface |
|
| initialized |
m_SparseMatrixPlus |
Interface |
|
| initialized |
m_Accumulator |
Interface |
|
| initialized_ |
m_SparseMatrixPlus |
Function |
|
| initInterp |
initInterpMod |
Subroutine |
|
| initInterp_readnl |
initInterpMod |
Subroutine |
|
| initp |
m_Accumulator |
Interface |
|
| InitPARTEHGlobals |
FatesInterfaceMod |
Subroutine |
|
| InitPRTBoundaryConditions |
EDCohortDynamicsMod |
Subroutine |
|
| InitPRTGlobalAllometricCarbon |
PRTAllometricCarbonMod |
Subroutine |
|
| InitPRTObject |
EDCohortDynamicsMod |
Subroutine |
allocate(cnp_allom_prt)
prt => cnp_allom_prt |
| InitRead |
pftconMod |
Subroutine |
|
| InitSnowLayers |
SnowHydrologyMod |
Subroutine |
|
| initUnstructured |
m_GeneralGrid |
Interface |
|
| initVertical |
initVerticalMod |
Subroutine |
|
| insert_cohort |
EDCohortDynamicsMod |
Subroutine |
|
| interp_1d_data |
initInterp1dData |
Interface |
|
| interp_bounds_type |
initInterpBounds |
Interface |
|
| interp_multilevel_container_type |
initInterpMultilevelContainer |
Interface |
|
| interp_multilevel_copy_type |
initInterpMultilevelCopy |
Interface |
|
| interp_multilevel_interp_type |
initInterpMultilevelInterp |
Interface |
|
| interp_multilevel_snow_type |
initInterpMultilevelSnow |
Interface |
|
| interpMonthlyVeg |
SatellitePhenologyMod |
Subroutine |
|
| intget |
m_inpak90 |
Function |
|
| iotype_index |
FatesIOVariableKindMod |
Function |
|
| irecv |
m_Transfer |
Interface |
|
| irrigation_params_type |
IrrigationMod |
Interface |
|
| is_beg_curr_day |
clm_time_manager |
Function |
|
| is_beg_curr_year |
clm_time_manager |
Function |
|
| is_end_curr_day |
RtmTimeManager |
Function |
|
| is_end_curr_day |
clm_time_manager |
Function |
|
| is_end_curr_month |
RtmTimeManager |
Function |
|
| is_end_curr_month |
clm_time_manager |
Function |
|
| is_end_curr_year |
clm_time_manager |
Function |
|
| is_first_restart_step |
RtmTimeManager |
Function |
|
| is_first_restart_step |
clm_time_manager |
Function |
|
| is_first_step |
RtmTimeManager |
Function |
|
| is_first_step |
clm_time_manager |
Function |
|
| is_first_step_of_this_run_segment |
clm_time_manager |
Function |
|
| is_gcell_all_ltypeX |
subgridWeightsMod |
Function |
|
| is_hydrologically_active |
column_varcon |
Function |
|
| is_last_step |
RtmTimeManager |
Function |
|
| is_last_step |
clm_time_manager |
Function |
|
| is_near_local_noon |
clm_time_manager |
Function |
|
| is_perpetual |
clm_time_manager |
Function |
|
| is_restart |
RtmTimeManager |
Function |
|
| is_restart |
clm_time_manager |
Function |
|
| isend |
m_Transfer |
Interface |
|
| isend |
m_GlobalSegMapComms |
Interface |
|
| IsItLoggingTime |
EDLoggingMortalityMod |
Subroutine |
|
| isleap |
ESMF_CalendarMod |
Function |
|
| IsProgBuildTemp |
UrbanParamsType |
Function |
|
| IsSimpleBuildTemp |
UrbanParamsType |
Function |
|
| IsSnowvegFlagOff |
CanopyHydrologyMod |
Function |
|
| IsSnowvegFlagOn |
CanopyHydrologyMod |
Function |
|
| IsSnowvegFlagOnRad |
CanopyHydrologyMod |
Function |
|
| KtoC |
HumanIndexMod |
Subroutine |
|
| l2g |
subgridAveMod |
Interface |
|
| l2g_1d |
subgridAveMod |
Subroutine |
|
| l2g_2d |
subgridAveMod |
Subroutine |
|
| lablin |
m_inpak90 |
Subroutine |
|
| lai_advance |
SatellitePhenologyMod |
Subroutine |
|
| LakeConInit |
LakeCon |
Subroutine |
|
| LakeFluxes |
LakeFluxesMod |
Subroutine |
|
| LakeHydrology |
LakeHydrologyMod |
Subroutine |
!!!!!!!!!!!!!!!!!!!!!!!!! Read more… |
| LakeTemperature |
LakeTemperatureMod |
Subroutine |
!!!!!!!!!!!!!!!!! Read more… |
| landunit_is_special |
landunit_varcon |
Function |
|
| landunit_varcon_init |
landunit_varcon |
Subroutine |
|
| len |
m_String |
Interface |
|
| Light |
CNDVLightMod |
Subroutine |
|
| LiquidWaterHeat |
TotalWaterAndHeatMod |
Function |
|
| lnd2atm |
lnd2atmMod |
Subroutine |
|
| lnd2atm_minimal |
lnd2atmMod |
Subroutine |
|
| lnd2atm_params_type |
lnd2atmType |
Interface |
|
| lnd_export |
lnd_import_export |
Subroutine |
|
| lnd_final_mct |
lnd_comp_mct |
Subroutine |
|
| lnd_import |
lnd_import_export |
Subroutine |
|
| lnd_init_mct |
lnd_comp_mct |
Subroutine |
|
| lnd_run_mct |
lnd_comp_mct |
Subroutine |
|
| local_col_range |
m_SparseMatrix |
Interface |
|
| local_row_range |
m_SparseMatrix |
Interface |
|
| LocalReduce |
m_AttrVectReduce |
Interface |
|
| LocalReduceRAttr |
m_AttrVectReduce |
Interface |
|
| LocalWeightedSumRAttr |
m_AttrVectReduce |
Interface |
|
| logging_litter_fluxes |
EDLoggingMortalityMod |
Subroutine |
|
| LoggingMortality_frac |
EDLoggingMortalityMod |
Subroutine |
|
| lookupfile |
pio_msg_mod |
Function |
|
| lookupiodesc |
pio_msg_mod |
Function |
|
| lowercase |
m_chars |
Interface |
|
| lsize |
m_AttrVect |
Interface |
|
| lsize |
m_GlobalMap |
Interface |
|
| lsize |
m_Accumulator |
Interface |
|
| lsize |
m_SparseMatrix |
Interface |
|
| lsize |
m_GlobalSegMap |
Interface |
|
| lsize |
m_GeneralGrid |
Interface |
|
| luavail |
m_ioutil |
Function |
|
| luflush |
m_ioutil |
Subroutine |
|
| LunaReadNML |
LunaMod |
Subroutine |
|
| m_swapm_FP |
m_SPMDutils |
Subroutine |
Purpose:
Reduced version of original swapm (for swap of multiple messages
using MPI point-to-point routines), more efficiently implementing a
subset of the swap protocols. Read more… |
| m_swapm_int |
m_SPMDutils |
Subroutine |
Purpose:
Reduced version of original swapm (for swap of multiple messages
using MPI point-to-point routines), more efficiently implementing a
subset of the swap protocols. Read more… |
| mainchannelRouting |
MOSART_physics_mod |
Subroutine |
|
| mall_ci |
m_mall |
Interface |
|
| mall_co |
m_mall |
Interface |
|
| mall_flush |
m_mall |
Interface |
|
| mall_ison |
m_mall |
Interface |
|
| mall_mci |
m_mall |
Interface |
|
| mall_mco |
m_mall |
Interface |
|
| mall_reset |
m_mall |
Interface |
|
| mall_set |
m_mall |
Interface |
|
| map_glc2lnd_ec |
map_glc2lnd_mod |
Subroutine |
|
| map_lnd2glc |
map_lnd2glc_mod |
Subroutine |
|
| map_lnd2rof_irrig |
map_lnd2rof_irrig_mod |
Subroutine |
|
| MaskedSpatialAverage |
m_SpatialIntegral |
Interface |
|
| MaskedSpatialAverageV |
m_SpatialIntegralV |
Interface |
|
| MaskedSpatialIntegral |
m_SpatialIntegral |
Interface |
|
| MaskedSpatialIntegralV |
m_SpatialIntegralV |
Interface |
|
| max_nlseg |
m_GlobalSegMap |
Interface |
|
| mct_avect_accum |
mct_mod |
Subroutine |
|
| mct_aVect_avg |
mct_mod |
Subroutine |
|
| mct_aVect_fldIndex |
mct_mod |
Function |
|
| mct_aVect_getRAttr |
mct_mod |
Subroutine |
|
| mct_aVect_info |
mct_mod |
Subroutine |
|
| mct_aVect_initSharedFields |
mct_mod |
Subroutine |
|
| mct_avect_mult |
mct_mod |
Subroutine |
|
| mct_aVect_putRAttr |
mct_mod |
Subroutine |
|
| mct_aVect_sharedFields |
mct_mod |
Subroutine |
|
| mct_avect_vecmult |
mct_mod |
Subroutine |
|
| mct_gsmap_Identical |
mct_mod |
Function |
|
| mct_myindex |
mct_mod |
Function |
|
| mct_rearr_rearrange_fldlist |
mct_mod |
Subroutine |
|
| megan_factors_get |
MEGANFactorsMod |
Subroutine |
|
| megan_factors_init |
MEGANFactorsMod |
Subroutine |
|
| MergeFour |
m_Merge |
Interface |
|
| MergeInData |
m_Merge |
Interface |
|
| MergeThree |
m_Merge |
Interface |
|
| MergeTwo |
m_Merge |
Interface |
|
| metadata_set |
seq_flds_mod |
Subroutine |
|
| model |
model.F90 |
Subroutine |
!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! Read more… |
| model1 |
twosequn |
Subroutine |
|
| model1 |
twoseq |
Subroutine |
|
| model1 |
twocon |
Subroutine |
|
| model1 |
twocmpseqNB |
Subroutine |
|
| model1init |
twocmpseqNB |
Subroutine |
|
| model2 |
twosequn |
Subroutine |
|
| model2 |
twoseq |
Subroutine |
|
| model2 |
twocon |
Subroutine |
|
| model2 |
twocmpseqNB |
Subroutine |
|
| model2init |
twocmpseqNB |
Subroutine |
|
| MoninObukIni |
FrictionVelocityMod |
Subroutine |
|
| Mortality_Derivative |
EDMortalityFunctionsMod |
Subroutine |
|
| mortality_rates |
EDMortalityFunctionsMod |
Subroutine |
|
| MP_abort |
m_mpif90 |
Interface |
|
| MP_cart_coords |
m_mpif90 |
Interface |
|
| MP_cart_create |
m_mpif90 |
Interface |
|
| MP_cart_rank |
m_mpif90 |
Interface |
|
| MP_comm_dup |
m_mpif90 |
Interface |
|
| MP_comm_free |
m_mpif90 |
Interface |
|
| MP_comm_rank |
m_mpif90 |
Interface |
|
| MP_comm_size |
m_mpif90 |
Interface |
|
| MP_die |
m_die |
Interface |
|
| MP_dims_create |
m_mpif90 |
Interface |
|
| MP_error_string |
m_mpif90 |
Interface |
|
| MP_finalize |
m_mpif90 |
Interface |
|
| MP_init |
m_mpif90 |
Interface |
|
| MP_initialized |
m_mpif90 |
Interface |
|
| MP_log2 |
m_mpif90 |
Function |
|
| MP_perr |
m_mpif90 |
Interface |
|
| MP_perr_die |
m_die |
Interface |
|
| MP_type |
m_mpif90 |
Interface |
|
| MP_wtick |
m_mpif90 |
Interface |
|
| MP_wtime |
m_mpif90 |
Interface |
|
| MPH_comm_join_ME_SE |
comm_sub12 |
Subroutine |
|
| MPH_comm_join_SE_overlap |
MPH_Single_Exec_Overlap |
Subroutine |
|
| MPH_component_id_ME_SE |
comm_sub12 |
Function |
|
| MPH_component_name |
comm_sub123 |
Function |
|
| MPH_find_name |
comm_sub123 |
Function |
|
| MPH_get_component_id |
comm_sub123 |
Function |
|
| MPH_global_id |
comm_sub123 |
Function |
|
| MPH_global_ME_SE |
comm_sub12 |
Subroutine |
|
| MPH_global_proc_id |
comm_sub123 |
Function |
|
| MPH_global_SE_overlap |
MPH_Single_Exec_Overlap |
Subroutine |
|
| MPH_help |
comm_sub123 |
Subroutine |
|
| MPH_init |
comm_sub123 |
Subroutine |
|
| MPH_local_ME |
MPH_Multi_Exec |
Subroutine |
|
| MPH_local_proc_id_ME_SE |
comm_sub12 |
Function |
|
| MPH_local_proc_id_SE_overlap |
MPH_Single_Exec_Overlap |
Function |
|
| MPH_local_SE |
MPH_Single_Exec |
Subroutine |
|
| MPH_local_SE_overlap |
MPH_Single_Exec_Overlap |
Subroutine |
|
| MPH_local_world_ME_SE |
comm_sub12 |
Function |
|
| MPH_local_world_SE_overlap |
MPH_Single_Exec_Overlap |
Function |
|
| MPH_low_proc_limit |
MPH_Single_Exec |
Function |
|
| MPH_low_proc_limit |
MPH_Single_Exec_Overlap |
Function |
|
| MPH_myName_ME_SE |
comm_sub12 |
Function |
|
| MPH_read_list_ME |
MPH_Multi_Exec |
Function |
|
| MPH_read_list_SE |
MPH_Single_Exec |
Function |
|
| MPH_read_list_SE_overlap |
MPH_Single_Exec_Overlap |
Function |
|
| MPH_redirect_output |
comm_sub123 |
Subroutine |
|
| MPH_setup_ME |
MPH_Multi_Exec |
Subroutine |
|
| MPH_setup_SE |
MPH_Single_Exec |
Subroutine |
|
| MPH_setup_SE_overlap |
MPH_Single_Exec_Overlap |
Subroutine |
|
| MPH_timer |
comm_sub123 |
Function |
|
| MPH_total_components |
comm_sub123 |
Function |
|
| MPH_up_proc_limit |
MPH_Single_Exec |
Function |
|
| MPH_up_proc_limit |
MPH_Single_Exec_Overlap |
Function |
|
| mpi_get_fort_pointers |
fort.F90 |
Subroutine |
|
| mpi_init |
fort.F90 |
Subroutine |
|
| mpi_init_thread |
fort.F90 |
Subroutine |
|
| mpout_close |
m_mpout |
Interface |
|
| mpout_flush |
m_mpout |
Interface |
|
| mpout_ison |
m_mpout |
Interface |
|
| mpout_log |
m_mpout |
Interface |
|
| mpout_open |
m_mpout |
Interface |
|
| mpout_sync |
m_mpout |
Interface |
|
| mrg_x2a_run_mct |
mrg_mod |
Subroutine |
|
| mrg_x2g_run_mct |
mrg_mod |
Subroutine |
|
| mrg_x2i_run_mct |
mrg_mod |
Subroutine |
|
| mrg_x2l_run_mct |
mrg_mod |
Subroutine |
|
| mrg_x2o_run_mct |
mrg_mod |
Subroutine |
|
| mrg_x2r_run_mct |
mrg_mod |
Subroutine |
|
| mrg_x2s_run_mct |
mrg_mod |
Subroutine |
|
| mrg_x2w_run_mct |
mrg_mod |
Subroutine |
|
| msize |
m_Navigator |
Interface |
|
| nan_cohort |
EDCohortDynamicsMod |
Subroutine |
|
| natveg_patch_exists |
subgridMod |
Function |
|
| Navigator_init |
m_Navigator |
Interface |
|
| ncd_defdim |
RtmIO |
Subroutine |
|
| ncd_defvar |
RtmIO |
Interface |
|
| ncd_enddef |
RtmIO |
Subroutine |
|
| ncd_inqdid |
RtmIO |
Subroutine |
|
| ncd_inqdlen |
RtmIO |
Subroutine |
|
| ncd_inqdname |
RtmIO |
Subroutine |
|
| ncd_inqfdims |
RtmIO |
Subroutine |
|
| ncd_inqvdids |
RtmIO |
Subroutine |
|
| ncd_inqvdims |
RtmIO |
Subroutine |
|
| ncd_inqvid |
RtmIO |
Subroutine |
|
| ncd_inqvname |
RtmIO |
Subroutine |
|
| ncd_io |
RtmIO |
Interface |
|
| ncd_pio_closefile |
RtmIO |
Subroutine |
|
| ncd_pio_createfile |
RtmIO |
Subroutine |
|
| ncd_pio_init |
RtmIO |
Subroutine |
|
| ncd_pio_openfile |
RtmIO |
Subroutine |
|
| ncd_putatt |
RtmIO |
Interface |
|
| nCols |
m_SparseMatrix |
Interface |
|
| ndayinyearsec |
ESMF_CalendarMod |
Function |
|
| ndaysinmonth |
ESMF_CalendarMod |
Function |
|
| ndaysinyear |
ESMF_CalendarMod |
Function |
|
| ndep_init |
ndepStreamMod |
Subroutine |
|
| ndep_interp |
ndepStreamMod |
Subroutine |
|
| NewSnowBulkDensity |
SnowHydrologyMod |
Subroutine |
|
| ngseg |
m_GlobalSegMap |
Interface |
|
| nIAttr |
m_AttrVect |
Interface |
|
| nIAttr |
m_Accumulator |
Interface |
|
| nitem |
m_List |
Interface |
|
| nitrifReadNML |
SoilBiogeochemNitrifDenitrifMod |
Subroutine |
|
| Nitrogen_investments |
LunaMod |
Subroutine |
|
| nlseg |
m_GlobalSegMap |
Interface |
|
| nmonthinyearsec |
ESMF_CalendarMod |
Function |
|
| normalize_basetime |
ESMF_BaseTimeMod |
Subroutine |
|
| normalize_timeint |
ESMF_TimeIntervalMod |
Subroutine |
|
| nRAttr |
m_AttrVect |
Interface |
|
| nRAttr |
m_Accumulator |
Interface |
|
| nRows |
m_SparseMatrix |
Interface |
|
| nsecondsinmonth |
ESMF_CalendarMod |
Function |
|
| nsecondsinyear |
ESMF_CalendarMod |
Function |
|
| nsecondsinyearmonth |
ESMF_CalendarMod |
Function |
|
| NStateUpdate1 |
CNNStateUpdate1Mod |
Subroutine |
|
| NStateUpdate2 |
CNNStateUpdate2Mod |
Subroutine |
|
| NStateUpdate2h |
CNNStateUpdate2Mod |
Subroutine |
|
| NStateUpdate3 |
CNNStateUpdate3Mod |
Subroutine |
|
| NStateUpdateDynPatch |
CNNStateUpdate1Mod |
Subroutine |
|
| nullify |
m_List |
Interface |
|
| NumComponents |
m_MCTWorld |
Interface |
|
| NumSegments |
m_Navigator |
Interface |
|
| NumSteps |
m_Accumulator |
Interface |
|
| nutrient_competition_clm45default_type |
NutrientCompetitionCLM45defaultMod |
Interface |
|
| nutrient_competition_FlexibleCN_type |
NutrientCompetitionFlexibleCNMod |
Interface |
|
| oas_definitions_init |
oas_defineMod |
Subroutine |
|
| ocn_final_mct |
ocn_comp_mct |
Subroutine |
|
| ocn_init_mct |
ocn_comp_mct |
Subroutine |
|
| ocn_run_mct |
ocn_comp_mct |
Subroutine |
|
| open_file_handler |
pio_msg_callbacks.F90 |
Subroutine |
|
| open_nf |
ionf_mod |
Function |
|
| openIO |
master.F90 |
Subroutine |
|
| operator (.lower.) |
m_chars |
Interface |
|
| operator (.upper.) |
m_chars |
Interface |
|
| operator(*) |
ESMF_TimeIntervalMod |
Interface |
|
| operator(+) |
ESMF_TimeMod |
Interface |
|
| operator(+) |
ESMF_BaseTimeMod |
Interface |
|
| operator(+) |
ESMF_TimeIntervalMod |
Interface |
|
| operator(-) |
ESMF_TimeMod |
Interface |
|
| operator(-) |
ESMF_BaseTimeMod |
Interface |
|
| operator(-) |
ESMF_TimeIntervalMod |
Interface |
|
| operator(.EQ.) |
ESMF_TimeMod |
Interface |
|
| operator(.EQ.) |
ESMF_BaseTimeMod |
Interface |
|
| operator(.EQ.) |
ESMF_TimeIntervalMod |
Interface |
|
| operator(.GE.) |
ESMF_TimeMod |
Interface |
|
| operator(.GE.) |
ESMF_BaseTimeMod |
Interface |
|
| operator(.GE.) |
ESMF_TimeIntervalMod |
Interface |
|
| operator(.GT.) |
ESMF_TimeMod |
Interface |
|
| operator(.GT.) |
ESMF_BaseTimeMod |
Interface |
|
| operator(.GT.) |
ESMF_TimeIntervalMod |
Interface |
|
| operator(.LE.) |
ESMF_TimeMod |
Interface |
|
| operator(.LE.) |
ESMF_BaseTimeMod |
Interface |
|
| operator(.LE.) |
ESMF_TimeIntervalMod |
Interface |
|
| operator(.LT.) |
ESMF_TimeMod |
Interface |
|
| operator(.LT.) |
ESMF_BaseTimeMod |
Interface |
|
| operator(.LT.) |
ESMF_TimeIntervalMod |
Interface |
|
| operator(.NE.) |
ESMF_TimeMod |
Interface |
|
| operator(.NE.) |
ESMF_BaseTimeMod |
Interface |
|
| operator(.NE.) |
ESMF_TimeIntervalMod |
Interface |
|
| operator(/) |
ESMF_BaseTimeMod |
Interface |
|
| operator(/) |
ESMF_TimeIntervalMod |
Interface |
|
| operator(==) |
ESMF_AlarmMod |
Interface |
|
| opnfil |
RtmFileUtils |
Subroutine |
|
| opnfil |
fileutils |
Subroutine |
|
| opnieee |
m_ioutil |
Subroutine |
|
| opntext |
m_ioutil |
Subroutine |
|
| OrderedPoints |
m_GlobalSegMap |
Interface |
|
| organicrd |
organicFileMod |
Subroutine |
|
| outputRoutineStatus |
master.F90 |
Subroutine |
|
| outputTestStatus |
master.F90 |
Subroutine |
|
| ozone_off_type |
OzoneOffMod |
Interface |
|
| ozone_type |
OzoneMod |
Interface |
|
| p2c |
subgridAveMod |
Interface |
|
| p2c_1d |
subgridAveMod |
Subroutine |
|
| p2c_1d_filter |
subgridAveMod |
Subroutine |
|
| p2c_2d |
subgridAveMod |
Subroutine |
|
| p2c_2d_filter |
subgridAveMod |
Subroutine |
|
| p2g |
subgridAveMod |
Interface |
|
| p2g_1d |
subgridAveMod |
Subroutine |
|
| p2g_2d |
subgridAveMod |
Subroutine |
|
| p2l |
subgridAveMod |
Interface |
|
| p2l_1d |
subgridAveMod |
Subroutine |
|
| p2l_2d |
subgridAveMod |
Subroutine |
|
| PairedMaskedSpatialAverages |
m_SpatialIntegral |
Interface |
|
| PairedMaskedSpatialIntegrals |
m_SpatialIntegral |
Interface |
|
| PairedSpatialAverages |
m_SpatialIntegral |
Interface |
|
| PairedSpatialAveragesV |
m_SpatialIntegralV |
Interface |
|
| PairedSpatialIntegrals |
m_SpatialIntegral |
Interface |
|
| PairedSpatialIntegralsV |
m_SpatialIntegralV |
Interface |
|
| partition_precip |
atm2lndMod |
Subroutine |
|
| patch_pft_size_profile |
EDPatchDynamicsMod |
Subroutine |
|
| patch_state_updater_type |
dynPatchStateUpdaterMod |
Interface |
|
| PatchMassStock |
ChecksBalancesMod |
Subroutine |
|
| PatchNormanRadiation |
EDSurfaceRadiationMod |
Subroutine |
|
| PE_in_component |
MPH_Single_Exec_Overlap |
Function |
|
| pedotransf |
FuncPedotransferMod |
Subroutine |
|
| peLocs |
m_GlobalSegMap |
Interface |
|
| perfutils_setunit |
perf_utils |
Subroutine |
|
| Permute |
m_AttrVect |
Interface |
|
| Permute |
m_SparseMatrix |
Interface |
|
| Permute |
m_GlobalSegMap |
Interface |
|
| permute |
m_Permuter |
Interface |
|
| Permute |
m_GeneralGrid |
Interface |
|
| perr |
m_die |
Interface |
|
| perr_die |
m_die |
Interface |
|
| phenology |
EDPhysiologyMod |
Subroutine |
|
| Photosynthesis |
PhotosynthesisMod |
Subroutine |
|
| PhotosynthesisHydraulicStress |
PhotosynthesisMod |
Subroutine |
! |
| PhotosynthesisTotal |
PhotosynthesisMod |
Subroutine |
|
| pio_callback_handler |
pio_msg_callbacks.F90 |
Subroutine |
|
| pio_copy_att |
nf_mod |
Function |
@public
@ingroup PIO_copy_att
@brief No idea what this function does
@details
@param infile @copydoc file_desc_t
@param invarid :
@param name :
@param outfile :
@param outvarid :
@retval ierr @copydoc error_return |
| PIO_def_dim |
nf_mod |
Function |
@public
@ingroup PIO_def_dim
@brief Defines the netcdf dimension
@details
@param File @copydoc file_desc_t
@param name : The name of the dimension to define
@param len : The size of the dimension
@param dimid : The dimension identifier |
| pio_def_var |
nf_mod |
Interface |
\defgroup PIO_def_var |
| PIO_enddef |
nf_mod |
Function |
@public
@ingroup PIO_enddef
@brief Exits netcdf define mode.
@details
@param File @copydoc file_desc_t
@retval ierr @copydoc error_return |
| pio_fc_gather_offset |
pio_support |
Subroutine |
Purpose:
Gather collective with additional flow control, so as to
be more robust when used with high process counts. Read more… |
| pio_iam_iotask |
pio |
Function |
|
| pio_inq_att |
nf_mod |
Interface |
\defgroup PIO_inq_att |
| pio_inq_attlen |
nf_mod |
Interface |
\defgroup PIO_inq_attlen |
| pio_inq_attname |
nf_mod |
Interface |
\defgroup PIO_inq_attname |
| pio_inq_dimid |
nf_mod |
Function |
@public
@ingroup PIO_inq_dimid
@brief Returns the netcdf dimension id for the name.
@details
@param File @copydoc file_desc_t
@param name : The name of the netcdf dimension.
@param dimid : The netcdf dimension id.
@retval ierr @copydoc error_return Read more… |
| pio_inq_dimlen |
nf_mod |
Function |
@public
@ingroup PIO_inq_dimlen
@brief Returns the extent of a netCDF dimension
@details
@param File @copydoc file_desc_t
@param dimid : The netcdf dimension.
@param dimlen : The extent of the netcdf dimension.
@retval ierr @copydoc error_return |
| pio_inq_dimname |
nf_mod |
Function |
@public
@ingroup PIO_inq_dimname
@brief Gets the name of a dimension given its ID
@details
@param File @copydoc file_desc_t
@param dimid : The netcdf dimension id.
@param dimname : The name associated with the netcdf dimension id.
@retval ierr @copydoc error_return |
| pio_inq_vardimid |
nf_mod |
Interface |
\defgroup PIO_inq_vardimid |
| pio_inq_varid |
nf_mod |
Interface |
\defgroup PIO_inq_varid |
| pio_inq_varname |
nf_mod |
Interface |
\defgroup PIO_inq_varname |
| pio_inq_varnatts |
nf_mod |
Interface |
\defgroup PIO_inq_varnatts |
| pio_inq_varndims |
nf_mod |
Interface |
\defgroup PIO_inq_varndims |
| pio_inq_vartype |
nf_mod |
Interface |
\defgroup PIO_inq_vartype |
| pio_inquire |
nf_mod |
Function |
@public
@ingroup PIO_inquire
@brief Gets metadata information for netcdf file.
@details
@param File @copydoc file_desc_t
@param nDimensions : Number of dimensions defined for the netcdf file
@param nVariables : Number of variables defined for the netcdf file
@param nAttributes : Number of attributes defined for the netcdf file
@param unlimitedDimID : the Unlimited dimension ID
@retval ierr @copydoc error_return |
| PIO_inquire_dimension |
nf_mod |
Function |
@public
@ingroup PIO_inquire_dimension
@brief Get information about a particular dimension in netcdf file
@details
@param ncid : A netcdf file descriptor returned by \ref PIO_openfile or \ref PIO_createfile.
@param dimid : The netcdf dimension ID.
@param name : The name of the dimension.
@param len : The length of the dimesions name.
@retval ierr @copydoc error_return |
| pio_inquire_variable |
nf_mod |
Interface |
\defgroup PIO_inquire_variable |
| pio_iotask_rank |
pio |
Function |
|
| pio_msg_handler |
pio_msg_mod |
Subroutine |
|
| pio_msg_handler_init |
pio_msg_mod |
Subroutine |
|
| pio_readdof |
pio_support |
Subroutine |
|
| PIO_redef |
nf_mod |
Function |
@public
@ingroup PIO_redef
@brief Re-enters netcdf define mode.
@details Read more… |
| pio_set_blocksize |
calcdecomp |
Subroutine |
@defgroup PIO_set_blocksize
Sets the contiguous block size read or written from each IO task.
The optimal value of this parameter is filesystem specific. |
| pio_type_to_mpi_type |
pio_mpi_utils |
Function |
|
| pio_writedof |
pio_support |
Subroutine |
|
| piodie |
pio_support |
Subroutine |
|
| plc |
PhotosynthesisMod |
Function |
|
| post_fire_mortality |
SFMainMod |
Subroutine |
Read more… |
| PreDisturbanceIntegrateLitter |
EDPhysiologyMod |
Subroutine |
|
| PreDisturbanceLitterFluxes |
EDPhysiologyMod |
Subroutine |
|
| prep_aoflux_calc_xao_ax |
prep_aoflux_mod |
Subroutine |
|
| prep_aoflux_calc_xao_ox |
prep_aoflux_mod |
Subroutine |
|
| prep_aoflux_get_xao_ax |
prep_aoflux_mod |
Function |
|
| prep_aoflux_get_xao_ox |
prep_aoflux_mod |
Function |
|
| prep_aoflux_init |
prep_aoflux_mod |
Subroutine |
|
| prep_atm_calc_i2x_ax |
prep_atm_mod |
Subroutine |
|
| prep_atm_calc_l2x_ax |
prep_atm_mod |
Subroutine |
|
| prep_atm_calc_o2x_ax |
prep_atm_mod |
Subroutine |
|
| prep_atm_get_i2x_ax |
prep_atm_mod |
Function |
|
| prep_atm_get_l2x_ax |
prep_atm_mod |
Function |
|
| prep_atm_get_mapper_Fi2a |
prep_atm_mod |
Function |
|
| prep_atm_get_mapper_Fl2a |
prep_atm_mod |
Function |
|
| prep_atm_get_mapper_Fo2a |
prep_atm_mod |
Function |
|
| prep_atm_get_mapper_Si2a |
prep_atm_mod |
Function |
|
| prep_atm_get_mapper_Sl2a |
prep_atm_mod |
Function |
|
| prep_atm_get_mapper_So2a |
prep_atm_mod |
Function |
|
| prep_atm_get_o2x_ax |
prep_atm_mod |
Function |
|
| prep_atm_init |
prep_atm_mod |
Subroutine |
|
| prep_atm_mrg |
prep_atm_mod |
Subroutine |
|
| prep_canopyfluxes |
CLMFatesInterfaceMod |
Subroutine |
|
| prep_glc_accum |
prep_glc_mod |
Subroutine |
|
| prep_glc_accum_avg |
prep_glc_mod |
Subroutine |
|
| prep_glc_calc_l2x_gx |
prep_glc_mod |
Subroutine |
|
| prep_glc_get_l2gacc_lx |
prep_glc_mod |
Function |
|
| prep_glc_get_l2gacc_lx_cnt |
prep_glc_mod |
Function |
|
| prep_glc_get_l2gacc_lx_one_instance |
prep_glc_mod |
Function |
|
| prep_glc_get_l2x_gx |
prep_glc_mod |
Function |
|
| prep_glc_get_mapper_Fl2g |
prep_glc_mod |
Function |
|
| prep_glc_get_mapper_Sl2g |
prep_glc_mod |
Function |
|
| prep_glc_init |
prep_glc_mod |
Subroutine |
|
| prep_glc_mrg |
prep_glc_mod |
Subroutine |
|
| prep_glc_zero_fields |
prep_glc_mod |
Subroutine |
|
| prep_ice_calc_a2x_ix |
prep_ice_mod |
Subroutine |
|
| prep_ice_calc_g2x_ix |
prep_ice_mod |
Subroutine |
|
| prep_ice_calc_o2x_ix |
prep_ice_mod |
Subroutine |
|
| prep_ice_calc_r2x_ix |
prep_ice_mod |
Subroutine |
|
| prep_ice_get_a2x_ix |
prep_ice_mod |
Function |
|
| prep_ice_get_g2x_ix |
prep_ice_mod |
Function |
|
| prep_ice_get_mapper_Rg2i |
prep_ice_mod |
Function |
|
| prep_ice_get_mapper_SFo2i |
prep_ice_mod |
Function |
|
| prep_ice_get_o2x_ix |
prep_ice_mod |
Function |
|
| prep_ice_get_r2x_ix |
prep_ice_mod |
Function |
|
| prep_ice_init |
prep_ice_mod |
Subroutine |
|
| prep_ice_mrg |
prep_ice_mod |
Subroutine |
|
| prep_lnd_calc_a2x_lx |
prep_lnd_mod |
Subroutine |
|
| prep_lnd_calc_g2x_lx |
prep_lnd_mod |
Subroutine |
|
| prep_lnd_calc_r2x_lx |
prep_lnd_mod |
Subroutine |
|
| prep_lnd_get_a2x_lx |
prep_lnd_mod |
Function |
|
| prep_lnd_get_g2x_lx |
prep_lnd_mod |
Function |
|
| prep_lnd_get_mapper_Fa2l |
prep_lnd_mod |
Function |
|
| prep_lnd_get_mapper_Fg2l |
prep_lnd_mod |
Function |
|
| prep_lnd_get_mapper_Fr2l |
prep_lnd_mod |
Function |
|
| prep_lnd_get_mapper_Sa2l |
prep_lnd_mod |
Function |
|
| prep_lnd_get_mapper_Sg2l |
prep_lnd_mod |
Function |
|
| prep_lnd_get_r2x_lx |
prep_lnd_mod |
Function |
|
| prep_lnd_init |
prep_lnd_mod |
Subroutine |
|
| prep_lnd_mrg |
prep_lnd_mod |
Subroutine |
|
| prep_ocn_accum |
prep_ocn_mod |
Subroutine |
|
| prep_ocn_accum_avg |
prep_ocn_mod |
Subroutine |
|
| prep_ocn_calc_a2x_ox |
prep_ocn_mod |
Subroutine |
|
| prep_ocn_calc_g2x_ox |
prep_ocn_mod |
Subroutine |
|
| prep_ocn_calc_i2x_ox |
prep_ocn_mod |
Subroutine |
|
| prep_ocn_calc_r2x_ox |
prep_ocn_mod |
Subroutine |
|
| prep_ocn_calc_w2x_ox |
prep_ocn_mod |
Subroutine |
|
| prep_ocn_get_a2x_ox |
prep_ocn_mod |
Function |
|
| prep_ocn_get_g2x_ox |
prep_ocn_mod |
Function |
|
| prep_ocn_get_i2x_ox |
prep_ocn_mod |
Function |
|
| prep_ocn_get_mapper_Fa2o |
prep_ocn_mod |
Function |
|
| prep_ocn_get_mapper_Fr2o |
prep_ocn_mod |
Function |
|
| prep_ocn_get_mapper_Rg2o_ice |
prep_ocn_mod |
Function |
|
| prep_ocn_get_mapper_Rg2o_liq |
prep_ocn_mod |
Function |
|
| prep_ocn_get_mapper_Rr2o_ice |
prep_ocn_mod |
Function |
|
| prep_ocn_get_mapper_Rr2o_liq |
prep_ocn_mod |
Function |
|
| prep_ocn_get_mapper_Sa2o |
prep_ocn_mod |
Function |
|
| prep_ocn_get_mapper_SFi2o |
prep_ocn_mod |
Function |
|
| prep_ocn_get_mapper_Sw2o |
prep_ocn_mod |
Function |
|
| prep_ocn_get_mapper_Va2o |
prep_ocn_mod |
Function |
|
| prep_ocn_get_r2x_ox |
prep_ocn_mod |
Function |
|
| prep_ocn_get_w2x_ox |
prep_ocn_mod |
Function |
|
| prep_ocn_get_x2oacc_ox |
prep_ocn_mod |
Function |
|
| prep_ocn_get_x2oacc_ox_cnt |
prep_ocn_mod |
Function |
|
| prep_ocn_init |
prep_ocn_mod |
Subroutine |
|
| prep_ocn_mrg |
prep_ocn_mod |
Subroutine |
|
| prep_rof_accum |
prep_rof_mod |
Subroutine |
|
| prep_rof_accum_avg |
prep_rof_mod |
Subroutine |
|
| prep_rof_calc_l2r_rx |
prep_rof_mod |
Subroutine |
|
| prep_rof_get_l2racc_lx |
prep_rof_mod |
Function |
|
| prep_rof_get_l2racc_lx_cnt |
prep_rof_mod |
Function |
|
| prep_rof_get_mapper_Fl2r |
prep_rof_mod |
Function |
|
| prep_rof_init |
prep_rof_mod |
Subroutine |
|
| prep_rof_mrg |
prep_rof_mod |
Subroutine |
|
| prep_wav_calc_a2x_wx |
prep_wav_mod |
Subroutine |
|
| prep_wav_calc_i2x_wx |
prep_wav_mod |
Subroutine |
|
| prep_wav_calc_o2x_wx |
prep_wav_mod |
Subroutine |
|
| prep_wav_init |
prep_wav_mod |
Subroutine |
|
| prep_wav_mrg |
prep_wav_mod |
Subroutine |
|
| PrescribedSoilMoistureAdvance |
SoilMoistureStreamMod |
Subroutine |
|
| PrescribedSoilMoistureInit |
SoilMoistureStreamMod |
Subroutine |
|
| PrescribedSoilMoistureInterp |
SoilMoistureStreamMod |
Subroutine |
|
| print |
m_Rearranger |
Interface |
|
| print |
m_Router |
Interface |
|
| print |
m_GlobalSegMap |
Interface |
|
| print_accum_fields |
accumulMod |
Subroutine |
|
| printnp |
m_MCTWorld |
Interface |
|
| prior_weights_type |
dynPriorWeightsMod |
Interface |
|
| ProcessStorage |
m_GlobalSegMap |
Interface |
|
| PRTBurnLosses |
PRTLossFluxesMod |
Subroutine |
|
| PRTDeciduousTurnover |
PRTLossFluxesMod |
Subroutine |
|
| PRTMaintTurnover |
PRTLossFluxesMod |
Subroutine |
|
| PRTPhenologyFlush |
PRTLossFluxesMod |
Subroutine |
|
| PRTReproRelease |
PRTLossFluxesMod |
Subroutine |
|
| ptr_chars |
m_String |
Interface |
|
| ptr_counts |
m_Navigator |
Interface |
|
| ptr_displs |
m_Navigator |
Interface |
|
| QSat |
QSatMod |
Subroutine |
|
| QSat_2 |
HumanIndexMod |
Subroutine |
|
| quadratic |
quadraticMod |
Subroutine |
|
| rank |
m_GlobalMap |
Interface |
|
| rank |
m_GlobalSegMap |
Interface |
|
| rankMerge |
m_rankMerge |
Interface |
|
| rankSet |
m_rankMerge |
Interface |
|
| rate_of_spread |
SFMainMod |
Subroutine |
**********.
Routine called daily from within ED within a site loop.
Returns the updated currentPatch%ROS_front value for each patch. |
| RCopy |
m_AttrVect |
Interface |
|
| rdnext |
m_inpak90 |
Subroutine |
|
| readAnnualVegetation |
SatellitePhenologyMod |
Subroutine |
loop over months and read vegetated data Read more… |
| readdarray_handler |
pio_msg_callbacks.F90 |
Subroutine |
|
| readNcdio |
paramUtilMod |
Interface |
|
| readNcdioArray1d |
paramUtilMod |
Subroutine |
|
| readNcdioArray1dCheckDimensions |
paramUtilMod |
Subroutine |
|
| readNcdioArray2d |
paramUtilMod |
Subroutine |
|
| readNcdioArray2dCheckDimensions |
paramUtilMod |
Subroutine |
|
| readNcdioScalar |
paramUtilMod |
Subroutine |
|
| readNcdioScalarCheckDimensions |
paramUtilMod |
Subroutine |
|
| ReadNL |
SoilHydrologyType |
Subroutine |
|
| readParameters |
readParamsMod |
Subroutine |
|
| readParams |
SoilBiogeochemPotentialMod |
Subroutine |
|
| readParams |
SoilBiogeochemDecompCascadeCNMod |
Subroutine |
|
| readParams |
CNMRespMod |
Subroutine |
|
| readParams |
CNGapMortalityMod |
Subroutine |
|
| readParams |
CNPhenologyMod |
Subroutine |
|
| readParams |
SoilBiogeochemLittVertTranspMod |
Subroutine |
|
| readParams |
SoilBiogeochemCompetitionMod |
Subroutine |
|
| readParams |
ch4Mod |
Subroutine |
|
| readParams |
SoilBiogeochemNLeachingMod |
Subroutine |
|
| readParams |
SoilBiogeochemNitrifDenitrifMod |
Subroutine |
|
| readParams |
SoilBiogeochemDecompMod |
Subroutine |
|
| readParams |
SoilBiogeochemDecompCascadeBGCMod |
Subroutine |
|
| readParams |
CNFUNMod |
Subroutine |
|
| ReadSparseMatrixAsc |
ReadSparseMatrixAsc.F90 |
Subroutine |
|
| Rearrange |
m_Rearranger |
Interface |
|
| recruitment |
EDPhysiologyMod |
Subroutine |
|
| recv |
m_AttrVectComms |
Interface |
|
| recv |
m_List |
Interface |
|
| recv |
m_GeneralGridComms |
Interface |
|
| recv |
m_Transfer |
Interface |
|
| recv |
m_GlobalSegMapComms |
Interface |
|
| Reduce |
m_AVTEST |
Interface |
|
| relavu |
RtmFileUtils |
Subroutine |
|
| relavu |
fileutils |
Subroutine |
|
| renormalize |
surfrdUtilsMod |
Subroutine |
|
| resize |
m_Navigator |
Interface |
|
| Restart |
SurfaceAlbedoType |
Subroutine |
|
| restart |
CLMFatesInterfaceMod |
Subroutine |
|
| Restart |
FrictionVelocityMod |
Subroutine |
|
| Restart |
SoilHydrologyType |
Subroutine |
|
| restFile_close |
restFileMod |
Subroutine |
|
| restFile_filename |
restFileMod |
Function |
|
| restFile_getfile |
restFileMod |
Subroutine |
|
| restFile_open |
restFileMod |
Subroutine |
|
| restFile_read |
restFileMod |
Subroutine |
|
| restFile_write |
restFileMod |
Subroutine |
|
| reweight_wrapup |
reweightMod |
Subroutine |
|
| rhoSat |
QSatMod |
Subroutine |
|
| RKF45 |
FatesIntegratorsMod |
Subroutine |
|
| rof_cpl_indices_set |
rof_cpl_indices |
Subroutine |
|
| rof_final_mct |
rof_comp_mct |
Subroutine |
|
| rof_init_mct |
rof_comp_mct |
Subroutine |
|
| rof_run_mct |
rof_comp_mct |
Subroutine |
|
| row_sum |
m_SparseMatrix |
Interface |
|
| row_sum_check |
m_SparseMatrix |
Interface |
|
| RtmHistAddfld |
RtmHistFile |
Subroutine |
|
| RtmHistFldsInit |
RtmHistFlds |
Subroutine |
|
| RtmHistFldsSet |
RtmHistFlds |
Subroutine |
|
| RtmHistHtapesBuild |
RtmHistFile |
Subroutine |
|
| RtmHistHtapesWrapup |
RtmHistFile |
Subroutine |
|
| RtmHistPrintflds |
RtmHistFile |
Subroutine |
|
| RtmHistRestart |
RtmHistFile |
Subroutine |
|
| RtmHistUpdateHbuf |
RtmHistFile |
Subroutine |
|
| Rtmini |
RtmMod |
Subroutine |
write(iulog,) "tcx ddist ",minval(ddist),maxval(ddist)
write(iulog,) "tcx evel ",minval(evel),maxval(evel) |
| RtmRestart |
RtmRestFile |
Subroutine |
|
| RtmRestFileName |
RtmRestFile |
Function |
|
| RtmRestFileRead |
RtmRestFile |
Subroutine |
|
| RtmRestFileWrite |
RtmRestFile |
Subroutine |
|
| RtmRestGetfile |
RtmRestFile |
Subroutine |
|
| RtmRestTimeManager |
RtmRestFile |
Subroutine |
|
| Rtmrun |
RtmMod |
Subroutine |
|
| RtmSpmdInit |
RtmSpmd |
Subroutine |
|
| RtmVarInit |
RtmVar |
Subroutine |
|
| RtmVarSet |
RtmVar |
Subroutine |
|
| run_has_transient_landcover |
dynSubgridControlMod |
Function |
|
| RunoffInit |
RunoffMod |
Subroutine |
|
| SatellitePhenology |
SatellitePhenologyMod |
Subroutine |
|
| SatellitePhenologyInit |
SatellitePhenologyMod |
Subroutine |
|
| scatter |
m_AttrVectComms |
Interface |
|
| scatter |
m_AccumulatorComms |
Interface |
|
| scatter |
m_GeneralGridComms |
Interface |
|
| scatter_data_from_master |
spmdGathScatMod |
Interface |
|
| ScatterByColumn |
m_SparseMatrixComms |
Interface |
|
| ScatterByRow |
m_SparseMatrixComms |
Interface |
|
| seccmp |
ESMF_BaseTimeMod |
Subroutine |
|
| SeedIn |
EDPhysiologyMod |
Subroutine |
|
| send |
m_AttrVectComms |
Interface |
|
| send |
m_List |
Interface |
|
| send |
m_GeneralGridComms |
Interface |
|
| send |
m_Transfer |
Interface |
|
| send |
m_GlobalSegMapComms |
Interface |
|
| SendCohortToLitter |
EDCohortDynamicsMod |
Subroutine |
|
| seq_cdata_init |
seq_cdata_mod |
Subroutine |
|
| seq_cdata_setptrs |
seq_cdata_mod |
Subroutine |
|
| seq_comm_clean |
seq_comm_mct |
Subroutine |
|
| seq_comm_cmppe |
seq_comm_mct |
Function |
|
| seq_comm_cplpe |
seq_comm_mct |
Function |
|
| seq_comm_get_ncomps |
seq_comm_mct |
Function |
|
| seq_comm_getnthreads |
seq_comm_mct |
Function |
|
| seq_comm_gloiam |
seq_comm_mct |
Function |
|
| seq_comm_gloroot |
seq_comm_mct |
Function |
|
| seq_comm_iam |
seq_comm_mct |
Function |
|
| seq_comm_iamin |
seq_comm_mct |
Function |
|
| seq_comm_iamroot |
seq_comm_mct |
Function |
|
| seq_comm_init |
seq_comm_mct |
Subroutine |
Initialize seq_comms elements Read more… |
| seq_comm_inst |
seq_comm_mct |
Function |
|
| seq_comm_mpicom |
seq_comm_mct |
Function |
|
| seq_comm_name |
seq_comm_mct |
Function |
|
| seq_comm_printcomms |
seq_comm_mct |
Subroutine |
|
| seq_comm_setnthreads |
seq_comm_mct |
Subroutine |
|
| seq_comm_setptrs |
seq_comm_mct |
Subroutine |
|
| seq_comm_suffix |
seq_comm_mct |
Function |
|
| seq_diag_accum_mct |
seq_diag_mct |
Subroutine |
|
| seq_diag_atm_mct |
seq_diag_mct |
Subroutine |
|
| seq_diag_avdiff_mct |
seq_diag_mct |
Subroutine |
|
| seq_diag_avect_mct |
seq_diag_mct |
Subroutine |
|
| seq_diag_avloc_mct |
seq_diag_mct |
Subroutine |
|
| seq_diag_glc_mct |
seq_diag_mct |
Subroutine |
|
| seq_diag_ice_mct |
seq_diag_mct |
Subroutine |
|
| seq_diag_lnd_mct |
seq_diag_mct |
Subroutine |
|
| seq_diag_ocn_mct |
seq_diag_mct |
Subroutine |
|
| seq_diag_print_mct |
seq_diag_mct |
Subroutine |
|
| seq_diag_rof_mct |
seq_diag_mct |
Subroutine |
|
| seq_diag_sum0_mct |
seq_diag_mct |
Subroutine |
|
| seq_diag_zero_mct |
seq_diag_mct |
Subroutine |
|
| seq_domain_areafactinit |
seq_domain_mct |
Subroutine |
|
| seq_domain_check |
seq_domain_mct |
Subroutine |
|
| seq_domain_compare |
seq_domain_mct |
Subroutine |
|
| seq_drydep_init |
seq_drydep_mod |
Subroutine |
|
| seq_drydep_readnl |
seq_drydep_mod |
Subroutine |
|
| seq_drydep_setHCoeff |
seq_drydep_mod |
Interface |
|
| seq_flds_add |
seq_flds_mod |
Subroutine |
|
| seq_flds_esmf_metadata_get |
seq_flds_mod |
Subroutine |
|
| seq_flds_getField |
seq_flds_mod |
Subroutine |
|
| seq_flds_lookup |
seq_flds_mod |
Interface |
|
| seq_flds_set |
seq_flds_mod |
Subroutine |
|
| seq_flux_atmocn_mct |
seq_flux_mct |
Subroutine |
|
| seq_flux_atmocnexch_mct |
seq_flux_mct |
Subroutine |
|
| seq_flux_init_mct |
seq_flux_mct |
Subroutine |
|
| seq_flux_initexch_mct |
seq_flux_mct |
Subroutine |
|
| seq_flux_ocnalb_mct |
seq_flux_mct |
Subroutine |
|
| seq_flux_readnl_mct |
seq_flux_mct |
Subroutine |
|
| seq_frac_init |
seq_frac_mct |
Subroutine |
|
| seq_frac_set |
seq_frac_mct |
Subroutine |
|
| seq_infodata_Exchange |
seq_infodata_mod |
Subroutine |
|
| seq_infodata_GetData |
seq_infodata_mod |
Interface |
|
| seq_infodata_Init |
seq_infodata_mod |
Subroutine |
|
| seq_infodata_Init2 |
seq_infodata_mod |
Subroutine |
Read more… |
| seq_infodata_print |
seq_infodata_mod |
Subroutine |
|
| seq_infodata_PutData |
seq_infodata_mod |
Interface |
|
| seq_io_close |
seq_io_mod |
Subroutine |
|
| seq_io_cpl_init |
seq_io_mod |
Subroutine |
|
| seq_io_date2yyyymmdd |
seq_io_mod |
Function |
|
| seq_io_enddef |
seq_io_mod |
Subroutine |
|
| seq_io_read |
seq_io_read_mod |
Interface |
|
| seq_io_read |
seq_io_mod |
Interface |
|
| seq_io_redef |
seq_io_mod |
Subroutine |
|
| seq_io_sec2hms |
seq_io_mod |
Function |
|
| seq_io_wopen |
seq_io_mod |
Subroutine |
|
| seq_io_write |
seq_io_mod |
Interface |
|
| seq_map_gsmapcheck |
seq_map_type_mod |
Subroutine |
|
| seq_map_init_exchange |
cplcomp_exchange_mod |
Subroutine |
|
| seq_map_init_rcfile |
seq_map_mod |
Subroutine |
|
| seq_map_init_rearrolap |
seq_map_mod |
Subroutine |
|
| seq_map_initvect |
seq_map_mod |
Subroutine |
|
| seq_map_map |
seq_map_mod |
Subroutine |
|
| seq_map_map_exchange |
cplcomp_exchange_mod |
Subroutine |
|
| seq_map_mapinit |
seq_map_type_mod |
Subroutine |
|
| seq_map_mapmatch |
seq_map_type_mod |
Subroutine |
|
| seq_map_mappoint |
seq_map_type_mod |
Subroutine |
|
| seq_map_mapvect |
seq_map_mod |
Subroutine |
|
| seq_map_readdata |
seq_map_mod |
Subroutine |
|
| seq_mctext_avExtend |
cplcomp_exchange_mod |
Subroutine |
|
| seq_mctext_avInit |
cplcomp_exchange_mod |
Subroutine |
|
| seq_mctext_gGridInit |
cplcomp_exchange_mod |
Subroutine |
|
| seq_mctext_gsmapInit |
cplcomp_exchange_mod |
Subroutine |
|
| seq_rest_read |
seq_rest_mod |
Subroutine |
|
| seq_rest_write |
seq_rest_mod |
Subroutine |
|
| seq_timemgr_alarmIsOn |
seq_timemgr_mod |
Function |
|
| seq_timemgr_AlarmSetOff |
seq_timemgr_mod |
Subroutine |
|
| seq_timemgr_AlarmSetOn |
seq_timemgr_mod |
Subroutine |
|
| seq_timemgr_clockAdvance |
seq_timemgr_mod |
Subroutine |
|
| seq_timemgr_clockInit |
seq_timemgr_mod |
Subroutine |
|
| seq_timemgr_clockPrint |
seq_timemgr_mod |
Subroutine |
|
| seq_timemgr_data_assimilation_active |
seq_timemgr_mod |
Function |
|
| seq_timemgr_EClockDateInSync |
seq_timemgr_mod |
Function |
|
| seq_timemgr_EClockGetData |
seq_timemgr_mod |
Subroutine |
|
| seq_timemgr_ETimeGet |
seq_timemgr_mod |
Subroutine |
|
| seq_timemgr_ETimeInit |
seq_timemgr_mod |
Subroutine |
|
| seq_timemgr_historyAlarmIsOn |
seq_timemgr_mod |
Function |
|
| seq_timemgr_pause_active |
seq_timemgr_mod |
Function |
|
| seq_timemgr_pause_component_active |
seq_timemgr_mod |
Function |
|
| seq_timemgr_pause_component_index |
seq_timemgr_mod |
Function |
|
| seq_timemgr_pauseAlarmIsOn |
seq_timemgr_mod |
Function |
|
| seq_timemgr_restartAlarmIsOn |
seq_timemgr_mod |
Function |
|
| seq_timemgr_stopAlarmIsOn |
seq_timemgr_mod |
Function |
|
| set_active |
subgridWeightsMod |
Subroutine |
|
| set_fates_ctrlparms |
FatesInterfaceMod |
Subroutine |
|
| set_fates_global_elements |
FatesInterfaceMod |
Subroutine |
|
| set_fcblocksize |
m_FcComms |
Subroutine |
|
| set_glc_elevclass_field |
seq_flds_mod |
Subroutine |
|
| set_is_pft_known_to_model |
pftconMod |
Subroutine |
|
| set_landunit_weight |
subgridWeightsMod |
Subroutine |
|
| set_mindist |
initInterpMindist |
Subroutine |
|
| set_nextsw_cday |
clm_time_manager |
Subroutine |
|
| set_num_cfts_known_to_model |
pftconMod |
Subroutine |
|
| set_patchno |
EDPatchDynamicsMod |
Subroutine |
|
| set_perchroot_opt |
SoilMoistStressMod |
Subroutine |
|
| set_root_fraction |
FatesAllometryMod |
Subroutine |
|
| set_single_match |
initInterpMindist |
Subroutine |
|
| set_site_properties |
EDInitMod |
Subroutine |
|
| set_subgrid_diagnostic_fields |
subgridWeightsMod |
Subroutine |
|
| set_timemgr_init |
clm_time_manager |
Subroutine |
|
| seterrorhandling_handler |
pio_msg_callbacks.F90 |
Subroutine |
|
| setExposedvegpFilter |
filterMod |
Subroutine |
|
| SetFatesTime |
FatesInterfaceMod |
Subroutine |
|
| setFilters |
filterMod |
Subroutine |
|
| SetMatrix |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_Snow |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_Snow_Soil |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_Snow_SoilNonUrban |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_Snow_SoilUrban |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_Snow_SoilUrbanNonRoad |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_Snow_SoilUrbanRoad |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_SnowNonUrban |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_SnowUrban |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_SnowUrbanNonRoad |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_SnowUrbanRoad |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_Soil |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_Soil_Snow |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_Soil_SnowNonUrban |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_Soil_SnowUrban |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_Soil_SnowUrbanNonRoad |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_Soil_SnowUrbanRoad |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_Soil_StandingSurfaceWater |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_SoilNonUrban |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_SoilUrban |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_SoilUrbanNonRoad |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_SoilUrbanRoad |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_StandingSurfaceWater |
SoilTemperatureMod |
Subroutine |
|
| SetMatrix_StandingSurfaceWater_Soil |
SoilTemperatureMod |
Subroutine |
|
| SetRHSVec |
SoilTemperatureMod |
Subroutine |
|
| SetRHSVec_Snow |
SoilTemperatureMod |
Subroutine |
|
| SetRHSVec_SnowNonUrban |
SoilTemperatureMod |
Subroutine |
|
| SetRHSVec_SnowUrban |
SoilTemperatureMod |
Subroutine |
|
| SetRHSVec_SnowUrbanNonRoad |
SoilTemperatureMod |
Subroutine |
|
| SetRHSVec_SnowUrbanRoad |
SoilTemperatureMod |
Subroutine |
|
| SetRHSVec_Soil |
SoilTemperatureMod |
Subroutine |
|
| SetRHSVec_Soil_StandingSurfaceWater |
SoilTemperatureMod |
Subroutine |
|
| SetRHSVec_SoilNonUrban |
SoilTemperatureMod |
Subroutine |
|
| SetRHSVec_SoilUrban |
SoilTemperatureMod |
Subroutine |
|
| SetRHSVec_SoilUrbanNonRoad |
SoilTemperatureMod |
Subroutine |
|
| SetRHSVec_SoilUrbanRoad |
SoilTemperatureMod |
Subroutine |
|
| SetRHSVec_StandingSurfaceWater |
SoilTemperatureMod |
Subroutine |
|
| SetState |
PRTGenericMod |
Subroutine |
|
| SharedAttrIndexList |
m_AttrVect |
Interface |
|
| SharedAttrIndexList |
m_Accumulator |
Interface |
|
| SharedIndices |
m_AttrVect |
Interface |
|
| SharedIndicesOneType |
m_AttrVect |
Interface |
|
| shr_abort_abort |
shr_abort_mod |
Subroutine |
|
| shr_abort_backtrace |
shr_abort_mod |
Subroutine |
|
| shr_cal_advDate |
shr_cal_mod |
Interface |
|
| shr_cal_advDateInt |
shr_cal_mod |
Interface |
|
| shr_cal_calendarName |
shr_cal_mod |
Function |
|
| shr_cal_date2julian |
shr_cal_mod |
Interface |
|
| shr_cal_date2ymd |
shr_cal_mod |
Interface |
|
| shr_cal_datetod2string |
shr_cal_mod |
Interface |
|
| shr_cal_elapsDaysStrtMonth |
shr_cal_mod |
Function |
|
| shr_cal_getDebug |
shr_cal_mod |
Subroutine |
|
| shr_cal_numDaysInMonth |
shr_cal_mod |
Function |
|
| shr_cal_numDaysInYear |
shr_cal_mod |
Function |
|
| shr_cal_setDebug |
shr_cal_mod |
Subroutine |
|
| shr_cal_timeSet |
shr_cal_mod |
Interface |
|
| shr_cal_validdate |
shr_cal_mod |
Interface |
|
| shr_cal_validHMS |
shr_cal_mod |
Function |
|
| shr_cal_validYMD |
shr_cal_mod |
Function |
|
| shr_cal_ymd2date |
shr_cal_mod |
Interface |
|
| shr_cal_ymd2julian |
shr_cal_mod |
Subroutine |
|
| shr_cal_ymds2rday_offset |
shr_cal_mod |
Subroutine |
|
| shr_cal_ymdtod2string |
shr_cal_mod |
Subroutine |
|
| shr_carma_readnl |
shr_carma_mod |
Subroutine |
|
| shr_const_isspval |
shr_const_mod |
Function |
|
| shr_dmodel_gGridCompare |
shr_dmodel_mod |
Function |
|
| shr_dmodel_gsmapCreate |
shr_dmodel_mod |
Interface |
|
| shr_dmodel_mapSet |
shr_dmodel_mod |
Interface |
|
| shr_dmodel_readgrid |
shr_dmodel_mod |
Subroutine |
|
| shr_dmodel_readLBUB |
shr_dmodel_mod |
Subroutine |
|
| shr_dmodel_rearrGGrid |
shr_dmodel_mod |
Subroutine |
|
| shr_dmodel_translate_list |
shr_dmodel_mod |
Subroutine |
|
| shr_dmodel_translateAV |
shr_dmodel_mod |
Subroutine |
|
| shr_dmodel_translateAV_list |
shr_dmodel_mod |
Subroutine |
|
| shr_exp_list_destroy |
shr_expr_parser_mod |
Subroutine |
|
| shr_exp_parse |
shr_expr_parser_mod |
Function |
|
| shr_file_chdir |
shr_file_mod |
Subroutine |
|
| shr_file_chStdIn |
shr_file_mod |
Subroutine |
|
| shr_file_chStdOut |
shr_file_mod |
Subroutine |
|
| shr_file_dirio |
shr_file_mod |
Subroutine |
|
| shr_file_freeUnit |
perf_utils |
Subroutine |
|
| shr_file_freeUnit |
shr_file_mod |
Subroutine |
|
| shr_file_get |
shr_file_mod |
Subroutine |
|
| shr_file_getLogLevel |
shr_file_mod |
Subroutine |
|
| shr_file_getLogUnit |
shr_file_mod |
Subroutine |
|
| shr_file_getUnit |
perf_utils |
Function |
|
| shr_file_getUnit |
shr_file_mod |
Function |
|
| shr_file_put |
shr_file_mod |
Subroutine |
|
| shr_file_queryPrefix |
shr_file_mod |
Function |
|
| shr_file_setIO |
shr_file_mod |
Subroutine |
|
| shr_file_setLogLevel |
shr_file_mod |
Subroutine |
|
| shr_file_setLogUnit |
shr_file_mod |
Subroutine |
|
| shr_file_stdio |
shr_file_mod |
Subroutine |
|
| shr_fire_emis_readnl |
shr_fire_emis_mod |
Subroutine |
|
| shr_flux_adjust_constants |
shr_flux_mod |
Subroutine |
|
| shr_flux_atmIce |
shr_flux_mod |
Subroutine |
|
| shr_flux_atmOcn |
shr_flux_mod |
Subroutine |
|
| shr_flux_atmOcn_diurnal |
shr_flux_mod |
Subroutine |
|
| shr_flux_MOstability |
shr_flux_mod |
Subroutine |
|
| shr_log_errMsg |
shr_log_mod |
Function |
|
| shr_log_OOBMsg |
shr_log_mod |
Function |
|
| shr_map_checkFilled |
shr_map_mod |
Function |
|
| shr_map_checkInit |
shr_map_mod |
Function |
|
| shr_map_clean |
shr_map_mod |
Subroutine |
|
| shr_map_get |
shr_map_mod |
Interface |
|
| shr_map_listValidOpts |
shr_map_mod |
Subroutine |
|
| shr_map_mapData |
shr_map_mod |
Interface |
|
| shr_map_mapSet |
shr_map_mod |
Interface |
|
| shr_map_print |
shr_map_mod |
Subroutine |
|
| shr_map_put |
shr_map_mod |
Interface |
|
| shr_map_setAbort |
shr_map_mod |
Subroutine |
|
| shr_map_setDebug |
shr_map_mod |
Subroutine |
|
| shr_map_setDopole |
shr_map_mod |
Subroutine |
|
| shr_mct_queryConfigFile |
shr_mct_mod |
Subroutine |
|
| shr_mct_sMatPInitnc |
shr_mct_mod |
Interface |
|
| shr_mct_sMatReaddnc |
shr_mct_mod |
Subroutine |
|
| shr_mct_sMatReadnc |
shr_mct_mod |
Subroutine |
!!!!!!!!!!!!!!!!!!!!!!!! Read more… |
| shr_mct_sMatWritednc |
shr_mct_mod |
Subroutine |
|
| shr_megan_readnl |
shr_megan_mod |
Subroutine |
|
| shr_mem_getusage |
shr_mem_mod |
Subroutine |
|
| shr_mem_init |
shr_mem_mod |
Subroutine |
|
| shr_mpi_abort |
shr_mpi_mod |
Subroutine |
|
| shr_mpi_barrier |
perf_utils |
Subroutine |
|
| shr_mpi_barrier |
shr_mpi_mod |
Subroutine |
|
| shr_mpi_bcast |
perf_utils |
Interface |
|
| shr_mpi_bcast |
shr_mpi_mod |
Interface |
|
| shr_mpi_chkerr |
shr_mpi_mod |
Subroutine |
|
| shr_mpi_commrank |
shr_mpi_mod |
Subroutine |
|
| shr_mpi_commsize |
shr_mpi_mod |
Subroutine |
|
| shr_mpi_finalize |
shr_mpi_mod |
Subroutine |
|
| shr_mpi_gatherv |
shr_mpi_mod |
Interface |
|
| shr_mpi_gathScatVInit |
shr_mpi_mod |
Interface |
|
| shr_mpi_init |
shr_mpi_mod |
Subroutine |
|
| shr_mpi_initialized |
shr_mpi_mod |
Subroutine |
|
| shr_mpi_max |
shr_mpi_mod |
Interface |
|
| shr_mpi_min |
shr_mpi_mod |
Interface |
|
| shr_mpi_recv |
shr_mpi_mod |
Interface |
|
| shr_mpi_scatterv |
shr_mpi_mod |
Interface |
|
| shr_mpi_send |
shr_mpi_mod |
Interface |
|
| shr_mpi_sum |
shr_mpi_mod |
Interface |
|
| shr_msg_chdir |
shr_msg_mod |
Subroutine |
|
| shr_msg_chStdIn |
shr_msg_mod |
Subroutine |
|
| shr_msg_chStdOut |
shr_msg_mod |
Subroutine |
|
| shr_msg_dirio |
shr_msg_mod |
Subroutine |
|
| shr_msg_stdio |
shr_msg_mod |
Subroutine |
|
| shr_ncread_close |
shr_ncread_mod |
Subroutine |
|
| shr_ncread_dimSize |
shr_ncread_mod |
Interface |
|
| shr_ncread_domain |
shr_ncread_mod |
Subroutine |
|
| shr_ncread_field4dG |
shr_ncread_mod |
Subroutine |
|
| shr_ncread_handleErr |
shr_ncread_mod |
Subroutine |
|
| shr_ncread_open |
shr_ncread_mod |
Subroutine |
|
| shr_ncread_setAbort |
shr_ncread_mod |
Subroutine |
|
| shr_ncread_setDebug |
shr_ncread_mod |
Subroutine |
|
| shr_ncread_tField |
shr_ncread_mod |
Interface |
|
| shr_ncread_varDimNum |
shr_ncread_mod |
Subroutine |
|
| shr_ncread_varDimSize |
shr_ncread_mod |
Interface |
|
| shr_ncread_varDimSizes |
shr_ncread_mod |
Subroutine |
|
| shr_ncread_varExists |
shr_ncread_mod |
Function |
|
| shr_ndep_readnl |
shr_ndep_mod |
Subroutine |
|
| shr_nl_find_group_name |
shr_nl_mod |
Subroutine |
|
| shr_orb_cosz |
shr_orb_mod |
Function |
|
| shr_orb_decl |
shr_orb_mod |
Subroutine |
|
| shr_orb_params |
shr_orb_mod |
Subroutine |
|
| shr_orb_print |
shr_orb_mod |
Subroutine |
|
| shr_pcdf_readwrite |
shr_pcdf_mod |
Subroutine |
|
| shr_pio_finalize |
shr_pio_mod |
Subroutine |
|
| shr_pio_getioformat |
shr_pio_mod |
Interface |
|
| shr_pio_getioroot |
shr_pio_mod |
Interface |
|
| shr_pio_getiosys |
shr_pio_mod |
Interface |
|
| shr_pio_getiotype |
shr_pio_mod |
Interface |
|
| shr_pio_getrearranger |
shr_pio_mod |
Interface |
|
| shr_pio_init1 |
shr_pio_mod |
Subroutine |
@public
@brief should be the first routine called after mpi_init.
It reads the pio default settings from file drv_in, namelist pio_default_inparm
and, if pio_async_interface is true, splits the IO tasks away from the
Compute tasks. It then returns the new compute comm in
Global_Comm and sets module variable io_comm. |
| shr_pio_init2 |
shr_pio_mod |
Subroutine |
@public
@brief if pio_async_interface is true, tasks in io_comm do not return from this subroutine. Read more… |
| shr_precip_partition_rain_snow_ramp |
shr_precip_mod |
Subroutine |
|
| shr_reprosum_calc |
shr_reprosum_mod |
Subroutine |
|
| shr_reprosum_setopts |
shr_reprosum_mod |
Subroutine |
|
| shr_reprosum_tolExceeded |
shr_reprosum_mod |
Function |
|
| shr_scam_checkSurface |
shr_scam_mod |
Subroutine |
|
| shr_scam_getCloseLatLon |
shr_scam_mod |
Interface |
|
| shr_spfn_erf |
shr_spfn_mod |
Interface |
|
| shr_spfn_erfc |
shr_spfn_mod |
Interface |
|
| shr_spfn_erfc_scaled |
shr_spfn_mod |
Interface |
|
| shr_spfn_gamma |
shr_spfn_mod |
Interface |
|
| shr_spfn_igamma |
shr_spfn_mod |
Function |
|
| shr_strdata_advance |
shr_strdata_mod |
Subroutine |
|
| shr_strdata_bcastnml |
shr_strdata_mod |
Subroutine |
|
| shr_strdata_clean |
shr_strdata_mod |
Subroutine |
|
| shr_strdata_create |
shr_strdata_mod |
Interface |
|
| shr_strdata_init |
shr_strdata_mod |
Subroutine |
|
| shr_strdata_pioinit |
shr_strdata_mod |
Interface |
|
| shr_strdata_print |
shr_strdata_mod |
Subroutine |
|
| shr_strdata_readnml |
shr_strdata_mod |
Subroutine |
|
| shr_strdata_restRead |
shr_strdata_mod |
Subroutine |
|
| shr_strdata_restWrite |
shr_strdata_mod |
Subroutine |
|
| shr_strdata_setlogunit |
shr_strdata_mod |
Subroutine |
|
| shr_strdata_setOrbs |
shr_strdata_mod |
Subroutine |
|
| shr_stream_dataDump |
shr_stream_mod |
Subroutine |
|
| shr_stream_default |
shr_stream_mod |
Subroutine |
|
| shr_stream_findBounds |
shr_stream_mod |
Subroutine |
|
| shr_stream_getCalendar |
shr_stream_mod |
Subroutine |
|
| shr_stream_getCurrFile |
shr_stream_mod |
Subroutine |
|
| shr_stream_getDataSource |
shr_stream_mod |
Subroutine |
|
| shr_stream_getDebug |
shr_stream_mod |
Subroutine |
|
| shr_stream_getDomainInfo |
shr_stream_mod |
Subroutine |
|
| shr_stream_getFile |
shr_stream_mod |
Subroutine |
|
| shr_stream_getFileFieldList |
shr_stream_mod |
Subroutine |
|
| shr_stream_getFileFieldName |
shr_stream_mod |
Subroutine |
|
| shr_stream_getFilepath |
shr_stream_mod |
Subroutine |
|
| shr_stream_getFirstFileName |
shr_stream_mod |
Subroutine |
|
| shr_stream_getModelFieldList |
shr_stream_mod |
Subroutine |
|
| shr_stream_getModelFieldName |
shr_stream_mod |
Subroutine |
|
| shr_stream_getNextFileName |
shr_stream_mod |
Subroutine |
|
| shr_stream_getNFiles |
shr_stream_mod |
Subroutine |
|
| shr_stream_getPrevFileName |
shr_stream_mod |
Subroutine |
|
| shr_stream_init |
shr_stream_mod |
Subroutine |
|
| shr_stream_isInit |
shr_stream_mod |
Function |
|
| shr_stream_parseInput |
shr_stream_mod |
Subroutine |
|
| shr_stream_restRead |
shr_stream_mod |
Subroutine |
|
| shr_stream_restWrite |
shr_stream_mod |
Subroutine |
|
| shr_stream_set |
shr_stream_mod |
Subroutine |
|
| shr_stream_setAbort |
shr_stream_mod |
Subroutine |
|
| shr_stream_setCurrFile |
shr_stream_mod |
Subroutine |
|
| shr_stream_setDebug |
shr_stream_mod |
Subroutine |
|
| shr_string_alphanum |
shr_string_mod |
Subroutine |
|
| shr_string_betweenTags |
shr_string_mod |
Subroutine |
|
| shr_string_clean |
shr_string_mod |
Subroutine |
|
| shr_string_convert_tabs |
shr_string_mod |
Function |
|
| shr_string_countChar |
shr_string_mod |
Function |
|
| shr_string_endIndex |
shr_string_mod |
Function |
|
| shr_string_getParentDir |
shr_string_mod |
Function |
|
| shr_string_lastIndex |
shr_string_mod |
Function |
|
| shr_string_leftalign_and_convert_tabs |
shr_string_mod |
Subroutine |
|
| shr_string_listAddSuffix |
shr_string_mod |
Subroutine |
|
| shr_string_listAppend |
shr_string_mod |
Subroutine |
|
| shr_string_listCreateField |
shr_string_mod |
Function |
|
| shr_string_listDiff |
shr_string_mod |
Subroutine |
|
| shr_string_listFromSuffixes |
shr_string_mod |
Function |
|
| shr_string_listGetDel |
shr_string_mod |
Subroutine |
|
| shr_string_listGetIndex |
shr_string_mod |
Subroutine |
|
| shr_string_listGetIndexF |
shr_string_mod |
Function |
|
| shr_string_listGetName |
shr_string_mod |
Subroutine |
|
| shr_string_listGetNum |
shr_string_mod |
Function |
|
| shr_string_listIntersect |
shr_string_mod |
Subroutine |
|
| shr_string_listIsValid |
shr_string_mod |
Function |
|
| shr_string_listMerge |
shr_string_mod |
Subroutine |
|
| shr_string_listPrepend |
shr_string_mod |
Subroutine |
|
| shr_string_listSetDel |
shr_string_mod |
Subroutine |
|
| shr_string_listUnion |
shr_string_mod |
Subroutine |
|
| shr_string_parseCFtunit |
shr_string_mod |
Subroutine |
|
| shr_string_setAbort |
shr_string_mod |
Subroutine |
|
| shr_string_setDebug |
shr_string_mod |
Subroutine |
|
| shr_string_toLower |
shr_string_mod |
Function |
|
| shr_string_toUpper |
shr_string_mod |
Function |
|
| shr_sys_abort |
perf_utils |
Subroutine |
|
| shr_sys_chdir |
shr_sys_mod |
Subroutine |
|
| shr_sys_flush |
shr_sys_mod |
Subroutine |
|
| shr_sys_getenv |
shr_sys_mod |
Subroutine |
|
| shr_sys_irtc |
shr_sys_mod |
Function |
|
| shr_sys_sleep |
shr_sys_mod |
Subroutine |
|
| shr_sys_system |
shr_sys_mod |
Subroutine |
|
| shr_timer_check |
shr_timer_mod |
Subroutine |
|
| shr_timer_check_all |
shr_timer_mod |
Subroutine |
|
| shr_timer_free |
shr_timer_mod |
Subroutine |
|
| shr_timer_free_all |
shr_timer_mod |
Subroutine |
|
| shr_timer_get |
shr_timer_mod |
Subroutine |
|
| shr_timer_init |
shr_timer_mod |
Subroutine |
|
| shr_timer_print |
shr_timer_mod |
Subroutine |
|
| shr_timer_print_all |
shr_timer_mod |
Subroutine |
|
| shr_timer_sleep |
shr_timer_mod |
Subroutine |
|
| shr_timer_start |
shr_timer_mod |
Subroutine |
|
| shr_timer_stop |
shr_timer_mod |
Subroutine |
|
| shr_timer_zero |
shr_timer_mod |
Subroutine |
|
| shr_timer_zero_all |
shr_timer_mod |
Subroutine |
|
| shr_tInterp_getAvgCosz |
shr_tInterp_mod |
Subroutine |
|
| shr_tInterp_getCosz |
shr_tInterp_mod |
Subroutine |
|
| shr_tInterp_getDebug |
shr_tInterp_mod |
Subroutine |
|
| shr_tInterp_getFactors |
shr_tInterp_mod |
Subroutine |
|
| shr_tInterp_setAbort |
shr_tInterp_mod |
Subroutine |
|
| shr_tInterp_setDebug |
shr_tInterp_mod |
Subroutine |
|
| shr_vmath_cos |
shr_vmath_mod |
Subroutine |
|
| shr_vmath_div |
shr_vmath_mod |
Subroutine |
|
| shr_vmath_exp |
shr_vmath_mod |
Subroutine |
|
| shr_vmath_log |
shr_vmath_mod |
Subroutine |
|
| shr_vmath_rsqrt |
shr_vmath_mod |
Subroutine |
|
| shr_vmath_sin |
shr_vmath_mod |
Subroutine |
|
| shr_vmath_sqrt |
shr_vmath_mod |
Subroutine |
|
| shr_wv_sat_final |
shr_wv_sat_mod |
Subroutine |
|
| shr_wv_sat_get_scheme_idx |
shr_wv_sat_mod |
Function |
|
| shr_wv_sat_init |
shr_wv_sat_mod |
Subroutine |
|
| shr_wv_sat_make_tables |
shr_wv_sat_mod |
Subroutine |
|
| shr_wv_sat_qsat_ice |
shr_wv_sat_mod |
Subroutine |
|
| shr_wv_sat_qsat_liquid |
shr_wv_sat_mod |
Subroutine |
|
| shr_wv_sat_qsat_mixed |
shr_wv_sat_mod |
Subroutine |
|
| shr_wv_sat_set_default |
shr_wv_sat_mod |
Function |
|
| shr_wv_sat_svp_ice |
shr_wv_sat_mod |
Function |
|
| shr_wv_sat_svp_liquid |
shr_wv_sat_mod |
Function |
|
| shr_wv_sat_svp_mixed |
shr_wv_sat_mod |
Function |
|
| shr_wv_sat_svp_to_qmmr |
shr_wv_sat_mod |
Function |
|
| shr_wv_sat_svp_to_qsat |
shr_wv_sat_mod |
Function |
|
| shr_wv_sat_valid_idx |
shr_wv_sat_mod |
Function |
|
| SiteMassStock |
ChecksBalancesMod |
Subroutine |
|
| sizetype_class_index |
FatesSizeAgeTypeIndicesMod |
Subroutine |
|
| sMatAvMult |
m_MatAttrVectMul |
Interface |
|
| SNICAR_RT |
SnowSnicarMod |
Subroutine |
|
| SnowAge_grain |
SnowSnicarMod |
Subroutine |
* 1. DRY SNOW AGING *** Read more… |
| SnowAge_init |
SnowSnicarMod |
Subroutine |
|
| SnowCapping |
SnowHydrologyMod |
Subroutine |
|
| SnowCappingExcess |
SnowHydrologyMod |
Subroutine |
|
| SnowCompaction |
SnowHydrologyMod |
Subroutine |
|
| SnowHydrology_readnl |
SnowHydrologyMod |
Subroutine |
|
| SnowHydrologySetControlForTesting |
SnowHydrologyMod |
Subroutine |
|
| SnowOptics_init |
SnowSnicarMod |
Subroutine |
|
| SnowWater |
SnowHydrologyMod |
Subroutine |
|
| soil_resistance_readNL |
SurfaceResistanceMod |
Subroutine |
|
| soil_water_retention_curve_clapp_hornberg_1978_type |
SoilWaterRetentionCurveClappHornberg1978Mod |
Interface |
|
| soil_water_retention_curve_vangenuchten_1980_type |
SoilWaterRetentionCurveVanGenuchten1980Mod |
Interface |
|
| SoilBiogeochemCompetition |
SoilBiogeochemCompetitionMod |
Subroutine |
|
| SoilBiogeochemCompetitionInit |
SoilBiogeochemCompetitionMod |
Subroutine |
|
| SoilBiogeochemDecomp |
SoilBiogeochemDecompMod |
Subroutine |
|
| SoilBiogeochemLittVertTransp |
SoilBiogeochemLittVertTranspMod |
Subroutine |
for single level case, no transport; just update the fluxes calculated in the StateUpdate1 subroutines |
| SoilBiogeochemNitrifDenitrif |
SoilBiogeochemNitrifDenitrifMod |
Subroutine |
! set all soils with the same pH as placeholder here
maximum potential denitrification rates based on heterotrophic respiration rates or nitrate concentrations,
from (del Grosso et al., 2000) |
| SoilBiogeochemNitrogenUptake |
SoilBiogeochemNitrogenUptakeMod |
Subroutine |
|
| SoilBiogeochemNLeaching |
SoilBiogeochemNLeachingMod |
Subroutine |
|
| SoilBiogeochemNStateUpdate1 |
SoilBiogeochemNStateUpdate1Mod |
Subroutine |
|
| SoilBiogeochemPotential |
SoilBiogeochemPotentialMod |
Subroutine |
calculate c:n ratios of applicable pools
not transition of cwd to litter |
| SoilBiogeochemPrecisionControl |
SoilBiogeochemPrecisionControlMod |
Subroutine |
|
| SoilBiogeochemPrecisionControlInit |
SoilBiogeochemPrecisionControlMod |
Subroutine |
|
| SoilBiogeochemVerticalProfile |
SoilBiogeochemVerticalProfileMod |
Subroutine |
aggregate root profile to column |
| SoilFluxes |
SoilFluxesMod |
Subroutine |
|
| SoilHydrologyInitTimeConst |
SoilHydrologyInitTimeConstMod |
Subroutine |
|
| SoilStateInitTimeConst |
SoilStateInitTimeConstMod |
Subroutine |
added by K.Sakaguchi for beta from Lee and Pielke, 1992 Read more… |
| SoilTemperature |
SoilTemperatureMod |
Subroutine |
|
| SoilWater |
SoilWaterMovementMod |
Subroutine |
$ call soilwater_mixed_form(bounds, num_hydrologyc, filter_hydrologyc, &
$ num_urbanc, filter_urbanc, soilhydrology_inst, soilstate_inst, &
$ waterflux_inst, waterstate_inst, temperature_inst) Read more… |
| Sort |
m_AttrVect |
Interface |
|
| Sort |
m_SparseMatrix |
Interface |
|
| Sort |
m_GlobalSegMap |
Interface |
|
| Sort |
m_GeneralGrid |
Interface |
|
| sort_cohorts |
EDCohortDynamicsMod |
Subroutine |
|
| SortPermute |
m_AttrVect |
Interface |
|
| SortPermute |
m_GGRIDTEST |
Interface |
|
| SortPermute |
m_SMATTEST |
Interface |
|
| SortPermute |
m_SparseMatrix |
Interface |
|
| SortPermute |
m_GlobalSegMap |
Interface |
|
| SortPermute |
m_AVTEST |
Interface |
|
| SortPermute |
m_GeneralGrid |
Interface |
|
| SparseMatrixToXGlobalSegMap |
m_SparseMatrixToMaps |
Interface |
|
| SparseMatrixToYGlobalSegMap |
m_SparseMatrixToMaps |
Interface |
|
| SpatialAverage |
m_SpatialIntegral |
Interface |
|
| SpatialAverageV |
m_SpatialIntegralV |
Interface |
|
| SpatialIntegral |
m_SpatialIntegral |
Interface |
|
| SpatialIntegralV |
m_SpatialIntegralV |
Interface |
|
| spawn_patches |
EDPatchDynamicsMod |
Subroutine |
***/
* INSERT NEW PATCH(ES) INTO LINKED LIST
**`***/ |
| species_from_string |
CNSpeciesMod |
Function |
|
| species_isotope_type |
SpeciesIsotopeType |
Interface |
|
| species_non_isotope_type |
SpeciesNonIsotopeType |
Interface |
|
| SpitFireCheckParams |
SFParamsMod |
Subroutine |
|
| SpitFireReceiveParams |
SFParamsMod |
Subroutine |
|
| SpitFireRegisterParams |
SFParamsMod |
Subroutine |
|
| spmd_init |
spmdMod |
Subroutine |
|
| srcfin |
srcmodel |
Subroutine |
!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! |
| srcinit |
srcmodel |
Subroutine |
!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! Read more… |
| srcrun |
srcmodel |
Subroutine |
|
| StepsDone |
m_Accumulator |
Interface |
|
| storage_fraction_of_target |
FatesAllometryMod |
Subroutine |
|
| str2rn |
m_inpak90 |
Function |
|
| strget |
m_inpak90 |
Subroutine |
|
| String_bcast |
m_String |
Interface |
|
| String_clean |
m_String |
Interface |
|
| string_handler_for_att |
pio_msg_callbacks.F90 |
Subroutine |
|
| String_init |
m_String |
Interface |
|
| String_len |
m_String |
Interface |
|
| String_mci |
m_String |
Interface |
|
| String_mco |
m_String |
Interface |
|
| StringLinkedList_clean |
m_StringLinkedList |
Interface |
|
| StringLinkedList_count |
m_StringLinkedList |
Interface |
|
| StringLinkedList_delete |
m_StringLinkedList |
Interface |
|
| StringLinkedList_eol |
m_StringLinkedList |
Interface |
|
| StringLinkedList_get |
m_StringLinkedList |
Interface |
|
| StringLinkedList_init |
m_StringLinkedList |
Interface |
|
| StringLinkedList_insert |
m_StringLinkedList |
Interface |
|
| StringLinkedList_next |
m_StringLinkedList |
Interface |
|
| StrTemplate |
m_StrTemplate |
Interface |
|
| subgrid_get_gcellinfo |
subgridMod |
Subroutine |
|
| subgrid_get_info_cohort |
subgridMod |
Subroutine |
|
| subgrid_get_info_crop |
subgridMod |
Subroutine |
|
| subgrid_get_info_glacier_mec |
subgridMod |
Subroutine |
|
| subgrid_get_info_lake |
subgridMod |
Subroutine |
|
| subgrid_get_info_natveg |
subgridMod |
Subroutine |
|
| subgrid_get_info_urban_hd |
subgridMod |
Subroutine |
|
| subgrid_get_info_urban_md |
subgridMod |
Subroutine |
|
| subgrid_get_info_urban_tbd |
subgridMod |
Subroutine |
|
| subgrid_get_info_wetland |
subgridMod |
Subroutine |
|
| subgridRest_check_consistency |
subgridRestMod |
Subroutine |
|
| subgridRest_read_cleanup |
subgridRestMod |
Subroutine |
|
| subgridRestRead |
subgridRestMod |
Subroutine |
|
| subgridRestWrite |
subgridRestMod |
Subroutine |
|
| subnetworkRouting |
MOSART_physics_mod |
Subroutine |
|
| SurfaceAlbedo |
SurfaceAlbedoMod |
Subroutine |
|
| SurfaceAlbedoInitTimeConst |
SurfaceAlbedoMod |
Subroutine |
|
| SurfaceRadiation |
SurfaceRadiationMod |
Subroutine |
|
| surfrd_get_data |
surfrdMod |
Subroutine |
|
| surfrd_get_globmask |
surfrdMod |
Subroutine |
|
| surfrd_get_grid |
surfrdMod |
Subroutine |
|
| SwampCoolEff |
HumanIndexMod |
Subroutine |
|
| swbgt |
HumanIndexMod |
Subroutine |
|
| sync_nf |
ionf_mod |
Function |
|
| t_adj_detailf |
perf_mod |
Subroutine |
|
| t_barrier_onf |
perf_mod |
Function |
|
| t_barrierf |
perf_mod |
Subroutine |
|
| t_disablef |
perf_mod |
Subroutine |
|
| t_drvstartf |
t_drv_timers_mod |
Subroutine |
|
| t_drvstopf |
t_drv_timers_mod |
Subroutine |
|
| t_enablef |
perf_mod |
Subroutine |
|
| t_finalizef |
perf_mod |
Subroutine |
|
| t_getLogUnit |
perf_mod |
Subroutine |
|
| t_initf |
perf_mod |
Subroutine |
|
| t_prf |
perf_mod |
Subroutine |
|
| t_profile_onf |
perf_mod |
Function |
|
| t_set_prefixf |
perf_mod |
Subroutine |
|
| t_setLogUnit |
perf_mod |
Subroutine |
|
| t_single_filef |
perf_mod |
Function |
|
| t_stampf |
perf_mod |
Subroutine |
|
| t_startf |
perf_mod |
Subroutine |
|
| t_startstop_valsf |
perf_mod |
Subroutine |
|
| t_stopf |
perf_mod |
Subroutine |
|
| t_unset_prefixf |
perf_mod |
Subroutine |
|
| template_col_from_landunit |
dynColumnTemplateMod |
Function |
|
| template_col_from_natveg_array |
dynColumnTemplateMod |
Subroutine |
|
| terminate_cohorts |
EDCohortDynamicsMod |
Subroutine |
|
| terminate_patches |
EDPatchDynamicsMod |
Subroutine |
|
| test_collectives |
ftest.F90 |
Subroutine |
|
| test_complex_indexed |
ftest.F90 |
Subroutine |
|
| test_contiguous |
ftest.F90 |
Subroutine |
|
| test_contiguous |
ftest_internal.F90 |
Subroutine |
|
| test_indices |
m_List |
Interface |
|
| test_mpi_version |
ftest.F90 |
Subroutine |
|
| test_multiple |
ftest.F90 |
Subroutine |
|
| test_multiple |
ftest_internal.F90 |
Subroutine |
|
| test_multiple_indexed |
ftest.F90 |
Subroutine |
|
| test_packed |
ftest.F90 |
Subroutine |
|
| test_packed |
ftest_internal.F90 |
Subroutine |
|
| test_simple_bindexed |
ftest.F90 |
Subroutine |
|
| test_simple_bindexed |
ftest_internal.F90 |
Subroutine |
|
| test_simple_hindexed |
ftest.F90 |
Subroutine |
|
| test_simple_hindexed |
ftest_internal.F90 |
Subroutine |
|
| test_simple_hvector |
ftest.F90 |
Subroutine |
|
| test_simple_hvector |
ftest_internal.F90 |
Subroutine |
|
| test_simple_indexed |
ftest.F90 |
Subroutine |
|
| test_simple_indexed |
ftest_internal.F90 |
Subroutine |
|
| test_vector |
ftest.F90 |
Subroutine |
|
| test_vector |
ftest_internal.F90 |
Subroutine |
|
| testall |
m_GSMapTest |
Interface |
|
| testall |
m_GGRIDTEST |
Interface |
|
| testall |
m_ACTEST |
Interface |
|
| testall |
m_MCTWORLDTEST |
Interface |
|
| testall |
m_SMATTEST |
Interface |
|
| testall |
m_ROUTERTEST |
Interface |
|
| testall |
m_AVTEST |
Interface |
|
| testall |
m_GMAPTEST |
Interface |
|
| testAttrVect |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_appendIAttr |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_appendRAttr |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_clean |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_copy |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_exportIAttr |
AttrVect_Test.F90 |
Subroutine |
! bug? --> call MCT_AtrVt_exportIAttr(av, AttrTag="foo",outVect=out, perrWith="quiet") |
| testAttrVect_exportIList |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_exportIListToChar |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_exportRAttr |
AttrVect_Test.F90 |
Subroutine |
! bug? --> call MCT_AtrVt_exportRAttr(av, AttrTag="foo",outVect=out, perrWith="quiet") |
| testAttrVect_exportRList |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_exportRListToChar |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_getIList |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_getRList |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_importIAttr |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_importRAttr |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_indexIA |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_indexRA |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_init |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_lsize |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_nIAttr |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_nRAttr |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_permute |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_sharedAttrIndexList |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_sort |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_sortPermute |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_unpermute |
AttrVect_Test.F90 |
Subroutine |
|
| testAttrVect_zero |
AttrVect_Test.F90 |
Subroutine |
|
| THIndex |
HumanIndexMod |
Subroutine |
|
| time_info_type |
dynTimeInfoMod |
Interface |
|
| timemgr_datediff |
clm_time_manager |
Subroutine |
|
| timemgr_init |
RtmTimeManager |
Subroutine |
|
| timemgr_init |
clm_time_manager |
Subroutine |
|
| timemgr_reset |
clm_time_manager |
Subroutine |
|
| timemgr_restart |
RtmTimeManager |
Subroutine |
|
| timemgr_restart |
clm_time_manager |
Subroutine |
|
| timemgr_restart_io |
clm_time_manager |
Subroutine |
|
| timemgr_setup |
RtmTimeManager |
Subroutine |
|
| to_lower |
perf_utils |
Function |
|
| toChar |
m_String |
Interface |
|
| toString |
shr_strconvert_mod |
Interface |
|
| TransferZ0mDisp |
CLMFatesInterfaceMod |
Subroutine |
|
| tree_lai |
FatesAllometryMod |
Function |
|
| tree_sai |
FatesAllometryMod |
Function |
|
| Tridiagonal |
TridiagonalMod |
Subroutine |
|
| trim_canopy |
EDPhysiologyMod |
Subroutine |
|
| Unpermute |
m_AttrVect |
Interface |
|
| unpermute |
m_Permuter |
Interface |
|
| update_accum_field |
accumulMod |
Interface |
|
| update_DA_nstep |
clm_time_manager |
Subroutine |
|
| update_hlm_dynamics |
EDCanopyStructureMod |
Subroutine |
|
| update_landunit_weights |
dynLandunitAreaMod |
Subroutine |
|
| update_landunit_weights_one_gcell |
dynLandunitAreaMod |
Subroutine |
|
| Update_Photosynthesis_Capacity |
LunaMod |
Subroutine |
|
| update_rad_dtime |
clm_time_manager |
Subroutine |
|
| UpdateCohortBioPhysRates |
EDCohortDynamicsMod |
Subroutine |
|
| UpdateDaylength |
DaylengthMod |
Subroutine |
|
| updateState_hillslope |
MOSART_physics_mod |
Subroutine |
|
| updateState_mainchannel |
MOSART_physics_mod |
Subroutine |
|
| updateState_subnetwork |
MOSART_physics_mod |
Subroutine |
|
| uppercase |
m_chars |
Interface |
|
| UrbanAlbedo |
UrbanAlbedoMod |
Subroutine |
|
| UrbanFluxes |
UrbanFluxesMod |
Subroutine |
|
| UrbanInput |
UrbanParamsType |
Subroutine |
|
| UrbanRadiation |
UrbanRadiationMod |
Subroutine |
|
| UrbanReadNML |
UrbanParamsType |
Subroutine |
|
| use_aquifer_layer |
SoilWaterMovementMod |
Function |
|
| val_check_ed_vars |
EDTypesMod |
Subroutine |
|
| VaporPres |
HumanIndexMod |
Subroutine |
|
| vecinit |
m_SparseMatrixPlus |
Interface |
|
| vecinit |
m_SparseMatrix |
Interface |
|
| vecinit_ |
m_SparseMatrixPlus |
Subroutine |
|
| VectorLength |
m_Navigator |
Interface |
|
| VOCEmission |
VOCEmissionMod |
Subroutine |
|
| waitrecv |
m_Transfer |
Interface |
|
| waitsend |
m_Transfer |
Interface |
|
| warn |
m_die |
Interface |
|
| wav_final_mct |
wav_comp_mct |
Subroutine |
|
| wav_init_mct |
wav_comp_mct |
Subroutine |
|
| wav_run_mct |
wav_comp_mct |
Subroutine |
|
| Wet_Bulb |
HumanIndexMod |
Subroutine |
|
| Wet_BulbS |
HumanIndexMod |
Subroutine |
|
| wind_effect |
SFMainMod |
Subroutine |
**********. |
| wiso_akci |
water_isotopes |
Function |
difrmj = difrm(isp)/fisub(isp)
wiso_akci = wiso_akci**expk(isp) |
| wiso_akel |
water_isotopes |
Function |
difrmj = difrm(isp)/fisub(isp)
else
wiso_akel = alpeq
end if Read more… |
| wiso_alpi |
water_isotopes |
Function |
|
| wiso_alpl |
water_isotopes |
Function |
|
| wiso_delta |
water_isotopes |
Function |
|
| wiso_flxoce |
water_isotopes |
Subroutine |
|
| wiso_get_fisub |
water_isotopes |
Function |
|
| wiso_get_ispec |
water_isotopes |
Function |
|
| wiso_get_roce |
water_isotopes |
Function |
|
| wiso_get_rstd |
water_isotopes |
Function |
|
| wiso_heff |
water_isotopes |
Function |
|
| wiso_init |
water_isotopes |
Subroutine |
|
| wiso_kmol |
water_isotopes |
Subroutine |
|
| wiso_kmolv10 |
water_isotopes |
Subroutine |
|
| wiso_ratio |
water_isotopes |
Function |
wiso_ratio = espmw(isp)*wiso_ratio/fisum(isp) ! correct! |
| wiso_ssatf |
water_isotopes |
Function |
wiso_ssatf = max(wiso_ssatf, fsata) |
| wrap_accumulatefluxes |
CLMFatesInterfaceMod |
Subroutine |
|
| wrap_bgc_summary |
CLMFatesInterfaceMod |
Subroutine |
|
| wrap_btran |
CLMFatesInterfaceMod |
Subroutine |
|
| wrap_canopy_radiation |
CLMFatesInterfaceMod |
Subroutine |
|
| wrap_hydraulics_drive |
CLMFatesInterfaceMod |
Subroutine |
|
| wrap_photosynthesis |
CLMFatesInterfaceMod |
Subroutine |
|
| wrap_sunfrac |
CLMFatesInterfaceMod |
Subroutine |
|
| wrap_update_hlmfates_dyn |
CLMFatesInterfaceMod |
Subroutine |
|
| wrf_error_fatal |
wrf_error_fatal.F90 |
Subroutine |
|
| wrf_error_fatal |
wrf_stuff.F90 |
Subroutine |
|
| wrf_message |
wrf_stuff.F90 |
Subroutine |
|
| wrf_message |
wrf_message.F90 |
Subroutine |
|
| write_coltype_metadata |
column_varcon |
Subroutine |
|
| writedarray_handler |
pio_msg_callbacks.F90 |
Subroutine |
|
| wtype_get_alpha |
water_types |
Function |
|
| wtype_get_itype |
water_types |
Function |
|
| wtype_init |
water_types |
Subroutine |
|
| zeit_allflush |
m_zeit |
Interface |
|
| zeit_ci |
m_zeit |
Interface |
|
| zeit_co |
m_zeit |
Interface |
|
| zeit_flush |
m_zeit |
Interface |
|
| zeit_reset |
m_zeit |
Interface |
|
| zero |
m_AttrVect |
Interface |
|
| zero |
m_Accumulator |
Interface |
|
| zero |
m_GeneralGrid |
Interface |
|
| zero_cohort |
EDCohortDynamicsMod |
Subroutine |
|
| zero_patch |
EDPatchDynamicsMod |
Subroutine |
|
| zero_site |
EDInitMod |
Subroutine |
|
| ZeroAllocationRates |
EDPhysiologyMod |
Subroutine |
|
| ZeroLitterFluxes |
EDPhysiologyMod |
Subroutine |
|