build-blocks:
- modulefiles added
This commit is contained in:
10
scripts/Compiler/H5root/modulefile
Normal file
10
scripts/Compiler/H5root/modulefile
Normal file
@@ -0,0 +1,10 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "visualization tool for H5hut files"
|
||||
set url "http://amas.psi.ch/"
|
||||
set license "PSI"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
set help "
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
30
scripts/Compiler/OpenBLAS/modulefile
Normal file
30
scripts/Compiler/OpenBLAS/modulefile
Normal file
@@ -0,0 +1,30 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "optimized BLAS and LAPACK library."
|
||||
set url "http://www.openblas.net/"
|
||||
set license "BSD"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
set help "
|
||||
The BLAS (Basic Linear Algebra Subprograms) are routines that provide
|
||||
standard building blocks for performing basic vector and matrix operations.
|
||||
The Level 1 BLAS perform scalar, vector and vector-vector operations, the
|
||||
Level 2 BLAS perform matrix-vector operations, and the Level 3 BLAS perform
|
||||
matrix-matrix operations. Because the BLAS are efficient, portable, and
|
||||
widely available, they are commonly used in the development of high quality
|
||||
linear algebra software, LAPACK for example.
|
||||
|
||||
LAPACK (Linear Algebra PACKage) is written in Fortran 90 and provides
|
||||
routines for solving systems of simultaneous linear equations, least-
|
||||
squares solutions of linear systems of equations, eigenvalue problems,
|
||||
and singular value problems. The associated matrix factorizations (LU,
|
||||
Cholesky, QR, SVD, Schur, generalized Schur) are also provided, as are
|
||||
related computations such as reordering of the Schur factorizations and
|
||||
estimating condition numbers. Dense and banded matrices are handled, but
|
||||
not general sparse matrices. In all areas, similar functionality is
|
||||
provided for real and complex matrices, in both single and double precision.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
setenv BLASLIB $PREFIX/libopenblas.a
|
||||
|
||||
30
scripts/Compiler/OpenBLAS_OMP/modulefile
Normal file
30
scripts/Compiler/OpenBLAS_OMP/modulefile
Normal file
@@ -0,0 +1,30 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "optimized BLAS and LAPACK library compiled with OpenMP."
|
||||
set url "http://www.openblas.net/"
|
||||
set license "BSD"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
set help "
|
||||
The BLAS (Basic Linear Algebra Subprograms) are routines that provide
|
||||
standard building blocks for performing basic vector and matrix operations.
|
||||
The Level 1 BLAS perform scalar, vector and vector-vector operations, the
|
||||
Level 2 BLAS perform matrix-vector operations, and the Level 3 BLAS perform
|
||||
matrix-matrix operations. Because the BLAS are efficient, portable, and
|
||||
widely available, they are commonly used in the development of high quality
|
||||
linear algebra software, LAPACK for example.
|
||||
|
||||
LAPACK (Linear Algebra PACKage) is written in Fortran 90 and provides
|
||||
routines for solving systems of simultaneous linear equations, least-
|
||||
squares solutions of linear systems of equations, eigenvalue problems,
|
||||
and singular value problems. The associated matrix factorizations (LU,
|
||||
Cholesky, QR, SVD, Schur, generalized Schur) are also provided, as are
|
||||
related computations such as reordering of the Schur factorizations and
|
||||
estimating condition numbers. Dense and banded matrices are handled, but
|
||||
not general sparse matrices. In all areas, similar functionality is
|
||||
provided for real and complex matrices, in both single and double precision.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
setenv OMP_NUM_THREADS 1
|
||||
setenv BLASLIB $PREFIX/libopenblas.a
|
||||
25
scripts/Compiler/SuperLU/modulefile
Normal file
25
scripts/Compiler/SuperLU/modulefile
Normal file
@@ -0,0 +1,25 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "library for direct solution of large, sparse, nonsymmetric systems of linear equations."
|
||||
set url "http://crd-legacy.lbl.gov/~xiaoye/SuperLU/"
|
||||
set license "BSD, see \$SUPERLU_DIR/share/doc/SuperLU/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)
|
||||
18
scripts/Compiler/UMFPACK/modulefile
Normal file
18
scripts/Compiler/UMFPACK/modulefile
Normal file
@@ -0,0 +1,18 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "routines for solving unsymmetric sparse linear systems using the Unsymmetric MultiFrontal method."
|
||||
set url "https://www.cise.ufl.edu/research/sparse/umfpack/"
|
||||
set license "GNU GPL"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
UMFPACK is a set of routines for solving unsymmetric sparse linear systems,
|
||||
Ax=b, using the Unsymmetric MultiFrontal method. Written in ANSI/ISO C, with
|
||||
a MATLAB (Version 6.0 and later) interface. Appears as a built-in routine
|
||||
(for lu, backslash, and forward slash) in MATLAB. Includes a MATLAB
|
||||
interface, a C-callable interface, and a Fortran-callable interface. Note
|
||||
that "UMFPACK" is pronounced in two syllables, "Umph Pack". It is not "You
|
||||
Em Ef Pack".
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
16
scripts/Compiler/atlas/modulefile
Normal file
16
scripts/Compiler/atlas/modulefile
Normal file
@@ -0,0 +1,16 @@
|
||||
#%Module1.0
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
set whatis "efficient BLAS and partial LAPACK implementation"
|
||||
set url "http://math-atlas.sourceforge.net/"
|
||||
set license "BSD-style license"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
set help "
|
||||
The ATLAS (Automatically Tuned Linear Algebra Software) project is an
|
||||
ongoing research effort focusing on applying empirical techniques in
|
||||
order to provide portable performance. At present, it provides C and
|
||||
Fortran77 interfaces to a portably efficient BLAS implementation, as
|
||||
well as a few routines from LAPACK.
|
||||
"
|
||||
|
||||
15
scripts/Compiler/boost/modulefile
Normal file
15
scripts/Compiler/boost/modulefile
Normal file
@@ -0,0 +1,15 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "C++ libraries"
|
||||
set url "http://www.boost.org"
|
||||
set license "Boost Software License"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
set help "
|
||||
Boost is a set of libraries for the C++ programming language that provide
|
||||
support for tasks and structures such as linear algebra, pseudorandom number
|
||||
generation, multithreading, image processing, regular expressions, and unit
|
||||
testing. It contains over eighty individual libraries.
|
||||
(Wikipedia)
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
16
scripts/Compiler/gsl/modulefile
Normal file
16
scripts/Compiler/gsl/modulefile
Normal file
@@ -0,0 +1,16 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "GNU Scientific Library"
|
||||
set url "http://www.gnu.org/software/gsl/"
|
||||
set license "GNU GPL"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
set help "
|
||||
The GNU Scientific Library (GSL) is a numerical library for C and C++
|
||||
programmers.
|
||||
|
||||
The library provides a wide range of mathematical routines such as random
|
||||
number generators, special functions and least-squares fitting. There are
|
||||
over 1000 functions in total with an extensive test suite.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
20
scripts/Compiler/hdf5_serial/modulefile
Normal file
20
scripts/Compiler/hdf5_serial/modulefile
Normal file
@@ -0,0 +1,20 @@
|
||||
#%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)
|
||||
|
||||
set-family HDF5_serial
|
||||
conflict hdf5
|
||||
|
||||
25
scripts/Compiler/mpich/modulefile
Normal file
25
scripts/Compiler/mpich/modulefile
Normal file
@@ -0,0 +1,25 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "a high performance implementation of the MPI standard."
|
||||
set url "http://www.mpich.org/"
|
||||
set license "BSD-like"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
set help "
|
||||
MPICH is a high-performance and widely portable implementation of the
|
||||
MPI Standard, designed to implement all of MPI-1, MPI-2, and MPI-3 (in-
|
||||
cluding dynamic process management, one-sided operations, parallel I/O,
|
||||
and other extensions).
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
set-family MPI
|
||||
|
||||
setenv MPICC $PREFIX/bin/mpicc
|
||||
setenv MPICXX $PREFIX/bin/mpicxx
|
||||
setenv MPIF77 $PREFIX/bin/mpif77
|
||||
setenv MPIF90 $PREFIX/bin/mpif90
|
||||
setenv MPIFC $PREFIX/bin/mpif90
|
||||
setenv MPIFORTRAN $PREFIX/bin/mpif90
|
||||
setenv MPIEXEC $PREFIX/bin/mpiexec
|
||||
setenv MPIRUN $PREFIX/bin/mpirun
|
||||
26
scripts/Compiler/openmpi/modulefile
Normal file
26
scripts/Compiler/openmpi/modulefile
Normal file
@@ -0,0 +1,26 @@
|
||||
#%Module1.0
|
||||
|
||||
module-whatis "open source MPI-2 implementation"
|
||||
module-url "http://www.open-mpi.org/"
|
||||
module-license "See \$OPENMPI_DIR/share/doc/openmpi/LICENSE"
|
||||
module-maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
module-help "
|
||||
The Open MPI Project is an open source MPI-2 implementation that is
|
||||
developed and maintained by a consortium of academic, research, and
|
||||
industry partners. Open MPI is therefore able to combine the expertise,
|
||||
technologies, and resources from all across the High Performance Computing
|
||||
community in order to build the best MPI library available. Open MPI offers
|
||||
advantages for system and software vendors, application developers and
|
||||
computer science researchers.
|
||||
"
|
||||
|
||||
module-addgroup MPI
|
||||
|
||||
setenv MPICC $PREFIX/bin/mpicc
|
||||
setenv MPICXX $PREFIX/bin/mpicxx
|
||||
setenv MPIF77 $PREFIX/bin/mpif77
|
||||
setenv MPIF90 $PREFIX/bin/mpif90
|
||||
setenv MPIFC $PREFIX/bin/mpif90
|
||||
setenv MPIFORTRAN $PREFIX/bin/mpif90
|
||||
setenv MPIEXEC $PREFIX/bin/mpiexec
|
||||
setenv MPIRUN $PREFIX/bin/mpirun
|
||||
16
scripts/Compiler/root/modulefile
Normal file
16
scripts/Compiler/root/modulefile
Normal file
@@ -0,0 +1,16 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "CERN root"
|
||||
set url "http://root.cern.ch/"
|
||||
set license "GNU LGPL v2"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
set help "
|
||||
ROOT is an object-oriented framework aimed at solving the data analysis
|
||||
challenges of high-energy physics. There are two key words in this
|
||||
definition, object oriented and framework. First, we explain what we
|
||||
mean by a framework and then why it is an object-oriented framework.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
setenv ROOTSYS $PREFIX
|
||||
15
scripts/Compiler/vtk/modulefile
Normal file
15
scripts/Compiler/vtk/modulefile
Normal file
@@ -0,0 +1,15 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "Visualization ToolKit"
|
||||
set url "http://www.vtk.org"
|
||||
set license "Kitware, Inc., Insight Software Consortium (BSD-like)"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
The Visualization Toolkit (VTK) is an open-source, freely available
|
||||
software system for 3D computer graphics, image processing and
|
||||
visualization. VTK consists of a C++ class library and several
|
||||
interpreted interface layers including Tcl/Tk, Java, and Python.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
17
scripts/HDF5/H5hut/modulefile
Normal file
17
scripts/HDF5/H5hut/modulefile
Normal file
@@ -0,0 +1,17 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "HDF5 utility toolkit"
|
||||
set url "http://amas.psi.ch/H5hut"
|
||||
set license "BSD-like"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
H5hut is a veneer API for HDF5: H5hut files are also valid HDF5 files
|
||||
and are compatible with other HDF5-based interfaces and tools. For
|
||||
example, the h5dump tool that comes standard with HDF5 can export H5hut
|
||||
files to ASCII or XML for additional portability. H5hut also includes
|
||||
tools to convert H5hut data to the Visualization ToolKit (VTK) format
|
||||
and to generate scripts for the GNUplot data plotting tool.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
14
scripts/HDF5/netcdf/modulefile
Normal file
14
scripts/HDF5/netcdf/modulefile
Normal file
@@ -0,0 +1,14 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "Network Common Data Form"
|
||||
set url "http://www.unidata.ucar.edu/software/netcdf/"
|
||||
set license "BSD-like, see \${NETCDF_DIR}/share/doc/netcdf/COPYRIGHT"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
NetCDF is a set of software libraries and self-describing, machine-
|
||||
independent data formats that support the creation, access, and
|
||||
sharing of array-oriented scientific data.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
17
scripts/HDF5_serial/H5hut_serial/modulefile
Normal file
17
scripts/HDF5_serial/H5hut_serial/modulefile
Normal file
@@ -0,0 +1,17 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "HDF5 utility toolkit"
|
||||
set url "http://amas.psi.ch/H5hut"
|
||||
set license "BSD-like"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
H5hut is a veneer API for HDF5: H5hut files are also valid HDF5 files
|
||||
and are compatible with other HDF5-based interfaces and tools. For
|
||||
example, the h5dump tool that comes standard with HDF5 can export H5hut
|
||||
files to ASCII or XML for additional portability. H5hut also includes
|
||||
tools to convert H5hut data to the Visualization ToolKit (VTK) format
|
||||
and to generate scripts for the GNUplot data plotting tool.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
14
scripts/Libraries/giflib/modulefile
Normal file
14
scripts/Libraries/giflib/modulefile
Normal file
@@ -0,0 +1,14 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "library and utilities for processing GIFs"
|
||||
set url "http://sourceforge.net/projects/giflib/"
|
||||
set license "X Consortium-like open-source license"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
giflib is a library for reading and writing gif images. It is API and ABI
|
||||
compatible with libungif which was in wide use while the LZW compression
|
||||
algorithm was patented.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
16
scripts/Libraries/gmp/modulefile
Normal file
16
scripts/Libraries/gmp/modulefile
Normal file
@@ -0,0 +1,16 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "GNU Multiple Precision Arithmetic Library"
|
||||
set url "http://gmplib.org/"
|
||||
set license "GNU GPL v3 / GNU LGPL v3"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
GMP is a free library for arbitrary precision arithmetic, operating on
|
||||
signed integers, rational numbers, and floating-point numbers. There is
|
||||
no practical limit to the precision except the ones implied by the available
|
||||
memory in the machine GMP runs on. GMP has a rich set of functions, and the
|
||||
functions have a regular interface.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
14
scripts/Libraries/libungif/modulefile
Normal file
14
scripts/Libraries/libungif/modulefile
Normal file
@@ -0,0 +1,14 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "library and utilities for processing GIFs"
|
||||
set url "http://sourceforge.net/projects/giflib/"
|
||||
set license "X Consortium-like open-source license"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
giflib is a library for reading and writing gif images. It is API and ABI
|
||||
compatible with libungif which was in wide use while the LZW compression
|
||||
algorithm was patented.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
13
scripts/Libraries/mpc/modulefile
Normal file
13
scripts/Libraries/mpc/modulefile
Normal file
@@ -0,0 +1,13 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "GNU Mpc"
|
||||
set url "http://www.multiprecision.org"
|
||||
set license "GNU LGPL v3"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Gnu Mpc is a C library for the arithmetic of complex numbers with
|
||||
arbitrarily high precision and correct rounding of the result.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
16
scripts/Libraries/mpfr/modulefile
Normal file
16
scripts/Libraries/mpfr/modulefile
Normal file
@@ -0,0 +1,16 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "GNU Multiple-Precision Floating-point library with correct Rounding"
|
||||
set url "http://www.mpfr.org/"
|
||||
set license "GNU GPL v3 / GNU LGPL v3"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
The main goal of MPFR is to provide a library for multiple-precision
|
||||
floating-point computation which is both efficient and has a well-
|
||||
defined semantics. It copies the good ideas from the ANSI/IEEE-754
|
||||
standard for double-precision floating-point arithmetic (53-bit
|
||||
significand).
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
15
scripts/Libraries/tiff/modulefile
Normal file
15
scripts/Libraries/tiff/modulefile
Normal file
@@ -0,0 +1,15 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "set of C functions that support the manipulation of TIFF image files."
|
||||
set url "http://www.libtiff.org/"
|
||||
set license "BSD-like, see: http://libtiff.org/misc.html"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
This software provides support for the Tag Image File Format (TIFF), a
|
||||
widely used format for storing image data. The latest version of the TIFF
|
||||
specification is available on-line in several different formats, as are a
|
||||
number of Technical Notes (TTN's).
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
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)
|
||||
12
scripts/OPAL/opt-pilot/modulefile
Normal file
12
scripts/OPAL/opt-pilot/modulefile
Normal file
@@ -0,0 +1,12 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "opt-pilot"
|
||||
set url "http://amas.psi.ch/OPAL"
|
||||
set license "PSI"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
19
scripts/Programming/Python/modulefile
Normal file
19
scripts/Programming/Python/modulefile
Normal file
@@ -0,0 +1,19 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "scripting language."
|
||||
set url "http://www.python.org/"
|
||||
set license "Python Software Foundation license (GPL-compatible)"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Python is an easy to learn, powerful programming language. It has
|
||||
efficient high-level data structures and a simple but effective
|
||||
approach to object-oriented programming. Python’s elegant syntax
|
||||
and dynamic typing, together with its interpreted nature, make it
|
||||
an ideal language for scripting and rapid application development
|
||||
in many areas on most platforms.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
|
||||
17
scripts/Programming/Tcl/modulefile
Normal file
17
scripts/Programming/Tcl/modulefile
Normal file
@@ -0,0 +1,17 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "a very powerful, easy to learn programming language"
|
||||
set url "http://www.tcl.tk"
|
||||
set license "BSD-lik"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Tcl (Tool Command Language) is a very powerful but easy to learn dynamic
|
||||
programming language, suitable for a very wide range of uses, including
|
||||
web and desktop applications, networking, administration, testing and many
|
||||
more. Open source and business-friendly, Tcl is a mature yet evolving
|
||||
language that is truly cross platform, easily deployed and highly
|
||||
extensible.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
16
scripts/Programming/Tk/modulefile
Normal file
16
scripts/Programming/Tk/modulefile
Normal file
@@ -0,0 +1,16 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "graphical user interface toolkit"
|
||||
set url "http://www.tcl.tk"
|
||||
set license "BSD-like"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Tk is a graphical user interface toolkit that takes developing desktop
|
||||
applications to a higher level than conventional approaches. Tk is the
|
||||
standard GUI not only for Tcl, but for many other dynamic languages, and
|
||||
can produce rich, native applications that run unchanged across Windows,
|
||||
Mac OS X, Linux and more.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
17
scripts/Programming/autoconf/modulefile
Normal file
17
scripts/Programming/autoconf/modulefile
Normal file
@@ -0,0 +1,17 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "part of the GNU autotools"
|
||||
set url "http://www.gnu.org/software/autoconf/"
|
||||
set license "GNU GPL v2/v3"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Autoconf is an extensible package of M4 macros that produce shell scripts
|
||||
to automatically configure software source code packages. These scripts
|
||||
can adapt the packages to many kinds of UNIX-like systems without manual
|
||||
user intervention. Autoconf creates a configuration script for a package
|
||||
from a template file that lists the operating system features that the
|
||||
package can use, in the form of M4 macro calls.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
14
scripts/Programming/automake/modulefile
Normal file
14
scripts/Programming/automake/modulefile
Normal file
@@ -0,0 +1,14 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "tool for automatically generating Makefile.in files"
|
||||
set url "http://www.gnu.org/software/automake/"
|
||||
set license "GNU GPL v2"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Automake is a tool for automatically generating Makefile.in files
|
||||
compliant with the GNU Coding Standards. Automake requires the use
|
||||
of Autoconf.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
42
scripts/Programming/binutils/modulefile
Normal file
42
scripts/Programming/binutils/modulefile
Normal file
@@ -0,0 +1,42 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "collection of binary tools like:ld, as, nm"
|
||||
set url "http://www.gnu.org/software/binutils/"
|
||||
set license "GNU GPL v3"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
The GNU Binutils are a collection of binary tools. The main ones are:
|
||||
|
||||
ld - the GNU linker.
|
||||
as - the GNU assembler.
|
||||
|
||||
But they also include:
|
||||
|
||||
addr2line - Converts addresses into filenames and line numbers.
|
||||
ar - A utility for creating, modifying and extracting from archives.
|
||||
c++filt - Filter to demangle encoded C++ symbols.
|
||||
dlltool - Creates files for building and using DLLs.
|
||||
gold - A new, faster, ELF only linker, still in beta test.
|
||||
gprof - Displays profiling information.
|
||||
nlmconv - Converts object code into an NLM.
|
||||
nm - Lists symbols from object files.
|
||||
objcopy - Copies and translates object files.
|
||||
objdump - Displays information from object files.
|
||||
ranlib - Generates an index to the contents of an archive.
|
||||
readelf - Displays information from any ELF format object file.
|
||||
size - Lists the section sizes of an object or archive file.
|
||||
strings - Lists printable strings from files.
|
||||
strip - Discards symbols.
|
||||
windmc - A Windows compatible message compiler.
|
||||
windres - A compiler for Windows resource files.
|
||||
|
||||
Most of these programs use BFD, the Binary File Descriptor library, to do
|
||||
low-level manipulation. Many of them also use the opcodes library to assemble
|
||||
and disassemble machine instructions.
|
||||
|
||||
The binutils have been ported to most major Unix variants as well as Wintel
|
||||
systems, and their main reason for existence is to give the GNU system (and
|
||||
GNU/Linux) the facility to compile and link programs."
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
16
scripts/Programming/cmake/modulefile
Normal file
16
scripts/Programming/cmake/modulefile
Normal file
@@ -0,0 +1,16 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "cross-platform, open-source build system."
|
||||
set url "http://www.cmake.org/"
|
||||
set license "Kitware, Inc., Insight Software Consortium (BSD-like)"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
CMake is a family of tools designed to build, test and package software.
|
||||
CMake is used to control the software compilation process using simple
|
||||
platform and compiler independent configuration files. CMake generates
|
||||
native makefiles and workspaces that can be used in the compiler
|
||||
environment of your choice.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
39
scripts/Programming/gcc/modulefile
Normal file
39
scripts/Programming/gcc/modulefile
Normal file
@@ -0,0 +1,39 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "GNU Compiler Collection"
|
||||
set url "http://gcc.gnu.org/"
|
||||
set license "GNU GPL v2/v3"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
The GNU Compiler Collection includes front ends for C, C++, Objective-C,
|
||||
Fortran, Java, Ada, and Go, as well as libraries for these languages
|
||||
(libstdc++, libgcj,...). GCC was originally written as the compiler for
|
||||
the GNU operating system.
|
||||
|
||||
This module includes compilers for
|
||||
- C/C++
|
||||
- Objective-C/Objective-C++
|
||||
- Fortran
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
set-family "Compiler"
|
||||
|
||||
setenv CC $PREFIX/bin/gcc
|
||||
setenv CXX $PREFIX/bin/g++
|
||||
setenv F77 $PREFIX/bin/gfortran
|
||||
setenv F90 $PREFIX/bin/gfortran
|
||||
setenv FC $PREFIX/bin/gfortran
|
||||
setenv FORTRAN $PREFIX/bin/gfortran
|
||||
|
||||
# Ubuntu hack
|
||||
if { [file exist "/usr/include/x86_64-linux-gnu"] } {
|
||||
append-path C_INCLUDE_PATH "/usr/include/x86_64-linux-gnu"
|
||||
append-path CPLUS_INCLUDE_PATH "/usr/include/x86_64-linux-gnu"
|
||||
}
|
||||
|
||||
if { [file exist "/usr/lib/x86_64-linux-gnu"] } {
|
||||
append-path LIBRARY_PATH "/usr/lib/x86_64-linux-gnu"
|
||||
}
|
||||
17
scripts/Programming/libtool/modulefile
Normal file
17
scripts/Programming/libtool/modulefile
Normal file
@@ -0,0 +1,17 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "generic library support script"
|
||||
set url "http://www.gnu.org/software/libtool/"
|
||||
set libtool "GNU GPL v2"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
GNU libtool is a generic library support script. Libtool hides the
|
||||
complexity of using shared libraries behind a consistent, portable
|
||||
interface.
|
||||
|
||||
To use libtool, add the new generic library building commands to
|
||||
your Makefile, Makefile.in, or Makefile.am.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
22
scripts/Programming/m4/modulefile
Normal file
22
scripts/Programming/m4/modulefile
Normal file
@@ -0,0 +1,22 @@
|
||||
#%Module1.0
|
||||
|
||||
module-whatis "traditional unix macro processor"
|
||||
module-url 'http://www.gnu.org/software/m4/'
|
||||
module-license "GNU GPL v3"
|
||||
module-maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
module-help "
|
||||
GNU M4 is an implementation of the traditional Unix macro processor. It
|
||||
is mostly SVR4 compatible although it has some extensions (for example,
|
||||
handling more than 9 positional parameters to macros). GNU M4 also has
|
||||
built-in functions for including files, running shell commands, doing
|
||||
arithmetic, etc.
|
||||
|
||||
GNU M4 is a macro processor in the sense that it copies its input to the
|
||||
output expanding macros as it goes. Macros are either builtin or user-
|
||||
defined and can take any number of arguments. Besides just doing macro
|
||||
expansion, m4 has builtin functions for including named files, running
|
||||
UNIX commands, doing integer arithmetic, manipulating text in various
|
||||
ways, recursion etc... m4 can be used either as a front-end to a compiler
|
||||
or as a macro processor in its own right.
|
||||
"
|
||||
18
scripts/Programming/psi-python27/modulefile
Normal file
18
scripts/Programming/psi-python27/modulefile
Normal file
@@ -0,0 +1,18 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "Anaconda Python Distribution - Python scripting language."
|
||||
set url "https://store.continuum.io/cshop/anaconda/"
|
||||
set license "http://docs.continuum.io/anaconda/eula.html"
|
||||
set maintainer "Derek Feichtinger <derek.feichtinger@psi.ch>"
|
||||
|
||||
set help "Anaconda is a completely free Python distribution
|
||||
(including for commercial use and redistribution). It includes over
|
||||
195 of the most popular Python packages for science, math,
|
||||
engineering, data analysis.
|
||||
|
||||
The distribution is enriched by PSI specific packages.
|
||||
"
|
||||
|
||||
set dont-setenv { LD_LIBRARY_PATH }
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
17
scripts/System/Java/modulefile
Normal file
17
scripts/System/Java/modulefile
Normal file
@@ -0,0 +1,17 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "programming language"
|
||||
set url "http://www.java.com"
|
||||
set license "See http://java.com/license"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Java is a programming language and computing platform first released by Sun
|
||||
Microsystems in 1995. There are lots of applications and websites that will
|
||||
not work unless you have Java installed, and more are created every day.
|
||||
Java is fast, secure, and reliable. From laptops to datacenters, game
|
||||
consoles to scientific supercomputers, cell phones to the Internet, Java is
|
||||
everywhere!
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
14
scripts/System/filebench/modulefile
Normal file
14
scripts/System/filebench/modulefile
Normal file
@@ -0,0 +1,14 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "File system and storage benchmark"
|
||||
set url "http://sourceforge.net/projects/filebench/"
|
||||
set license "Common Development and Distribution License"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Filebench is a file system and storage benchmark that can generate a variety
|
||||
of workloads. It employs extensive Workload Model Language (WML) for detailed
|
||||
workload specification.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
18
scripts/System/fsstress/modulefile
Normal file
18
scripts/System/fsstress/modulefile
Normal file
@@ -0,0 +1,18 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "fsstress"
|
||||
set url "http://www.cs.duke.edu/ari/fstress/"
|
||||
set license "BSD-like"
|
||||
set licensefile "COPYRIGHT"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Fstress is a synthetic, flexible, self-scaling NFS file service benchmark
|
||||
whose primary goal is flexibility. Fstress exports control over several
|
||||
dimensions in both data set and workload, enabling a wide range of tests
|
||||
for fundamental evaluation of file service scalability, sizing,
|
||||
configuration, and other factors. Fstress includes several important
|
||||
canned workloads.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
14
scripts/System/mdtest/modulefile
Normal file
14
scripts/System/mdtest/modulefile
Normal file
@@ -0,0 +1,14 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "filesystem metadata benchmark"
|
||||
set url "http://mdtest.sourceforge.net/"
|
||||
set license "GNU GPL v2"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
mdtest is an MPI-coordinated metadata benchmark test that performs
|
||||
open/stat/close operations on files and directories and then reports
|
||||
the performance.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
27
scripts/System/nmap/modulefile
Normal file
27
scripts/System/nmap/modulefile
Normal file
@@ -0,0 +1,27 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "utility for network discovery and security auditing."
|
||||
set url "http://nmap.org/"
|
||||
set license "GNU GPL v2"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Nmap (\"Network Mapper\") is a free and open source (license) utility for
|
||||
network discovery and security auditing. Many systems and network
|
||||
administrators also find it useful for tasks such as network inventory,
|
||||
managing service upgrade schedules, and monitoring host or service uptime.
|
||||
Nmap uses raw IP packets in novel ways to determine what hosts are available
|
||||
on the network, what services (application name and version) those hosts are
|
||||
offering, what operating systems (and OS versions) they are running, what
|
||||
type of packet filters/firewalls are in use, and dozens of other
|
||||
characteristics. It was designed to rapidly scan large networks, but works
|
||||
fine against single hosts. Nmap runs on all major computer operating
|
||||
systems, and official binary packages are available for Linux, Windows, and
|
||||
Mac OS X. In addition to the classic command-line Nmap executable, the Nmap
|
||||
suite includes an advanced GUI and results viewer (Zenmap), a flexible data
|
||||
transfer, redirection, and debugging tool (Ncat), a utility for comparing
|
||||
scan results (Ndiff), and a packet generation and response analysis tool
|
||||
(Nping).
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
13
scripts/System/patchelf/modulefile
Normal file
13
scripts/System/patchelf/modulefile
Normal file
@@ -0,0 +1,13 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "modify dynamic linker and RPATH of ELF executables."
|
||||
set url "http://nixos.org/patchelf.html"
|
||||
set license "GNU GPL v3"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
PatchELF is a small utility to modify the dynamic linker and RPATH of
|
||||
ELF executables.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
22
scripts/Tools/Eclipse/modulefile
Normal file
22
scripts/Tools/Eclipse/modulefile
Normal file
@@ -0,0 +1,22 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "C/C++ IDE"
|
||||
set url "http://eclipse.org/home/index.php"
|
||||
set license "Eclipse license"
|
||||
set licensefile "notice.html"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Eclipse is famous for its Java Integrated Development Environment (IDE), but
|
||||
its C/C++ IDE and PHP IDE are pretty cool too. You can easily combine
|
||||
language support and other features into any of our default packages, and
|
||||
the Eclipse Marketplace allows for virtually unlimited customization and
|
||||
extension.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
if { [uname sysname] == "Darwin" } {
|
||||
set-alias Eclipse "open -n \"$PREFIX/Eclipse.app\""
|
||||
}
|
||||
|
||||
21
scripts/Tools/Firefox/modulefile
Normal file
21
scripts/Tools/Firefox/modulefile
Normal file
@@ -0,0 +1,21 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "open source web browser"
|
||||
set url "https://www.mozilla.org/en-US/firefox/desktop/"
|
||||
set license " Mozilla Public License 2.0 and other"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Mozilla Firefox (known simply as Firefox) is a free and open-source web
|
||||
browser developed for Windows, OS X, and Linux, with a mobile version for
|
||||
Android, by the Mozilla Foundation and its subsidiary, the Mozilla
|
||||
Corporation. Firefox uses the Gecko layout engine to render web pages, which
|
||||
implements current and anticipated web standards.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
if { [uname sysname] == "Darwin" } {
|
||||
set-alias Firefox "open -n \"$PREFIX/Firefox.app\""
|
||||
}
|
||||
|
||||
16
scripts/Tools/Opera/modulefile
Normal file
16
scripts/Tools/Opera/modulefile
Normal file
@@ -0,0 +1,16 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "long term support version"
|
||||
set url "http://www.opera.com/"
|
||||
set license "Opera EULA"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Firefox web browser.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
if { [uname sysname] == "Darwin" } {
|
||||
set-alias Opera "open -n \"$PREFIX/Opera.app\""
|
||||
}
|
||||
20
scripts/Tools/Thunderbird/modulefile
Normal file
20
scripts/Tools/Thunderbird/modulefile
Normal file
@@ -0,0 +1,20 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "free, open source, cross-platform email, news, and chat client."
|
||||
set url "http://www.mozilla.org/en-US/thunderbird/"
|
||||
set license " Mozilla Public License 2.0 and other"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Thunderbird is an email, newsgroup, news feed, and chat (XMPP, IRC, Twitter)
|
||||
client. The vanilla version is not a personal information manager, although
|
||||
the Mozilla Lightning extension adds PIM functionality. Additional features,
|
||||
if needed, are often available via other extensions.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
if { [uname sysname] == "Darwin" } {
|
||||
set-alias Thunderbird "open -n \"$PREFIX/Thunderbird.app\""
|
||||
}
|
||||
|
||||
30
scripts/Tools/emacs/modulefile
Normal file
30
scripts/Tools/emacs/modulefile
Normal file
@@ -0,0 +1,30 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "extensible, customizable text editor—and more"
|
||||
set url "http://www.gnu.org/software/emacs/"
|
||||
set license "GNU GPL v3"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
GNU Emacs is an extensible, customizable text editor—and more. At its
|
||||
core is an interpreter for Emacs Lisp, a dialect of the Lisp programming
|
||||
language with extensions to support text editing. The features of GNU
|
||||
Emacs include:
|
||||
|
||||
- Content-sensitive editing modes, including syntax coloring, for a
|
||||
variety of file types including plain text, source code, and HTML.
|
||||
|
||||
- Complete built-in documentation, including a tutorial for new users.
|
||||
|
||||
- Full Unicode support for nearly all human languages and their scripts.
|
||||
|
||||
- Highly customizable, using Emacs Lisp code or a graphical interface.
|
||||
|
||||
- A large number of extensions that add other functionality, including
|
||||
a project planner, mail and news reader, debugger interface, calendar,
|
||||
and more. Many of these extensions are distributed with GNU Emacs;
|
||||
others are available separately.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
21
scripts/Tools/git/modulefile
Normal file
21
scripts/Tools/git/modulefile
Normal file
@@ -0,0 +1,21 @@
|
||||
#%Module1.0
|
||||
|
||||
set dont-setenv { GIT_DIR }
|
||||
|
||||
set whatis "distributed version control system"
|
||||
set url "http://git-scm.com/"
|
||||
set license "GNU GPL v2"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Git is a free and open source distributed version control system
|
||||
designed to handle everything from small to very large projects
|
||||
with speed and efficiency.
|
||||
|
||||
Git is easy to learn and has a tiny footprint with lightning fast
|
||||
performance. It outclasses SCM tools like Subversion, CVS, Perforce,
|
||||
and ClearCase with features like cheap local branching, convenient
|
||||
staging areas, and multiple workflows.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
22
scripts/Tools/global/modulefile
Normal file
22
scripts/Tools/global/modulefile
Normal file
@@ -0,0 +1,22 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "source code tag system"
|
||||
set url "http://www.gnu.org/software/global/"
|
||||
set license "GNU GPL v3"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
GNU GLOBAL is a source code tag system that works the same way across
|
||||
diverse environments, such as Emacs editor, Vi editor, Less viewer, Bash
|
||||
shell, various web browsers, etc. You can locate specified tags, such as
|
||||
functions, macros, structs, classes, in your source files and move there
|
||||
easily. It is useful for hacking large projects which contain many
|
||||
sub-directories, many #ifdef and many main() functions. It is similar to
|
||||
ctags or etags, but is different from them at the point of independence of
|
||||
any editor. It runs on a UNIX (POSIX) compatible operating system, like GNU
|
||||
and BSD.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
|
||||
|
||||
19
scripts/Tools/gnuplot/modulefile
Normal file
19
scripts/Tools/gnuplot/modulefile
Normal file
@@ -0,0 +1,19 @@
|
||||
#%Module1.0
|
||||
|
||||
set whatis "portable command-line driven graphing utility"
|
||||
set url "http://www.gnuplot.info/"
|
||||
set license "See \$GNUPLOT_DIR/share/doc/gnuplot/Copyright"
|
||||
set maintainer "Achim Gsell <achim.gsell@psi.ch>"
|
||||
|
||||
set help "
|
||||
Gnuplot is a portable command-line driven graphing utility for Linux,
|
||||
OS/2, MS Windows, OSX, VMS, and many other platforms. The source code
|
||||
is copyrighted but freely distributed (i.e., you don't have to pay for
|
||||
it). It was originally created to allow scientists and students to
|
||||
visualize mathematical functions and data interactively, but has grown
|
||||
to support many non-interactive uses such as web scripting. It is also
|
||||
used as a plotting engine by third-party applications like Octave.
|
||||
Gnuplot has been supported and under active development since 1986.
|
||||
"
|
||||
|
||||
source $env(PSI_LIBMODULES)
|
||||
Reference in New Issue
Block a user