| Procedure | Location | Procedure Type | Description |
|---|---|---|---|
| axis_obj_Final | leapBlock | Subroutine | Finalizes object and frees data. |
| axis_obj_Init | leapBlock | Subroutine | Initialize axis. |
| bc_set_Add | leapBC | Subroutine | Adds a new region to bc_set. |
| bc_set_BuildMask | leapBC | Subroutine | Builds an integer field, where cells=0 denotes interior cells, and cells=1 denotes boundary cells for input variable. |
| bc_set_CheckBCExists | leapBC | Function | Checks whether there is BC for a given variable on a given region. |
| bc_set_CheckBounds | leapBC | Function | Makes sure bounds represent a plane. |
| bc_set_Expand | leapBC | Subroutine | Resizes array to accomodate a new element. |
| bc_set_Final | leapBC | Subroutine | Finalizes bc_set and frees memory. |
| bc_set_GetBCPointer | leapBC | Subroutine | Fetches a pointer to the val array describing the Dirichlet or Neumann BC of a given variable on a given region. |
| bc_set_GetBCType | leapBC | Function | |
| bc_set_GetExtents | leapBC | Function | Returns the extents (lo and hi bounds) of a region. |
| bc_set_GetRegionIndex | leapBC | Function | Returns the index of a region, or -1 if not found. |
| bc_set_GetSideDirByNormal | leapBC | Subroutine | |
| bc_set_GetSideDirByRegion | leapBC | Subroutine | |
| bc_set_Info | leapBC | Subroutine | Prints to stdout information on bc_set, for debugging. |
| bc_set_Init | leapBC | Subroutine | Initializes bc_set. |
| bc_set_Read | leapBC | Subroutine | Reads boundary conditions from file. |
| bc_set_SetBC | leapBC | Subroutine | Sets boundary condition of a given type, for a given variable on a given region. |
| bc_set_UpdateBoundaryDirichlet | leapBC | Subroutine | Updates ghost cells to enforce Dirichlet BC |
| bc_set_UpdateBoundaryNeumann | leapBC | Subroutine | Updates ghostcells to enforce Neumann BC. |
| bc_set_UpdateBoundaryScalar | leapBC | Subroutine | Imposes boundary conditions for a scalar variable. |
| bc_set_UpdateBoundarySymmetryMinus | leapBC | Subroutine | Updates ghostcells to enforce symmetry BC. Minus version. |
| bc_set_UpdateBoundarySymmetryPlus | leapBC | Subroutine | Updates ghostcells to enforce symmetry BC. Plus version. |
| bc_set_UpdateBoundaryVector | leapBC | Subroutine | Imposes boundary conditions for a vector field. For symmetry BC, the sign depends is 'plus' or 'minus' depending on the alignment between the vector component and the symmetry direction. |
| bc_set_UpdateExtents | leapBC | Subroutine | Finds the intersection between block owned by this MPI rank, and the plane defining the region. |
| bc_set_Write | leapBC | Subroutine | Writes bc_set to disk using HDF5. The file structure follows this convention: |
| block_obj_Final | leapBlock | Subroutine | Finalizes the block object. |
| block_obj_GetOwningCell | leapBlock | Function | Returns the coordinates of the cell that contains the position p. This subroutine ignores gost cells. As such, it will always return an internal cell of the domain. If the point is located in a ghost cell, the returned cell will be an internal boundary cell that is closest to that ghost cell. |
| block_obj_GetOwningCellWGC | leapBlock | Function | Returns the coordinates of the cell that contains the position p, inclusive of ghost cells. |
| block_obj_Info | leapBlock | Subroutine | Prints to stdout information about this block |
| block_obj_Init | leapBlock | Subroutine | Initializes block object. |
| block_obj_Init2 | leapBlock | Subroutine | [DEPRECATED] Initializes block object. |
| block_obj_Locate | leapBlock | Function | Returns block ID and rank of the block where the point is located using a binary search alogirthm. Note that this function assumes that the point is within the domain, i.e., (pmin <= p <= pmax) and that any treatment for periodicity has been previously applied. |
| block_obj_Partition | leapBlock | Subroutine | Partitions a parent block into sub-blocks based on a given decomposition Nb(3) for parallel simulations. This will also define the partition axes, and update local bounds/extents, and global bounds/extents. |
| block_obj_Read | leapBlock | Subroutine | Reads block data using HDF5. |
| block_obj_SetConveniencePointers | leapBlock | Subroutine | Associate convenience pointers. |
| block_obj_SetPeriodicity | leapBlock | Subroutine | Sets block periodicity in each direction. |
| block_obj_SetupMPITypes | leapBlock | Subroutine | Defines MPI derived type for communicating ghostcells. |
| block_obj_SetupUniformGrid | leapBlock | Subroutine | Initializes a uniform grid on this block. |
| block_obj_SubDivideBlock | leapBlock | Subroutine | Computes the bounds of the sub-block form the bounds of the parent block. Each sub-block gets about the same number of grid points in each direction. |
| block_obj_UpdateExtents | leapBlock | Subroutine | Updates the dimensional extents of the block. |
| block_obj_UpdateGridGhostCells | leapBlock | Subroutine | Updates the ghostcell values of local grid owned by the current MPI rank. Note that each MPI rank stores only its portion of the grid, thus needs to have proper ghostcell values. |
| block_obj_UpdateMidPoints | leapBlock | Subroutine | Updates mid points. |
| block_obj_UpdateSpacing | leapBlock | Subroutine | Updates grid spacing arrays. |
| block_obj_Write | leapBlock | Subroutine | Writes block data using HDF5. |
| cdifs_AdvanceSolutionMomentumRHS1 | cdifs_AdvanceSolution_smod | Function | Computes Momentum operator RHS for velocity component in x1-direction. |
| cdifs_AdvanceSolutionMomentumRHS2 | cdifs_AdvanceSolution_smod | Function | Computes Momentum operator RHS for velocity component in x2-direction. |
| cdifs_AdvanceSolutionMomentumRHS3 | cdifs_AdvanceSolution_smod | Function | Computes Momentum operator RHS for velocity component in x3-direction. |
| cdifs_obj_AdvanceSolution | cdifs | Interface | |
| cdifs_obj_AdvanceSolutionBodyForce | cdifs_AdvanceSolution_smod | Subroutine | Computes bodyforces based on old state. |
| cdifs_obj_AdvanceSolutionCorrector | cdifs_AdvanceSolution_smod | Subroutine | Perform corrector step: compute pressure at n+1 and divergence-free velocity at n+1. |
| cdifs_obj_AdvanceSolutionIB | cdifs_AdvanceSolution_smod | Subroutine | Performs intermediate IB step> |
| cdifs_obj_AdvanceSolutionPredictor | cdifs_AdvanceSolution_smod | Subroutine | Performs predictor step: compute intermediate velocity. |
| cdifs_obj_AdvanceSolutionRP | cdifs_AdvanceSolution_smod | Subroutine | Advances Resolved Particle centroids and markers to n+1. |
| cdifs_obj_ComputeSolidVF | cdifs | Subroutine | Computes the solid volume fraction (ibVF) by solving a Poisson equation. This subroutine computes the IB normals fields, applies approriate boundary conditions, and takes the divergence, which forms the right-hand side of the poisson equation. It then uses a HYPRE solver to solve this equation. In case where the Poisson operator is singular and using resolved particles, this subroutine will apply a correction that sets the solid volume fraction at particle centroids. |
| cdifs_obj_Final | cdifs | Subroutine | Finalizes solver and frees memory. |
| cdifs_obj_FlowUpdateMonitor | cdifs_Monitor_smod | Subroutine | Monitors flow data. |
| cdifs_obj_Init | cdifs | Subroutine | Initializes the CDIFS solver. |
| cdifs_obj_LinkHDF5Object | cdifs | Subroutine | Links HDF5 Object. |
| cdifs_obj_Monitor | cdifs | Interface | |
| cdifs_obj_PrepareSolver | cdifs | Interface | |
| cdifs_obj_PrepareSolverBCS | cdifs_PrepareSolver_smod | Subroutine | Prepares the boundary conditions used by CDIFS. This subroutine reads pre-existing BCS file on disk. The BCS file must include boundary conditions for restart fields (i.e., V1,V2,V3,P) at minimum. Additional boundary conditions may be required. E.g. if IBs are used, the file must contain boundary conditions for ibVF. In such a case, the subroutine adds additional boundary conditions for ibF, ibN, and ibS based on the specified boundary conditions for ibVF. If no Dirichlet conditions are given for ibVF, it marks the volume fraction Poisson equation as singular. |
| cdifs_obj_PrepareSolverBlock | cdifs_PrepareSolver_smod | Subroutine | Prepares block for run. This subroutine reads pre-existing block file on disk and partitions domain based on parameters in the input file. |
| cdifs_obj_PrepareSolverBodyforce | cdifs_PrepareSolver_smod | Subroutine | Prepares bodyorces used by CDIFS. |
| cdifs_obj_PrepareSolverFields | cdifs_PrepareSolver_smod | Subroutine | Prepares fields used by the CDIFS solver. Restart fields (V1,V2,V3,P) are read from file. |
| cdifs_obj_PrepareSolverMonitor | cdifs_PrepareSolver_smod | Subroutine | Prepares the monitors used by CDIFS. |
| cdifs_obj_PrepareSolverOperators | cdifs_PrepareSolver_smod | Subroutine | Prepares operators used by CDIFS. This subroutine also initializes the HYPRE solvers and builds any required operator with the specified boundary conditions. |
| cdifs_obj_PrepareSolverOperatorsDIV | cdifs_PrepareSolver_smod | Subroutine | Generates the divergence operator for the velocity field, and adjusts at the boundaries. |
| cdifs_obj_PrepareSolverOperatorsPGRAD | cdifs_PrepareSolver_smod | Subroutine | Generates the gradient operator for the pressure field, and adjusts at the boundaries. |
| cdifs_obj_PrepareSolverOperatorsPLAP | cdifs_PrepareSolver_smod | Subroutine | Generates the pressure Laplacian operator. |
| cdifs_obj_PrepareSolverOperatorsVFLAP | cdifs_PrepareSolver_smod | Subroutine | Generates the VF Laplacian operator |
| cdifs_obj_PrepareSolverOperatorsVLAP | cdifs_PrepareSolver_smod | Subroutine | Generates the viscous Laplacian operator and adjusts at the boundaries. |
| cdifs_obj_PrepareSolverOutput | cdifs_PrepareSolver_smod | Subroutine | Prepares output list used by CDIFS. |
| cdifs_obj_UpdateCollisions | cdifs_AdvanceSolution_smod | Subroutine | Computes collisions between resolved Particles and Immersed Boundaries. |
| cdifs_obj_WriteOutputData | cdifs | Interface | |
| cdifs_obj_WriteRestartData | cdifs | Interface | |
| cli_obj_Get | leapCli | Subroutine | Gets command line options, by looping over command line arguments and finding pairs of the type "-switch value" |
| collision_obj_AddImmersedBoundaries | collisions | Subroutine | Adds an Immersed Boundary to list of collisional objects. |
| collision_obj_AddPointParticles | collisions | Subroutine | Adds Point Particles to list of collisional objects. |
| collision_obj_AddResolvedParticles | collisions | Subroutine | Adds Resolved Particles to list of collisional objects. |
| collision_obj_ComputeCollisions | collisions | Subroutine | Computes collisions between all added objects. |
| collision_obj_ComputeCollisionsPPvIB | collisions | Subroutine | Computes collisions between Point Particles and Immersed Boundaries. |
| collision_obj_ComputeCollisionsPPvPP | collisions | Subroutine | Computes collisions between pairs of Point Particles. |
| collision_obj_ComputeCollisionsPPvWALL | collisions | Subroutine | Computes collisions between Point Particles and Walls. |
| collision_obj_ComputeCollisionsRPvIB | collisions | Subroutine | Computes collisions between Resolved Particles and Immersed Boundaries. |
| collision_obj_ComputeCollisionsRPvPP | collisions | Subroutine | Computes collisions between Point and Resolved Particles. |
| collision_obj_ComputeCollisionsRPvRP | collisions | Subroutine | Computes collisions between pairs of Resolved Particles. |
| collision_obj_ComputeCollisionsRPvWALL | collisions | Subroutine | Computes collisions between Resolved Particles and Walls. |
| collision_obj_Final | collisions | Subroutine | Finalizes object and frees memory. |
| collision_obj_Init | collisions | Subroutine | Initializes object. |
| collision_obj_Prepare | collisions | Subroutine | Prepares object for use in solvers. |
| collision_obj_Sanitize | collisions | Subroutine | Frees data: removes ghost objects and frees neighbor lists. |
| collision_obj_SetupCollisionBlock | collisions | Subroutine | Initializes cblock to handle collisions. This extra block is expected to be coarser than the simulation block, but larger than the maximum object size. It is used to expedite neighbor searches. |
| collision_obj_SetupCollisionBlock2 | collisions | Subroutine | Initializes cblock to handle collisions. This extra block is expected to be coarser than the simulation block, but larger than the maximum object size. It is used to expedite neighbor searches. |
| collision_obj_UpdateGhostObjects | collisions | Subroutine | Updates ghost objects in preparation for collisions. |
| collision_obj_UpdateNeighborList | collisions | Subroutine | Updates neighbor lists in preparation for collisions. |
| cross_product | immersed_boundaries_markers | Function | Returns the cross product of two vectors. |
| cross_product | particles_resolved | Function | Returns the cross product of two vectors. |
| cross_product | collisions | Function | Returns the cross product of two vectors. |
| cudaDeviceGetAttribute | leapCuda | Interface | |
| cudaFree | leapCuda | Interface | |
| cudaGetDeviceCount | leapCuda | Interface | |
| cudaMallocManaged | leapCuda | Interface | |
| DEM_col | collisions | Function | Computes collisions with a Linearized Spring Dashpot model. |
| device_free | leapCuda | Function | |
| device_Get_Attribute | leapCuda | Function | Wrapper function for "cudaDeviceGetAttribute" |
| device_Get_Count | leapCuda | Function | Wrapper function for "cudaGetDeviceCount" |
| device_info | leapCuda | Subroutine | Get information about GPU |
| device_malloc_managed | leapCuda | Function | Wrapper function for "cudaMallocManaged" |
| eulerian_obj_AddEulerianIObj | leapEulerian | Function | Performs addition of integer Eulerian objects. |
| eulerian_obj_AddEulerianRObj | leapEulerian | Function | Performs addition of real Eulerian objects. |
| eulerian_obj_AddUpGhostCells | leapEulerian | Subroutine | Updates and add-up the ghostcells. |
| eulerian_obj_AddUpGhostCells_x | leapEulerian | Subroutine | Adds up ghostcells in the x direction with non-blocking mpi directives. |
| eulerian_obj_AddUpGhostCells_y | leapEulerian | Subroutine | Adds up ghostcells in the y direction with non-blocking mpi directives. |
| eulerian_obj_AddUpGhostCells_z | leapEulerian | Subroutine | Adds up ghostcells in the z direction with non-blocking mpi directives. |
| eulerian_obj_Allocate | leapEulerian | Subroutine | Allocates Cell array in Eulerian object. |
| eulerian_obj_AssignEulerianObj | leapEulerian | Subroutine | Performs assignment for Eulerian_obj. |
| eulerian_obj_AssignInt0D | leapEulerian | Subroutine | Performs assignment for Eulerian_obj. |
| eulerian_obj_AssignReal0D | leapEulerian | Subroutine | Performs assignment for Eulerian_obj. |
| eulerian_obj_Deallocate | leapEulerian | Subroutine | Deallocate Cell array in Eulerian object. |
| eulerian_obj_Final | leapEulerian | Subroutine | Finalizes the Eulerian object and free memory. |
| eulerian_obj_Info | leapEulerian | Subroutine | Prints info about this structure. |
| eulerian_obj_Init | leapEulerian | Subroutine | Initializes an Eulerian field. |
| eulerian_obj_Mean | leapEulerian | Function | Computes the mean of an Eulerian_obj. |
| eulerian_obj_MulInt0D | leapEulerian | Function | Performs multiplication of integer Eulerian objects by integer scalar. |
| eulerian_obj_MulReal0D | leapEulerian | Function | Performs multiplication of real Eulerian objects by real scalar. |
| eulerian_obj_Norm2 | leapEulerian | Function | Computes norm2 of an Eulerian_obj. |
| eulerian_obj_SubEulerianIObj | leapEulerian | Function | Performs subtraction of integer Eulerian objects. |
| eulerian_obj_SubEulerianRObj | leapEulerian | Function | Performs subtraction of real Eulerian objects. |
| eulerian_obj_UpdateGhostCells | leapEulerian | Subroutine | Updates the ghostcells. |
| eulerian_obj_UpdateGhostCells_x | leapEulerian | Subroutine | Updates the ghostcells in the x direction with non-blocking mpi directives. |
| eulerian_obj_UpdateGhostCells_y | leapEulerian | Subroutine | Updates the ghostcells in the y direction with non-blocking mpi directives. |
| eulerian_obj_UpdateGhostCells_z | leapEulerian | Subroutine | Updates the ghostcells in the z direction with non-blocking mpi directives. |
| eulerian_set_Add | leapEulerian | Subroutine | Adds a eulerian object to the eulerian set. |
| eulerian_set_Final | leapEulerian | Subroutine | Finalizes object and frees up memory. |
| eulerian_set_GetIndex | leapEulerian | Function | Returns the index of an Eulerian_obj contained in this%fields given its name. |
| eulerian_set_GetOverwrite | leapEulerian | Function | Returns whether overwriting is true or false |
| eulerian_set_GetReadFileName | leapEulerian | Function | Returns the base name of file to write |
| eulerian_set_GetWriteFileName | leapEulerian | Function | Returns the base name of file to write. |
| eulerian_set_Info | leapEulerian | Subroutine | Prints info about this collection of eulerian objects |
| eulerian_set_Init | leapEulerian | Subroutine | Initializes an Eulerian Set. |
| eulerian_set_ReadH5HUT | leapEulerian | Subroutine | Reads Eulerian data using H5HUT. |
| eulerian_set_ReadHDF5 | leapEulerian | Subroutine | Reads Eulerian data with LEAP's HDF5. |
| eulerian_set_ReadSingleH5HUT | leapEulerian | Subroutine | Reads one Eulerian object based on name with H5HUT. |
| eulerian_set_ReadSingleHDF5 | leapEulerian | Subroutine | Reads one Eulerian object based on name using LEAP's HDF5. |
| eulerian_set_SetOverwrite | leapEulerian | Subroutine | Sets file overwritting |
| eulerian_set_SetReadFileName | leapEulerian | Subroutine | Set the base name of file to read |
| eulerian_set_SetWriteFileName | leapEulerian | Subroutine | Sets the base name of file to write. |
| eulerian_set_WriteH5HUT | leapEulerian | Subroutine | Writes Eulerian data using H5HUT. |
| eulerian_set_WriteHDF5 | leapEulerian | Subroutine | Write Eulerian data using LEAP's HDF5. |
| eulerian_set_WriteSILO | leapEulerian | Subroutine | Write Eulerian data using SILO. |
| eulerian_set_WriteSingleH5HUT | leapEulerian | Subroutine | Write a single Eulerian object to file using H5HUT. |
| eulerian_set_WriteSingleHDF5 | leapEulerian | Subroutine | Write a single Eulerian object to file using LEAP's HDF5. |
| eulerian_set_WriteSingleSILO | leapEulerian | Subroutine | Write a single Eulerian objects to file using SILO. |
| g1_box | leapfilters | Function | |
| g1_cosine | leapfilters | Function | |
| g1_cosine2 | leapfilters | Function | |
| g1_parabolic | leapfilters | Function | |
| g1_roma | leapfilters | Function | |
| g1_triangle | leapfilters | Function | |
| g1_triweight | leapfilters | Function | |
| grans_obj_AdvanceSolution | grans | Interface | |
| grans_obj_AdvanceSolution_ComputeCollisionForces | grans_AdvanceSolution_smod | Subroutine | Compute collision forces |
| grans_obj_ComputeSolidVF | grans | Subroutine | Computes the solid volume fraction (ibVF) by solving a Poisson equation. This subroutine computes the IB normals fields, applies approriate boundary conditions, and takes the divergence, which forms the right-hand side of the poisson equation. It then uses a HYPRE solver to solve this equation. In case where the Poisson operator is singular and using resolved particles, this subroutine will apply a correction that sets the solid volume fraction at particle centroids. |
| grans_obj_Final | grans | Subroutine | Finalizes solver and frees memory. |
| grans_obj_Init | grans | Subroutine | Initializes the GRANS solver. |
| grans_obj_LinkHDF5Object | grans | Subroutine | Links HDF5 Object. |
| grans_obj_Monitor | grans | Interface | |
| grans_obj_PrepareSolver | grans | Interface | |
| grans_obj_PrepareSolverBCS | grans_PrepareSolver_smod | Subroutine | Prepares the boundary conditions used by GRANS. Note that the only boundary conditions required by GRANS are those in connection with the volume fraction Poisson equations. This subroutine reads pre-existing BCS file on disk. It adds additional boundary conditions for ibF, ibN, and ibS based on the specified boundary conditions for ibVF. If no Dirichlet conditions are given for ibVF, it marks the volume fraction Poisson equation as singular. |
| grans_obj_PrepareSolverBlock | grans_PrepareSolver_smod | Subroutine | Prepares block for run. This subroutine reads pre-existing block file on disk and partitions domain based on parameters in the input file. |
| grans_obj_PrepareSolverCollision | grans_PrepareSolver_smod | Subroutine | Prepares the collision utility used by GRANS. If the collision grid spacing is not provided, this subroutine makes it equal to the largest particle diameter. Collisions with IBs are default to true, but can be turned off. Users can use collisions with walls instead (for simple geometries). Additional parameters are read in the Prepare subroutine of the collision object. |
| grans_obj_PrepareSolverFields | grans_PrepareSolver_smod | Subroutine | Prepares fields used by the GRANS solver. |
| grans_obj_PrepareSolverMonitor | grans_PrepareSolver_smod | Subroutine | Prepares the monitors used by GRANS. |
| grans_obj_PrepareSolverOperators | grans_PrepareSolver_smod | Subroutine | Prepares operators used by GRANS. This subroutine also builds the volume fraction Poisson operator with the specified boundary conditions. |
| grans_obj_PrepareSolverOutput | grans_PrepareSolver_smod | Subroutine | Prepares output list used by GRANS. |
| grans_obj_WriteOutputData | grans | Interface | |
| grans_obj_WriteRestartData | grans | Interface | |
| h5hut_obj_Final | leapIO_h5hut | Subroutine | Finalizes object and frees memeory. |
| h5hut_obj_GetNFields | leapIO_h5hut | Subroutine | Gets number of fields in step. |
| h5hut_obj_GetNPoints | leapIO_h5hut | Subroutine | Gets number of data points in step. H5HUT assumes that all datasets have the same number of points, thus we return the number of points of the first dataset we find. |
| h5hut_obj_GetNSteps | leapIO_h5hut | Function | Counts and returns number of steps in file. |
| h5hut_obj_Init | leapIO_h5hut | Subroutine | Initializes structure. |
| h5hut_obj_JumpToStep | leapIO_h5hut | Subroutine | Jumps to a specific step. |
| h5hut_obj_LastTimeStep | leapIO_h5hut | Subroutine | Gets information about the last step. |
| h5hut_obj_NewTimeStep | leapIO_h5hut | Subroutine | Creates a new step and updates attributes. |
| h5hut_obj_Read1D | leapIO_h5hut | Subroutine | Reads Lagrangian/1D data fom a h5hut file. If no offset is provided, uses default h5hut file view. Otherwise, sets file view manually. |
| h5hut_obj_Read3D | leapIO_h5hut | Subroutine | Reads Eulerian/3D data from a h5hut file. |
| h5hut_obj_ReadAttributes0D | leapIO_h5hut | Subroutine | Reads scalar attributes. |
| h5hut_obj_ReadAttributes1D | leapIO_h5hut | Subroutine | Reads an array of attributes. |
| h5hut_obj_SetStep | leapIO_h5hut | Subroutine | Sets the current step in file, and possibly create a new one, if this step does not exist yet. |
| h5hut_obj_StepCount | leapIO_h5hut | Function | Returns number of steps. |
| h5hut_obj_Write1D | leapIO_h5hut | Subroutine | Writes Lagrangian/1D data to a h5hut file. |
| h5hut_obj_Write3D | leapIO_h5hut | Subroutine | Writes Eulerian/3D data to a h5hut file. |
| h5hut_obj_WriteAttributes0D | leapIO_h5hut | Subroutine | Writes scalar attributes. |
| h5hut_obj_WriteAttributes1D | leapIO_h5hut | Subroutine | Writes an array of attributes. |
| h5hut_obj_WriteGrid | leapIO_h5hut | Subroutine | Writes grid attributes. |
| hashtbl_obj_Final | leapUtils | Subroutine | |
| hashtbl_obj_Get_int4 | leapUtils | Subroutine | |
| hashtbl_obj_Get_int8 | leapUtils | Subroutine | |
| hashtbl_obj_Get_real_dp | leapUtils | Subroutine | |
| hashtbl_obj_Get_real_sp | leapUtils | Subroutine | |
| hashtbl_obj_HashString | leapUtils | Function | |
| hashtbl_obj_Init | leapUtils | Subroutine | Initializes the hashtable. |
| hashtbl_obj_Print | leapUtils | Subroutine | |
| hashtbl_obj_Put | leapUtils | Subroutine | |
| hashtbl_obj_Remove | leapUtils | Subroutine | |
| hdf5_obj_Close | leapIO_hdf5 | Subroutine | Closes hdf5 file. |
| hdf5_obj_CloseGroup | leapIO_hdf5 | Subroutine | Closes an HDF5 group and removes it from the hashtable. |
| hdf5_obj_CreateGroup | leapIO_hdf5 | Subroutine | Creates a group (analogous to directory) in an HDF5 file and updates hash table. |
| hdf5_obj_Final | leapIO_hdf5 | Subroutine | Finalizes object and frees memory. |
| hdf5_obj_FixGroupName | leapIO_hdf5 | Function | Function that will append and prepend '/' if missing. |
| hdf5_obj_GetGroupObject | leapIO_hdf5 | Function | Returns the HDF5 object id of the group. |
| hdf5_obj_GetNPoints | leapIO_hdf5 | Function | Returns the number of points in a dataset given by name under group given by name. |
| hdf5_obj_Init | leapIO_hdf5 | Subroutine | Initializes the hdf5 object. |
| hdf5_obj_Open | leapIO_hdf5 | Subroutine | Opens a hdf5 file given by name with mode stated by flag. This can take one of these values: 'R' for read only 'W' for write only (will delete existing file) 'RW' for read-write |
| hdf5_obj_OpenGroup | leapIO_hdf5 | Subroutine | Opens a group (analogous to directory) in an HDF5 file and updates hash table. |
| hdf5_obj_Read1D | leapIO_hdf5 | Subroutine | Reads a 1D dataset located under groupname and given by name. If no offset is provided, uses default file view. Otherwise, sets file view manually. |
| hdf5_obj_Read3D | leapIO_hdf5 | Subroutine | Reads a 3D dataset located under groupname and given by name. |
| hdf5_obj_ReadAttributes0D | leapIO_hdf5 | Subroutine | Read a scalar attribute under a given group. |
| hdf5_obj_ReadAttributes1D | leapIO_hdf5 | Subroutine | Read a 1-D array of attributes under a given group. |
| hdf5_obj_ReadCoord | leapIO_hdf5 | Subroutine | Reads coordinates from HDF5 file. Only the root MPI rank does the reading, and then broadcasts to other MPI ranks. |
| hdf5_obj_ReadDatasetNames | leapIO_hdf5 | Subroutine | Reads the dataset names under a given base group in an HDF5 file. |
| hdf5_obj_ReadGroupNames | leapIO_hdf5 | Subroutine | Reads the groups (i.e., directories) under a given base group in an HDF5 file. |
| hdf5_obj_Write1D | leapIO_hdf5 | Subroutine | Writes an array/1D data to a HDF5 file. |
| hdf5_obj_Write3D | leapIO_hdf5 | Subroutine | Writes Eulerian/3D data to a HDF5 file. |
| hdf5_obj_WriteAttributes0D | leapIO_hdf5 | Subroutine | Writes a scalar attribute. |
| hdf5_obj_WriteAttributes1D | leapIO_hdf5 | Subroutine | Writes an array of attributes. |
| hdf5_obj_WriteCoord | leapIO_hdf5 | Subroutine | Writes coordinates to HDF5 file. Only the root MPI rank does the writing. |
| hypre_obj_BuildMatrixIJ | leapHypre | Subroutine | Sets the coefficients of the matrix. |
| hypre_obj_BuildMatrixS | leapHypre | Subroutine | Define the entries of the matrix Ax=b one row at a time Finite difference/Finite volume 2nd order Laplacian: ddu/dxdx = -2 u(i,j,k)/dxdx + u(i-1,j,k)/dxdx + u(i+1,j,k)/dxdx ddu/dydy = -2 u(i,j,k)/dydy + u(i,j-1,k)/dydy + u(i,j+1,k)/dydy ddu/dzdz = -2 u(i,j,k)/dzdz + u(i,j,k-1)/dzdz + u(i,j,k+1)/dzdz |
| hypre_obj_Final | leapHypre | Subroutine | Destroys objects/pointers and clears data. |
| hypre_obj_Init | leapHypre | Subroutine | Initializes the hypre object. |
| hypre_obj_PrintMatrixS | leapHypre | Subroutine | Prints the matrix coefficients for debugging. |
| hypre_obj_SelectSolver | leapHypre | Subroutine | Selects one of the preconfigured solvers and get solver-specific parameters. |
| hypre_obj_SetRHS | leapHypre | Subroutine | Sets the entries of the rhs vector, one element at a time. |
| hypre_obj_SetRHSIJ | leapHypre | Subroutine | Sets the entries of the rhs vector, one element at a time. |
| hypre_obj_SetRHSS | leapHypre | Subroutine | Set the entries of the rhs vector for the Struct interface. |
| hypre_obj_Setup | leapHypre | Subroutine | Sets up the hypre objects in preparation for solves. Note: Setting up HYPRE is an expensive operation so it's best to do this only once during a simulation as opposed to setting-up and destorying each time-step. |
| hypre_obj_SetupGridS | leapHypre | Subroutine | Sets up the hypre grid. |
| hypre_obj_SetupMatrixIJ | leapHypre | Subroutine | Sets up matrix with IJ interface. |
| hypre_obj_SetupMatrixS | leapHypre | Subroutine | Sets up and builds the matrix. |
| hypre_obj_SetupPointersIJ | leapHypre | Subroutine | Sets up pointers for IJ solver. |
| hypre_obj_SetupRHSIJ | leapHypre | Subroutine | Sets up the rhs vector. |
| hypre_obj_SetupRHSS | leapHypre | Subroutine | Sets up the rhs vector. |
| hypre_obj_SetupRowsIJ | leapHypre | Subroutine | Sets up row indexing used with IJ interface. |
| hypre_obj_SetupSolIJ | leapHypre | Subroutine | Setup the solution vector, and initialize it to zero |
| hypre_obj_SetupSolIJver | leapHypre | Subroutine | Sets up solver with IJ interface. |
| hypre_obj_SetupSolS | leapHypre | Subroutine | Setup the solution vector, and initialize it to zero |
| hypre_obj_SetupSolverS | leapHypre | Subroutine | Sets up the hypre solver. |
| hypre_obj_SetupStencilS | leapHypre | Subroutine | Sets up the discretization stencil. Each entry represents the relative offset (in index space) E.g.: a 2D 5-pt stencil would have the following geometry -- Offset { {0,0}, {-1,0}, {1,0}, {0,-1}, {0,1} } E.g.: a 3D 7-pt stencil would have the following geometry -- Offset { {0,0,0}, {-1,0,0}, {1,0,0}, {0,-1,0}, {0,1,0}, {0,0,-1}, {0,0,1} } |
| hypre_obj_Solve | leapHypre | Subroutine | Solves the system Ax=b and return the solution. |
| hypre_obj_SolveIJ | leapHypre | Subroutine | Solves the system Ax=b and return the solution, IJ interface. |
| hypre_obj_SolveS | leapHypre | Subroutine | Solves the system Ax=b and return the solution, Struct interface. |
| int_g1_box | leapfilters | Function | Integral of box filter from 0 to r. |
| int_g1_cosine | leapfilters | Function | Integral of cosine filter from 0 to r. |
| int_g1_cosine2 | leapfilters | Function | Integral of second cosine filter from 0 to r. |
| int_g1_parabolic | leapfilters | Function | Integral of parabolic filter from 0 to r |
| int_g1_roma | leapfilters | Function | Integral of Roma and Peskin's filter from 0 to r. |
| int_g1_triangle | leapfilters | Function | Integral of triangle filter from 0 to r. |
| int_g1_triweight | leapfilters | Function | Integral of triweight filter from 0 to r. |
| lagrangian_obj_Extrapolate | leapLagrangian | Subroutine | Gets a bump function centered on the lagrangian object. |
| lagrangian_obj_Interpolate | leapLagrangian | Function | Interpolates a field f defined on an Eulerian stencil to the location of a lagrangian object |
| lagrangian_obj_Locate | leapLagrangian | Function | Locates a Lagrangian object on an external grid. Returns the location of the cell containing the object. |
| lagrangian_set_ApplyPeriodicity | leapLagrangian | Subroutine | Applies periodic boundary conditions. |
| lagrangian_set_Communicate | leapLagrangian | Subroutine | Communicates lagrangian objects across MPI_rank. This subroutine relies on a rank locator procedure (GetOwnerRankOpt) to determine the rank that should own each Lagrangian object. The default rank locator is the one provided by the block object associated with this Lagrangian_set. From there, each rank will send objects that they no longer own and receive objects from other ranks that belongs to it. Note that this subroutine allocates an array (buf_send) of size (MAX NUMBER of OBJECTS to SEND) x (NUMBER OF MPI RANKS) For massively parallel simulations, this may cause out of memory issues. In those cases, care must be exercised to reduce the number of objects to be sent at any given time (e.g.: by doing communications in small batches). |
| lagrangian_set_CreateMPIType | leapLagrangian | Subroutine | Creates an MPI data type for parallel communication of the Lagrangian objects. |
| lagrangian_set_Final | leapLagrangian | Subroutine | Finalizes the structure and frees memory. |
| lagrangian_set_FreeMPIType | leapLagrangian | Subroutine | Frees the MPI data type. |
| lagrangian_set_GetOverwrite | leapLagrangian | Function | Returns whether overwriting is true or false. |
| lagrangian_set_GetOwnerRankByBlock | leapLagrangian | Function | Returns the MPI rank that should own this lagrangian object based on which block it belongs to. |
| lagrangian_set_GetReadFileName | leapLagrangian | Function | Returns the base name of file to read. |
| lagrangian_set_GetWriteFileName | leapLagrangian | Function | Returns the base name of file to write. |
| lagrangian_set_Info | leapLagrangian | Subroutine | Prints diagnostics information about the derived type to the standard output. |
| lagrangian_set_Init | leapLagrangian | Subroutine | Initialize lagrangian objects related IO. |
| lagrangian_set_Localize | leapLagrangian | Subroutine | Localizes all Lagrangian object on the grid. For each Lagrangian object in the set, this subroutine finds the cell (staggering=0) where this object is located and updates its cell indices. |
| lagrangian_set_Recycle | leapLagrangian | Subroutine | Sorting routine: stacks active lagrangian objects (i.e., who's id is >=1) at the beginning of the array then resizes. Objects with id <= 0 (such as ghost objects) are removed by this subroutine. |
| lagrangian_set_Resize | leapLagrangian | Subroutine | Changes the size of an array of Lagrangian objects. To avoid excessive reallocating, the object array will be reallocated only if the new size is (1+RESIZE_INCREMENT) larger or (1-RESIZE_INCREMENT) smaller than previous size. When the size change does not justify reallocating, the excess objects at the end tail of the object array will be marked as inactive with a large negative ID. |
| lagrangian_set_SetFilterKernel | leapLagrangian | Subroutine | Sets the interpolation and extrapolation filter kernels. Default is the Triangle kernel. |
| lagrangian_set_SetFilterSize | leapLagrangian | Subroutine | Adjusts the filter half size. Note that the block needs to contain enough ghost cells to be able to represent a filter kernel centered on the edge of the domain. Otherwise, an error will be returnned. The larger the filter size, the more ghost cells are required. |
| lagrangian_set_SetOverwrite | leapLagrangian | Subroutine | Sets file overwritting. |
| lagrangian_set_SetReadFileName | leapLagrangian | Subroutine | Sets the base name of file to read. |
| lagrangian_set_SetWriteFileName | leapLagrangian | Subroutine | Sets the base name of file to write. |
| lagrangian_set_UpdateCount | leapLagrangian | Subroutine | Updates the total count of Lagrangian objects. |
| lagrangian_set_UpdateGhostObjects | leapLagrangian | Subroutine | Updates ghost objects. Copies objects that lie "dist"-away from the block's boundaries to neighboring MPI-ranks and designate copies as Ghost Objects (id<0). This subroutine will also update the local count (i.e., this%count_) to (NBR of ACTIVE OBJECTS) + (NBR of GHOST OBJECTS). However, the global count (this%count) will remain unchanged (i.e., equal to the total count of active ojbects only)0 |
| lagrangian_set_UpdateGhostObjectsDir | leapLagrangian | Subroutine | Updates ghost objects in the idir direction. Copies objects that lie "dist"-away from the block's boundaries in idir-direction to neighboring MPI-ranks. Copied objects get a negative ID to designate them as ghost objects |
| marker_obj_assign | immersed_boundaries_markers | Subroutine | Assignment |
| marker_set_AddCylinder | immersed_boundaries_markers | Subroutine | Adds an IB cylinder (with open faces). |
| marker_set_AddPlane | immersed_boundaries_markers | Subroutine | Adds an IB plane. |
| marker_set_AddSphere | immersed_boundaries_markers | Subroutine | Adds an IB sphere. |
| marker_set_CoM | immersed_boundaries_markers | Function | Finds the center of area. |
| marker_set_ComputeSolidVolFrac | immersed_boundaries_markers | Subroutine | Computes the solid volume fraction on the mesh. |
| marker_set_Filter | immersed_boundaries_markers | Subroutine | Computes a filtered quantity on the Eulerian grid. |
| marker_set_Final | immersed_boundaries_markers | Subroutine | Finalizes the marker_set type. This subourtine replaces the inheritted lagrangian_final. |
| marker_set_GetIBForcing | immersed_boundaries_markers | Subroutine | Computes the IB forcing Interpolation are carried out by trilinear interpolations. |
| marker_set_Init | immersed_boundaries_markers | Subroutine | Initializes the marker_set type. This subourtine replaces the inheritted lagrangian_init. |
| marker_set_LoadSTL | immersed_boundaries_markers | Subroutine | Loads markers from a binary STL. This is a serial routine. |
| marker_set_Prepare | immersed_boundaries_markers | Subroutine | Prepares marker_set for use with solvers. |
| marker_set_ReadH5HUT | immersed_boundaries_markers | Subroutine | Reads marker data from file in parallel using H5HUT. |
| marker_set_ReadHDF5 | immersed_boundaries_markers | Subroutine | Reads marker data from file in parallel using HDF5. |
| marker_set_SetMPIDataTypeParams | immersed_boundaries_markers | Subroutine | Sets up parameters for creating the MPI derived type. Create the MPI structure |
| marker_set_SetObjectType | immersed_boundaries_markers | Subroutine | Sets the sample type used in allocation of polymorphic variables. |
| marker_set_SetReadChunkSize | immersed_boundaries_markers | Subroutine | Sets the chunk size. |
| marker_set_UpdateNormals | immersed_boundaries_markers | Subroutine | Updates the Normals field. |
| marker_set_UpdateSDF | immersed_boundaries_markers | Subroutine | Updates the Surface Density Function. |
| marker_set_WriteH5HUT | immersed_boundaries_markers | Subroutine | Writes marker data to file in parallel using H5HUT. |
| marker_set_WriteHDF5 | immersed_boundaries_markers | Subroutine | Write marker data to file in parallel using HDF5. |
| monitor_obj_Final | leapMonitor | Subroutine | Finalizes the object and frees memory. |
| monitor_obj_Formats | leapMonitor | Subroutine | Defines how to print values. Format specifier for an integer Format specifier for a real Format specifier for a logical Format specifier for a full line |
| monitor_obj_Init | leapMonitor | Subroutine | Intializes a single monitor. |
| monitor_obj_Print | leapMonitor | Subroutine | Prints to file or stdout content of the monitor |
| monitor_obj_SetVal | leapMonitor | Subroutine | Sets the value in the nth column of a monitor. |
| monitor_set_Create | leapMonitor | Subroutine | Creates a new monitor. |
| monitor_set_Expand | leapMonitor | Subroutine | Changes the size of monitors arrays to add 1 element. |
| monitor_set_Final | leapMonitor | Subroutine | Finalizes object and frees memory. |
| monitor_set_GetIndex | leapMonitor | Function | Returns the ID of a monitor identified by name. |
| monitor_set_Info | leapMonitor | Subroutine | Print a number of diagnostics information. |
| monitor_set_Init | leapMonitor | Subroutine | Initializes a set of monitors. |
| monitor_set_Print | leapMonitor | Subroutine | Prints content of monitors. |
| monitor_set_Set | leapMonitor | Subroutine | Sets the label or value of a column ofa a monitor given by name. |
| op_obj_ApplyLaplacianDC | leapDiffOp | Subroutine | Applies Dirichlet boundary conditions to the RHS of a Laplacian equation. |
| op_obj_BuildLaplacian | leapDiffOp | Subroutine | Builds Laplacian operator using Morinishi's schemes. |
| op_obj_conv11 | leapDiffOp | Function | Computes d(U1 U1)/dx1. |
| op_obj_conv12 | leapDiffOp | Function | Computes d(U1 U2)/dx1. |
| op_obj_conv13 | leapDiffOp | Function | Computes d(U1 U1)/dx1. |
| op_obj_conv21 | leapDiffOp | Function | Computes d(U2 U1)/dx2. |
| op_obj_conv22 | leapDiffOp | Function | Computes d(U2 U2)/dx2. |
| op_obj_conv23 | leapDiffOp | Function | Computes d(U2 U1)/dx2. |
| op_obj_conv31 | leapDiffOp | Function | Computes d(U3 U1)/dx1. |
| op_obj_conv32 | leapDiffOp | Function | Computes d(U3 U1)/dx1. |
| op_obj_conv33 | leapDiffOp | Function | Computes d(U3 U1)/dx1. |
| op_obj_d1dx1 | leapDiffOp | Function | Computes the derivative in the x1-direction. Note: If input is face-centered (on x1), result is cell-centered (on x1m). If input is cell-centered (on x1m), result is face-centered (on x1). |
| op_obj_d1dx2 | leapDiffOp | Function | Computes the derivative in the x2-direction. Note: If input is face-centered (on x2), result is cell-centered (on x2m). If input is cell-centered (on x2m), result is face-centered (on x2). |
| op_obj_d1dx3 | leapDiffOp | Function | Computes the derivative in the x3-direction. Note: If input is face-centered (on x3), result is cell-centered (on x3m). If input is cell-centered (on x3m), result is face-centered (on x3). |
| op_obj_div | leapDiffOp | Function | Computes the divergence of a vector (in1,in2,in3). This function takes in1,in2,in3 cell-centered (stag=0) and returns the divergence on cell centers (stag=0) |
| op_obj_Final | leapDiffOp | Subroutine | Finalizes object and frees memory. |
| op_obj_Init | leapDiffOp | Subroutine | Initializes object. The operator order can be specified by the optional parameter. Otherwise, the object initializes 2nd order operators by default. |
| op_obj_intrp1 | leapDiffOp | Function | Interpolates in the x1-direction. Note: If input is face-centered (on x1), result is cell-centered (on x1m). If input is cell-centered (on x1m), result is face-centered (on x1). |
| op_obj_intrp2 | leapDiffOp | Function | Interpolates in the x2-direction. Note: If input is face-centered (on x2), result is cell-centered (on x2m). If input is cell-centered (on x2m), result is face-centered (on x2). |
| op_obj_intrp3 | leapDiffOp | Function | Interpolates in the x3-direction. Note: If input is face-centered (on x3), result is cell-centered (on x3m). If input is cell-centered (on x3m), result is face-centered (on x3). |
| op_obj_StrainRate | leapDiffOp | Function | Computes the strain rate tensor from the velocity field. Result is on mid points (staggering=0). Tensor is stored as follows: S = 0.5*( grad(u) + grad(u)^T ) ( S(1) S(4) S(6) ) = ( S(4) S(2) S(5) ) ( S(6) S(5) S(3) ) |
| parallel_obj_Bcast_char | leapParallel | Subroutine | MPI Broadcast operation from root rank. |
| parallel_obj_Bcast_int_0d | leapParallel | Subroutine | MPI Broadcast operation from root rank. |
| parallel_obj_Bcast_int_1d | leapParallel | Subroutine | MPI Broadcast operation from root rank. |
| parallel_obj_Bcast_int_2d | leapParallel | Subroutine | MPI Broadcast operation from root rank. |
| parallel_obj_Bcast_int_3d | leapParallel | Subroutine | MPI Broadcast operation from root rank. |
| parallel_obj_Bcast_log_0d | leapParallel | Subroutine | MPI Broadcast operation from root rank. |
| parallel_obj_Bcast_log_1d | leapParallel | Subroutine | MPI Broadcast operation from root rank. |
| parallel_obj_Bcast_real_0d | leapParallel | Subroutine | MPI Broadcast operation from root rank. |
| parallel_obj_Bcast_real_1d | leapParallel | Subroutine | MPI Broadcast operation from root rank. |
| parallel_obj_Bcast_real_2d | leapParallel | Subroutine | MPI Broadcast operation from root rank. |
| parallel_obj_Bcast_real_3d | leapParallel | Subroutine | MPI Broadcast operation from root rank. |
| parallel_obj_Final | leapParallel | Subroutine | Finalizes MPI and the parallel environment. |
| parallel_obj_Init | leapParallel | Subroutine | Initializes the parallel environement. |
| parallel_obj_Lor_0d | leapParallel | Subroutine | MPI LOGICAL OR reduction operation. |
| parallel_obj_Lor_1d | leapParallel | Subroutine | MPI LOGICAL OR reduction operation. |
| parallel_obj_Max_int_0d | leapParallel | Subroutine | MPI MAX reduction operation. |
| parallel_obj_Max_int_1d | leapParallel | Subroutine | MPI MAX reduction operation. |
| parallel_obj_Max_real_0d | leapParallel | Subroutine | MPI MAX reduction operation. |
| parallel_obj_Max_real_1d | leapParallel | Subroutine | MPI MAX reduction operation. |
| parallel_obj_Min_int_0d | leapParallel | Subroutine | MPI MIN reduction operation. |
| parallel_obj_Min_int_1d | leapParallel | Subroutine | MPI MIN reduction operation. |
| parallel_obj_Min_real_0d | leapParallel | Subroutine | MPI MIN reduction operation. |
| parallel_obj_Min_real_1d | leapParallel | Subroutine | |
| parallel_obj_RankIsRoot | leapParallel | Function | Determines if this rank is the root rank. |
| parallel_obj_Stop | leapParallel | Subroutine | Subroutine to gracefully stop the execution with an optional error message. |
| parallel_obj_Sum_int_0d | leapParallel | Subroutine | MPI SUM reduction operation. |
| parallel_obj_Sum_int_1d | leapParallel | Subroutine | MPI SUM reduction operation. |
| parallel_obj_Sum_int_2d | leapParallel | Subroutine | MPI SUM reduction operation. |
| parallel_obj_Sum_int_3d | leapParallel | Subroutine | MPI SUM reduction operation. |
| parallel_obj_Sum_real_0d | leapParallel | Subroutine | MPI SUM reduction operation. |
| parallel_obj_Sum_real_1d | leapParallel | Subroutine | MPI SUM reduction operation. |
| parallel_obj_Sum_real_2d | leapParallel | Subroutine | MPI SUM reduction operation. |
| parallel_obj_Sum_real_3d | leapParallel | Subroutine | MPI SUM reduction operation. |
| parallel_obj_Time | leapParallel | Function | Returns the elapsed time since an arbitrary origin. Note that different ranks return different WTIMEs. |
| parallel_obj_Topology | leapParallel | Subroutine | Builds a Cartesian topolgy with MPI. Define a root processor at coordinates (1,1,1) |
| parser_obj_AddEntry | leapParser | Subroutine | Resizes entries array to add a new entry. |
| parser_obj_AssignDefault0D | leapParser | Subroutine | Sets 0D (scalar) value equal to 0D (scalar) default. |
| parser_obj_AssignDefault1D | leapParser | Subroutine | Sets 1D (array) values equal to 1D (array) defaults. |
| parser_obj_FetchLabelID | leapParser | Function | Returns ID of label in entries array. Returns 0 if label not found. |
| parser_obj_final | leapParser | Subroutine | Finalizes object and frees allocated memory. |
| parser_obj_init | leapParser | Subroutine | Initializes the parser object. |
| parser_obj_IsDefined | leapParser | Function | Checks whether a label was found when parsing the file. |
| parser_obj_ParseFile | leapParser | Subroutine | Parses an ASCII file. This subroutine will identify all entries in the file (label-value pairs) and store them internally. Users can specify the filename using the optional optInput variable. Otherwise, the default filename is 'input'. |
| parser_obj_ParseLine | leapParser | Subroutine | Parses a line by finding the label-value pair and storing it as a new entry. |
| parser_obj_print | leapParser | Subroutine | Prints all variables found in the parsed file. |
| parser_obj_read0D | leapParser | Subroutine | Reads 0D (scalar) values of kind real, integer, logical, or character string. If label is not found and the optional default is provided, the value will be set to the default value. If the label is not found and there is no optional default, this subroutine will return an error. |
| parser_obj_read1D | leapParser | Subroutine | Reads 1D (array) values of kind real, integer, logical, or character string. If label is not found and the optional default is provided, the value will be set to the default value. If the label is not found and there is no optional default, this subroutine will return an error. |
| parser_obj_ReformatLine | leapParser | Subroutine | Fomats a line by removing comments and replacing tabs with spaces. |
| particle_BH_obj_assign | particles_point | Subroutine | Assignment |
| particle_obj_assign | particles_point | Subroutine | Assignment |
| particle_set_AdvanceCenters | particles_point | Subroutine | Advances centers to next timestep. |
| particle_set_ChangePartType | particles_point | Subroutine | Changes Particle Type. This deletes all existing particle data and redeclares the associated MPI type. |
| particle_set_CreateMonitor | particles_point | Subroutine | Creates monitor file for Point Particles. |
| particle_set_Filter | particles_point | Subroutine | Filters a quantity to the Eulerian grid. |
| particle_set_Prepare | particles_point | Subroutine | Prepares for use with solvers. |
| particle_set_ReadH5HUT | particles_point | Subroutine | Reads particle data from file in parallel using H5HUT. |
| particle_set_ReadHDF5 | particles_point | Subroutine | Reads particle data from file in parallel using HDF5. |
| particle_set_SetMPIDataTypeParams | particles_point | Subroutine | Sets up parameters used when creating the MPI derived type. |
| particle_set_SetMPIDataTypeParams_BH | particles_point | Subroutine | Sets up parameters used when creating the MPI derived type of particles with BH type. |
| particle_set_SetMPIDataTypeParams_default | particles_point | Subroutine | Sets up parameters used when creating the MPI derived type of particles with default type. |
| particle_set_SetObjectType | particles_point | Subroutine | Sets the sample type used in allocation of polymorphic variables. |
| particle_set_StoreOld | particles_point | Subroutine | Stores values from previous timestep. |
| particle_set_UpdateMonitor | particles_point | Subroutine | Updates monitoring data. |
| particle_set_WriteH5HUT | particles_point | Subroutine | Writes particle data to file in parallel using H5HUT. |
| particle_set_WriteHDF5 | particles_point | Subroutine | Writes particle data to file in parallel using HDF5. |
| particle_set_WriteSilo | particles_point | Subroutine | Writes particle data to file in parallel using SILO. |
| region_obj_Add | leapBC | Subroutine | Adds a new variable to region. |
| region_obj_Expand | leapBC | Subroutine | Resizes array to accomodate a new element. |
| region_obj_Final | leapBC | Subroutine | |
| region_obj_GetBCIndex | leapBC | Function | Returns index of a variable in this region, or -1 if not found. |
| region_obj_Init | leapBC | Subroutine | Initializes a region |
| ResPart_obj_assign | particles_resolved | Subroutine | Assignment |
| ResPart_set_AdvanceCenters | particles_resolved | Subroutine | Advances centers to next timestep |
| ResPart_set_AdvanceMarkers | particles_resolved | Subroutine | Advances markers to next timestep |
| ResPart_set_CreateMonitor | particles_resolved | Subroutine | Creates monitor file for Resolved Particles |
| ResPart_set_Filter | particles_resolved | Subroutine | Filters a quantity to the Eulerian grid |
| ResPart_set_Final | particles_resolved | Subroutine | Finalizes the ResPart_set type. This subourtine replaces the inheritted lagrangian_final. |
| ResPart_set_GetCentroidVF | particles_resolved | Function | Computes average solid volume fraction at particle centroids |
| ResPart_set_GetHydroForces | particles_resolved | Subroutine | Computes hydrodynamic force on particle. |
| ResPart_set_GetIBForcing | particles_resolved | Subroutine | Computes the IB forcing |
| ResPart_set_GetOwnerRankByRP | particles_resolved | Function | Returns the MPI rank of the lagrangian centroid owning this marker. |
| ResPart_set_GetSurfaceStresses | particles_resolved | Subroutine | Computes hydrodynamic stresses on markers |
| ResPart_set_Init | particles_resolved | Subroutine | Initializes the ResPart_set type. This subourtine replaces the inheritted lagrangian_init. |
| ResPart_set_Prepare | particles_resolved | Subroutine | Prepares ResPart_set for use with solvers. |
| ResPart_set_ReadH5HUT | particles_resolved | Subroutine | Reads ResPart data from file using H5HUT. |
| ResPart_set_ReadHDF5 | particles_resolved | Subroutine | Reads ResPart data from file with HDF5. |
| ResPart_set_Regroup | particles_resolved | Subroutine | Regroup markers with their respective centroids on the same MPI block |
| ResPart_set_SetFilterSize | particles_resolved | Subroutine | Filters a quantity to the Eulerian grid |
| ResPart_set_SetMPIDataTypeParams | particles_resolved | Subroutine | Sets up parameters used when creating the MPI derived type. |
| ResPart_set_SetObjectType | particles_resolved | Subroutine | Sets the sample type used in allocation of polymorphic variables. |
| ResPart_set_SetReadFileName | particles_resolved | Subroutine | Sets the base name of file to read. |
| ResPart_set_SetWriteFileName | particles_resolved | Subroutine | Sets the base name of file to write. |
| ResPart_set_StoreOld | particles_resolved | Subroutine | Stores values from previous timestep |
| ResPart_set_UpdateLookup | particles_resolved | Subroutine | Update lookup array -- The lookup array returns the local (MPI rank) index of a centroid when given the global ID of that centroid |
| ResPart_set_UpdateMonitor | particles_resolved | Subroutine | |
| ResPart_set_UpdateNormals | particles_resolved | Subroutine | Updates the Normals field |
| ResPart_set_UpdateSDF | particles_resolved | Subroutine | Updates the Surface Density Function |
| ResPart_set_WriteH5HUT | particles_resolved | Subroutine | Writes ResPart data to file using H5HUT. |
| ResPart_set_WriteHDF5 | particles_resolved | Subroutine | Writes ResPart data to file using HDF5. |
| ResPart_set_WriteSILO | particles_resolved | Subroutine | Writes data to disk in Silo format. |
| silo_obj_CreateGroups | leapIO_silo | Subroutine | Sets up silo groups for poor man's IO. Splits MPI ranks into groups of size nproc_node. Each group writes squentially to its own file. |
| silo_obj_Final | leapIO_silo | Subroutine | Finalizes structure and frees memory. |
| silo_obj_Init | leapIO_silo | Subroutine | Initialize structure. |
| silo_obj_NewTimeStep | leapIO_silo | Subroutine | Creates a new Silo virtual data base (VDB) for this timestep. |
| silo_obj_SetupGroupFiles | leapIO_silo | Subroutine | Creates silo files and their internal structure. |
| silo_obj_WriteGrid | leapIO_silo | Subroutine | Writes grid attributes. |
| silo_obj_WriteLagrangianMesh | leapIO_silo | Subroutine | Writes Lagrangian mesh attributes. |
| silo_obj_WriteScalar1D | leapIO_silo | Subroutine | Writes 1D array to a hdf5 file with silo. |
| silo_obj_WriteScalar3D | leapIO_silo | Subroutine | Writes Eulerian/3D data to a hdf5 file with silo. |
| sllist_obj_Free | leapUtils | Subroutine | Free all data associated with this list. |
| sllist_obj_Get_int4 | leapUtils | Subroutine | Traverse the list until key is found. Returns the associated value to the key, or -1 if key not found. |
| sllist_obj_Get_int8 | leapUtils | Subroutine | Traverse the list until key is found. Returns the associated value to the key, or -1 if key not found. |
| sllist_obj_Get_real_dp | leapUtils | Subroutine | Traverse the list until key is found. Returns the associated value to the key, or -1 if key not found. |
| sllist_obj_Get_real_sp | leapUtils | Subroutine | Traverse the list until key is found. Returns the associated value to the key, or -1 if key not found. |
| sllist_obj_Put | leapUtils | Subroutine | Adds a pair key-value to the list. |
| sllist_obj_Remove | leapUtils | Subroutine | Remove key-value pair from list. |
| solid_set_Communicate | immersed_boundaries_solids | Subroutine | Communicates markers of all solids in this set. |
| solid_set_Filter | immersed_boundaries_solids | Subroutine | Filters a quantity to the Eulerian grid. |
| solid_set_Final | immersed_boundaries_solids | Subroutine | Finalizes object and frees memory. |
| solid_set_Init | immersed_boundaries_solids | Subroutine | Initializes a collection of solids. |
| solid_set_Localize | immersed_boundaries_solids | Subroutine | Localizes markers of all solids in this set on the grid. |
| solid_set_ReadH5HUT | immersed_boundaries_solids | Subroutine | Reads all solids from disk using H5HUT. |
| solid_set_ReadHDF5 | immersed_boundaries_solids | Subroutine | Reads all solids from disk using HDF5. |
| solid_set_SetFilterKernel | immersed_boundaries_solids | Subroutine | Selects interpolation and extrapolation kernels. |
| solid_set_SetFilterSize | immersed_boundaries_solids | Subroutine | Changes filter size to desired value. |
| solid_set_SetOverwrite | immersed_boundaries_solids | Subroutine | Sets file overwritting |
| solid_set_SetReadFileName | immersed_boundaries_solids | Subroutine | Sets the names of files to read. |
| solid_set_SetWriteFileName | immersed_boundaries_solids | Subroutine | Sets the names of files to write. |
| solid_set_WriteH5HUT | immersed_boundaries_solids | Subroutine | Writes all solids to disk using H5HUT. |
| solid_set_WriteHDF5 | immersed_boundaries_solids | Subroutine | Writes all solids to disk using HDF5. Add some attributes |
| stringtool_obj_RemoveExtension | leapUtils | Function | Removes file extension from filename while preserving scientific notation and dots in paths. |
| stringtool_obj_RemovePath | leapUtils | Function | Removes path from filename. |
| sysutils_obj_CreateDirectory | leapUtils | Subroutine | Creates a directory using system commands. |
| sysutils_obj_DeleteDirectory | leapUtils | Subroutine | Deletes a directory using system commands. |
| sysutils_obj_DeleteFile | leapUtils | Subroutine | Deletes a file. |
| sysutils_obj_DirectoryExists | leapUtils | Function | |
| sysutils_obj_FileExists | leapUtils | Function | Checks whether a file exists. |
| timer_obj_AddTiming | leapTimer | Subroutine | Adds timing info. |
| timer_obj_Done | leapTimer | Function | Determines whether simulation is over. |
| timer_obj_EndRun | leapTimer | Subroutine | Changes run status to finished. |
| timer_obj_Final | leapTimer | Subroutine | Finalizes and frees memomry. |
| timer_obj_GetTiming | leapTimer | Function | Returns timing information for data given by name. |
| timer_obj_Init | leapTimer | Subroutine | Initializes the timer. |
| timer_obj_StepForward | leapTimer | Subroutine | Moves timer from n to n+1 |
| timer_obj_TimeToWriteOutputData | leapTimer | Function | Determine whether it is time to write visualization files. |
| timer_obj_TimeToWriteRestartData | leapTimer | Function | Determine whether it is time to write restart files. |
| timer_obj_UpdateTiming | leapTimer | Subroutine | Updates timing info with elapsed time since beginning of current iteration. |
| xdmf_attribute_obj_Free | leapIO_xdmf | Subroutine | Frees up data stored by this XDMF attribute. |
| xdmf_grid_obj_Free | leapIO_xdmf | Subroutine | Frees up data stored by this XDMF grid. |
| xdmf_obj_AddField | leapIO_xdmf | Subroutine | Adds field information to the xdmf object. |
| xdmf_obj_AddGrid | leapIO_xdmf | Subroutine | Adds grid information to the xdmf object. |
| xdmf_obj_Final | leapIO_xdmf | Subroutine | Finalizes object and frees memmory. |
| xdmf_obj_Init | leapIO_xdmf | Subroutine | Initialize XDMF object. |
| xdmf_obj_Resize | leapIO_xdmf | Subroutine | Resizes the fields array in an xdmf object. Note that resizing occurs in increaments of size (RESIZE_INCREMENT). By default, RESIZE_INCREMENT=10, meaning that if resizing occurs, it will increase or reduce the array size by 10 slots. This is done to avoid frequent reallocating. |
| xdmf_obj_Write | leapIO_xdmf | Subroutine | Write the XDMF info to a file. This is a serial subroutine and should be called by only one rank. |