build-blocks:
- modulefiles added
This commit is contained in:
35
scripts/MPI/BoxLib/modulefile
Normal file
35
scripts/MPI/BoxLib/modulefile
Normal file
@@ -0,0 +1,35 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "block-structured AMR framework"
|
||||
set url "https://ccse.lbl.gov/BoxLib/index.html"
|
||||
set license "BSD"
|
||||
set licensefile "license.txt"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
BoxLib contains all the functionality needed to write a parallel,
|
||||
block-structured AMR application. The fundamental parallel abstraction is
|
||||
the MultiFab, which holds the data on the union of grids at a level. A
|
||||
MultiFab is composed of FAB's; each FAB is an array of data on a single
|
||||
grid. During each MultiFab operation the FAB's composing that MultiFab are
|
||||
distributed among the cores. MultiFab's at each level of refinement are
|
||||
distributed independently. The software supports two data distribution
|
||||
schemes, as well as a dynamic switching scheme that decides which approach
|
||||
to use based on the number of grids at a level and the number of processors.
|
||||
The first scheme is based on a heuristic knapsack algorithm; the second is
|
||||
based on the use of a Morton-ordering space-filling curve. MultiFab
|
||||
operations are performed with an owner computes rule with each processor
|
||||
operating independently on its local data. For operations that require data
|
||||
owned by other processors, the MultiFab operations are preceded by a data
|
||||
exchange between processors. Each processor contains meta-data that is
|
||||
needed to fully specify the geometry and processor assignments of the
|
||||
MultiFab's. At a minimum, this requires the storage of an array of boxes
|
||||
specifying the index space region for each AMR level of refinement. The
|
||||
meta-data can thus be used to dynamically evaluate the necessary
|
||||
communication patterns for sharing data amongst processors, enabling us to
|
||||
optimize communications patterns within the algorithm. One of the advantages
|
||||
of computing with fewer, larger grids in the hybrid OpenMP--MPI approach
|
||||
is that the size of the meta-data is substantially reduced.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
28
scripts/MPI/OPAL/modulefile
Normal file
28
scripts/MPI/OPAL/modulefile
Normal file
@@ -0,0 +1,28 @@
|
||||
#%Module1.0
|
||||
|
||||
# OPAL_PREFIX is also used by OpenMPI!
|
||||
set dont-setenv { OPAL_PREFIX }
|
||||
|
||||
set whatis "Object Oriented Particle Accelerator Library"
|
||||
set url "http://amas.psi.ch/OPAL"
|
||||
set license "PSI"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
OPAL is a C++ framework for general particle accelerator simulations. It
|
||||
includes various beam line element descriptions and methods for single
|
||||
particle optics, namely maps up to arbitrary order, symplectic integration
|
||||
schemes and lastly time integration. OPAL is based on IPPL (Independent
|
||||
Parallel Particle Layer) which adds parallel capabilities. Main functions
|
||||
inherited from IPPL are: structured rectangular grids, fields and parallel
|
||||
FFT and particles with the respective interpolation operators. Other
|
||||
features are, expression templates and massive parallelism (up to 65000
|
||||
processors) which makes is possible to tackle the largest problems in the
|
||||
field. A new iterative solver handles arbitrary complex boundary conditions
|
||||
and benefiting from the new geometry class.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
setenv OPAL_EXE_PATH "${PREFIX}/bin"
|
||||
|
||||
set-family OPAL
|
||||
26
scripts/MPI/SuperLU_DIST/modulefile
Normal file
26
scripts/MPI/SuperLU_DIST/modulefile
Normal file
@@ -0,0 +1,26 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "SuperLU_DIST - A library for direct solution of large, sparse, nonsymmetric systems of linear equations."
|
||||
set url "http://crd-legacy.lbl.gov/~xiaoye/SuperLU/"
|
||||
set license "BSD"
|
||||
set licensefile "README"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
SuperLU is a general purpose library for the direct solution of large,
|
||||
sparse, nonsymmetric systems of linear equations on high performance
|
||||
machines. The library is written in C and is callable from either C or
|
||||
Fortran. The library routines will perform an LU decomposition with
|
||||
partial pivoting and triangular system solves through forward and back
|
||||
substitution. The LU factorization routines can handle non-square
|
||||
matrices but the triangular solves are performed only for square
|
||||
matrices. The matrix columns may be preordered (before factorization)
|
||||
either through library or user supplied routines. This preordering for
|
||||
sparsity is completely separate from the factorization. Working
|
||||
precision iterative refinement subroutines are provided for improved
|
||||
backward stability. Routines are also provided to equilibrate the
|
||||
system, estimate the condition number, calculate the relative backward
|
||||
error, and estimate error bounds for the refined solutions.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
12
scripts/MPI/cpmd/modulefile
Normal file
12
scripts/MPI/cpmd/modulefile
Normal file
@@ -0,0 +1,12 @@
|
||||
#%Module1.0
|
||||
|
||||
module-whatis "plane wave/pseudopotential implementation of Density Functional Theory"
|
||||
module-url "http://cpmd.org/"
|
||||
module-license "?"
|
||||
module-maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
module-help "
|
||||
The CPMD code is a parallelized plane wave / pseudopotential implementation
|
||||
of Density Functional Theory, particularly designed for ab-initio molecular
|
||||
dynamics.
|
||||
"
|
||||
|
||||
21
scripts/MPI/gromacs/modulefile
Normal file
21
scripts/MPI/gromacs/modulefile
Normal file
@@ -0,0 +1,21 @@
|
||||
#%Module1.0
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
set whatis "GROMACS is a versatile package to perform molecular dynamics"
|
||||
set url "http://www.gromacs.org/"
|
||||
set license "See PREFIX/share/doc/COPYING"
|
||||
set maintainer "Antonio Benedetto <antonio.benedetto@psi.ch>"
|
||||
set help "
|
||||
GROMACS is a versatile package to perform molecular dynamics, i.e. simulate
|
||||
the Newtonian equations of motion for systems with hundreds to millions of
|
||||
particles.
|
||||
|
||||
It is primarily designed for biochemical molecules like proteins, lipids and
|
||||
nucleic acids that have a lot of complicated bonded interactions, but since
|
||||
GROMACS is extremely fast at calculating the nonbonded interactions (that
|
||||
usually dominate simulations) many groups are also using it for research on
|
||||
non-biological systems, e.g. polymers.
|
||||
"
|
||||
|
||||
set-family MPI
|
||||
19
scripts/MPI/hdf5/modulefile
Normal file
19
scripts/MPI/hdf5/modulefile
Normal file
@@ -0,0 +1,19 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "Hierachical Data Format 5"
|
||||
set url "http://www.hdfgroup.org/HDF5"
|
||||
set license "HDF license (BSD-like)"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
set help "
|
||||
HDF5 is a data model, library, and file format for storing and managing
|
||||
data. It supports an unlimited variety of datatypes, and is designed for
|
||||
flexible and efficient I/O and for high volume and complex data. HDF5 is
|
||||
portable and is extensible, allowing applications to evolve in their use
|
||||
of HDF5. The HDF5 Technology suite includes tools and applications for
|
||||
managing, manipulating, viewing, and analyzing data in the HDF5 format.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
conflict hdf5_serial
|
||||
set-family HDF5
|
||||
17
scripts/MPI/ippl/modulefile
Normal file
17
scripts/MPI/ippl/modulefile
Normal file
@@ -0,0 +1,17 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "the Independent Parallel Particle Layer"
|
||||
set url "http://amas.psi.ch/IPPL"
|
||||
set license "PSI"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
IPPL is an object-oriented framework for particle based applications in
|
||||
computational science requiring high-performance parallel computers. It
|
||||
is a library of C++ classes designed to represent common abstractions in
|
||||
these applications. IPPL is based on data-parallel programming at the
|
||||
highest abstraction layer. Codes developed on serial workstations port
|
||||
to all supported architectures, including parallel processors.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
19
scripts/MPI/parmetis/modulefile
Normal file
19
scripts/MPI/parmetis/modulefile
Normal file
@@ -0,0 +1,19 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "ParMETIS - Parallel Graph Partitioning and Fill-reducing Matrix Ordering"
|
||||
set url "http://glaros.dtc.umn.edu/gkhome/metis/parmetis/overview"
|
||||
set license "See: \$PARMETIS_DIR/share/doc/parmetis/LICENSE.txt"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
ParMETIS is an MPI-based parallel library that implements a variety of
|
||||
algorithms for partitioning unstructured graphs, meshes, and for computing
|
||||
fill-reducing orderings of sparse matrices. ParMETIS extends the functioni-
|
||||
ality provided by METIS and includes routines that are especially suited
|
||||
for parallel AMR computations and large scale numerical simulations. The
|
||||
algorithms implemented in ParMETIS are based on the parallel multilevel
|
||||
k-way graph-partitioning, adaptive repartitioning, and parallel multi-
|
||||
constrained partitioning schemes developed in our lab.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
20
scripts/MPI/trilinos/modulefile
Normal file
20
scripts/MPI/trilinos/modulefile
Normal file
@@ -0,0 +1,20 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "Object-Oriented Solver Framework"
|
||||
set url "http://trilinos.sandia.gov/"
|
||||
set license "BSD-like"
|
||||
set licensefile "Copyright.txt"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Trilinos is a collection of open source software libraries, called packages,
|
||||
intended to be used as building blocks for the development of scientific
|
||||
applications. The word \"Trilinos\" is Greek and conveys the idea of \"a string
|
||||
of pearls,\" suggesting a number of software packages linked together by a
|
||||
common infrastructure. Trilinos was developed at Sandia National Laboratories
|
||||
from a core group of existing algorithms, and utilizes the functionality of
|
||||
software interfaces such as the BLAS, LAPACK, and MPI.
|
||||
(Wikipedia)
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
Reference in New Issue
Block a user