lev_lafayette's blog

Julia cluster install with MPI packages

Julia is a high-level, high-performance dynamic language for technical computing. With a "just in time" compiler, it is very fast, especially compared to languages like MATLAB, Octave, R etc. However it is relatively new and a cluster installation and package deployment has a few quirks.

Download the source from github. By default you will be building the latest unstable version of Julia from the git checkout. However, we want to run 0.4.0 (or rather, 0.4rc4) which is the last stable release.


# cd /usr/local/src/JULIA

MrBayes HPC Installation

Mr. Bayes is a program for Bayesian inference and model choice across a wide range of phylogenetic and evolutionary models.

Download, extract. Note that the developers have produced a tarbomb which will require a separate directory created before download. This has been raised as a bug.

Note that more recent versions of MrBayes make much better use of autoconfiguration tools.


cd /usr/local/src/MRBAYES
mkdir mrbayes-3.2.5
cd mrbayes-3.2.5

General Atomic and Molecular Electronic Structure System HPC Installation

GAMESS (General Atomic and Molecular Electronic Structure System (GAMESS)) is a general ab initio quantum chemistry package. You will need to agree to the license prior to download, which will provide a link to gamess-current.tar.gz

Download and extract, load the environment variables for atlas and gcc.


cd /usr/local/src/
tar gamess-current.tar.gz
cd gamess
module load atlas/3.10.2
module load gcc/4.9.1

JAGS (Just Another Gibbs Sampler) Installation

JAGS is Just Another Gibbs Sampler. It is a program for analysis of Bayesian hierarchical models using Markov Chain Monte Carlo (MCMC) simulation not wholly unlike BUGS.


cd /usr/local/src/JAGS
wget http://downloads.sourceforge.net/project/mcmc-jags/JAGS/3.x/Source/JAGS-3.4.0.tar.gz
tar xvf JAGS-3.4.0.tar.gz
mv JAGS-3.4.0 jags-3.4.0
cd jags-3.4.0
../config
make
make check
make install
make installcheck

The config script takes the following form


#!/bin/bash
install=$(basename $(pwd) | sed 's%-%/%')

MuTect Installation

MuTect is a method developed at the Broad Institute for the reliable and accurate identification of somatic point mutations in next generation sequencing data of cancer genomes.

For complete details, please see the publication in Nature Biotechnology:

Cibulskis, K. et al. Sensitive detection of somatic point mutations in impure and heterogeneous cancer samples. Nat Biotechnology (2013).doi:10.1038/nbt.2514

Download after login.

PROJ.4 Cartographic Projections library installation

The PROJ.4 Cartographic Projections library was originally written by Gerald Evenden then of the USGS.

Download, extract, install.


cd /usr/local/src/PROJ
wget http://download.osgeo.org/proj/proj-4.9.1.tar.gz
tar xvf proj-4.9.1.tar.gz
cd proj-4.9.1
../config
make
make check
make install

The config file is a quick executable.


#!/bin/bash
./configure --prefix=/usr/local/$(basename $(pwd) | sed 's#-#/#')

Geospatial Data Abstraction Library Installation

GDAL (Geospatial Data Abstraction Library) is a translator library for raster and vector geospatial data formats.

Download, extract, install.


cd /usr/local/src/GDAL
wget http://download.osgeo.org/gdal/1.11.2/gdal-1.11.2.tar.gz
tar gdal-1.11.2.tar.gz
cd gdal-1.11.2
../config
make
make install

The config file is a quick executable.


#!/bin/bash
./configure --prefix=/usr/local/$(basename $(pwd) | sed 's#-#/#')

Pages