Difference between revisions of "Biocluster Applications"

From Carl R. Woese Institute for Genomic Biology - University of Illinois Urbana-Champaign
Jump to navigation Jump to search
Line 36: Line 36:
 
|efitools/devlocal
 
|efitools/devlocal
 
|
 
|
|-
 
|Autoconf
 
|
 
|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. - Homepage: http://www.gnu.org/software/autoconf/
 
|-
 
|[https://developer.nvidia.com/cuda-toolkit CUDA]
 
|10.0.130<br>8.0.61<br>8.0.61-IGB-gcc-4.9.4<br>9.0.176-IGB-gcc-4.9.4<br>9.1.85
 
|CUDA (formerly Compute Unified Device Architecture) is a parallel computing platform and programming model created by NVIDIA and implemented by the graphics processing units (GPUs) that they produce. CUDA gives developers access to the virtual instruction set and memory of the parallel computational elements in CUDA GPUs.
 
|-
 
|cairo
 
|
 
|Cairo is a 2D graphics library with support for multiple output devices. Currently supported output targets include the X Window System (via both Xlib and XCB), Quartz, Win32, image buffers, PostScript, PDF, and SVG file output. Experimental backends include OpenGL, BeOS, OS/2, and DirectFB
 
|-
 
|Tcl
 
|
 
|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.
 
 
|-
 
|-
 
|[http://454.com/products/analysis-software/index.asp 454]
 
|[http://454.com/products/analysis-software/index.asp 454]
Line 76: Line 60:
 
|
 
|
 
|ANTLR, ANother Tool for Language Recognition, (formerly PCCTS) is a language tool that provides a framework for constructing recognizers, compilers, and translators from grammatical descriptions containing Java, C#, C++, or Python actions.
 
|ANTLR, ANother Tool for Language Recognition, (formerly PCCTS) is a language tool that provides a framework for constructing recognizers, compilers, and translators from grammatical descriptions containing Java, C#, C++, or Python actions.
 +
|-
 +
|[https://github.com/bcgsc/arcs ARCS]
 +
|1.0.0-IGB-gcc-4.9.4-Perl-5.24.1
 +
|Scaffolding genome sequence assemblies using 10X Genomics GemCode/Chromium data. - Homepage: https://github.com/bcgsc/arcs
 
|-
 
|-
 
|ATK
 
|ATK
Line 81: Line 69:
 
|ATK provides the set of accessibility interfaces that are implemented by other toolkits and applications. Using the ATK interfaces, accessibility tools have full access to view and control running applications.
 
|ATK provides the set of accessibility interfaces that are implemented by other toolkits and applications. Using the ATK interfaces, accessibility tools have full access to view and control running applications.
 
|-
 
|-
|[https://github.com/bbuchfink/diamond DIAMOND]
+
|[https://github.com/MikkelSchubert/adapterremoval AdapterRemoval]
|0.8.38-IGB-gcc-4.9.4<br>0.9.10-IGB-gcc-4.9.4<br>0.9.16-IGB-gcc-4.9.4<br>0.9.22-IGB-gcc-4.9.4<br>0.9.24-IGB-gcc-4.9.4<br>0.9.24-IGB-gcc-8.2.0<br>0.9.9-IGB-gcc-4.9.4
+
|2.1.7-IGB-gcc-4.9.4
|Accelerated BLAST compatible local sequence aligner
+
|This program searches for and removes remnant adapter sequences from High-Throughput Sequencing (HTS) data and (optionally) trims low quality bases from the 3 end of reads following adapter removal.
 
|-
 
|-
|M4
+
|[https://github.com/DReichLab/AdmixTools AdmixTools]
|
+
|1.0.1-IGB-gcc-4.9.4
|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. - Homepage: http://www.gnu.org/software/m4/m4.html
+
|The ADMIXTOOLS package implements 5 methods described in Patterson et al. (2012) Ancient Admixture in Human History. Details of the methods and algorithm can be found in this paper.
|-
 
|[http://www.perl.org/ Perl]
 
|5.24.1-IGB-gcc-4.9.4<br>5.24.1-IGB-gcc-4.9.4-bare<br>5.26.1-IGB-gcc-4.9.4-unthreaded<br>5.28.1-IGB-gcc-8.2.0
 
|Larry Wall Practical Extraction and Report Language
 
|-
 
|[https://github.com/bcgsc/arcs ARCS]
 
|1.0.0-IGB-gcc-4.9.4-Perl-5.24.1
 
|Scaffolding genome sequence assemblies using 10X Genomics GemCode/Chromium data. - Homepage: https://github.com/bcgsc/arcs
 
|-
 
|[https://github.com/MikkelSchubert/adapterremoval AdapterRemoval]
 
|2.1.7-IGB-gcc-4.9.4
 
|This program searches for and removes remnant adapter sequences from High-Throughput Sequencing (HTS) data and (optionally) trims low quality bases from the 3 end of reads following adapter removal.
 
|-
 
|[https://github.com/DReichLab/AdmixTools AdmixTools]
 
|1.0.1-IGB-gcc-4.9.4
 
|The ADMIXTOOLS package implements 5 methods described in Patterson et al. (2012) Ancient Admixture in Human History. Details of the methods and algorithm can be found in this paper.
 
 
|-
 
|-
 
|[https://www.continuum.io/anaconda-overview Anaconda2]
 
|[https://www.continuum.io/anaconda-overview Anaconda2]
Line 120: Line 92:
 
|3f570cd-IGB-gcc-4.9.4<br>df5361f-IGB-gcc-4.9.4
 
|3f570cd-IGB-gcc-4.9.4<br>df5361f-IGB-gcc-4.9.4
 
|Analyze your assembly by comparing it to a reference genome
 
|Analyze your assembly by comparing it to a reference genome
 +
|-
 +
|Autoconf
 +
|
 +
|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. - Homepage: http://www.gnu.org/software/autoconf/
 
|-
 
|-
 
|[https://jgi.doe.gov/data-and-tools/bbtools/ BBMap]
 
|[https://jgi.doe.gov/data-and-tools/bbtools/ BBMap]
Line 132: Line 108:
 
|4.0.0-IGB-gcc-4.9.4
 
|4.0.0-IGB-gcc-4.9.4
 
|BLASR (Basic Local Alignment with Successive Refinement) rapidly maps  reads to genomes by finding the highest scoring local alignment or set of local alignments  between the read and the genome. Optimized for PacBios extraordinarily long reads and  taking advantage of rich quality values, BLASR maps reads rapidly with high accuracy.  
 
|BLASR (Basic Local Alignment with Successive Refinement) rapidly maps  reads to genomes by finding the highest scoring local alignment or set of local alignments  between the read and the genome. Optimized for PacBios extraordinarily long reads and  taking advantage of rich quality values, BLASR maps reads rapidly with high accuracy.  
 +
|-
 +
|[https://github.com/bbuchfink/diamond DIAMOND]
 +
|0.8.38-IGB-gcc-4.9.4<br>0.9.10-IGB-gcc-4.9.4<br>0.9.16-IGB-gcc-4.9.4<br>0.9.22-IGB-gcc-4.9.4<br>0.9.24-IGB-gcc-4.9.4<br>0.9.24-IGB-gcc-8.2.0<br>0.9.9-IGB-gcc-4.9.4
 +
|Accelerated BLAST compatible local sequence aligner
 
|-
 
|-
 
|[http://blast.ncbi.nlm.nih.gov/ BLAST]
 
|[http://blast.ncbi.nlm.nih.gov/ BLAST]
Line 184: Line 164:
 
|1.1.2-IGB-gcc-4.9.4<br>1.2.0-IGB-gcc-4.9.4<br>1.2.2-IGB-gcc-4.9.4
 
|1.1.2-IGB-gcc-4.9.4<br>1.2.0-IGB-gcc-4.9.4<br>1.2.2-IGB-gcc-4.9.4
 
|Bowtie is an ultrafast, memory-efficient short read aligner.It aligns short DNA sequences (reads) to the human genome.
 
|Bowtie is an ultrafast, memory-efficient short read aligner.It aligns short DNA sequences (reads) to the human genome.
|-
 
|[http://bioinform.github.io/breakseq2/ BreakSeq2]
 
|2.2-IGB-gcc-4.9.4-Python-2.7.13
 
|Ultrafast and accurate nucleotide-resolution analysis of structural variants - Homepage: http://bioinform.github.io/breakseq2/
 
 
|-
 
|-
 
|[http://weizhong-lab.ucsd.edu/cd-hit/ CD-HIT]
 
|[http://weizhong-lab.ucsd.edu/cd-hit/ CD-HIT]
Line 196: Line 172:
 
|
 
|
 
|CMake, the cross-platform, open-source build system. CMake is a family of tools designed to build, test and package software.
 
|CMake, the cross-platform, open-source build system. CMake is a family of tools designed to build, test and package software.
|-
 
|[https://github.com/abyzovlab/CNVnator CNVnator]
 
|0.3.3-IGB-gcc-4.9.4
 
|a tool for CNV discovery and genotyping from depth-of-coverage by mapped reads
 
 
|-
 
|-
 
|[https://github.com/BinPro/CONCOCT CONCOCT]
 
|[https://github.com/BinPro/CONCOCT CONCOCT]
Line 208: Line 180:
 
|2.1-3-IGB-gcc-4.9.4
 
|2.1-3-IGB-gcc-4.9.4
 
|CUnit is a lightweight system for writing, administering, and running unit tests in C.  It provides C programmers a basic testing functionality with a flexible variety of user interfaces.
 
|CUnit is a lightweight system for writing, administering, and running unit tests in C.  It provides C programmers a basic testing functionality with a flexible variety of user interfaces.
|-
 
|[http://ecogenomics.github.io/CheckM CheckM]
 
|1.0.7-IGB-gcc-4.9.4-Python-2.7.13
 
|CheckM provides a set of tools for assessing the quality of genomes recovered from isolates, single cells, or metagenomes.
 
 
|-
 
|-
 
|[http://sanger-pathogens.github.io/circlator/ Circlator]
 
|[http://sanger-pathogens.github.io/circlator/ Circlator]
Line 217: Line 185:
 
|A tool to circularize genome assemblies.  
 
|A tool to circularize genome assemblies.  
 
|-
 
|-
|[http://www.circos.ca/ Circos]
+
|[https://developer.nvidia.com/cuda-toolkit CUDA]
|0.69-4-IGB-gcc-4.9.4-Perl-5.24.1
+
|10.0.130<br>8.0.61<br>8.0.61-IGB-gcc-4.9.4<br>9.0.176-IGB-gcc-4.9.4<br>9.1.85
|Circos is a software package for visualizing data and information. It visualizes data in a circular layout - this makes Circos ideal for exploring relationships between objects or positions. - Homepage: http://www.circos.ca/
+
|CUDA (formerly Compute Unified Device Architecture) is a parallel computing platform and programming model created by NVIDIA and implemented by the graphics processing units (GPUs) that they produce. CUDA gives developers access to the virtual instruction set and memory of the parallel computational elements in CUDA GPUs.
 
|-
 
|-
 
|Clp
 
|Clp
 
|
 
|
 
|Clp (Coin-or linear programming) is an open-source linear programming solver written in C++.  
 
|Clp (Coin-or linear programming) is an open-source linear programming solver written in C++.  
|-
 
|[http://www.clustal.org/omega/ Clustal-Omega]
 
|1.2.4-IGB-gcc-4.9.4
 
|Clustal Omega is a multiple sequence alignment program for proteins. It produces biologically meaningful multiple sequence alignments of divergent sequences. Evolutionary relationships can be seen via viewing Cladograms or Phylograms  - Homepage: http://www.clustal.org/omega/
 
|-
 
|[http://www.ebi.ac.uk/Tools/msa/clustalw2/ ClustalW2]
 
|2.1-IGB-gcc-4.9.4
 
|ClustalW2 is a general purpose multiple sequence alignment program for DNA or proteins. - Homepage: http://www.ebi.ac.uk/Tools/msa/clustalw2/
 
 
|-
 
|-
 
|[https://github.com/PacificBiosciences/ConsensusCore ConsensusCore]
 
|[https://github.com/PacificBiosciences/ConsensusCore ConsensusCore]
Line 252: Line 212:
 
|
 
|
 
|Berkeley DB enables the development of custom data management solutions, without the overhead traditionally associated with such custom projects.
 
|Berkeley DB enables the development of custom data management solutions, without the overhead traditionally associated with such custom projects.
|-
 
|[http://www.broadinstitute.org/software/discovar/blog/ DISCOVARdenovo]
 
|52488-IGB-gcc-4.9.4
 
|DISCOVAR de novo can generate de novo assemblies for both large and small genomes. It currently does not call variants.
 
|-
 
|[http://www1.montpellier.inra.fr/CBGP/diyabc/index.php DIYABC]
 
|2.1.0
 
|a user-friendly approach to Approximate Bayesian Computation for inference on population history using molecular markers
 
|-
 
|[https://dendropy.org/ DendroPy]
 
|4.4.0-IGB-gcc-4.9.4-Python-3.6.1
 
|DendroPy is a Python library for phylogenetic computing.
 
 
|-
 
|-
 
|[http://www.doxygen.org Doxygen]
 
|[http://www.doxygen.org Doxygen]
Line 269: Line 217:
 
|Doxygen is a documentation system for C++, C, Java, Objective-C, Python,  IDL (Corba and Microsoft flavors), Fortran, VHDL, PHP, C#, and to some extent D.
 
|Doxygen is a documentation system for C++, C, Java, Objective-C, Python,  IDL (Corba and Microsoft flavors), Fortran, VHDL, PHP, C#, and to some extent D.
 
|-
 
|-
|[http://emboss.sourceforge.net/ EMBOSS]
+
|[https://github.com/csmiller/EMIRGE EMIRGE]
|6.6.0-IGB-gcc-4.9.4-Java-1.8.0_121
 
|EMBOSS, The European Molecular Biology Open Software Suite. EMBOSS is a free Open Source software analysis package specially developed for the needs of the molecular biology (e.g. EMBnet) user community.
 
|-
 
|[https://github.com/csmiller/EMIRGE EMIRGE]
 
 
|0.61.1-IGB-gcc-4.9.4-Python-2.7.13
 
|0.61.1-IGB-gcc-4.9.4-Python-2.7.13
 
|EMIRGE reconstructs full length ribosomal genes from short readsequencing data.  In the process, it also provides estimates of thesequences abundances.
 
|EMIRGE reconstructs full length ribosomal genes from short readsequencing data.  In the process, it also provides estimates of thesequences abundances.
Line 284: Line 228:
 
|1.8.8-IGB-gcc-4.9.4-Python-2.7.13
 
|1.8.8-IGB-gcc-4.9.4-Python-2.7.13
 
|FALCON is a diploid aware genome assembler designed for Pacific Biosciences long read data.
 
|FALCON is a diploid aware genome assembler designed for Pacific Biosciences long read data.
|-
 
|[https://github.com/PacificBiosciences/FALCON_unzip FALCON_unzip]
 
|0.4.0-IGB-gcc-4.9.4-Python-2.7.13
 
|FALCON-Unzip contains the modules that works with FALCON for full diploid assembly (representing haplotype specific contigs as "haplotigs" as assembly output).
 
 
|-
 
|-
 
|[http://hannonlab.cshl.edu/fastx_toolkit/ FASTX-Toolkit]
 
|[http://hannonlab.cshl.edu/fastx_toolkit/ FASTX-Toolkit]
Line 296: Line 236:
 
|20180117-IGB-gcc-4.9.4
 
|20180117-IGB-gcc-4.9.4
 
|This document is intended to give a technical description of the FEELnc pipeline in order to annotate long non-coding RNAs (lncRNAs) based on reconstructed transcripts from RNA-seq data (either with or without a reference genome).  
 
|This document is intended to give a technical description of the FEELnc pipeline in order to annotate long non-coding RNAs (lncRNAs) based on reconstructed transcripts from RNA-seq data (either with or without a reference genome).  
|-
 
|FFTW
 
|
 
|FFTW is a C subroutine library for computing the discrete Fourier transform (DFT) in one or more dimensions, of arbitrary input size, and of both real and complex data.
 
 
|-
 
|-
 
|[https://www.ffmpeg.org/ FFmpeg]
 
|[https://www.ffmpeg.org/ FFmpeg]
Line 308: Line 244:
 
|1.3.1-IGB-gcc-4.9.4
 
|1.3.1-IGB-gcc-4.9.4
 
|Programs and libraries for working with Free Lossless Audio Codec (FLAC) files.
 
|Programs and libraries for working with Free Lossless Audio Codec (FLAC) files.
|-
 
|[https://github.com/dstreett/FLASH2 FLASH2]
 
|2.2.00-IGB-gcc-4.9.4
 
|FLASH (Fast Length Adjustment of SHort reads) is an accurate and fast toolto merge paired-end reads that were generated from DNA fragments whoselengths are shorter than twice the length of reads.  Merged read pairs resultin unpaired longer reads, which are generally more desired in genomeassembly and genome analysis processes.
 
 
|-
 
|-
 
|[https://github.com/md5sam/Falcon2Fastg Falcon2Fastg]
 
|[https://github.com/md5sam/Falcon2Fastg Falcon2Fastg]
Line 320: Line 252:
 
|2.1.6.1-IGB-gcc-4.9.4
 
|2.1.6.1-IGB-gcc-4.9.4
 
|FastME provides distance algorithms to infer phylogenies. FastME is based on balanced minimum evolution, which is the very principle of NJ. FastME improves over NJ by performing topological moves using fast, sophisticated algorithms.
 
|FastME provides distance algorithms to infer phylogenies. FastME is based on balanced minimum evolution, which is the very principle of NJ. FastME improves over NJ by performing topological moves using fast, sophisticated algorithms.
|-
 
|[http://www.microbesonline.org/fasttree/ FastTree]
 
|2.1.10-IGB-gcc-4.9.4
 
|FastTree infers approximately-maximum-likelihood phylogenetic trees from alignments of nucleotide or protein sequences. FastTree can handle alignments with up to a million of sequences in a reasonable amount of time and memory.
 
|-
 
|[https://github.com/fenderglass/Flye Flye]
 
|2.4.2-IGB-gcc-4.9.4-Python-2.7.13
 
|Flye is a de novo assembler for single molecule sequencing reads, such as those produced by PacBio and Oxford Nanopore Technologies.
 
 
|-
 
|-
 
|[https://github.com/ekg/freebayes FreeBayes]
 
|[https://github.com/ekg/freebayes FreeBayes]
Line 342: Line 266:
 
|-
 
|-
 
|GCC
 
|GCC
|
 
|The GNU Compiler Collection includes front ends for C, C++, Objective-C, Fortran, Java, and Ada, as well as libraries for these languages (libstdc++, libgcj,...).
 
|-
 
|GCCcore
 
 
|
 
|
 
|The GNU Compiler Collection includes front ends for C, C++, Objective-C, Fortran, Java, and Ada, as well as libraries for these languages (libstdc++, libgcj,...).
 
|The GNU Compiler Collection includes front ends for C, C++, Objective-C, Fortran, Java, and Ada, as well as libraries for these languages (libstdc++, libgcj,...).
Line 352: Line 272:
 
|2.66-IGB-gcc-4.9.4-Perl-5.24.1
 
|2.66-IGB-gcc-4.9.4-Perl-5.24.1
 
|GD.pm - Interface to Gd Graphics Library
 
|GD.pm - Interface to Gd Graphics Library
|-
 
|[http://www.gdal.org/ GDAL]
 
|2.3.1-IGB-gcc-4.9.4
 
|GDAL is a translator library for raster geospatial data formats that is released under an X/MIT style Open Source license by the Open Source Geospatial Foundation. As a library, it presents a single abstract data model to the calling application for all supported formats. It also comes with a variety of useful commandline utilities for data translation and processing.
 
 
|-
 
|-
 
|[https://bitbucket.org/feeldead/gfold GFOLD]
 
|[https://bitbucket.org/feeldead/gfold GFOLD]
Line 368: Line 284:
 
|2018-05-30-IGB-gcc-4.9.4
 
|2018-05-30-IGB-gcc-4.9.4
 
|A Genomic Mapping and Alignment Program for mRNA and EST Sequences, andGSNAP: Genomic Short-read Nucleotide Alignment Program
 
|A Genomic Mapping and Alignment Program for mRNA and EST Sequences, andGSNAP: Genomic Short-read Nucleotide Alignment Program
|-
 
|[http://research-pub.gene.com/gmap/ GMAP-GSNAP]
 
|2017-11-15-IGB-gcc-4.9.4
 
|GMAP: A Genomic Mapping and Alignment Program for mRNA and EST Sequences GSNAP: Genomic Short-read Nucleotide Alignment Program
 
 
|-
 
|-
 
|[https://melodi.ee.washington.edu/gmtk/ GMTK]
 
|[https://melodi.ee.washington.edu/gmtk/ GMTK]
 
|1.4.4-IGB-gcc-4.9.4
 
|1.4.4-IGB-gcc-4.9.4
 
|The Graphical Models Toolkit (GMTK) is an open source, publicly available toolkit for rapidly prototyping statistical models using dynamic graphical models (DGMs) and dynamic Bayesian networks (DBNs). GMTK can be used for applications and research in speech and language processing, bioinformatics, activity recognition, and any time series application. GMTK has many features, including exact and approximate inference; a large variety of built-in factors including dense, sparse, and deterministic conditional probability tables, native support for ARPA backoff-based factors and factored language models, parameter sharing, gamma and beta distributions, dense and sparse Gaussian factors, heterogeneous mixtures, deep neural network factors, and time-inhomogeneous trellis factors; arbitrary order embedded Markov chains; a GUI-based graph viewer; flexible feature-file support and processing tools (supporting pfiles, HTK files, ASCII/binary, and HDF5 files); and both offline and streaming online inference methods that can be used for both parameter learning and prediction. More information is available in the documentation. All in all, GMTK offers a flexible, concise, and expressive probabilistic modeling framework with which one may rapidly specify a vast collection of temporal statistical models.
 
|The Graphical Models Toolkit (GMTK) is an open source, publicly available toolkit for rapidly prototyping statistical models using dynamic graphical models (DGMs) and dynamic Bayesian networks (DBNs). GMTK can be used for applications and research in speech and language processing, bioinformatics, activity recognition, and any time series application. GMTK has many features, including exact and approximate inference; a large variety of built-in factors including dense, sparse, and deterministic conditional probability tables, native support for ARPA backoff-based factors and factored language models, parameter sharing, gamma and beta distributions, dense and sparse Gaussian factors, heterogeneous mixtures, deep neural network factors, and time-inhomogeneous trellis factors; arbitrary order embedded Markov chains; a GUI-based graph viewer; flexible feature-file support and processing tools (supporting pfiles, HTK files, ASCII/binary, and HDF5 files); and both offline and streaming online inference methods that can be used for both parameter learning and prediction. More information is available in the documentation. All in all, GMTK offers a flexible, concise, and expressive probabilistic modeling framework with which one may rapidly specify a vast collection of temporal statistical models.
|-
 
|GObject-Introspection
 
|
 
|GObject introspection is a middleware layer between C libraries (using GObject) and language bindings. The C library can be scanned at compile time and generate a metadata file, in addition to the actual native C library. Then at runtime, language bindings can read this metadata and automatically provide bindings to call into the C library.
 
|-
 
|[https://developer.gnome.org/gtk+/stable/ GTK+]
 
|2.24.31-IGB-gcc-4.9.4-Python-2.7.13<br>2.24.31-IGB-gcc-4.9.4-Python-3.6.1
 
|The GTK+ 2 package contains libraries used for creating graphical user interfaces for applications.
 
|-
 
|[http://guidance.tau.ac.il/ver2/ GUIDANCE]
 
|2.02-IGB-gcc-4.9.4-Perl-5.24.1
 
|GUIDANCE is meant to be used for weighting, filtering or masking unreliably aligned positions in sequence alignments before subsequent analysis. For example, align codon sequences (nucleotide sequences that code for proteins) using PAGAN, remove columns with low GUIDANCE scores, and use the remaining alignment to infer positive selection using the branch-site dN/dS test. Other analyses where GUIDANCE filtering could be useful include phylogeny reconstruction, reconstruction of the history of specific insertion and deletion events, inference of recombination events, etc. - Homepage: http://guidance.tau.ac.il/ver2/
 
|-
 
|Gdk-Pixbuf
 
|
 
|The Gdk Pixbuf is a toolkit for image loading and pixel buffer manipulation. It is used by GTK+ 2 and GTK+ 3 to load and manipulate images. In the past it was distributed as part of GTK+ 2 but it was split off into a separate package in preparation for the change to GTK+ 3.
 
 
|-
 
|-
 
|[http://exon.gatech.edu/GeneMark/ GeneMark-ES]
 
|[http://exon.gatech.edu/GeneMark/ GeneMark-ES]
Line 404: Line 300:
 
|3.0.2-IGB-gcc-4.9.4-Python-2.7.13
 
|3.0.2-IGB-gcc-4.9.4-Python-2.7.13
 
|The GenomicConsensus package provides the variantCaller tool, which allows you to apply the Quiver or Arrow algorithm to mapped PacBio reads to get consensus and variant calls.
 
|The GenomicConsensus package provides the variantCaller tool, which allows you to apply the Quiver or Arrow algorithm to mapped PacBio reads to get consensus and variant calls.
|-
 
|[http://ghostscript.com GhostScript]
 
|9.21-IGB-gcc-4.9.4
 
|Ghostscript is a versatile processor for PostScript data with the ability to render PostScript to different targets. It used to be part of the cups printing stack, but is no longer used for that. - Homepage: http://ghostscript.com
 
 
|-
 
|-
 
|[https://ccb.jhu.edu/software/glimmerhmm GlimmerHMM]
 
|[https://ccb.jhu.edu/software/glimmerhmm GlimmerHMM]
Line 417: Line 309:
 
|Complete Gradle install.From mobile apps to microservices, from small startups to big enterprises,Gradle helps teams build, automate and deliver better software, faster.  
 
|Complete Gradle install.From mobile apps to microservices, from small startups to big enterprises,Gradle helps teams build, automate and deliver better software, faster.  
 
|-
 
|-
|[http://www.graphicsmagick.org/ GraphicsMagick]
+
|[http://hmmer.org/ HMMER]
|1.3.26-IGB-gcc-4.9.4
+
|2.3.2-IGB-gcc-4.9.4<br>3.1b2-IGB-gcc-4.9.4<br>3.2.1-IGB-gcc-4.9.4
|GraphicsMagick is the swiss army knife of image processing.
+
|HMMER is used for searching sequence databases for homologs of protein sequences, and for making protein sequence alignments. It implements methods using probabilistic models called profile hidden Markov models (profile HMMs).  Compared to BLAST, FASTA, and other sequence alignment and database search tools based on older scoring methodology, HMMER aims to be significantly more accurate and more able to detect remote homologs because of the strength of its underlying mathematical models. In the past, this strength came at significant computational expense, but in the new HMMER3 project, HMMER is now essentially as fast as BLAST.
 
|-
 
|-
|[https://sourceforge.net/projects/biogrinder/ Grinder]
+
|[http://homer.ucsd.edu/homer/ HOMER]
|0.5.4-IGB-gcc-4.9.4-Perl-5.24.1
 
|Grinder is a versatile open-source bioinformatic tool to create simulated omic shotgun and amplicon sequence libraries for all main sequencing platforms.
 
|-
 
|[http://www.gurobi.com/ Gurobi]
 
|7.5.2
 
|The Gurobi Optimizer was designed from the ground up to be the fastest, most powerful solver available for your LP, QP, QCP, and MIP (MILP, MIQP, and MIQCP) problems.
 
|-
 
|[https://ccb.jhu.edu/software/hisat2/index.shtml HISAT2]
 
|2.0.5-IGB-gcc-4.9.4<br>2.1.0-IGB-gcc-4.9.4
 
|HISAT2 is a fast and sensitive alignment program for mapping next-generation sequencing reads (both DNA and RNA) against the general human population (as well as against a single reference genome).
 
|-
 
|[http://hmmer.org/ HMMER]
 
|2.3.2-IGB-gcc-4.9.4<br>3.1b2-IGB-gcc-4.9.4<br>3.2.1-IGB-gcc-4.9.4
 
|HMMER is used for searching sequence databases for homologs of protein sequences, and for making protein sequence alignments. It implements methods using probabilistic models called profile hidden Markov models (profile HMMs).  Compared to BLAST, FASTA, and other sequence alignment and database search tools based on older scoring methodology, HMMER aims to be significantly more accurate and more able to detect remote homologs because of the strength of its underlying mathematical models. In the past, this strength came at significant computational expense, but in the new HMMER3 project, HMMER is now essentially as fast as BLAST.
 
|-
 
|[http://homer.ucsd.edu/homer/ HOMER]
 
 
|4.9.1-IGB-gcc-4.9.4-Perl-5.24.1
 
|4.9.1-IGB-gcc-4.9.4-Perl-5.24.1
 
|HOMER (Hypergeometric Optimization of Motif EnRichment) is a suite of tools for Motif Discovery and ChIP-Seq analysis. It is a collection of command line programs for unix-style operating systems written in mostly perl and c++. Homer was primarily written as a de novo motif discovery algorithm that is well suited for finding 8-12 bp motifs in large scale genomics data.
 
|HOMER (Hypergeometric Optimization of Motif EnRichment) is a suite of tools for Motif Discovery and ChIP-Seq analysis. It is a collection of command line programs for unix-style operating systems written in mostly perl and c++. Homer was primarily written as a de novo motif discovery algorithm that is well suited for finding 8-12 bp motifs in large scale genomics data.
Line 444: Line 320:
 
|0.9.0-IGB-gcc-4.9.4-Python-2.7.13<br>0.9.1-IGB-gcc-4.9.4-Python-2.7.13
 
|0.9.0-IGB-gcc-4.9.4-Python-2.7.13<br>0.9.1-IGB-gcc-4.9.4-Python-2.7.13
 
|A framework to process and analyze data from high-throughput sequencing (HTS) assays
 
|A framework to process and analyze data from high-throughput sequencing (HTS) assays
|-
 
|[http://huttenhower.sph.harvard.edu/humann2 HUMAnN2]
 
|0.11.1-IGB-gcc-4.9.4-Python-3.6.1<br>0.11.2-IGB-gcc-4.9.4-Python-3.6.1
 
|HUMAnN is a pipeline for efficiently and accurately profiling the presence/absence and abundance of microbial pathways in a community from metagenomic or metatranscriptomic sequencing data (typically millions of short DNA/RNA reads).
 
 
|-
 
|-
 
|HarfBuzz
 
|HarfBuzz
Line 456: Line 328:
 
|2.9.0-IGB-gcc-4.9.4-Python-2.7.13
 
|2.9.0-IGB-gcc-4.9.4-Python-2.7.13
 
|HiC-Pro was designed to process Hi-C data, from raw fastq files (paired-end Illumina data) to the normalized contact maps. Since version 2.7.0, HiC-Pro supports the main Hi-C protocols, including digestion protocols as well as protocols that do not require restriction enzyme such as DNase Hi-C.
 
|HiC-Pro was designed to process Hi-C data, from raw fastq files (paired-end Illumina data) to the normalized contact maps. Since version 2.7.0, HiC-Pro supports the main Hi-C protocols, including digestion protocols as well as protocols that do not require restriction enzyme such as DNase Hi-C.
|-
 
|[https://github.com/kundajelab/idr IDR]
 
|2.0.4-IGB-gcc-4.9.4-Python-3.6.1
 
|The IDR (Irreproducible Discovery Rate) framework is a unified approach to measure the reproducibility of findings identified from replicate experiments and provide highly stable thresholds based on reproducibility. Unlike the usual scalar measures of reproducibility, the IDR approach creates a curve, which quantitatively assesses when the findings are no longer consistent across replicates. In laymans terms, the IDR method compares a pair of ranked lists of identifications (such as ChIP-seq peaks).
 
 
|-
 
|-
 
|IGB-gcc
 
|IGB-gcc
Line 473: Line 341:
 
|IPython provides a rich architecture for interactive computing with: Powerful interactive shells (terminal and Qt-based). A browser-based notebook with support for code, text, mathematical expressions, inline plots and other rich media. Support for interactive data visualization and use of GUI toolkits. Flexible, embeddable interpreters to load into your own projects. Easy to use, high performance tools for parallel computing.
 
|IPython provides a rich architecture for interactive computing with: Powerful interactive shells (terminal and Qt-based). A browser-based notebook with support for code, text, mathematical expressions, inline plots and other rich media. Support for interactive data visualization and use of GUI toolkits. Flexible, embeddable interpreters to load into your own projects. Easy to use, high performance tools for parallel computing.
 
|-
 
|-
|[https://microbiology.se/software/itsx/ ITSx]
+
|[http://www.ece.uvic.ca/~frodo/jasper/ JasPer]
|1.1.1-IGB-gcc-4.9.4
+
|1.900.1-IGB-gcc-4.9.4<br>2.0.10-IGB-gcc-4.9.4
|TSx: Improved software detection and extraction of ITS1 and ITS2 from ribosomal ITS sequences of fungi and other eukaryotes for use in environmental sequencing
+
|The JasPer Project is an open-source initiative to provide a free software-based reference implementation of the codec specified in the JPEG-2000 Part-1 standard. - Homepage: http://www.ece.uvic.ca/~frodo/jasper/
 
|-
 
|-
|[https://databank.illinois.edu/ IllinoisDataBank]
+
|[https://github.com/TGAC/KAT KAT]
|1.0-IGB-gcc-4.9.4-Python-3.6.1
 
|The Illinois Data Bank is a public access repository for publishing research data from the University of Illinois at Urbana-Champaign
 
|-
 
|[http://www.imagemagick.org/ ImageMagick]
 
|7.0.5-5-IGB-gcc-4.9.4
 
|ImageMagick is a software suite to create, edit, compose, or convert bitmap images - Homepage: http://www.imagemagick.org/
 
|-
 
|[http://eddylab.org/infernal/ Infernal]
 
|1.1.2-IGB-gcc-4.9.4
 
|Infernal,INFERence of RNA ALignment, is for searching DNA sequence databases for RNA structure and sequence similarities.
 
|-
 
|[https://www.ebi.ac.uk/interpro/interproscan.html InterProScan]
 
|5.27-66.0-IGB-gcc-4.9.4-Java-1.8.0_152<br>5.28-67.0-IGB-gcc-4.9.4-Java-1.8.0_152<br>5.33-72.0-IGB-gcc-4.9.4-Java-1.8.0_152<br>5.33-72.0-IGB-gcc-4.9.4-Java-1.8.0_201
 
|InterProScan is the software package that allows sequences (protein and nucleic) to be scanned against InterPros signatures. Signatures are predictive models, provided by several different databases, that make up the InterPro consortium.
 
|-
 
|[http://www.ece.uvic.ca/~frodo/jasper/ JasPer]
 
|1.900.1-IGB-gcc-4.9.4<br>2.0.10-IGB-gcc-4.9.4
 
|The JasPer Project is an open-source initiative to provide a free software-based reference implementation of the codec specified in the JPEG-2000 Part-1 standard. - Homepage: http://www.ece.uvic.ca/~frodo/jasper/
 
|-
 
|[http://www.genome.umd.edu/jellyfish.html Jellyfish]
 
|1.1.12-IGB-gcc-4.9.4<br>2.2.10-IGB-gcc-8.2.0<br>2.2.6-IGB-gcc-4.9.4
 
|Jellyfish is a tool for fast, memory-efficient counting of k-mers in DNA.
 
|-
 
|[https://github.com/TGAC/KAT KAT]
 
 
|2.4.1-IGB-gcc-4.9.4
 
|2.4.1-IGB-gcc-4.9.4
 
|KAT is a suite of tools that analyse jellyfish hashes or sequence files (fasta or fastq) using kmer counts.  
 
|KAT is a suite of tools that analyse jellyfish hashes or sequence files (fasta or fastq) using kmer counts.  
Line 508: Line 352:
 
|0.6.1-IGB-gcc-4.9.4-Python-3.6.1
 
|0.6.1-IGB-gcc-4.9.4-Python-3.6.1
 
|KneadData is a tool designed to perform quality control on metagenomic sequencing data, especially data from microbiome experiments. In these experiments, samples are typically taken from a host in hopes of learning something about the microbial community on the host. However, metagenomic sequencing data from such experiments will often contain a high ratio of host to bacterial reads. This tool aims to perform principled in silico separation of bacterial reads from these contaminant reads, be they from the host, from bacterial 16S sequences, or other user-defined sources.
 
|KneadData is a tool designed to perform quality control on metagenomic sequencing data, especially data from microbiome experiments. In these experiments, samples are typically taken from a host in hopes of learning something about the microbial community on the host. However, metagenomic sequencing data from such experiments will often contain a high ratio of host to bacterial reads. This tool aims to perform principled in silico separation of bacterial reads from these contaminant reads, be they from the host, from bacterial 16S sequences, or other user-defined sources.
|-
 
|[https://ccb.jhu.edu/software/kraken/ Kraken]
 
|1.0-IGB-gcc-4.9.4
 
|Kraken is a system for assigning taxonomic labels to short DNA sequences, usually obtained through metagenomic studies. Previous attempts by other bioinformatics software to accomplish this task have often used sequence alignment or machine learning techniques that were quite slow, leading to the development of less sensitive but much faster abundance estimation programs.
 
|-
 
|[https://github.com/marbl/Krona Krona]
 
|2.7-IGB-gcc-4.9.4-Perl-5.24.1
 
|Interactively explore metagenomes and more from a web browser.
 
 
|-
 
|-
 
|[http://lame.sourceforge.net/ LAME]
 
|[http://lame.sourceforge.net/ LAME]
 
|3.99.5-IGB-gcc-4.9.4
 
|3.99.5-IGB-gcc-4.9.4
 
|LAME is a high quality MPEG Audio Layer III (MP3) encoder licensed under the LGPL.
 
|LAME is a high quality MPEG Audio Layer III (MP3) encoder licensed under the LGPL.
|-
 
|[http://www.bx.psu.edu/~rsharris/lastz/ LASTZ]
 
|1.04.00-IGB-gcc-4.9.4
 
|LASTZ is a program for aligning DNA sequences, a pairwise aligner. Originally designed to handle sequences the size of human chromosomes and from different species, it is also useful for sequences produced by NGS  sequencing technologies such as Roche 454. - Homepage: http://www.bx.psu.edu/~rsharris/lastz/
 
 
|-
 
|-
 
|[https://bitbucket.org/nsegata/lefse LEfSe]
 
|[https://bitbucket.org/nsegata/lefse LEfSe]
 
|20180219-IGB-gcc-4.9.4-Python-2.7.13
 
|20180219-IGB-gcc-4.9.4-Python-2.7.13
 
|LEfSe
 
|LEfSe
|-
 
|[http://www.bcgsc.ca/platform/bioinfo/software/links LINKS]
 
|1.8.5-IGB-gcc-4.9.4-Perl-5.24.1
 
|LINKS is a scalable genomics application for scaffolding or re-scaffolding genome assembly drafts with long reads, such as those produced by Oxford Nanopore Technologies Ltd and Pacific Biosciences. It provides a generic alignment-free framework for scaffolding and can work on any sequences. It is versatile and supports not only long sequences as a source of long-range information, but also MPET pairs and linked-reads, such as those from the 10X Genomics GemCode and Chromium platform, via ARCS (http://www.bcgsc.ca/platform/bioinfo/software/arcs). Fill gaps in LINKS-derived scaffolds using Sealer (http://www.bcgsc.ca/platform/bioinfo/software/sealer).
 
|-
 
|[http://llvm.org/ LLVM]
 
|4.0.1-IGB-gcc-4.9.4<br>6.0.0-IGB-gcc-4.9.4
 
|The LLVM Core libraries provide a modern source- and target-independent optimizer, along with code generation support for many popular CPUs (as well as some less common ones!) These libraries are built around a well specified code representation known as the LLVM intermediate representation ("LLVM IR"). The LLVM Core libraries are well documented, and it is particularly easy to invent your own language (or port an existing compiler) to use LLVM as an optimizer and code generator.
 
|-
 
|[https://symas.com/lmdb LMDB]
 
|0.9.22-IGB-gcc-4.9.4
 
|LMDB is a fast, memory-efficient database. With memory-mapped files, it has the read performance of a pure in-memory database while retaining the persistence of standard disk-based databases.
 
|-
 
|[http://lasagne.readthedocs.io/en/latest/index.html Lasagne]
 
|20170606-IGB-gcc-4.9.4-Python-2.7.13
 
|Lasagne is a lightweight library to build and train neural networks in Theano. - Homepage: http://lasagne.readthedocs.io/en/latest/index.html
 
 
|-
 
|-
 
|LibTIFF
 
|LibTIFF
 
|
 
|
 
|tiff: Library and tools for reading and writing TIFF data files
 
|tiff: Library and tools for reading and writing TIFF data files
|-
 
|[http://sourceforge.net/projects/libuuid/ LibUUID]
 
|1.0.3-IGB-gcc-4.9.4
 
|Portable uuid C library
 
|-
 
|[http://www.littlecms.com/ LittleCMS]
 
|2.8-IGB-gcc-4.9.4
 
|Little CMS intends to be an OPEN SOURCE small-footprint color management engine, with special focus on accuracy and performance.  - Homepage: http://www.littlecms.com/
 
 
|-
 
|-
 
|[http://www.lua.org/ Lua]
 
|[http://www.lua.org/ Lua]
Line 564: Line 372:
 
|1.4.2-1-IGB-gcc-4.9.4-Python-2.7.13
 
|1.4.2-1-IGB-gcc-4.9.4-Python-2.7.13
 
|Model-based Analysis of ChIP-Seq (MACS) on short reads sequencers  such as Genome Analyzer (Illumina / Solexa). MACS empirically models the length of  the sequenced ChIP fragments, which tends to be shorter than sonication or library  construction size estimates, and uses it to improve the spatial resolution of predicted  binding sites. MACS also uses a dynamic Poisson distribution to effectively capture  local biases in the genome sequence, allowing for more sensitive and robust prediction.
 
|Model-based Analysis of ChIP-Seq (MACS) on short reads sequencers  such as Genome Analyzer (Illumina / Solexa). MACS empirically models the length of  the sequenced ChIP fragments, which tends to be shorter than sonication or library  construction size estimates, and uses it to improve the spatial resolution of predicted  binding sites. MACS also uses a dynamic Poisson distribution to effectively capture  local biases in the genome sequence, allowing for more sensitive and robust prediction.
|-
 
|[http://mafft.cbrc.jp/alignment/software/ MAFFT]
 
|7.310-IGB-gcc-4.9.4
 
|MAFFT is a multiple sequence alignment program  for unix-like operating systems.  It offers a range of multiple alignment methods, L-INS-i (accurate; for alignment of <∼200 sequences),  FFT-NS-2 (fast; for alignment of <∼10,000 sequences), etc. - Homepage: http://mafft.cbrc.jp/alignment/software/
 
 
|-
 
|-
 
|[http://www.yandell-lab.org/software/maker.html MAKER]
 
|[http://www.yandell-lab.org/software/maker.html MAKER]
Line 576: Line 380:
 
|0.4.26-IGB-gcc-4.9.4
 
|0.4.26-IGB-gcc-4.9.4
 
|MAPGD is a series of related programs that estimate allele frequency, heterozygosity, Hardy-Weinberg disequilibrium, linkage disequilibrium and identity-by-descent (IBD) coefficients from population genomic data using a statistically rigorous maximum likelihood approach.
 
|MAPGD is a series of related programs that estimate allele frequency, heterozygosity, Hardy-Weinberg disequilibrium, linkage disequilibrium and identity-by-descent (IBD) coefficients from population genomic data using a statistically rigorous maximum likelihood approach.
|-
 
|[http://www.mathworks.com/products/matlab MATLAB]
 
|2017a<br>2017b
 
|MATLAB is a high-level language and interactive environment that enables you to perform computationally intensive tasks faster than with traditional programming languages such as C, C++, and Fortran.
 
 
|-
 
|-
 
|[https://www.mathworks.com/help/matlab/matlab-engine-for-python.html MATLAB-python]
 
|[https://www.mathworks.com/help/matlab/matlab-engine-for-python.html MATLAB-python]
 
|2017b-IGB-gcc-4.9.4-Python-3.6.1
 
|2017b-IGB-gcc-4.9.4-Python-3.6.1
 
|The MATLAB Engine API for Python provides a package for Python to call MATLAB as a computational engine. The engine supports the reference implementation (CPython) for Python versions 2.7, 3.5, and 3.6.
 
|The MATLAB Engine API for Python provides a package for Python to call MATLAB as a computational engine. The engine supports the reference implementation (CPython) for Python versions 2.7, 3.5, and 3.6.
|-
 
|[http://micans.org/mcl/ MCL]
 
|14.137-IGB-gcc-4.9.4
 
|The MCL algorithm is short for the Markov Cluster Algorithm, a fastand scalable unsupervised cluster algorithm for graphs (also known as networks) basedon simulation of (stochastic) flow in graphs.  - Homepage: http://micans.org/mcl/
 
 
|-
 
|-
 
|[https://github.com/voutcn/megahit MEGAHIT]
 
|[https://github.com/voutcn/megahit MEGAHIT]
 
|1.1.1-IGB-gcc-4.9.4
 
|1.1.1-IGB-gcc-4.9.4
 
|MEGAHIT is a single node assembler for large and complex metagenomics NGS reads, such as soil. It makes use of succinct de Bruijn graph (SdBG) to achieve low memory assembly. - Homepage: https://github.com/voutcn/megahit
 
|MEGAHIT is a single node assembler for large and complex metagenomics NGS reads, such as soil. It makes use of succinct de Bruijn graph (SdBG) to achieve low memory assembly. - Homepage: https://github.com/voutcn/megahit
|-
 
|[http://ab.inf.uni-tuebingen.de/software/megan6/ MEGAN]
 
|6.12.2-Java-1.8.0_152
 
|MEGAN6 is a comprehensive toolbox for interactively analyzing microbiome data. All the interactive tools you need in one application.
 
 
|-
 
|-
 
|[http://www.mpich.org/ MPICH]
 
|[http://www.mpich.org/ MPICH]
Line 616: Line 408:
 
|1.0.6-IGB-gcc-4.9.4-Python-3.6.1
 
|1.0.6-IGB-gcc-4.9.4-Python-3.6.1
 
|A super-fast templating language that borrows the best ideas from the existing templating languages
 
|A super-fast templating language that borrows the best ideas from the existing templating languages
|-
 
|[http://www.netlab.uky.edu/p/bioinfo/MapSplice2 MapSplice]
 
|2.2.1-IGB-gcc-4.9.4-Python-2.7.13
 
|MapSplice is a software for mapping RNA-seq data to reference genome for splice junction discovery that depends only on reference genome, and not on any further annotations.
 
|-
 
|[https://mariadb.org/ MariaDB]
 
|10.1.31-IGB-gcc-4.9.4<br>10.1.31-IGB-gcc-8.2.0<br>5.5.58-IGB-gcc-4.9.4
 
|MariaDB An enhanced, drop-in replacement for MySQL.
 
 
|-
 
|-
 
|[https://github.com/matterport/Mask_RCNN MaskRCNN]
 
|[https://github.com/matterport/Mask_RCNN MaskRCNN]
 
|20190227-IGB-gcc-4.9.4-Python-3.6.1
 
|20190227-IGB-gcc-4.9.4-Python-3.6.1
 
|This is an implementation of Mask R-CNN on Python 3, Keras, and TensorFlow. The model generates bounding boxes and segmentation masks for each instance of an object in the image.  
 
|This is an implementation of Mask R-CNN on Python 3, Keras, and TensorFlow. The model generates bounding boxes and segmentation masks for each instance of an object in the image.  
|-
 
|[https://sourceforge.net/projects/meraculous20/ Meraculous-2d]
 
|2.2.6-IGB-gcc-4.9.4
 
|Meraculous-2D is a whole genome assembler for NGS reads (Illumina) that is capable of assembling large, diploid genomes with modest computational requirements.
 
|-
 
|[https://bitbucket.org/berkeleylab/metabat MetaBAT]
 
|2.12.1
 
|MetaBAT, an efficient tool for accurately reconstructing single genomes from complex microbial communities
 
|-
 
|[http://metagene.nig.ac.jp/ MetaGeneAnnotator]
 
|20080819-x86-64
 
|MetaGeneAnnotator is a gene-finding program for prokaryote and phage.
 
 
|-
 
|-
 
|[https://metavelvet.dna.bio.keio.ac.jp/ MetaVelvet]
 
|[https://metavelvet.dna.bio.keio.ac.jp/ MetaVelvet]
Line 652: Line 424:
 
|1.38.1.1<br>1.39.5<br>1.39.5-IGB-gcc-4.9.4
 
|1.38.1.1<br>1.39.5<br>1.39.5-IGB-gcc-4.9.4
 
|Mothur is a single piece of open-source, expandable software to fill the bioinformatics needs of the microbial ecology community.
 
|Mothur is a single piece of open-source, expandable software to fill the bioinformatics needs of the microbial ecology community.
|-
 
|[http://www.nasm.us/ NASM]
 
|2.12.02-IGB-gcc-4.9.4
 
|NASM: General-purpose x86 assembler
 
|-
 
|[http://nco.sourceforge.net NCO]
 
|4.7.2-IGB-gcc-4.9.4
 
|manipulates and analyzes data stored in netCDF-accessible formats, including DAP, HDF4, and HDF5
 
|-
 
|[https://github.com/ncbi/ngs NGS]
 
|1.3.0-IGB-gcc-4.9.4
 
|NGS is a new, domain-specific API for accessing reads, alignments and pileups produced from Next Generation Sequencing. - Homepage: https://github.com/ncbi/ngs
 
|-
 
|[http://www.nwchem-sw.org NWChem]
 
|6.6.revision27746-IGB-gcc-4.9.4-Python-2.7.13
 
|NWChem aims to provide its users with computational chemistry tools that are scalable both in their ability to treat large scientific computational chemistry problems efficiently, and in their use of available parallel computing resources from high-performance parallel supercomputers to conventional workstation clusters. NWChem software can handle: biomolecules, nanostructures, and solid-state; from quantum to classical, and all combinations; Gaussian basis functions or plane-waves; scaling from one to thousands of processors; properties and relativity.
 
|-
 
|[https://github.com/wdecoster/NanoPlot NanoPlot]
 
|1.18.2-IGB-gcc-4.9.4-Python-3.6.1
 
|Plotting tool for long read sequencing data and alignments.
 
|-
 
|[https://ccl.northwestern.edu/netlogo/ NetLogo]
 
|5.2.1<br>6.0.3
 
|NetLogo is a multi-agent programmable modeling environment. It is used by many tens of thousands of students, teachers and researchers worldwide.
 
|-
 
|[http://nucleoatac.readthedocs.io/en/latest/ NucleoATAC]
 
|0.3.4-IGB-gcc-4.9.4-Python-2.7.13
 
|NucleoATAC is a python package for calling nucleosome positions and occupancy using ATAC-Seq data. Functions for calling nucleosomes are included in the nucleoatac command-line function. NucleoATAC also includes other utlities for working with ATAC-seq data under the pyatac function.
 
|-
 
|[http://ocaml.org/ OCaml]
 
|4.05.0-IGB-gcc-4.9.4
 
|OCaml is a general purpose industrial-strength programming language with an emphasis on expressiveness and safety. Developed for more than 20 years at Inria it benefits from one of the most advanced type systems and supports functional, imperative and object-oriented styles of programming.
 
 
|-
 
|-
 
|[https://github.com/brianbeliveau/OligoMiner OligoMiner]
 
|[https://github.com/brianbeliveau/OligoMiner OligoMiner]
Line 696: Line 436:
 
|2.1.0-GCC-4.9.4-2.28<br>4.0.0-GCC-8.2.0-2.32
 
|2.1.0-GCC-4.9.4-2.28<br>4.0.0-GCC-8.2.0-2.32
 
|The Open MPI Project is an open source MPI-3 implementation.
 
|The Open MPI Project is an open source MPI-3 implementation.
|-
 
|OpenPGM
 
|
 
|OpenPGM is an open source implementation of the Pragmatic General Multicast (PGM) specification in RFC 3208 available at www.ietf.org. PGM is a reliable and scalable multicast protocol that enables receivers to detect loss, request retransmission of lost data, or notify an application of unrecoverable loss. PGM is a receiver-reliable protocol, which means the receiver is responsible for ensuring all data is received, absolving the sender of reception responsibility.
 
|-
 
|[http://orthomcl.org/ OrthoMCL]
 
|2.0.9-IGB-gcc-4.9.4-Perl-5.24.1
 
|OrthoMCL is a genome-scale algorithm for grouping orthologous protein sequences. - Homepage: http://orthomcl.org/
 
|-
 
|[http://wasabiapp.org/software/pagan PAGAN]
 
|20150723-IGB-gcc-4.9.4
 
|PAGAN is a general-purpose method for the alignment of sequence graphs. PAGAN is based on the phylogeny-aware progressive alignment algorithm and uses graphs to describe the uncertainty in the presence of characters at certain sequence positions. However, graphs also allow describing the uncertainty in input sequences and modelling e.g. homopolymer errors in Roche 454 reads, or representing inferred ancestral sequences against which other sequences can then be aligned. PAGAN is still under development and will hopefully evolve to an easy-to-use, general-purpose method for phylogenetic sequence alignment.
 
 
|-
 
|-
 
|[http://abacus.gene.ucl.ac.uk/software/paml.html PAML]
 
|[http://abacus.gene.ucl.ac.uk/software/paml.html PAML]
Line 720: Line 448:
 
|
 
|
 
|The PCRE library is a set of functions that implement regular expression pattern matching using the same syntax and semantics as Perl 5.
 
|The PCRE library is a set of functions that implement regular expression pattern matching using the same syntax and semantics as Perl 5.
|-
 
|[http://sco.h-its.org/exelixis/web/software/pear/ PEAR]
 
|0.9.8-IGB-gcc-4.9.4
 
|PEAR is an ultrafast, memory-efficient and highly accurate pair-end read merger.  It is fully parallelized and can run with as low as just a few kilobytes of memory. - Homepage: http://sco.h-its.org/exelixis/web/software/pear/
 
|-
 
|[http://picrust.github.io/picrust/ PICRUSt]
 
|1.1.1-IGB-gcc-4.9.4-Python-2.7.13<br>1.1.3-IGB-gcc-4.9.4-Python-2.7.13
 
|PICRUSt (pronounced pie crust) is a bioinformatics software package designed to predict metagenome functional content from marker gene (e.g., 16S rRNA) surveys and full genomes.
 
|-
 
|[https://genie.weizmann.ac.il/pubs/mir07/mir07_exe.html PITA]
 
|6-IGB-gcc-4.9.4
 
|The PITA executable allows you to identify and score microRNA targets on UTRs.
 
|-
 
|[http://wasabiapp.org/software/prank/ PRANK]
 
|170427-IGB-gcc-4.9.4
 
|PRANK is a probabilistic multiple alignment program for DNA, codon and amino-acid sequences. It’s based on a novel algorithm that treats insertions correctly and avoids over-estimation of the number of deletion events. In addition, PRANK borrows ideas from maximum likelihood methods used in phylogenetics and correctly takes into account the evolutionary distances between sequences. Lastly, PRANK allows for defining a potential structure for sequences to be aligned and then, simultaneously with the alignment, predicts the locations of structural units in the sequences.
 
 
|-
 
|-
 
|PROJ
 
|PROJ
Line 745: Line 457:
 
|Pango is a library for laying out and rendering of text, with an emphasis on internationalization.Pango can be used anywhere that text layout is needed, though most of the work on Pango so far has been done in thecontext of the GTK+ widget toolkit. Pango forms the core of text and font handling for GTK+-2.x. - Homepage: http://www.pango.org/
 
|Pango is a library for laying out and rendering of text, with an emphasis on internationalization.Pango can be used anywhere that text layout is needed, though most of the work on Pango so far has been done in thecontext of the GTK+ widget toolkit. Pango forms the core of text and font handling for GTK+-2.x. - Homepage: http://www.pango.org/
 
|-
 
|-
|[https://github.com/shawnzhangyx/PePr PePr]
+
|Phantompeaktools-spp
|1.1.21-IGB-gcc-4.9.4-Python-2.7.13
+
|
|PePr is a ChIP-Seq Peak-calling and Prioritization pipeline that uses a sliding window approach and models read counts across replicates and between groups with a negative binomial distribution.
 
|-
 
|[https://github.com/kundajelab/phantompeakqualtools Phantompeaktools]
 
|1.2-IGB-gcc-4.9.4-R-3.4.1
 
|Custom SPP for Phantompeaktools
 
|-
 
|Phantompeaktools-spp
 
|
 
 
|Custom SPP for Phantompeaktools
 
|Custom SPP for Phantompeaktools
 
|-
 
|-
Line 768: Line 472:
 
|5.1.0-IGB-gcc-4.9.4-Python-2.7.13<br>5.1.0-IGB-gcc-4.9.4-Python-3.6.1
 
|5.1.0-IGB-gcc-4.9.4-Python-2.7.13<br>5.1.0-IGB-gcc-4.9.4-Python-3.6.1
 
|Pillow is the friendly PIL fork by Alex Clark and Contributors. PIL is the Python Imaging Library by Fredrik Lundh and Contributors.
 
|Pillow is the friendly PIL fork by Alex Clark and Contributors. PIL is the Python Imaging Library by Fredrik Lundh and Contributors.
|-
 
|[https://github.com/rrwick/Porechop Porechop]
 
|0.2.3-IGB-gcc-4.9.4-Python-3.6.1
 
|Porechop is a tool for finding and removing adapters from Oxford Nanopore reads.
 
|-
 
|[https://github.com/hyattpd/prodigal Prodigal]
 
|2.6.3
 
|Fast, reliable protein-coding gene prediction for prokaryotic genomes.
 
|-
 
|[https://github.com/uoregon-postlethwait/prost Prost]
 
|0.7.45-IGB-gcc-4.9.4-Python-2.7.13
 
|Prost (PRocessing Of Small Transcripts) is a python application that quantifies and annotates microRNA (miRNA) expression in metazoans with assembled genomes. Prost works by counting short transcripts within a user-specifiable length range. These counted transcripts are aligned to a user specifiable genome allowing for post-transcriptional modification (e.g. untemplated additions, editing, alternative cutting) and then "binned" together based on genomic location. Each bin is then annotated with databases of mature miRNAs, hairpins, and other types of RNAs (the databases may be derived from miRBase, Ensembls BioMart, other databases, or may be custom built by the user).
 
 
|-
 
|-
 
|[https://mathema.tician.de/software/pycuda/ PyCUDA]
 
|[https://mathema.tician.de/software/pycuda/ PyCUDA]
 
|2017.1-IGB-gcc-4.9.4-Python-2.7.13
 
|2017.1-IGB-gcc-4.9.4-Python-2.7.13
 
|PyCUDA lets you access Nvidia‘s CUDA parallel computation API from Python. - Homepage: https://mathema.tician.de/software/pycuda/
 
|PyCUDA lets you access Nvidia‘s CUDA parallel computation API from Python. - Homepage: https://mathema.tician.de/software/pycuda/
|-
 
|[http://pytorch.org PyTorch]
 
|0.3.0-IGB-gcc-4.9.4-Python-3.6.1<br>0.4.0-IGB-gcc-4.9.4-Python-3.6.1<br>0.4.1-IGB-gcc-4.9.4-Python-2.7.13<br>1.0.1.post2-IGB-gcc-4.9.4-Python-3.6.1
 
|Tensors and Dynamic neural networks in Pythonwith strong GPU acceleration.
 
 
|-
 
|-
 
|[http://www.zeromq.org/bindings:python PyZMQ]
 
|[http://www.zeromq.org/bindings:python PyZMQ]
 
|16.0.2-IGB-gcc-4.9.4-Python-3.6.1
 
|16.0.2-IGB-gcc-4.9.4-Python-3.6.1
 
|Python bindings for ZeroMQ
 
|Python bindings for ZeroMQ
|-
 
|[http://qiime.org/ QIIME]
 
|1.9.1
 
|QIIME is an open-source bioinformatics pipeline for performing microbiome analysis from raw DNA sequencing data.
 
|-
 
|[http://qt.io/ Qt]
 
|4.8.7-IGB-gcc-4.9.4
 
|Qt is a comprehensive cross-platform C++ application framework.
 
 
|-
 
|-
 
|[https://github.com/stamatak/standard-RAxML RAxML]
 
|[https://github.com/stamatak/standard-RAxML RAxML]
Line 812: Line 492:
 
|1.0.18-IGB-gcc-4.9.4
 
|1.0.18-IGB-gcc-4.9.4
 
|REAPR is a tool that evaluates the accuracy of a genome assembly using mapped paired end reads, without the use of a reference genome for comparison. It can be used in any stage of an assembly pipeline to automatically break incorrect scaffolds and flag other errors in an assembly for manual inspection. It reports mis-assemblies and other warnings, and produces a new broken assembly based on the error calls. - Homepage: http://www.sanger.ac.uk/science/tools/reapr
 
|REAPR is a tool that evaluates the accuracy of a genome assembly using mapped paired end reads, without the use of a reference genome for comparison. It can be used in any stage of an assembly pipeline to automatically break incorrect scaffolds and flag other errors in an assembly for manual inspection. It reports mis-assemblies and other warnings, and produces a new broken assembly based on the error calls. - Homepage: http://www.sanger.ac.uk/science/tools/reapr
|-
 
|[http://eddylab.org/software/recon/ RECON]
 
|1.08-IGB-gcc-4.9.4-Perl-5.24.1
 
|a package for automated de novo identification of repeat families from genomic sequences
 
 
|-
 
|-
 
|[https://github.com/slowkoni/rfmix RFMix]
 
|[https://github.com/slowkoni/rfmix RFMix]
Line 828: Line 504:
 
|2.6.0-IGB-gcc-4.9.4
 
|2.6.0-IGB-gcc-4.9.4
 
|RMBlast is a RepeatMasker compatible version of the standard NCBI blastn program. The primary difference between this distribution and the NCBI distribution is the addition of a new program "rmblastn" for use with RepeatMasker and RepeatModeler.
 
|RMBlast is a RepeatMasker compatible version of the standard NCBI blastn program. The primary difference between this distribution and the NCBI distribution is the addition of a new program "rmblastn" for use with RepeatMasker and RepeatModeler.
|-
 
|[https://bibiserv2.cebitec.uni-bielefeld.de/rnahybrid RNAhybrid]
 
|2.1.2-IGB-gcc-4.9.4
 
|RNAhybrid is a tool for finding the minimum free energy hybridization of a long and a short RNA. The hybridization is performed in a kind of domain mode, ie. the short sequence is hybridized to the best fitting part of the long one. The tool is primarily meant as a means for microRNA target prediction.
 
 
|-
 
|-
 
|[http://www.cbs.dtu.dk/cgi-bin/sw_request?rnammer RNAmmer]
 
|[http://www.cbs.dtu.dk/cgi-bin/sw_request?rnammer RNAmmer]
Line 837: Line 509:
 
|Ribosomal RNA sub units
 
|Ribosomal RNA sub units
 
|-
 
|-
|[http://rna.urmc.rochester.edu/RNAstructure.html RNAstructure]
+
|cairo
|6.0-IGB-gcc-4.9.4
+
|
|RNAstructure is a complete package for RNA and DNA secondary structure prediction and analysis. It includes algorithms for secondary structure prediction, including facility to predict base pairing probabilities.
+
|Cairo is a 2D graphics library with support for multiple output devices. Currently supported output targets include the X Window System (via both Xlib and XCB), Quartz, Win32, image buffers, PostScript, PDF, and SVG file output. Experimental backends include OpenGL, BeOS, OS/2, and DirectFB
 
|-
 
|-
|[http://younglab.wi.mit.edu/super_enhancer_code.html ROSE]
+
|[http://bioinform.github.io/breakseq2/ BreakSeq2]
|20150210-IGB-gcc-4.9.4-Python-2.7.13
+
|2.2-IGB-gcc-4.9.4-Python-2.7.13
|To create stitched enhancers, and to separate super-enhancers from typical enhancers using sequencing data (.bam)
+
|Ultrafast and accurate nucleotide-resolution analysis of structural variants - Homepage: http://bioinform.github.io/breakseq2/
 
|-
 
|-
|[http://download.rsat.eu/ RSAT]
+
|[https://github.com/abyzovlab/CNVnator CNVnator]
|2018-08-04-IGB-gcc-4.9.4
+
|0.3.3-IGB-gcc-4.9.4
|We offer tools to analyse cis-regulatory elements in genome sequences, motif discovery (support genome-wide data sets like ChIP-seq), transcription factor binding motif analysis (quality assessment, comparisons and clustering), comparative genomics, analysis of regulatory variations
+
|a tool for CNV discovery and genotyping from depth-of-coverage by mapped reads
 
|-
 
|-
|[http://deweylab.github.io/RSEM/ RSEM]
+
|[http://ecogenomics.github.io/CheckM CheckM]
|1.3.0-IGB-gcc-4.9.4<br>1.3.1-IGB-gcc-4.9.4
+
|1.0.7-IGB-gcc-4.9.4-Python-2.7.13
|RNA-Seq by Expectation-Maximization
+
|CheckM provides a set of tools for assessing the quality of genomes recovered from isolates, single cells, or metagenomes.
 
|-
 
|-
|[http://rseqc.sourceforge.net/ RSeQC]
+
|[http://www.circos.ca/ Circos]
|2.6.4-IGB-gcc-4.9.4-Python-2.7.13
+
|0.69-4-IGB-gcc-4.9.4-Perl-5.24.1
|RSeQC package provides a number of useful modules that can comprehensively evaluate high throughput sequence data especially RNA-seq data. Some basic modules quickly inspect sequence quality, nucleotide composition bias, PCR bias and GC bias, while RNA-seq specific modules evaluate sequencing saturation, mapped reads distribution, coverage uniformity, strand specificity, transcript level RNA integrity etc.
+
|Circos is a software package for visualizing data and information. It visualizes data in a circular layout - this makes Circos ideal for exploring relationships between objects or positions. - Homepage: http://www.circos.ca/
 
|-
 
|-
|[http://fenderglass.github.io/Ragout/ Ragout]
+
|[http://www.clustal.org/omega/ Clustal-Omega]
|2.0-IGB-gcc-4.9.4
+
|1.2.4-IGB-gcc-4.9.4
|Ragout (Reference-Assisted Genome Ordering UTility) is a tool for chromosome assembly using multiple references.  
+
|Clustal Omega is a multiple sequence alignment program for proteins. It produces biologically meaningful multiple sequence alignments of divergent sequences. Evolutionary relationships can be seen via viewing Cladograms or Phylograms  - Homepage: http://www.clustal.org/omega/
 
|-
 
|-
|[https://cran.r-project.org/web/packages/RcppGSL/index.html RcppGSL]
+
|[http://www.ebi.ac.uk/Tools/msa/clustalw2/ ClustalW2]
|0.3.2-IGB-gcc-4.9.4-R-3.3.3
+
|2.1-IGB-gcc-4.9.4
|Rcpp integration for GNU GSL vectors and matrices The GNU Scientific Library (or GSL) is a collection of numerical routines for scientific computing. It is particularly useful for C and C++ programs as it provides a standard C interface to a wide range of mathematical routines. There are over 1000 functions in total with an extensive test suite. The RcppGSL package provides an easy-to-use interface between GSL data structures and R using concepts from Rcpp which is itself a package that eases the interfaces between R and C++. This package also serves as a prime example of how to build a package that uses Rcpp to connect to another third-party library. The autoconf script, inline plugin and example package can all be used as a stanza to write a similar package against another library.
+
|ClustalW2 is a general purpose multiple sequence alignment program for DNA or proteins. - Homepage: http://www.ebi.ac.uk/Tools/msa/clustalw2/
 
|-
 
|-
|[http://www.repeatmasker.org/ RepeatMasker]
+
|[http://www.broadinstitute.org/software/discovar/blog/ DISCOVARdenovo]
|4.0.7-IGB-gcc-4.9.4-Perl-5.24.1<br>4.0.7-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded
+
|52488-IGB-gcc-4.9.4
|RepeatMasker is a program that screens DNA sequences for interspersed repeats and low complexity DNA sequences.  
+
|DISCOVAR de novo can generate de novo assemblies for both large and small genomes. It currently does not call variants.
 
|-
 
|-
|[http://www.repeatmasker.org/RepeatModeler/ RepeatModeler]
+
|[http://www1.montpellier.inra.fr/CBGP/diyabc/index.php DIYABC]
|1.0.11-IGB-gcc-4.9.4-Perl-5.24.1
+
|2.1.0
|1.0.11
+
|a user-friendly approach to Approximate Bayesian Computation for inference on population history using molecular markers
 
|-
 
|-
|[http://www.repeatmasker.org/RepeatModeler/ RepeatScout]
+
|[https://dendropy.org/ DendroPy]
|1.0.5-IGB-gcc-4.9.4
+
|4.4.0-IGB-gcc-4.9.4-Python-3.6.1
|De Novo Repeat Finder,
+
|DendroPy is a Python library for phylogenetic computing.
 
|-
 
|-
|[https://cran.r-project.org/web/packages/Rmpi/index.html Rmpi]
+
|[http://emboss.sourceforge.net/ EMBOSS]
|0.6-6-IGB-gcc-4.9.4-R-3.4.2
+
|6.6.0-IGB-gcc-4.9.4-Java-1.8.0_121
|An interface (wrapper) to MPI APIs. It also provides interactive R manager and worker environment.
+
|EMBOSS, The European Molecular Biology Open Software Suite. EMBOSS is a free Open Source software analysis package specially developed for the needs of the molecular biology (e.g. EMBnet) user community.
 
|-
 
|-
|[https://www.ruby-lang.org Ruby]
+
|[https://github.com/PacificBiosciences/FALCON_unzip FALCON_unzip]
|2.4.2-IGB-gcc-4.9.4
+
|0.4.0-IGB-gcc-4.9.4-Python-2.7.13
|Ruby is a dynamic, open source programming language with a focus on simplicity and productivity. It has an elegant syntax that is  natural to read and easy to write.
+
|FALCON-Unzip contains the modules that works with FALCON for full diploid assembly (representing haplotype specific contigs as "haplotigs" as assembly output).
 
|-
 
|-
|[https://www.rust-lang.org Rust]
+
|FFTW
|1.30.0-IGB-gcc-4.9.4
+
|
|Rust is a systems programming language that runs blazingly fast, prevents segfaults, and guarantees thread safety.
+
|FFTW is a C subroutine library for computing the discrete Fourier transform (DFT) in one or more dimensions, of arbitrary input size, and of both real and complex data.
 
|-
 
|-
|[http://www.scons.org/ SCons]
+
|[https://github.com/dstreett/FLASH2 FLASH2]
|3.0.1-IGB-gcc-4.9.4-Python-2.7.13<br>3.0.1-IGB-gcc-4.9.4-Python-3.6.1
+
|2.2.00-IGB-gcc-4.9.4
|SCons is a software construction tool.
+
|FLASH (Fast Length Adjustment of SHort reads) is an accurate and fast toolto merge paired-end reads that were generated from DNA fragments whoselengths are shorter than twice the length of reads.  Merged read pairs resultin unpaired longer reads, which are generally more desired in genomeassembly and genome analysis processes.
 
|-
 
|-
|[http://www.libsdl.org/ SDL2]
+
|[http://www.microbesonline.org/fasttree/ FastTree]
|2.0.4-IGB-gcc-4.9.4
+
|2.1.10-IGB-gcc-4.9.4
|SDL: Simple DirectMedia Layer, a cross-platform multimedia library
+
|FastTree infers approximately-maximum-likelihood phylogenetic trees from alignments of nucleotide or protein sequences. FastTree can handle alignments with up to a million of sequences in a reasonable amount of time and memory.
 
|-
 
|-
|[https://github.com/smirarab/sepp SEPP]
+
|[https://github.com/fenderglass/Flye Flye]
|20180223-IGB-gcc-4.9.4-Python-2.7.13
+
|2.4.2-IGB-gcc-4.9.4-Python-2.7.13
|SEPP stands for "SATe-enabled Phylogenetic Placement", and addresses the problem of phylogenetic placement of short reads into reference alignments and trees.
+
|Flye is a de novo assembler for single molecule sequencing reads, such as those produced by PacBio and Oxford Nanopore Technologies.
 
|-
 
|-
|[https://github.com/ruanjue/smartdenovo SMARTdenovo]
+
|GCCcore
|20170916-IGB-gcc-4.9.4-Perl-5.24.1
+
|
|SMARTdenovo is a de novo assembler for PacBio and Oxford Nanopore (ONT) data. It produces an assembly from all-vs-all raw read alignments without an error correction stage. It also provides tools to generate accurate consensus sequences, though a platform dependent consensus polish tools (e.g. Quiver for PacBio or Nanopolish for ONT) are still required for higher accuracy.
+
|The GNU Compiler Collection includes front ends for C, C++, Objective-C, Fortran, Java, and Ada, as well as libraries for these languages (libstdc++, libgcj,...).
 
|-
 
|-
|[http://korflab.ucdavis.edu/software.html SNAP]
+
|[http://www.gdal.org/ GDAL]
|2013-11-29-IGB-gcc-4.9.4
+
|2.3.1-IGB-gcc-4.9.4
|(Semi-HMM-based Nucleic Acid Parser) gene prediction tool
+
|GDAL is a translator library for raster geospatial data formats that is released under an X/MIT style Open Source license by the Open Source Geospatial Foundation. As a library, it presents a single abstract data model to the calling application for all supported formats. It also comes with a variety of useful commandline utilities for data translation and processing.
 
|-
 
|-
|[http://snver.sourceforge.net/ SNVer]
+
|[http://research-pub.gene.com/gmap/ GMAP-GSNAP]
|0.5.3-Java-1.8.0_121<br>0.5.3-Java-1.8.0_152
+
|2017-11-15-IGB-gcc-4.9.4
|SNVer is a statistical tool for calling common and rare variants in analysis of pool or individual next-generation sequencing data. It reports one single overall p-value for evaluating the significance of a candidate locus being a variant, based on which multiplicity control can be obtained.
+
|GMAP: A Genomic Mapping and Alignment Program for mRNA and EST Sequences GSNAP: Genomic Short-read Nucleotide Alignment Program
 
|-
 
|-
|[http://soap.genomics.org.cn/SOAPdenovo-Trans.html SOAPdenovo-Trans]
+
|GObject-Introspection
|1.03
+
|
|SOAPdenovo-Trans is a de novo transcriptome assembler basing on the SOAPdenovo framework, adapt to alternative splicing and different expression level among transcripts.The assembler provides a more accurate, complete and faster way to construct the full-length transcript sets.  
+
|GObject introspection is a middleware layer between C libraries (using GObject) and language bindings. The C library can be scanned at compile time and generate a metadata file, in addition to the actual native C library. Then at runtime, language bindings can read this metadata and automatically provide bindings to call into the C library.
 
|-
 
|-
|[http://trace.ncbi.nlm.nih.gov/Traces/sra/sra.cgi?view=std SRA-Toolkit]
+
|[https://developer.gnome.org/gtk+/stable/ GTK+]
|2.8.2-1
+
|2.24.31-IGB-gcc-4.9.4-Python-2.7.13<br>2.24.31-IGB-gcc-4.9.4-Python-3.6.1
|The NCBI SRA Toolkit enables reading (dumping) of sequencing files from the SRA database and writing (loading) files into the .sra format  - Homepage: http://trace.ncbi.nlm.nih.gov/Traces/sra/sra.cgi?view=std
+
|The GTK+ 2 package contains libraries used for creating graphical user interfaces for applications.
 
|-
 
|-
|[https://github.com/STAR-Fusion/STAR-Fusion/wiki STAR-Fusion]
+
|[http://guidance.tau.ac.il/ver2/ GUIDANCE]
|1.6.0-IGB-gcc-4.9.4
+
|2.02-IGB-gcc-4.9.4-Perl-5.24.1
|STAR-Fusion is a component of the Trinity Cancer Transcriptome Analysis Toolkit (CTAT). STAR-Fusion uses the STAR aligner to identify candidate fusion transcripts supported by Illumina reads.
+
|GUIDANCE is meant to be used for weighting, filtering or masking unreliably aligned positions in sequence alignments before subsequent analysis. For example, align codon sequences (nucleotide sequences that code for proteins) using PAGAN, remove columns with low GUIDANCE scores, and use the remaining alignment to infer positive selection using the branch-site dN/dS test. Other analyses where GUIDANCE filtering could be useful include phylogeny reconstruction, reconstruction of the history of specific insertion and deletion events, inference of recombination events, etc. - Homepage: http://guidance.tau.ac.il/ver2/
 
|-
 
|-
|[http://computation.llnl.gov/projects/sundials SUNDIALS]
+
|M4
|2.6.2-IGB-gcc-4.9.4
+
|
|SUNDIALS: SUite of Nonlinear and DIfferential/ALgebraic Equation Solvers
+
|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. - Homepage: http://www.gnu.org/software/m4/m4.html
 
|-
 
|-
|[http://www.swig.org/ SWIG]
+
|Gdk-Pixbuf
|2.0.12-IGB-gcc-4.9.4-Python-2.7.13<br>3.0.12-IGB-gcc-4.9.4-Python-2.7.13<br>3.0.12-IGB-gcc-4.9.4-Python-2.7.13-Perl-5.24.1
 
|SWIG is a software development tool that connects programs written in C and C++ with a variety of high-level programming languages. - Homepage: http://www.swig.org/
 
|-
 
|ScaLAPACK
 
 
|
 
|
|The ScaLAPACK (or Scalable LAPACK) library includes a subset of LAPACK routines redesigned for distributed memory MIMD parallel computers.
+
|The Gdk Pixbuf is a toolkit for image loading and pixel buffer manipulation. It is used by GTK+ 2 and GTK+ 3 to load and manipulate images. In the past it was distributed as part of GTK+ 2 but it was split off into a separate package in preparation for the change to GTK+ 3.
 
|-
 
|-
|[https://www.pmgenomics.ca/hoffmanlab/proj/segway/ Segway]
+
|[http://ghostscript.com GhostScript]
|2.0.1-IGB-gcc-4.9.4-Python-2.7.13
+
|9.21-IGB-gcc-4.9.4
|Segway is a tool for easy pattern discovery and identification in functional genomics data.
+
|Ghostscript is a versatile processor for PostScript data with the ability to render PostScript to different targets. It used to be part of the cups printing stack, but is no longer used for that. - Homepage: http://ghostscript.com
 
|-
 
|-
|[https://github.com/bioinf/Sibelia Sibelia]
+
|[http://www.graphicsmagick.org/ GraphicsMagick]
|3.0.7-IGB-gcc-4.9.4
+
|1.3.26-IGB-gcc-4.9.4
|Sibelia is a tool for finding synteny blocks in closely related genomes, like different strains of the same bacterial species.
+
|GraphicsMagick is the swiss army knife of image processing.
 
|-
 
|-
|[http://www.cbs.dtu.dk/cgi-bin/nph-sw_request?signalp SignalP]
+
|[https://sourceforge.net/projects/biogrinder/ Grinder]
|4.1
+
|0.5.4-IGB-gcc-4.9.4-Perl-5.24.1
|Signal peptide and cleavage sites in gram+, gram- and eukaryotic amino acid sequences
+
|Grinder is a versatile open-source bioinformatic tool to create simulated omic shotgun and amplicon sequence libraries for all main sequencing platforms.
 
|-
 
|-
|[http://http://sox.sourceforge.net/ SoX]
+
|[http://www.gurobi.com/ Gurobi]
|14.4.2-IGB-gcc-4.9.4
+
|7.5.2
|Sound eXchange, the Swiss Army knife of audio manipulation
+
|The Gurobi Optimizer was designed from the ground up to be the fastest, most powerful solver available for your LP, QP, QCP, and MIP (MILP, MIQP, and MIQCP) problems.
 
|-
 
|-
|[http://vfsmspineagent.fsm.northwestern.edu/ Spine]
+
|[https://ccb.jhu.edu/software/hisat2/index.shtml HISAT2]
|0.2.1-IGB-gcc-4.9.4
+
|2.0.5-IGB-gcc-4.9.4<br>2.1.0-IGB-gcc-4.9.4
|Spine identifies a core genome from input genomic sequences. Sequences are aligned using Nucmer and regions found to be in common between all or a user-defined subset of genomes will be returned.
+
|HISAT2 is a fast and sensitive alignment program for mapping next-generation sequencing reads (both DNA and RNA) against the general human population (as well as against a single reference genome).
 
|-
 
|-
|[http://creskolab.uoregon.edu/stacks/ Stacks]
+
|[http://huttenhower.sph.harvard.edu/humann2 HUMAnN2]
|1.47-IGB-gcc-4.9.4
+
|0.11.1-IGB-gcc-4.9.4-Python-3.6.1<br>0.11.2-IGB-gcc-4.9.4-Python-3.6.1
|Stacks is a software pipeline for building loci from short-read sequences, such as those generated on the Illumina platform. Stacks was developed to work with restriction enzyme-based data, such as RAD-seq, for the purpose of building genetic maps and conducting population genomics and phylogeography.
+
|HUMAnN is a pipeline for efficiently and accurately profiling the presence/absence and abundance of microbial pathways in a community from metagenomic or metatranscriptomic sequencing data (typically millions of short DNA/RNA reads).
 
|-
 
|-
|[http://ccb.jhu.edu/software/stringtie/ StringTie]
+
|[https://github.com/kundajelab/idr IDR]
|1.3.3-IGB-gcc-4.9.4<br>1.3.6-IGB-gcc-4.9.4
+
|2.0.4-IGB-gcc-4.9.4-Python-3.6.1
|StringTie is a fast and highly efficient assembler of RNA-Seq alignments into potential transcripts.
+
|The IDR (Irreproducible Discovery Rate) framework is a unified approach to measure the reproducibility of findings identified from replicate experiments and provide highly stable thresholds based on reproducibility. Unlike the usual scalar measures of reproducibility, the IDR approach creates a curve, which quantitatively assesses when the findings are no longer consistent across replicates. In laymans terms, the IDR method compares a pair of ranked lists of identifications (such as ChIP-seq peaks).
 
|-
 
|-
|[https://support.10xgenomics.com/de-novo-assembly/software/overview/latest/welcome Supernova]
+
|[https://microbiology.se/software/itsx/ ITSx]
|1.1.5<br>1.2.0<br>1.2.1<br>2.0.0<br>2.0.1<br>2.1.0<br>2.1.1
+
|1.1.1-IGB-gcc-4.9.4
|Supernova is a software package for de novo assembly from Chromium Linked-Reads that are made from a single whole-genome library from an individual DNA source. A key feature of Supernova is that it creates diploid assemblies, thus separately representing maternal and paternal chromosomes over very long distances.
+
|TSx: Improved software detection and extraction of ITS1 and ITS2 from ribosomal ITS sequences of fungi and other eukaryotes for use in environmental sequencing
 
|-
 
|-
|[http://www.maizegenetics.net/tassel TASSEL]
+
|[https://databank.illinois.edu/ IllinoisDataBank]
|5.2.28-Java-1.8.0_121
+
|1.0-IGB-gcc-4.9.4-Python-3.6.1
|While TASSEL has changed considerably since its initial public release in 2001, its primary function continues to be providing tools to investigate the relationship between phenotypes and genotypes
+
|The Illinois Data Bank is a public access repository for publishing research data from the University of Illinois at Urbana-Champaign
 
|-
 
|-
|[http://www.cbs.dtu.dk/cgi-bin/nph-sw_request?tmhmm TMHMM]
+
|[http://www.imagemagick.org/ ImageMagick]
|2.0c-IGB-gcc-4.9.4
+
|7.0.5-5-IGB-gcc-4.9.4
|Transmembrane helices in proteins
+
|ImageMagick is a software suite to create, edit, compose, or convert bitmap images - Homepage: http://www.imagemagick.org/
 
|-
 
|-
|[https://github.com/Generade-nl/TULIP TULIP]
+
|[http://eddylab.org/infernal/ Infernal]
|20170513-IGB-gcc-4.9.4-Perl-5.24.1
+
|1.1.2-IGB-gcc-4.9.4
|Tulipseed takes as input alignments files of long reads to sparse short seeds, and outputs a graph and scaffold structures. Tulipbulb adds long read sequencing data to these.
+
|Infernal,INFERence of RNA ALignment, is for searching DNA sequence databases for RNA structure and sequence similarities.
 
|-
 
|-
|[https://github.com/tensorflow/models TensorFlowModels]
+
|[https://www.ebi.ac.uk/interpro/interproscan.html InterProScan]
|1.11-IGB-gcc-4.9.4-Python-3.6.1<br>20171113-IGB-gcc-4.9.4-Python-3.6.1
+
|5.27-66.0-IGB-gcc-4.9.4-Java-1.8.0_152<br>5.28-67.0-IGB-gcc-4.9.4-Java-1.8.0_152<br>5.33-72.0-IGB-gcc-4.9.4-Java-1.8.0_152<br>5.33-72.0-IGB-gcc-4.9.4-Java-1.8.0_201
|This repository contains a number of different models implemented in TensorFlow:
+
|InterProScan is the software package that allows sequences (protein and nucleic) to be scanned against InterPros signatures. Signatures are predictive models, provided by several different databases, that make up the InterPro consortium.
 
|-
 
|-
|[https://www.tensorflow.org/ Tensorflow]
+
|[http://www.genome.umd.edu/jellyfish.html Jellyfish]
|1.2.1-IGB-gcc-4.9.4-Python-2.7.13
+
|1.1.12-IGB-gcc-4.9.4<br>2.2.10-IGB-gcc-8.2.0<br>2.2.6-IGB-gcc-4.9.4
|An open-source software library for Machine Intelligence
+
|Jellyfish is a tool for fast, memory-efficient counting of k-mers in DNA.
 
|-
 
|-
|[http://deeplearning.net/software/theano Theano]
+
|fontconfig
|0.9.0-IGB-gcc-4.9.4-Python-2.7.13
 
|Theano is a Python library that allows you to define, optimize,and evaluate mathematical expressions involving multi-dimensional arrays efficiently. - Homepage: http://deeplearning.net/software/theano
 
|-
 
|Tk
 
 
|
 
|
|Tk is an open source, cross-platform widget toolchain that provides a library of basic elements for building a graphical user interface (GUI) in many different programming languages.
+
|Fontconfig is a library designed to provide system-wide font configuration, customization andapplication access.
 
|-
 
|-
|[http://ccb.jhu.edu/software/tophat/index.shtml TopHat]
+
|[https://ccb.jhu.edu/software/kraken/ Kraken]
|1.4.1<br>2.1.1-IGB-gcc-4.9.4
+
|1.0-IGB-gcc-4.9.4
|TopHat is a fast splice junction mapper for RNA-Seq reads.
+
|Kraken is a system for assigning taxonomic labels to short DNA sequences, usually obtained through metagenomic studies. Previous attempts by other bioinformatics software to accomplish this task have often used sequence alignment or machine learning techniques that were quite slow, leading to the development of less sensitive but much faster abundance estimation programs.  
 
|-
 
|-
|[https://github.com/torch/distro Torch]
+
|[https://github.com/marbl/Krona Krona]
|20171018-IGB-gcc-4.9.4-Python-3.6.1
+
|2.7-IGB-gcc-4.9.4-Perl-5.24.1
|Torch is a scientific computing framework with wide support for machine learning algorithms that puts GPUs first. It is easy to use and efficient, thanks to an easy and fast scripting language, LuaJIT, and an underlying C/CUDA implementation.
+
|Interactively explore metagenomes and more from a web browser.
 
|-
 
|-
|[https://github.com/TransDecoder/TransDecoder/wiki TransDecoder]
+
|[http://www.bx.psu.edu/~rsharris/lastz/ LASTZ]
|5.1.0-IGB-gcc-4.9.4-Perl-5.24.1
+
|1.04.00-IGB-gcc-4.9.4
|TransDecoder identifies candidate coding regions within transcript sequences, such as those generated by de novo RNA-Seq transcript assembly using Trinity, or constructed based on RNA-Seq alignments to the genome using Tophat and Cufflinks.
+
|LASTZ is a program for aligning DNA sequences, a pairwise aligner. Originally designed to handle sequences the size of human chromosomes and from different species, it is also useful for sequences produced by NGS  sequencing technologies such as Roche 454. - Homepage: http://www.bx.psu.edu/~rsharris/lastz/
 
|-
 
|-
|[http://www.bioinformatics.babraham.ac.uk/projects/trim_galore/ Trim_Galore]
+
|[http://www.bcgsc.ca/platform/bioinfo/software/links LINKS]
|0.4.4-IGB-gcc-4.9.4
+
|1.8.5-IGB-gcc-4.9.4-Perl-5.24.1
|A wrapper tool around Cutadapt and FastQC to consistently apply  quality and adapter trimming to FastQ files, with some extra functionality for  MspI-digested RRBS-type (Reduced Representation Bisufite-Seq) libraries.
+
|LINKS is a scalable genomics application for scaffolding or re-scaffolding genome assembly drafts with long reads, such as those produced by Oxford Nanopore Technologies Ltd and Pacific Biosciences. It provides a generic alignment-free framework for scaffolding and can work on any sequences. It is versatile and supports not only long sequences as a source of long-range information, but also MPET pairs and linked-reads, such as those from the 10X Genomics GemCode and Chromium platform, via ARCS (http://www.bcgsc.ca/platform/bioinfo/software/arcs). Fill gaps in LINKS-derived scaffolds using Sealer (http://www.bcgsc.ca/platform/bioinfo/software/sealer).
 
|-
 
|-
|[http://www.drive5.com/usearch/index.html USEARCH]
+
|[http://llvm.org/ LLVM]
|6.1.544<br>7.0.1090<br>9.2.64
+
|4.0.1-IGB-gcc-4.9.4<br>6.0.0-IGB-gcc-4.9.4
|USEARCH is a unique sequence analysis tool which offers search and clustering algorithms that are often orders of magnitude faster than BLAST.
+
|The LLVM Core libraries provide a modern source- and target-independent optimizer, along with code generation support for many popular CPUs (as well as some less common ones!) These libraries are built around a well specified code representation known as the LLVM intermediate representation ("LLVM IR"). The LLVM Core libraries are well documented, and it is particularly easy to invent your own language (or port an existing compiler) to use LLVM as an optimizer and code generator.
 
|-
 
|-
|[https://vcftools.github.io VCFtools]
+
|[https://symas.com/lmdb LMDB]
|0.1.15-IGB-gcc-4.9.4-Perl-5.24.1
+
|0.9.22-IGB-gcc-4.9.4
|The aim of VCFtools is to provide  easily accessible methods for working with complex  genetic variation data in the form of VCF files. - Homepage: https://vcftools.github.io
+
|LMDB is a fast, memory-efficient database. With memory-mapped files, it has the read performance of a pure in-memory database while retaining the persistence of standard disk-based databases.
 
|-
 
|-
|[https://github.com/Ensembl/ensembl-vep VEP]
+
|[http://lasagne.readthedocs.io/en/latest/index.html Lasagne]
|92.4-IGB-gcc-4.9.4-Perl-5.24.1
+
|20170606-IGB-gcc-4.9.4-Python-2.7.13
|VEP (Variant Effect Predictor) predicts the functional effects of genomic variants.
+
|Lasagne is a lightweight library to build and train neural networks in Theano. - Homepage: http://lasagne.readthedocs.io/en/latest/index.html
 
|-
 
|-
|[https://github.com/IGBIllinois/VICSIN VICSIN]
+
|[http://sourceforge.net/projects/libuuid/ LibUUID]
|0.5-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13<br>0.5.1-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13<br>0.5.2-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13<br>dev
+
|1.0.3-IGB-gcc-4.9.4
|VICSIN = Viral, Integrative, and Conjugative Sequence Identification and Networking
+
|Portable uuid C library
 
|-
 
|-
|[https://github.com/torognes/vsearch VSEARCH]
+
|[http://www.littlecms.com/ LittleCMS]
|2.4.3-IGB-gcc-4.9.4
+
|2.8-IGB-gcc-4.9.4
|VSEARCH stands for vectorized search, as the tool takes advantage of parallelism in the form of SIMD vectorization as well as multiple threads to perform accurate alignments at high speed. - Homepage: https://github.com/torognes/vsearch
+
|Little CMS intends to be an OPEN SOURCE small-footprint color management engine, with special focus on accuracy and performance. - Homepage: http://www.littlecms.com/
 
|-
 
|-
|[https://www.tbi.univie.ac.at/RNA/ ViennaRNA]
+
|[http://mafft.cbrc.jp/alignment/software/ MAFFT]
|2.4.2-IGB-gcc-4.9.4
+
|7.310-IGB-gcc-4.9.4
|The ViennaRNA Package consists of a C code library and several stand-alone programs for the prediction and comparison of RNA secondary structures.  
+
|MAFFT is a multiple sequence alignment program  for unix-like operating systems.  It offers a range of multiple alignment methods, L-INS-i (accurate; for alignment of <∼200 sequences),  FFT-NS-2 (fast; for alignment of <∼10,000 sequences), etc. - Homepage: http://mafft.cbrc.jp/alignment/software/
 
|-
 
|-
|[https://github.com/simroux/VirSorter VirSorter]
+
|[http://www.mathworks.com/products/matlab MATLAB]
|20170215-IGB-gcc-4.9.4-Perl-5.24.1
+
|2017a<br>2017b
|VirSorter: mining viral signal from microbial genomic data.
+
|MATLAB is a high-level language and interactive environment that enables you to perform computationally intensive tasks faster than with traditional programming languages such as C, C++, and Fortran.
 
|-
 
|-
|[http://tukaani.org/xz/ XZ]
+
|[http://micans.org/mcl/ MCL]
|5.2.3-IGB-gcc-4.9.4<br>5.2.3-IGB-gcc-8.2.0
+
|14.137-IGB-gcc-4.9.4
|xz: XZ utilities
+
|The MCL algorithm is short for the Markov Cluster Algorithm, a fastand scalable unsupervised cluster algorithm for graphs (also known as networks) basedon simulation of (stochastic) flow in graphs. - Homepage: http://micans.org/mcl/
 
|-
 
|-
|Yasm
+
|[http://ab.inf.uni-tuebingen.de/software/megan6/ MEGAN]
|
+
|6.12.2-Java-1.8.0_152
|Yasm: Complete rewrite of the NASM assembler with BSD license
+
|MEGAN6 is a comprehensive toolbox for interactively analyzing microbiome data. All the interactive tools you need in one application.
 
|-
 
|-
|[http://www.zeromq.org/ ZeroMQ]
+
|[http://www.netlab.uky.edu/p/bioinfo/MapSplice2 MapSplice]
|4.2.2-IGB-gcc-4.9.4
+
|2.2.1-IGB-gcc-4.9.4-Python-2.7.13
|ZeroMQ looks like an embeddable networking library but acts like a concurrency framework. It gives you sockets that carry atomic messages across various transports like in-process, inter-process, TCP, and multicast. You can connect sockets N-to-N with patterns like fanout, pub-sub, task distribution, and request-reply. It is fast enough to be the fabric for clustered products. Its asynchronous I/O model gives you scalable multicore applications, built as asynchronous message-processing tasks. It has a score of language APIs and runs on most operating systems.
+
|MapSplice is a software for mapping RNA-seq data to reference genome for splice junction discovery that depends only on reference genome, and not on any further annotations.
 
|-
 
|-
|[http://www-inf.enst.fr/~demaille/a2ps/ a2ps]
+
|[https://mariadb.org/ MariaDB]
|4.14-IGB-gcc-4.9.4
+
|10.1.31-IGB-gcc-4.9.4<br>10.1.31-IGB-gcc-8.2.0<br>5.5.58-IGB-gcc-4.9.4
|a2ps-4.14: Formats an ascii file for printing on a postscript printer
+
|MariaDB An enhanced, drop-in replacement for MySQL.
 
|-
 
|-
|[http://www.genetics.ucla.edu/software/admixture/index.html admixture]
+
|[https://sourceforge.net/projects/meraculous20/ Meraculous-2d]
|1.3.0
+
|2.2.6-IGB-gcc-4.9.4
|ADMIXTURE is a software tool for maximum likelihood estimation of individual ancestries from multilocus SNP genotype datasets. It uses the same statistical model as STRUCTURE but calculates estimates much more rapidly using a fast numerical optimization algorithm.  
+
|Meraculous-2D is a whole genome assembler for NGS reads (Illumina) that is capable of assembling large, diploid genomes with modest computational requirements.
 
|-
 
|-
|[https://nanoporetech.com/ albacore]
+
|[https://bitbucket.org/berkeleylab/metabat MetaBAT]
|2.0.2-IGB-gcc-4.9.4-Python-3.6.1<br>2.1.10-IGB-gcc-4.9.4-Python-3.6.1<br>2.3.1-IGB-gcc-4.9.4-Python-3.6.1
+
|2.12.1
|Local basecalling for MinKNOW
+
|MetaBAT, an efficient tool for accurately reconstructing single genomes from complex microbial communities
 
|-
 
|-
|[https://bitbucket.org/antismash/antismash/ antismash]
+
|[http://metagene.nig.ac.jp/ MetaGeneAnnotator]
|4.1.0
+
|20080819-x86-64
|antiSMASH allows the rapid genome-wide identification, annotation and analysis of secondary metabolite biosynthesis gene clusters in bacterial and fungal genomes. It integrates and cross-links with a large number of in silico secondary metabolite analysis tools that have been published earlier.
+
|MetaGeneAnnotator is a gene-finding program for prokaryote and phage.
 
|-
 
|-
|argtable
+
|[http://www.nasm.us/ NASM]
|
+
|2.12.02-IGB-gcc-4.9.4
|Argtable is an ANSI C library for parsing GNU style command line options with a minimum of fuss.  - Homepage: http://argtable.sourceforge.net/
+
|NASM: General-purpose x86 assembler
 
|-
 
|-
|[http://asperasoft.com/ aspera]
+
|[http://nco.sourceforge.net NCO]
|3.7.6
+
|4.7.2-IGB-gcc-4.9.4
|Aspera’s unwavering mission is to create the next-generation software technologies that move the world’s data at maximum speed, regardless of file size, transfer distance and network conditions.
+
|manipulates and analyzes data stored in netCDF-accessible formats, including DAP, HDF4, and HDF5
 
|-
 
|-
|[http://atactk.readthedocs.io/ atactk]
+
|[http://www.nwchem-sw.org NWChem]
|0.1.6-IGB-gcc-4.9.4-Python-2.7.13
+
|6.6.revision27746-IGB-gcc-4.9.4-Python-2.7.13
|a toolkit for ATAC-seq data
+
|NWChem aims to provide its users with computational chemistry tools that are scalable both in their ability to treat large scientific computational chemistry problems efficiently, and in their use of available parallel computing resources from high-performance parallel supercomputers to conventional workstation clusters. NWChem software can handle: biomolecules, nanostructures, and solid-state; from quantum to classical, and all combinations; Gaussian basis functions or plane-waves; scaling from one to thousands of processors; properties and relativity.
 
|-
 
|-
|[https://aws.amazon.com/cli/ awscli]
+
|[http://www.perl.org/ Perl]
|1.16.113-IGB-gcc-4.9.4-Python-3.6.1
+
|5.24.1-IGB-gcc-4.9.4<br>5.24.1-IGB-gcc-4.9.4-bare<br>5.26.1-IGB-gcc-4.9.4-unthreaded<br>5.28.1-IGB-gcc-8.2.0
|The AWS Command Line Interface (CLI) is a unified tool to manage your AWS services. With just one tool to download and configure, you can control multiple AWS services from the command line and automate them through scripts.
+
|Larry Wall Practical Extraction and Report Language
 
|-
 
|-
|[http://dna.ku.dk/%7Esapfo/bammds.html bammds]
+
|[https://github.com/ncbi/ngs NGS]
|20140602-IGB-gcc-4.9.4
+
|1.3.0-IGB-gcc-4.9.4
|Software that allows to create a multidimensional scaling (MDS) plot of populations for genetic data.
+
|NGS is a new, domain-specific API for accessing reads, alignments and pileups produced from Next Generation Sequencing. - Homepage: https://github.com/ncbi/ngs
 
|-
 
|-
|[https://github.com/PacificBiosciences/bax2bam bax2bam]
+
|libxslt
|20171114-IGB-gcc-4.9.4
+
|
|bax2bam converts the legacy PacBio basecall format (bax.h5) into the BAMbasecall format.  
+
|Libxslt is the XSLT C library developed for the GNOME project (but usable outside of the Gnome platform).
 
|-
 
|-
|[http://bazel.io/ bazel]
+
|[https://github.com/wdecoster/NanoPlot NanoPlot]
|0.6.0-Java-1.8.0_121
+
|1.18.2-IGB-gcc-4.9.4-Python-3.6.1
|Bazel is a build tool that builds code quickly and reliably. It is used to build the majority of Googles software.
+
|Plotting tool for long read sequencing data and alignments.
 +
|-
 +
|[https://ccl.northwestern.edu/netlogo/ NetLogo]
 +
|5.2.1<br>6.0.3
 +
|NetLogo is a multi-agent programmable modeling environment. It is used by many tens of thousands of students, teachers and researchers worldwide.
 
|-
 
|-
|[https://faculty.washington.edu/browning/beagle/beagle.html beagle]
+
|[http://nucleoatac.readthedocs.io/en/latest/ NucleoATAC]
|03Jul18.40b-Java-1.8.0_152
+
|0.3.4-IGB-gcc-4.9.4-Python-2.7.13
|Beagle is a software package for phasing genotypes and for imputing ungenotyped markers. Version 5.0 has new, fast algorithms for genotype phasing and imputation.  
+
|NucleoATAC is a python package for calling nucleosome positions and occupancy using ATAC-Seq data. Functions for calling nucleosomes are included in the nucleoatac command-line function. NucleoATAC also includes other utlities for working with ATAC-seq data under the pyatac function.
 
|-
 
|-
|[https://bedops.readthedocs.io/en/latest/ bedops]
+
|[http://ocaml.org/ OCaml]
|2.4.30
+
|4.05.0-IGB-gcc-4.9.4
|BEDOPS is an open-source command-line toolkit that performs highly efficient and scalable Boolean and other set operations, statistical calculations, archiving, conversion and other management of genomic data of arbitrary scale.  
+
|OCaml is a general purpose industrial-strength programming language with an emphasis on expressiveness and safety. Developed for more than 20 years at Inria it benefits from one of the most advanced type systems and supports functional, imperative and object-oriented styles of programming.
 
|-
 
|-
|binutils
+
|OpenPGM
 
|
 
|
|binutils: GNU binary utilities
+
|OpenPGM is an open source implementation of the Pragmatic General Multicast (PGM) specification in RFC 3208 available at www.ietf.org. PGM is a reliable and scalable multicast protocol that enables receivers to detect loss, request retransmission of lost data, or notify an application of unrecoverable loss. PGM is a receiver-reliable protocol, which means the receiver is responsible for ensuring all data is received, absolving the sender of reception responsibility.
 
|-
 
|-
|[https://github.com/lmrodriguezr/rocker bio-rocker]
+
|[http://orthomcl.org/ OrthoMCL]
|1.2.0-IGB-gcc-4.9.4-Ruby-2.4.2
+
|2.0.9-IGB-gcc-4.9.4-Perl-5.24.1
|Accurately detecting functional genes in metagenomes.
+
|OrthoMCL is a genome-scale algorithm for grouping orthologous protein sequences. - Homepage: http://orthomcl.org/
 
|-
 
|-
|[https://github.com/IGBIllinois/biodatabase/ biodatabase]
+
|[http://wasabiapp.org/software/pagan PAGAN]
|1.0-IGB-gcc-4.9.4
+
|20150723-IGB-gcc-4.9.4
|Scripts to create databases on the biodatabase machine.
+
|PAGAN is a general-purpose method for the alignment of sequence graphs. PAGAN is based on the phylogeny-aware progressive alignment algorithm and uses graphs to describe the uncertainty in the presence of characters at certain sequence positions. However, graphs also allow describing the uncertainty in input sequences and modelling e.g. homopolymer errors in Roche 454 reads, or representing inferred ancestral sequences against which other sequences can then be aligned. PAGAN is still under development and will hopefully evolve to an easy-to-use, general-purpose method for phylogenetic sequence alignment.
 
|-
 
|-
|[http://biom-format.org/ biom-format]
+
|[http://sco.h-its.org/exelixis/web/software/pear/ PEAR]
|2.1.6-IGB-gcc-4.9.4-Python-2.7.13<br>2.1.6-IGB-gcc-4.9.4-Python-3.6.1
+
|0.9.8-IGB-gcc-4.9.4
|The BIOM file format (canonically pronounced biome) is designed to be a general-use format for representing biological sample by observation contingency tables.
+
|PEAR is an ultrafast, memory-efficient and highly accurate pair-end read merger. It is fully parallelized and can run with as low as just a few kilobytes of memory. - Homepage: http://sco.h-its.org/exelixis/web/software/pear/
 
|-
 
|-
|[https://github.com/barricklab/breseq breseq]
+
|[http://picrust.github.io/picrust/ PICRUSt]
|0.31.0-IGB-gcc-4.9.4
+
|1.1.1-IGB-gcc-4.9.4-Python-2.7.13<br>1.1.3-IGB-gcc-4.9.4-Python-2.7.13
|is a computational pipeline for the analysis of short-read re-sequencing data (e.g. Illumina, 454, IonTorrent, etc.). It uses reference-based alignment approaches to predict mutations in a sample relative to an already sequenced genome.
+
|PICRUSt (pronounced pie crust) is a bioinformatics software package designed to predict metagenome functional content from marker gene (e.g., 16S rRNA) surveys and full genomes.
 
|-
 
|-
|[http://invisible-island.net/byacc/byacc.html byacc]
+
|[https://genie.weizmann.ac.il/pubs/mir07/mir07_exe.html PITA]
|20170709-IGB-gcc-4.9.4
+
|6-IGB-gcc-4.9.4
|Berkeley Yacc (byacc) is generally conceded to be the best yacc variant available.In contrast to bison, it is written to avoid dependencies upon a particular compiler.
+
|The PITA executable allows you to identify and score microRNA targets on UTRs.
 
|-
 
|-
|[http://www.bzip.org/ bzip2]
+
|[http://wasabiapp.org/software/prank/ PRANK]
|1.0.6-IGB-gcc-4.9.4<br>1.0.6-IGB-gcc-8.2.0
+
|170427-IGB-gcc-4.9.4
|bzip2 is a freely available, patent free, high-quality data compressor. It typically compresses files to within 10% to 15% of the best available techniques (the PPM family of statistical compressors), whilst being around twice as fast at compression and six times faster at decompression.
+
|PRANK is a probabilistic multiple alignment program for DNA, codon and amino-acid sequences. It’s based on a novel algorithm that treats insertions correctly and avoids over-estimation of the number of deletion events. In addition, PRANK borrows ideas from maximum likelihood methods used in phylogenetics and correctly takes into account the evolutionary distances between sequences. Lastly, PRANK allows for defining a potential structure for sequences to be aligned and then, simultaneously with the alignment, predicts the locations of structural units in the sequences.
 
|-
 
|-
|cURL
+
|[https://github.com/shawnzhangyx/PePr PePr]
|
+
|1.1.21-IGB-gcc-4.9.4-Python-2.7.13
|libcurl is a free and easy-to-use client-side URL transfer library, supporting DICT, FILE, FTP, FTPS, Gopher, HTTP, HTTPS, IMAP, IMAPS, LDAP, LDAPS, POP3, POP3S, RTMP, RTSP, SCP, SFTP, SMTP, SMTPS, Telnet and TFTP. libcurl supports SSL certificates, HTTP POST, HTTP PUT, FTP uploading, HTTP form based upload, proxies, cookies, user+password authentication (Basic, Digest, NTLM, Negotiate, Kerberos), file transfer resume, http proxy tunneling and more.
+
|PePr is a ChIP-Seq Peak-calling and Prioritization pipeline that uses a sliding window approach and models read counts across replicates and between groups with a negative binomial distribution.
 
|-
 
|-
|[https://github.com/ComparativeGenomicsToolkit/cactus cactus]
+
|[https://github.com/kundajelab/phantompeakqualtools Phantompeaktools]
|20180705-IGB-gcc-4.9.4-Python-2.7.13
+
|1.2-IGB-gcc-4.9.4-R-3.4.1
|Cactus is a reference-free whole-genome multiple alignment program.
+
|Custom SPP for Phantompeaktools
 
|-
 
|-
|[https://github.com/gpertea/cdbfasta cdbfasta]
+
|[https://github.com/rrwick/Porechop Porechop]
|20170316-IGB-gcc-4.9.4
+
|0.2.3-IGB-gcc-4.9.4-Python-3.6.1
|CDB (Constant DataBase) indexing and retrieval tools for FASTA files
+
|Porechop is a tool for finding and removing adapters from Oxford Nanopore reads.
 
|-
 
|-
|[https://ccb.jhu.edu/software/centrifuge/ centrifuge]
+
|[https://github.com/hyattpd/prodigal Prodigal]
|1.0.3-beta-IGB-gcc-4.9.4<br>1.0.4-beta-IGB-gcc-4.9.4
+
|2.6.3
|Centrifuge is a very rapid and memory-efficient system for the classification of DNA sequences from microbial samples, with better sensitivity than and comparable accuracy to other leading systems.
+
|Fast, reliable protein-coding gene prediction for prokaryotic genomes.
 
|-
 
|-
|[https://bitbucket.org/valenlab/chopchop chopchop]
+
|[https://github.com/uoregon-postlethwait/prost Prost]
|20190211-IGB-gcc-4.9.4-Python-2.7.13
+
|0.7.45-IGB-gcc-4.9.4-Python-2.7.13
|CHOPCHOP is a python script that allows quick and customizable design of guide RNA. We support selecting target sites for CRISPR/Cas9, CRISPR/Cpf1 or TALEN with wide range of customization. We even support C2c2 for isoform targeting.
+
|Prost (PRocessing Of Small Transcripts) is a python application that quantifies and annotates microRNA (miRNA) expression in metazoans with assembled genomes. Prost works by counting short transcripts within a user-specifiable length range. These counted transcripts are aligned to a user specifiable genome allowing for post-transcriptional modification (e.g. untemplated additions, editing, alternative cutting) and then "binned" together based on genomic location. Each bin is then annotated with databases of mature miRNAs, hairpins, and other types of RNAs (the databases may be derived from miRBase, Ensembls BioMart, other databases, or may be custom built by the user).
 
|-
 
|-
|[http://www.biostat.jhsph.edu/~hji/cisgenome/ cisgenome]
+
|[http://pytorch.org PyTorch]
|2.0-IGB-gcc-4.9.4
+
|0.3.0-IGB-gcc-4.9.4-Python-3.6.1<br>0.4.0-IGB-gcc-4.9.4-Python-3.6.1<br>0.4.1-IGB-gcc-4.9.4-Python-2.7.13<br>1.0.1.post2-IGB-gcc-4.9.4-Python-3.6.1
|An integrated tool for tiling array, ChIP-seq, genome and cis-regulatory element analysis
+
|Tensors and Dynamic neural networks in Pythonwith strong GPU acceleration.
 
|-
 
|-
|[https://github.com/cocodataset/cocoapi cocoapi]
+
|[http://qiime.org/ QIIME]
|20190218-IGB-gcc-4.9.4-Python-3.6.1
+
|1.9.1
|OCO is a large image dataset designed for object detection, segmentation, person keypoints detection, stuff segmentation, and caption generation.
+
|QIIME is an open-source bioinformatics pipeline for performing microbiome analysis from raw DNA sequencing data.
 
|-
 
|-
|[http://www.gnu.org/software/coreutils/coreutils.html coreutils]
+
|[http://qt.io/ Qt]
|8.28-IGB-gcc-4.9.4
+
|4.8.7-IGB-gcc-4.9.4
|The GNU Core Utilities are the basic file, shell and text manipulation utilities of the GNU operating system.These are the core utilities which are expected to exist on every operating system.  
+
|Qt is a comprehensive cross-platform C++ application framework.
 
|-
 
|-
|[https://github.com/iqbal-lab/cortex cortex]
+
|[http://eddylab.org/software/recon/ RECON]
|1.0.5.21-IGB-gcc-4.9.4
+
|1.08-IGB-gcc-4.9.4-Perl-5.24.1
|reference free variant assembly
+
|a package for automated de novo identification of repeat families from genomic sequences
 
|-
 
|-
|[https://github.com/cboursnell/crb-blast crb-blast]
+
|[https://bibiserv2.cebitec.uni-bielefeld.de/rnahybrid RNAhybrid]
|0.6.9-IGB-gcc-4.9.4
+
|2.1.2-IGB-gcc-4.9.4
|Conditional Reciprocal Best BLAST - high confidence ortholog assignment. CRB-BLAST is a novel method for finding orthologs between one set of sequences and another. This is particularly useful in genome and transcriptome annotation.
+
|RNAhybrid is a tool for finding the minimum free energy hybridization of a long and a short RNA. The hybridization is performed in a kind of domain mode, ie. the short sequence is hybridized to the best fitting part of the long one. The tool is primarily meant as a means for microRNA target prediction.  
 
|-
 
|-
|[https://github.com/broadinstitute/cromwell cromwell]
+
|[http://rna.urmc.rochester.edu/RNAstructure.html RNAstructure]
|39-Java-1.8.0_152
+
|6.0-IGB-gcc-4.9.4
|Scientific workflow engine designed for simplicity & scalability. Trivially transition between one off use cases to massive scale production environments
+
|RNAstructure is a complete package for RNA and DNA secondary structure prediction and analysis. It includes algorithms for secondary structure prediction, including facility to predict base pairing probabilities.
 
|-
 
|-
|[http://opensource.scilifelab.se/projects/cutadapt/ cutadapt]
+
|[http://younglab.wi.mit.edu/super_enhancer_code.html ROSE]
|1.14-IGB-gcc-4.9.4-Python-2.7.13<br>1.17-IGB-gcc-4.9.4-Python-3.6.1
+
|20150210-IGB-gcc-4.9.4-Python-2.7.13
|Cutadapt finds and removes adapter sequences, primers, poly-A tails and other types of unwanted sequence from your high-throughput sequencing reads.  
+
|To create stitched enhancers, and to separate super-enhancers from typical enhancers using sequencing data (.bam)
 
|-
 
|-
|[http://owenjm.github.io/damidseq_pipeline/ damidseq]
+
|[http://download.rsat.eu/ RSAT]
|1.4-IGB-gcc-4.9.4
+
|2018-08-04-IGB-gcc-4.9.4
|Processing DamID-seq data involves extending single-end reads, aligning the reads to the genome and determining the coverage, similar to processing regular ChIP-seq datasets.
+
|We offer tools to analyse cis-regulatory elements in genome sequences, motif discovery (support genome-wide data sets like ChIP-seq), transcription factor binding motif analysis (quality assessment, comparisons and clustering), comparative genomics, analysis of regulatory variations
 
|-
 
|-
|[https://github.com/fidelram/deepTools deepTools]
+
|[http://deweylab.github.io/RSEM/ RSEM]
|2.5.3-IGB-gcc-4.9.4-Python-2.7.13<br>3.0.1-IGB-gcc-4.9.4-Python-2.7.13<br>3.2.1-IGB-gcc-4.9.4-Python-3.6.1
+
|1.3.0-IGB-gcc-4.9.4<br>1.3.1-IGB-gcc-4.9.4
|deepTools addresses the challenge of handling the large amounts of data that are now routinely generated from DNA sequencing centers. deepTools contains useful modules to process the mapped reads data for multiple quality checks, creating normalized coverage files in standard bedGraph and bigWig file formats, that allow comparison between different files (for example, treatment and control). Finally, using such normalized and standardized files, deepTools can create many publication-ready visualizations to identify enrichments and for functional annotations of the genome.
+
|RNA-Seq by Expectation-Maximization
 
|-
 
|-
|[https://github.com/spragunr/deep_q_rl deep_q_rl]
+
|libtool
|20160603-IGB-gcc-4.9.4-Python-2.7.13
+
|
|This package provides a Lasagne/Theano-based implementation of the deep Q-learning algorithm described in:Playing Atari with Deep Reinforcement Learning Volodymyr Mnih, Koray Kavukcuoglu, David Silver, Alex Graves, Ioannis Antonoglou, Daan Wierstra, Martin RiedmillerandMnih, Volodymyr, et al. "Human-level control through deep reinforcement learning." Nature 518.7540 (2015): 529-533.
+
|GNU libtool is a generic library support script. Libtool hides the complexity of using shared libraries behind a consistent, portable interface. - Homepage: http://www.gnu.org/software/libtool
 
|-
 
|-
|[https://github.com/shenlab-sinai/diffreps diffReps]
+
|[http://rseqc.sourceforge.net/ RSeQC]
|1.55.6-IGB-gcc-4.9.4-Perl-5.24.1
+
|2.6.4-IGB-gcc-4.9.4-Python-2.7.13
|ChIP-seq is now widely used to profile the protein DNA interactions on a genome. It is of high interest to compare the differential enrichment of a histone mark or transcription factor between two contrasting conditions, such as disease vs. control. diffReps is developed to serve this purpose. It scans the whole genome using a sliding window, performing millions of statistical tests and report the significant hits. - Homepage: https://github.com/shenlab-sinai/diffreps
+
|RSeQC package provides a number of useful modules that can comprehensively evaluate high throughput sequence data especially RNA-seq data. Some basic modules quickly inspect sequence quality, nucleotide composition bias, PCR bias and GC bias, while RNA-seq specific modules evaluate sequencing saturation, mapped reads distribution, coverage uniformity, strand specificity, transcript level RNA integrity etc.
 
|-
 
|-
|[http://www.crypticlineage.net/pages/distruct.html distruct]
+
|[http://fenderglass.github.io/Ragout/ Ragout]
|2.2-IGB-gcc-4.9.4
+
|2.0-IGB-gcc-4.9.4
|Modified version of the original distruct.py
+
|Ragout (Reference-Assisted Genome Ordering UTility) is a tool for chromosome assembly using multiple references.  
 
|-
 
|-
|[http://expressionanalysis.github.io/ea-utils/ ea-utils]
+
|[https://cran.r-project.org/web/packages/RcppGSL/index.html RcppGSL]
|1.04.807-IGB-gcc-4.9.4
+
|0.3.2-IGB-gcc-4.9.4-R-3.3.3
|Command-line tools for processing biological sequencing data. Barcode demultiplexing, adapter trimming, etc. Primarily written to support an Illumina based pipeline - but should work with any FASTQs.
+
|Rcpp integration for GNU GSL vectors and matrices The GNU Scientific Library (or GSL) is a collection of numerical routines for scientific computing. It is particularly useful for C and C++ programs as it provides a standard C interface to a wide range of mathematical routines. There are over 1000 functions in total with an extensive test suite. The RcppGSL package provides an easy-to-use interface between GSL data structures and R using concepts from Rcpp which is itself a package that eases the interfaces between R and C++. This package also serves as a prime example of how to build a package that uses Rcpp to connect to another third-party library. The autoconf script, inline plugin and example package can all be used as a stanza to write a similar package against another library.
 
|-
 
|-
|[https://github.com/DReichLab/EIG eigensoft]
+
|[http://www.repeatmasker.org/ RepeatMasker]
|7.2.1-IGB-gcc-4.9.4
+
|4.0.7-IGB-gcc-4.9.4-Perl-5.24.1<br>4.0.7-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded
|The EIGENSOFT package combines functionality from our population genetics methods (Patterson et al. 2006) and our EIGENSTRAT stratification correction method (Price et al. 2006).  
+
|RepeatMasker is a program that screens DNA sequences for interspersed repeats and low complexity DNA sequences.  
 
|-
 
|-
|[https://github.com/biocore-ntnu/epic epic]
+
|[http://www.repeatmasker.org/RepeatModeler/ RepeatModeler]
|0.2.9-IGB-gcc-4.9.4-Python-2.7.13
+
|1.0.11-IGB-gcc-4.9.4-Perl-5.24.1
|epic is a software package for finding medium to diffusely enriched domains in chip-seq data. It is a fast, parallel and memory-efficient implementation of the incredibly popular SICER algorithm.  
+
|1.0.11
 
|-
 
|-
|[https://www.ebi.ac.uk/about/vertebrate-genomics/software/exonerate exonerate]
+
|[http://www.repeatmasker.org/RepeatModeler/ RepeatScout]
|2.2.0-IGB-gcc-4.9.4
+
|1.0.5-IGB-gcc-4.9.4
|Exonerate is a generic tool for pairwise sequence comparison. It allows you to align sequences using a many alignment models, either exhaustive dynamic programming or a variety of heuristics.
+
|De Novo Repeat Finder,
 
|-
 
|-
|expat
+
|[https://cran.r-project.org/web/packages/Rmpi/index.html Rmpi]
|
+
|0.6-6-IGB-gcc-4.9.4-R-3.4.2
|Expat is an XML parser library written in C. It is a stream-oriented parser in which an application registers handlers for things the parser might find in the XML document (like start tags)
+
|An interface (wrapper) to MPI APIs. It also provides interactive R manager and worker environment.
 
|-
 
|-
|[https://github.com/mateidavid/fast5 fast5]
+
|[https://www.ruby-lang.org Ruby]
|0.6.2-IGB-gcc-4.9.4<br>0.6.3-IGB-gcc-4.9.4<br>0.6.5-IGB-gcc-4.9.4
+
|2.4.2-IGB-gcc-4.9.4
|A lightweight C++ library for accessing Oxford Nanopore Technologies sequencing data.
+
|Ruby is a dynamic, open source programming language with  a focus on simplicity and productivity. It has an elegant syntax that is  natural to read and easy to write.
 
|-
 
|-
|[http://scheet.org/software.html fastPHASE]
+
|[https://www.rust-lang.org Rust]
|20160330
+
|1.30.0-IGB-gcc-4.9.4
|astPHASE is a program to estimate missing genotypes and unobserved haplotypes.  
+
|Rust is a systems programming language that runs blazingly fast, prevents segfaults, and guarantees thread safety.
 
|-
 
|-
|[https://github.com/OpenGene/fastp fastp]
+
|[http://www.scons.org/ SCons]
|0.19.5-IGB-gcc-4.9.4<br>0.19.6-IGB-gcc-4.9.4-7117eba<br>0.20.0-IGB-gcc-4.9.4
+
|3.0.1-IGB-gcc-4.9.4-Python-2.7.13<br>3.0.1-IGB-gcc-4.9.4-Python-3.6.1
|A tool designed to provide fast all-in-one preprocessing for FastQ files. This tool is developed in C++ with multithreading supported to afford high performance.
+
|SCons is a software construction tool.
 
|-
 
|-
|[https://github.com/adrianlopezroche/fdupes fdupes]
+
|[http://www.libsdl.org/ SDL2]
|1.6.1-IGB-gcc-4.9.4
+
|2.0.4-IGB-gcc-4.9.4
|FDUPES is a program for identifying duplicate files residingwithin specified directories.
+
|SDL: Simple DirectMedia Layer, a cross-platform multimedia library
 
|-
 
|-
|[http://fulcrumgenomics.github.io/fgbio/ fgbio]
+
|[https://github.com/smirarab/sepp SEPP]
|0.6.0-Java-1.8.0_152
+
|20180223-IGB-gcc-4.9.4-Python-2.7.13
|fgbio is a command line toolkit for working with genomic and particularly next generation sequencing data.
+
|SEPP stands for "SATe-enabled Phylogenetic Placement", and addresses the problem of phylogenetic placement of short reads into reference alignments and trees.
 
|-
 
|-
|file
+
|[https://github.com/ruanjue/smartdenovo SMARTdenovo]
|
+
|20170916-IGB-gcc-4.9.4-Perl-5.24.1
|The file command is a file type guesser, that is, a command-line tool that tells you in words what kind of data a file contains.
+
|SMARTdenovo is a de novo assembler for PacBio and Oxford Nanopore (ONT) data. It produces an assembly from all-vs-all raw read alignments without an error correction stage. It also provides tools to generate accurate consensus sequences, though a platform dependent consensus polish tools (e.g. Quiver for PacBio or Nanopolish for ONT) are still required for higher accuracy.
 
|-
 
|-
|flex
+
|[http://korflab.ucdavis.edu/software.html SNAP]
|
+
|2013-11-29-IGB-gcc-4.9.4
|Flex (Fast Lexical Analyzer) is a tool for generating scanners. A scanner,  sometimes called a tokenizer, is a program which recognizes lexical patterns in text. - Homepage: http://flex.sourceforge.net/
+
|(Semi-HMM-based Nucleic Acid Parser) gene prediction tool
 
|-
 
|-
|fontconfig
+
|[http://snver.sourceforge.net/ SNVer]
|
+
|0.5.3-Java-1.8.0_121<br>0.5.3-Java-1.8.0_152
|Fontconfig is a library designed to provide system-wide font configuration, customization andapplication access.
+
|SNVer is a statistical tool for calling common and rare variants in analysis of pool or individual next-generation sequencing data. It reports one single overall p-value for evaluating the significance of a candidate locus being a variant, based on which multiplicity control can be obtained.  
 
|-
 
|-
|[https://github.com/seqan/flexbar flexbar]
+
|[http://soap.genomics.org.cn/SOAPdenovo-Trans.html SOAPdenovo-Trans]
|3.0.3-IGB-gcc-4.9.4
+
|1.03
|The program Flexbar preprocesses high-throughput sequencing data efficiently. It demultiplexes barcoded runs and removes adapter sequences. Moreover, trimming and filtering features are provided.  
+
|SOAPdenovo-Trans is a de novo transcriptome assembler basing on the SOAPdenovo framework, adapt to alternative splicing and different expression level among transcripts.The assembler provides a more accurate, complete and faster way to construct the full-length transcript sets.  
 
|-
 
|-
|freetype
+
|[https://github.com/STAR-Fusion/STAR-Fusion/wiki STAR-Fusion]
|
+
|1.6.0-IGB-gcc-4.9.4
|FreeType 2 is a software font engine that is designed to be small, efficient, highly customizable, and portable while capable of producing high-quality output (glyph images). It can be used in graphics libraries, display servers, font conversion tools, text image generation tools, and many other products as well.
+
|STAR-Fusion is a component of the Trinity Cancer Transcriptome Analysis Toolkit (CTAT). STAR-Fusion uses the STAR aligner to identify candidate fusion transcripts supported by Illumina reads.
 
|-
 
|-
|[http://www.gnu.org/software/gdb/gdb.html gdb]
+
|[http://computation.llnl.gov/projects/sundials SUNDIALS]
|8.0.1-IGB-gcc-4.9.4-Python-2.7.13
+
|2.6.2-IGB-gcc-4.9.4
|The GNU Project Debugger
+
|SUNDIALS: SUite of Nonlinear and DIfferential/ALgebraic Equation Solvers
 
|-
 
|-
|[https://gdc.cancer.gov/access-data/gdc-data-transfer-tool gdc-client]
+
|[http://www.swig.org/ SWIG]
|1.3.0-IGB-gcc-4.9.4-Python-2.7.13
+
|2.0.12-IGB-gcc-4.9.4-Python-2.7.13<br>3.0.12-IGB-gcc-4.9.4-Python-2.7.13<br>3.0.12-IGB-gcc-4.9.4-Python-2.7.13-Perl-5.24.1
|The GDC Data Transfer Tool Client provides a command-line interface supporting both GDC data downloads and submissions.
+
|SWIG is a software development tool that connects programs written in C and C++ with a variety of high-level programming languages. - Homepage: http://www.swig.org/
 
|-
 
|-
|[http://www1.montpellier.inra.fr/CBGP/software/GeneClass/ geneclass]
+
|[https://www.pmgenomics.ca/hoffmanlab/proj/segway/ Segway]
|2.0
+
|2.0.1-IGB-gcc-4.9.4-Python-2.7.13
|GeneClass2 is a program employing multilocus genotypes to select or exclude populations as origins of individuals (Assignment and Migrants Detection). This is a completely rewritten new version that includes pop100gene features.
+
|Segway is a tool for easy pattern discovery and identification in functional genomics data.
 
|-
 
|-
|gengetopt
+
|[https://github.com/bioinf/Sibelia Sibelia]
|
+
|3.0.7-IGB-gcc-4.9.4
|Gengetopt is a tool to write command line option parsing code for C programs. - Homepage: https://www.gnu.org/software/gengetopt/gengetopt.html
+
|Sibelia is a tool for finding synteny blocks in closely related genomes, like different strains of the same bacterial species.
 
|-
 
|-
|[http://genometools.org/ genometools]
+
|[http://www.cbs.dtu.dk/cgi-bin/nph-sw_request?signalp SignalP]
|1.5.10-IGB-gcc-4.9.4
+
|4.1
|The GenomeTools genome analysis system is a free collection of bioinformatics tools (in the realm of genome informatics) combined into a single binary named gt. It is based on a C library named “libgenometools” which consists of several modules.
+
|Signal peptide and cleavage sites in gram+, gram- and eukaryotic amino acid sequences
 
|-
 
|-
|[http://trac.osgeo.org/geos geos]
+
|[http://http://sox.sourceforge.net/ SoX]
|3.7.1-IGB-gcc-4.9.4
+
|14.4.2-IGB-gcc-4.9.4
|GEOS (Geometry Engine - Open Source) is a C++ port of the JTS Topology Suite
+
|Sound eXchange, the Swiss Army knife of audio manipulation
 
|-
 
|-
|gettext
+
|[http://vfsmspineagent.fsm.northwestern.edu/ Spine]
|
+
|0.2.1-IGB-gcc-4.9.4
|GNU gettext is an important step for the GNU Translation Project, as it is an asset on which we maybuild many other steps. This package offers to programmers, translators, and even users, a well integrated set of toolsand documentation
+
|Spine identifies a core genome from input genomic sequences. Sequences are aligned using Nucmer and regions found to be in common between all or a user-defined subset of genomes will be returned.
 
|-
 
|-
|[http://acgt.cs.tau.ac.il/gevalt/ gevalt]
+
|[http://creskolab.uoregon.edu/stacks/ Stacks]
|2.0-Java-1.8.0_152
+
|1.47-IGB-gcc-4.9.4
|GEVALT (GEnotype Visualization and ALgorithmic Tool) is designed to simplify and expedite the process of genotype analysis and disease association tests by providing a common interface to several common tasks relating to such analyses.  
+
|Stacks is a software pipeline for building loci from short-read sequences, such as those generated on the Illumina platform. Stacks was developed to work with restriction enzyme-based data, such as RAD-seq, for the purpose of building genetic maps and conducting population genomics and phylogeography.
 
|-
 
|-
|[http://ccb.jhu.edu/software/stringtie/gffcompare.shtml gffcompare]
+
|[http://ccb.jhu.edu/software/stringtie/ StringTie]
|0.10.6-IGB-gcc-4.9.4
+
|1.3.3-IGB-gcc-4.9.4<br>1.3.6-IGB-gcc-4.9.4
|The program gffcompare can be used to compare, merge, annotate and estimate accuracy of one or more GFF files (the query files), when compared with a reference annotation (also provided as GFF).  
+
|StringTie is a fast and highly efficient assembler of RNA-Seq alignments into potential transcripts.
 
|-
 
|-
|[http://ccb.jhu.edu/software/stringtie/gff.shtml gffread]
+
|[https://support.10xgenomics.com/de-novo-assembly/software/overview/latest/welcome Supernova]
|ba7535f-IGB-gcc-4.9.4
+
|1.1.5<br>1.2.0<br>1.2.1<br>2.0.0<br>2.0.1<br>2.1.0<br>2.1.1
|The program gffread can be used to validate, filter, convert and perform various other operations on GFF files
+
|Supernova is a software package for de novo assembly from Chromium Linked-Reads that are made from a single whole-genome library from an individual DNA source. A key feature of Supernova is that it creates diploid assemblies, thus separately representing maternal and paternal chromosomes over very long distances.
 
|-
 
|-
|[http://git-scm.com/ git]
+
|Tcl
|2.9.5-IGB-gcc-4.9.4
+
|
|Git is a free and open source distributed version control system designedto handle everything from small to very large projects with speed and efficiency.
+
|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.
 
|-
 
|-
|[https://git-lfs.github.com/ git-lfs]
+
|[http://trace.ncbi.nlm.nih.gov/Traces/sra/sra.cgi?view=std SRA-Toolkit]
|2.2.1-IGB-gcc-4.9.4
+
|2.8.2-1
|Git Large File Storage (LFS) replaces large files such as audio samples, videos,  datasets, and graphics with text pointers inside Git, while storing the file contents on a remote server like GitHub.com or GitHub Enterprise.
+
|The NCBI SRA Toolkit enables reading (dumping) of sequencing files from the SRA database and writing (loading) files into the .sra format - Homepage: http://trace.ncbi.nlm.nih.gov/Traces/sra/sra.cgi?view=std
 
|-
 
|-
|glproto
+
|ScaLAPACK
 
|
 
|
|X protocol and ancillary headers
+
|The ScaLAPACK (or Scalable LAPACK) library includes a subset of LAPACK routines redesigned for distributed memory MIMD parallel computers.
 
|-
 
|-
|[http://gnuplot.sourceforge.net/ gnuplot]
+
|[http://www.maizegenetics.net/tassel TASSEL]
|4.6.7-IGB-gcc-4.9.4<br>5.0.6-IGB-gcc-4.9.4
+
|5.2.28-Java-1.8.0_121
|Portable interactive, function plotting utility - Homepage: http://gnuplot.sourceforge.net/
+
|While TASSEL has changed considerably since its initial public release in 2001, its primary function continues to be providing tools to investigate the relationship between phenotypes and genotypes
 
|-
 
|-
|gompi
+
|[http://www.cbs.dtu.dk/cgi-bin/nph-sw_request?tmhmm TMHMM]
|
+
|2.0c-IGB-gcc-4.9.4
|GNU Compiler Collection (GCC) based compiler toolchain, including OpenMPI for MPI support.
+
|Transmembrane helices in proteins
 
|-
 
|-
|[https://github.com/data61/gossamer gossamer]
+
|[https://github.com/Generade-nl/TULIP TULIP]
|20170105-IGB-gcc-4.9.4
+
|20170513-IGB-gcc-4.9.4-Perl-5.24.1
|The gossamer bioinformatics suite contains goss, gossple, xenome, and electus
+
|Tulipseed takes as input alignments files of long reads to sparse short seeds, and outputs a graph and scaffold structures. Tulipbulb adds long read sequencing data to these.
 
|-
 
|-
|[https://www.gnu.org/software/gperf/ gperf]
+
|[https://github.com/tensorflow/models TensorFlowModels]
|3.1-IGB-gcc-4.9.4
+
|1.11-IGB-gcc-4.9.4-Python-3.6.1<br>20171113-IGB-gcc-4.9.4-Python-3.6.1
|GNU gperf is a perfect hash function generator. For a given list of strings, it produces a hash function and hash table, in form of C or C++ code, for looking up a value depending on the input string. The hash function is perfect, which means that the hash table has no collisions, and the hash table lookup needs a single string comparison only.
+
|This repository contains a number of different models implemented in TensorFlow:
 
|-
 
|-
|[https://bitbucket.org/nsegata/graphlan/ graphlan]
+
|[https://www.tensorflow.org/ Tensorflow]
|6ca8735-IGB-gcc-4.9.4-Python-2.7.13
+
|1.2.1-IGB-gcc-4.9.4-Python-2.7.13
|GraPhlAn is a software tool for producing high-quality circular representations of taxonomic and phylogenetic trees. It focuses on concise, integrative, informative, and publication-ready representations of phylogenetically- and taxonomically-driven investigation.
+
|An open-source software library for Machine Intelligence
 
|-
 
|-
|[https://github.com/DecodeGenetics/graphtyper graphtyper]
+
|[http://deeplearning.net/software/theano Theano]
|1.3-IGB-gcc-4.9.4
+
|0.9.0-IGB-gcc-4.9.4-Python-2.7.13
|Graphtyper is a highly scalable genotyping software. It represents a reference genome and known variants of a genomic region using an acyclic mathematical graph structure (a "pangenome reference"), which high-throughput sequence reads are re-aligned to for the purpose of discovering and genotyping SNPs and small indels.
+
|Theano is a Python library that allows you to define, optimize,and evaluate mathematical expressions involving multi-dimensional arrays efficiently. - Homepage: http://deeplearning.net/software/theano
 
|-
 
|-
|[http://www.graphviz.org/ graphviz]
+
|Tk
|2.40.1-IGB-gcc-4.9.4<br>2.40.1-IGB-gcc-4.9.4-Python-2.7.13
+
|
|Graphviz is open source graph visualization software. Graph visualization is a way of representing structural information as diagrams of abstract graphs and networks. It has important applications in networking, bioinformatics,  software engineering, database and web design, machine learning, and in visual interfaces for other technical domains.
+
|Tk is an open source, cross-platform widget toolchain that provides a library of basic elements for building a graphical user interface (GUI) in many different programming languages.
 
|-
 
|-
|[https://github.com/google/googletest gtest]
+
|[http://ccb.jhu.edu/software/tophat/index.shtml TopHat]
|1.8.0-IGB-gcc-4.9.4
+
|1.4.1<br>2.1.1-IGB-gcc-4.9.4
|Googles C++ test framework
+
|TopHat is a fast splice junction mapper for RNA-Seq reads.
 
|-
 
|-
|[http://www.well.ox.ac.uk/~cfreeman/software/gwas/gtool.html gtool]
+
|[https://github.com/torch/distro Torch]
|0.7.5
+
|20171018-IGB-gcc-4.9.4-Python-3.6.1
|GTOOL is a program for transforming sets of genotype data for use with the programs SNPTEST and IMPUTE.  
+
|Torch is a scientific computing framework with wide support for machine learning algorithms that puts GPUs first. It is easy to use and efficient, thanks to an easy and fast scripting language, LuaJIT, and an underlying C/CUDA implementation.
 
|-
 
|-
|[https://cran.r-project.org/web/packages/h2o/index.html h2o]
+
|[https://github.com/TransDecoder/TransDecoder/wiki TransDecoder]
|3.14.0.3-IGB-gcc-4.9.4-R-3.3.3
+
|5.1.0-IGB-gcc-4.9.4-Perl-5.24.1
|R scripting functionality for H2O, the open source math engine for big data that computes parallel distributed machine learning algorithms such as generalized linear models, gradient boosting machines, random forests, and neural networks (deep learning) within various cluster environments.
+
|TransDecoder identifies candidate coding regions within transcript sequences, such as those generated by de novo RNA-Seq transcript assembly using Trinity, or constructed based on RNA-Seq alignments to the genome using Tophat and Cufflinks.
 
|-
 
|-
|h5py
+
|[http://www.bioinformatics.babraham.ac.uk/projects/trim_galore/ Trim_Galore]
|
+
|0.4.4-IGB-gcc-4.9.4
|The h5py package provides both a high- and low-level interface to the HDF5 library from Python.
+
|A wrapper tool around Cutadapt and FastQC to consistently apply  quality and adapter trimming to FastQ files, with some extra functionality for  MspI-digested RRBS-type (Reduced Representation Bisufite-Seq) libraries.
 
|-
 
|-
|[https://forge-dga.jouy.inra.fr/projects/hapflk hapflk]
+
|[http://www.drive5.com/usearch/index.html USEARCH]
|1.4-IGB-gcc-4.9.4-Python-3.6.1
+
|6.1.544<br>7.0.1090<br>9.2.64
|hapflk is a software implementing the hapFLK and FLK tests for the detection of selection signatures based on multiple population genotyping data.
+
|USEARCH is a unique sequence analysis tool which offers search and clustering algorithms that are often orders of magnitude faster than BLAST.
 
|-
 
|-
|help2man
+
|[https://vcftools.github.io VCFtools]
|
+
|0.1.15-IGB-gcc-4.9.4-Perl-5.24.1
|help2man produces simple manual pages from the --help and --version output of other commands.
+
|The aim of VCFtools is to provide  easily accessible methods for working with complex  genetic variation data in the form of VCF files. - Homepage: https://vcftools.github.io
 
|-
 
|-
|hwloc
+
|[https://github.com/Ensembl/ensembl-vep VEP]
|
+
|92.4-IGB-gcc-4.9.4-Perl-5.24.1
|The Portable Hardware Locality (hwloc) software package provides a portable abstraction(across OS, versions, architectures, ...) of the hierarchical topology of modern architectures, includingNUMA memory nodes, sockets, shared caches, cores and simultaneous multithreading. It also gathers varioussystem attributes such as cache and memory information as well as the locality of I/O devices such asnetwork interfaces, InfiniBand HCAs or GPUs. It primarily aims at helping applications with gatheringinformation about modern computing hardware so as to exploit it accordingly and efficiently.
+
|VEP (Variant Effect Predictor) predicts the functional effects of genomic variants.
 
|-
 
|-
|[http://icorn.sourceforge.net/documentation.html icorn]
+
|[https://github.com/IGBIllinois/VICSIN VICSIN]
|0.97-IGB-gcc-4.9.4
+
|0.5-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13<br>0.5.1-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13<br>0.5.2-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13<br>dev
|Inputs: Reference Sequence (FASTA) & reads (FASTQ) & information of short reads
+
|VICSIN = Viral, Integrative, and Conjugative Sequence Identification and Networking
 
|-
 
|-
|[https://mathgen.stats.ox.ac.uk/impute/impute_v2.html impute2]
+
|[https://github.com/torognes/vsearch VSEARCH]
|2.3.2
+
|2.4.3-IGB-gcc-4.9.4
|IMPUTE2 is freely available for academic use. To see rules for non-academic use, please read the LICENCE file, which is included with each software download.  
+
|VSEARCH stands for vectorized search, as the tool takes advantage of parallelism in the form of SIMD vectorization as well as multiple threads to perform accurate alignments at high speed. - Homepage: https://github.com/torognes/vsearch
 
|-
 
|-
|[https://github.com/LLNL/ior ior]
+
|[https://www.tbi.univie.ac.at/RNA/ ViennaRNA]
|3.0.1-IGB-gcc-4.9.4
+
|2.4.2-IGB-gcc-4.9.4
|Parallel filesystem I/O benchmark
+
|The ViennaRNA Package consists of a C code library and several stand-alone programs for the prediction and comparison of RNA secondary structures.
 
|-
 
|-
|[http://www.digip.org/jansson/ jansson]
+
|[https://github.com/simroux/VirSorter VirSorter]
|2.6-IGB-gcc-4.9.4
+
|20170215-IGB-gcc-4.9.4-Perl-5.24.1
|Jansson is a C library for encoding, decoding and manipulating JSON data.  
+
|VirSorter: mining viral signal from microbial genomic data.
 
|-
 
|-
|[http://www.canonware.com/jemalloc jemalloc]
+
|[http://tukaani.org/xz/ XZ]
|5.0.1-IGB-gcc-4.9.4
+
|5.2.3-IGB-gcc-4.9.4<br>5.2.3-IGB-gcc-8.2.0
|jemalloc is a general purpose malloc(3) implementation that emphasizes fragmentation avoidance and scalable concurrency support.
+
|xz: XZ utilities
 
|-
 
|-
|[http://jupyter.org/ jupyter]
+
|Yasm
|1.0.0-IGB-gcc-4.9.4-Python-3.6.1
+
|
|Project Jupyter exists to develop open-source software, open-standards, and services for interactive computing across dozens of programming languages.
+
|Yasm: Complete rewrite of the NASM assembler with BSD license
 
|-
 
|-
|libxslt
+
|[http://www.zeromq.org/ ZeroMQ]
|
+
|4.2.2-IGB-gcc-4.9.4
|Libxslt is the XSLT C library developed for the GNOME project (but usable outside of the Gnome platform).
+
|ZeroMQ looks like an embeddable networking library but acts like a concurrency framework. It gives you sockets that carry atomic messages across various transports like in-process, inter-process, TCP, and multicast. You can connect sockets N-to-N with patterns like fanout, pub-sub, task distribution, and request-reply. It is fast enough to be the fabric for clustered products. Its asynchronous I/O model gives you scalable multicore applications, built as asynchronous message-processing tasks. It has a score of language APIs and runs on most operating systems.
 
|-
 
|-
|[http://pachterlab.github.io/kallisto/ kallisto]
+
|[http://www-inf.enst.fr/~demaille/a2ps/ a2ps]
|0.43.1-IGB-gcc-4.9.4<br>0.44.0-IGB-gcc-4.9.4
+
|4.14-IGB-gcc-4.9.4
|kallisto is a program for quantifying abundances of transcripts from RNA-Seq data, or more generally of target sequences using high-throughput sequencing reads.
+
|a2ps-4.14: Formats an ascii file for printing on a postscript printer
 
|-
 
|-
|[http://genome.cse.ucsc.edu kentUtils]
+
|[http://www.genetics.ucla.edu/software/admixture/index.html admixture]
|353-IGB-gcc-4.9.4
+
|1.3.0
|UCSC genome browser kent bioinformatic utilities
+
|ADMIXTURE is a software tool for maximum likelihood estimation of individual ancestries from multilocus SNP genotype datasets. It uses the same statistical model as STRUCTURE but calculates estimates much more rapidly using a fast numerical optimization algorithm.
 
|-
 
|-
|[https://github.com/matthiasplappert/keras-rl keras-rl]
+
|[https://nanoporetech.com/ albacore]
|0.3.0-IGB-gcc-4.9.4-Python-2.7.13
+
|2.0.2-IGB-gcc-4.9.4-Python-3.6.1<br>2.1.10-IGB-gcc-4.9.4-Python-3.6.1<br>2.3.1-IGB-gcc-4.9.4-Python-3.6.1
|keras-rl implements some state-of-the art deep reinforcement learning algorithms in Python and seamlessly integrates with the deep learning library Keras.  
+
|Local basecalling for MinKNOW
 
|-
 
|-
|[https://github.com/alticelabs/kyoto kyoto]
+
|[https://bitbucket.org/antismash/antismash/ antismash]
|20170410-IGB-gcc-4.9.4
+
|4.1.0
|Kyoto Tycoon is a lightweight network server on top of the Kyoto Cabinet key-value database, built for high-performance and concurrency. Some of its features include:
+
|antiSMASH allows the rapid genome-wide identification, annotation and analysis of secondary metabolite biosynthesis gene clusters in bacterial and fungal genomes. It integrates and cross-links with a large number of in silico secondary metabolite analysis tools that have been published earlier.
 
|-
 
|-
|[http://lbzip2.org/ lbzip2]
+
|argtable
|2.5-IGB-gcc-4.9.4
+
|
|lbzip2 is a free, multi-threaded compression utility with support for bzip2 compressed file format.
+
|Argtable is an ANSI C library for parsing GNU style command line options with a minimum of fuss.  - Homepage: http://argtable.sourceforge.net/
 
|-
 
|-
|[https://lftp.yar.ru/ lftp]
+
|[http://asperasoft.com/ aspera]
|4.8.3
+
|3.7.6
|FTP is a sophisticated file transfer program supporting a number of network protocols (ftp, http, sftp, fish, torrent).  
+
|Aspera’s unwavering mission is to create the next-generation software technologies that move the world’s data at maximum speed, regardless of file size, transfer distance and network conditions.
 
|-
 
|-
|libdap
+
|[http://atactk.readthedocs.io/ atactk]
|
+
|0.1.6-IGB-gcc-4.9.4-Python-2.7.13
|A C++ SDK which contains an implementation of DAP 2.0 and the development versions of DAP3, up to 3.4. This includes both Client- and Server-side support classes.
+
|a toolkit for ATAC-seq data
 
|-
 
|-
|libdrm
+
|[https://aws.amazon.com/cli/ awscli]
|
+
|1.16.113-IGB-gcc-4.9.4-Python-3.6.1
|Direct Rendering Manager runtime library.
+
|The AWS Command Line Interface (CLI) is a unified tool to manage your AWS services. With just one tool to download and configure, you can control multiple AWS services from the command line and automate them through scripts.
 
|-
 
|-
|libevent
+
|[http://dna.ku.dk/%7Esapfo/bammds.html bammds]
|
+
|20140602-IGB-gcc-4.9.4
|The libevent API provides a mechanism to execute a callback function when a specific event occurs on a file descriptor or after a timeout has been reached. Furthermore, libevent also support callbacks due to signals or regular timeouts.
+
|Software that allows to create a multidimensional scaling (MDS) plot of populations for genetic data.
 
|-
 
|-
|libffi
+
|[https://github.com/PacificBiosciences/bax2bam bax2bam]
|
+
|20171114-IGB-gcc-4.9.4
|The libffi library provides a portable, high level programming interface to various callingconventions. This allows a programmer to call any function specified by a call interface description at run-time.
+
|bax2bam converts the legacy PacBio basecall format (bax.h5) into the BAMbasecall format.
 +
|-
 +
|[http://bazel.io/ bazel]
 +
|0.6.0-Java-1.8.0_121
 +
|Bazel is a build tool that builds code quickly and reliably. It is used to build the majority of Googles software.
 
|-
 
|-
|libgd
+
|[https://faculty.washington.edu/browning/beagle/beagle.html beagle]
|
+
|03Jul18.40b-Java-1.8.0_152
|GD is an open source code library for the dynamic creation of images by programmers. - Homepage: http://libgd.bitbucket.org/
+
|Beagle is a software package for phasing genotypes and for imputing ungenotyped markers. Version 5.0 has new, fast algorithms for genotype phasing and imputation.  
 
|-
 
|-
|[http://deeplearning.net/software/libgpuarray/ libgpuarray]
+
|[https://bedops.readthedocs.io/en/latest/ bedops]
|0.6.5-IGB-gcc-4.9.4
+
|2.4.30
|Make a common GPU ndarray(n dimensions array) that can be reused by all projects that is as future proof as possible, while keeping it easy to use for simple need/quick test. - Homepage: http://deeplearning.net/software/libgpuarray/
+
|BEDOPS is an open-source command-line toolkit that performs highly efficient and scalable Boolean and other set operations, statistical calculations, archiving, conversion and other management of genomic data of arbitrary scale.  
 
|-
 
|-
|libgtextutils
+
|binutils
 
|
 
|
|ligtextutils is a dependency of fastx-toolkit and is provided via the same upstream - Homepage: http://hannonlab.cshl.edu/fastx_toolkit/
+
|binutils: GNU binary utilities
 
|-
 
|-
|[http://libharu.org/ libharu]
+
|[https://github.com/lmrodriguezr/rocker bio-rocker]
|2.3.0-IGB-gcc-4.9.4
+
|1.2.0-IGB-gcc-4.9.4-Ruby-2.4.2
|libHaru is a free, cross platform, open source library for generating PDF files. - Homepage: http://libharu.org/
+
|Accurately detecting functional genes in metagenomes.
 
|-
 
|-
|libjpeg-turbo
+
|[https://github.com/IGBIllinois/biodatabase/ biodatabase]
|
+
|1.0-IGB-gcc-4.9.4
|libjpeg-turbo is a fork of the original IJG libjpeg which uses SIMD to accelerate baseline JPEGcompression and decompression. libjpeg is a library that implements JPEG image encoding, decoding and transcoding.
+
|Scripts to create databases on the biodatabase machine.
 
|-
 
|-
|libpciaccess
+
|[http://biom-format.org/ biom-format]
|
+
|2.1.6-IGB-gcc-4.9.4-Python-2.7.13<br>2.1.6-IGB-gcc-4.9.4-Python-3.6.1
|Generic PCI access library.
+
|The BIOM file format (canonically pronounced biome) is designed to be a general-use format for representing biological sample by observation contingency tables.
 
|-
 
|-
|libpng
+
|[https://github.com/barricklab/breseq breseq]
|
+
|0.31.0-IGB-gcc-4.9.4
|libpng is the official PNG reference library
+
|is a computational pipeline for the analysis of short-read re-sequencing data (e.g. Illumina, 454, IonTorrent, etc.). It uses reference-based alignment approaches to predict mutations in a sample relative to an already sequenced genome.
 
|-
 
|-
|libpthread-stubs
+
|[http://invisible-island.net/byacc/byacc.html byacc]
|
+
|20170709-IGB-gcc-4.9.4
|The X protocol C-language Binding (XCB) is a replacement for Xlib featuring a small footprint,latency hiding, direct access to the protocol, improved threading support, and extensibility.
+
|Berkeley Yacc (byacc) is generally conceded to be the best yacc variant available.In contrast to bison, it is written to avoid dependencies upon a particular compiler.
 
|-
 
|-
|libreadline
+
|[http://www.bzip.org/ bzip2]
|
+
|1.0.6-IGB-gcc-4.9.4<br>1.0.6-IGB-gcc-8.2.0
|The GNU Readline library provides a set of functions for use by applications that allow users to edit command lines as they are typed in. Both Emacs and vi editing modes are available. The Readline library includes additional functions to maintain a list of previously-entered command lines, to recall and perhaps reedit those lines, and perform csh-like history expansion on previous commands.
+
|bzip2 is a freely available, patent free, high-quality data compressor. It typically compresses files to within 10% to 15% of the best available techniques (the PPM family of statistical compressors), whilst being around twice as fast at compression and six times faster at decompression.
 
|-
 
|-
|libsodium
+
|cURL
 
|
 
|
|Sodium is a modern, easy-to-use software library for encryption, decryption, signatures, password hashing and more.
+
|libcurl is a free and easy-to-use client-side URL transfer library, supporting DICT, FILE, FTP, FTPS, Gopher, HTTP, HTTPS, IMAP, IMAPS, LDAP, LDAPS, POP3, POP3S, RTMP, RTSP, SCP, SFTP, SMTP, SMTPS, Telnet and TFTP. libcurl supports SSL certificates, HTTP POST, HTTP PUT, FTP uploading, HTTP form based upload, proxies, cookies, user+password authentication (Basic, Digest, NTLM, Negotiate, Kerberos), file transfer resume, http proxy tunneling and more.
 
|-
 
|-
|libxml2
+
|[https://github.com/ComparativeGenomicsToolkit/cactus cactus]
|
+
|20180705-IGB-gcc-4.9.4-Python-2.7.13
|Libxml2 is the XML C parser and toolchain developed for the Gnome project (but usable outside of the Gnome platform).
+
|Cactus is a reference-free whole-genome multiple alignment program.
 
|-
 
|-
|[http://support.10xgenomics.com/genome-exome/software/pipelines/latest/what-is-long-ranger longranger]
+
|[https://github.com/gpertea/cdbfasta cdbfasta]
|2.1.3<br>2.1.6<br>2.2.2
+
|20170316-IGB-gcc-4.9.4
|Long Ranger is a set of analysis pipelines that processes Chromium sequencing output to align reads and call and phase SNPs, indels, and structural variants. There are five main pipelines, each triggered by a longranger command
+
|CDB (Constant DataBase) indexing and retrieval tools for FASTA files
 
|-
 
|-
|[https://support.10xgenomics.com/genome-exome/software/visualization/latest/what-is-loupe loupe]
+
|[https://ccb.jhu.edu/software/centrifuge/ centrifuge]
|2.1.1
+
|1.0.3-beta-IGB-gcc-4.9.4<br>1.0.4-beta-IGB-gcc-4.9.4
|Loupe is a genome browser designed to visualize the Linked-Read data produced by the 10x Chromium Platform. Loupe is named for a jewelers loupe, which is used to inspect gems.
+
|Centrifuge is a very rapid and memory-efficient system for the classification of DNA sequences from microbial samples, with better sensitivity than and comparable accuracy to other leading systems.
 
|-
 
|-
|lzo
+
|[https://bitbucket.org/valenlab/chopchop chopchop]
|
+
|20190211-IGB-gcc-4.9.4-Python-2.7.13
|Portable lossless data compression library
+
|CHOPCHOP is a python script that allows quick and customizable design of guide RNA. We support selecting target sites for CRISPR/Cas9, CRISPR/Cpf1 or TALEN with wide range of customization. We even support C2c2 for isoform targeting.
 
|-
 
|-
|[https://bitbucket.org/liulab/mageck-vispr mageck-vispr]
+
|[http://www.biostat.jhsph.edu/~hji/cisgenome/ cisgenome]
|0.5.4-IGB-gcc-4.9.4-Python-3.6.1
+
|2.0-IGB-gcc-4.9.4
|MAGeCK-VISPR is a comprehensive quality control, analysis and visualization workflow for CRISPR/Cas9 screens.
+
|An integrated tool for tiling array, ChIP-seq, genome and cis-regulatory element analysis
 
|-
 
|-
|[https://github.com/DpeerLab/magic magic]
+
|[https://github.com/cocodataset/cocoapi cocoapi]
|0.1-IGB-gcc-4.9.4-Python-3.6.1
+
|20190218-IGB-gcc-4.9.4-Python-3.6.1
|A diffusion-based imputation method reveals gene-gene interactions in single-cell RNA-sequencing data
+
|OCO is a large image dataset designed for object detection, segmentation, person keypoints detection, stuff segmentation, and caption generation.
 
|-
 
|-
|[https://github.com/nanoporetech/medaka medaka]
+
|[http://www.gnu.org/software/coreutils/coreutils.html coreutils]
|0.1.0-IGB-gcc-4.9.4-Python-3.6.1
+
|8.28-IGB-gcc-4.9.4
|Medaka demonstrates a framework for error correcting sequencing data, particularly aimed at nanopore sequencing. Tools are provided for both training and inference. The code exploits the keras deep learning library.
+
|The GNU Core Utilities are the basic file, shell and text manipulation utilities of the GNU operating system.These are the core utilities which are expected to exist on every operating system.  
 
|-
 
|-
|[https://github.com/IGBIllinois/memprof memprof]
+
|[https://github.com/iqbal-lab/cortex cortex]
|1.01
+
|1.0.5.21-IGB-gcc-4.9.4
|Memprof is HPC Cluster Program Profiler. It records the memory, processor, and IO usage of a process. It will then generate a graph of the results.
+
|reference free variant assembly
 
|-
 
|-
|[https://bitbucket.org/biobakery/metaphlan2 metaphlan2]
+
|[https://github.com/cboursnell/crb-blast crb-blast]
|2.6.0-IGB-gcc-4.9.4-Python-3.6.1<br>2.7.6-IGB-gcc-4.9.4-Python-2.7.13<br>2.7.8-IGB-gcc-4.9.4-Python-2.7.13<br>2.7.8-IGB-gcc-4.9.4-Python-3.6.1
+
|0.6.9-IGB-gcc-4.9.4
|MetaPhlAn is a computational tool for profiling the composition of microbial communities (Bacteria, Archaea, Eukaryotes and Viruses) from metagenomic shotgun sequencing data (i.e. not 16S) with species-level. With the newly added StrainPhlAn module, it is now possible to perform accurate strain-level microbial profiling.
+
|Conditional Reciprocal Best BLAST - high confidence ortholog assignment. CRB-BLAST is a novel method for finding orthologs between one set of sequences and another. This is particularly useful in genome and transcriptome annotation.
 
|-
 
|-
|[https://www.agisoft.com/ metashape]
+
|[https://github.com/broadinstitute/cromwell cromwell]
|1.5.1-IGB-gcc-4.9.4
+
|39-Java-1.8.0_152
|photogrammetricprocessing of digital images and 3D spatial data generation
+
|Scientific workflow engine designed for simplicity & scalability. Trivially transition between one off use cases to massive scale production environments
 
|-
 
|-
|[https://github.com/LangilleLab/microbiome_helper microbiome_helper]
+
|[http://opensource.scilifelab.se/projects/cutadapt/ cutadapt]
|20171114-IGB-gcc-4.9.4
+
|1.14-IGB-gcc-4.9.4-Python-2.7.13<br>1.17-IGB-gcc-4.9.4-Python-3.6.1
|An assortment of scripts to help process and automate various microbiome and metagenomic bioinformatic tools. We provide workflows, tutorials and a virtual box image to help researchers process microbial data.
+
|Cutadapt finds and removes adapter sequences, primers, poly-A tails and other types of unwanted sequence from your high-throughput sequencing reads.  
 
|-
 
|-
|[http://microbiomeutil.sourceforge.net/ microbiomeutil]
+
|[http://owenjm.github.io/damidseq_pipeline/ damidseq]
|20110519-IGB-gcc-4.9.4
+
|1.4-IGB-gcc-4.9.4
|Contains ChimeraSlayer, WigeoN, and NAST-iEr
+
|Processing DamID-seq data involves extending single-end reads, aligning the reads to the genome and determining the coverage, similar to processing regular ChIP-seq datasets.
 
|-
 
|-
|libtool
+
|[https://github.com/fidelram/deepTools deepTools]
|
+
|2.5.3-IGB-gcc-4.9.4-Python-2.7.13<br>3.0.1-IGB-gcc-4.9.4-Python-2.7.13<br>3.2.1-IGB-gcc-4.9.4-Python-3.6.1
|GNU libtool is a generic library support script. Libtool hides the complexity of using shared libraries behind a consistent, portable interface. - Homepage: http://www.gnu.org/software/libtool
+
|deepTools addresses the challenge of handling the large amounts of data that are now routinely generated from DNA sequencing centers. deepTools contains useful modules to process the mapped reads data for multiple quality checks, creating normalized coverage files in standard bedGraph and bigWig file formats, that allow comparison between different files (for example, treatment and control). Finally, using such normalized and standardized files, deepTools can create many publication-ready visualizations to identify enrichments and for functional annotations of the genome.
 
|-
 
|-
|[https://github.com/lh3/miniasm miniasm]
+
|[https://github.com/spragunr/deep_q_rl deep_q_rl]
|0.2-IGB-gcc-4.9.4
+
|20160603-IGB-gcc-4.9.4-Python-2.7.13
|Miniasm is a very fast OLC-based de novo assembler for noisy long reads. It takes all-vs-all read self-mappings (typically by minimap) as input and outputs an assembly graph in the GFA format. Different from mainstream assemblers, miniasm does not have a consensus step. It simply concatenates pieces of read sequences to generate the final unitig sequences. Thus the per-base error rate is similar to the raw input reads.
+
|This package provides a Lasagne/Theano-based implementation of the deep Q-learning algorithm described in:Playing Atari with Deep Reinforcement Learning Volodymyr Mnih, Koray Kavukcuoglu, David Silver, Alex Graves, Ioannis Antonoglou, Daan Wierstra, Martin RiedmillerandMnih, Volodymyr, et al. "Human-level control through deep reinforcement learning." Nature 518.7540 (2015): 529-533.
 
|-
 
|-
|[https://github.com/lh3/minimap minimap]
+
|[https://github.com/shenlab-sinai/diffreps diffReps]
|0.2-IGB-gcc-4.9.4<br>2.11-IGB-gcc-4.9.4<br>2.16-IGB-gcc-4.9.4-Python-3.6.1<br>2.3-IGB-gcc-4.9.4<br>2.8-IGB-gcc-4.9.4
+
|1.55.6-IGB-gcc-4.9.4-Perl-5.24.1
|Minimap is an experimental tool to efficiently find multiple approximate mapping positions between two sets of long sequences, such as between reads and reference genomes, between genomes and between long noisy reads.  
+
|ChIP-seq is now widely used to profile the protein DNA interactions on a genome. It is of high interest to compare the differential enrichment of a histone mark or transcription factor between two contrasting conditions, such as disease vs. control. diffReps is developed to serve this purpose. It scans the whole genome using a sliding window, performing millions of statistical tests and report the significant hits. - Homepage: https://github.com/shenlab-sinai/diffreps
 
|-
 
|-
|[https://github.com/PacificBiosciences/minorseq/blob/54ac795d7c119d21a4611d91ac458cd3e2e2b30a/doc/INSTALL.md minorseq]
+
|[http://www.crypticlineage.net/pages/distruct.html distruct]
|20180314-IGB-gcc-4.9.4
+
|2.2-IGB-gcc-4.9.4
|Minor Variant Calling and Phasing Tools
+
|Modified version of the original distruct.py
 
|-
 
|-
|[https://www.mdc-berlin.de/8551903/en/ mirdeep]
+
|[http://expressionanalysis.github.io/ea-utils/ ea-utils]
|2.0.0.8-IGB-gcc-4.9.4
+
|1.04.807-IGB-gcc-4.9.4
|miRDeep2 is a completely overhauled tool which discovers microRNA genes by analyzing sequenced RNAs.  
+
|Command-line tools for processing biological sequencing data. Barcode demultiplexing, adapter trimming, etc. Primarily written to support an Illumina based pipeline - but should work with any FASTQs.
 
|-
 
|-
|[https://github.com/wdecoster/nanopack nanopack]
+
|[https://github.com/DReichLab/EIG eigensoft]
|1.0.0-IGB-gcc-4.9.4-Python-3.6.1
+
|7.2.1-IGB-gcc-4.9.4
|Easily install all my long read processing and analysis scripts simultaneously.
+
|The EIGENSOFT package combines functionality from our population genetics methods (Patterson et al. 2006) and our EIGENSTRAT stratification correction method (Price et al. 2006).  
 
|-
 
|-
|[https://github.com/jts/nanopolish nanopolish]
+
|[https://github.com/biocore-ntnu/epic epic]
|0.10.1-IGB-gcc-4.9.4<br>0.10.2-IGB-gcc-4.9.4<br>0.11.0-IGB-gcc-4.9.4<br>0.6.0-IGB-gcc-4.9.4<br>0.7.1-IGB-gcc-4.9.4<br>0.7.1-IGB-gcc-4.9.4-159d92b<br>0.8.3-IGB-gcc-4.9.4<br>0.8.5-IGB-gcc-4.9.4<br>0.9.0-IGB-gcc-4.9.4
+
|0.2.9-IGB-gcc-4.9.4-Python-2.7.13
|Software package for signal-level analysis of Oxford Nanopore sequencing data.
+
|epic is a software package for finding medium to diffusely enriched domains in chip-seq data. It is a fast, parallel and memory-efficient implementation of the incredibly popular SICER algorithm.  
 
|-
 
|-
|[https://github.com/kblin/ncbi-genome-download ncbi-genome-download]
+
|[https://www.ebi.ac.uk/about/vertebrate-genomics/software/exonerate exonerate]
|0.2.9-IGB-gcc-4.9.4-Python-3.6.1
+
|2.2.0-IGB-gcc-4.9.4
|Some script to download bacterial and fungal genomes from NCBI after they restructured their FTP a while ago.
+
|Exonerate is a generic tool for pairwise sequence comparison. It allows you to align sequences using a many alignment models, either exhaustive dynamic programming or a variety of heuristics.
 
|-
 
|-
|[https://github.com/ncbi/ncbi-vdb ncbi-vdb]
+
|expat
|2.8.2-IGB-gcc-4.9.4
+
|
|The SRA Toolkit and SDK from NCBI is a collection of tools and libraries for using data in the INSDC Sequence Read Archives. - Homepage: https://github.com/ncbi/ncbi-vdb
+
|Expat is an XML parser library written in C. It is a stream-oriented parser in which an application registers handlers for things the parser might find in the XML document (like start tags)
 
|-
 
|-
|[http://cran.r-project.org/web/packages/ncdf4 ncdf4]
+
|[https://github.com/mateidavid/fast5 fast5]
|1.16-IGB-gcc-4.9.4-R-3.3.3
+
|0.6.2-IGB-gcc-4.9.4<br>0.6.3-IGB-gcc-4.9.4<br>0.6.5-IGB-gcc-4.9.4
|This package provides a high-level R interface to data files written using Unidatas netCDF library (version 4 or earlier), which are binary data files that are portable across platforms and include metadata information in addition to the data sets.
+
|A lightweight C++ library for accessing Oxford Nanopore Technologies sequencing data.
 
|-
 
|-
|ncurses
+
|[http://scheet.org/software.html fastPHASE]
|
+
|20160330
|The Ncurses (new curses) library is a free software emulation of curses in System V Release 4.0, and more. It uses Terminfo format, supports pads and color and multiple highlights and forms characters and function-key mapping, and has all the other SYSV-curses enhancements over BSD Curses.
+
|astPHASE is a program to estimate missing genotypes and unobserved haplotypes.  
 
|-
 
|-
|[http://www.unidata.ucar.edu/software/netcdf/ netCDF]
+
|[https://github.com/OpenGene/fastp fastp]
|4.4.1.1-IGB-gcc-4.9.4
+
|0.19.5-IGB-gcc-4.9.4<br>0.19.6-IGB-gcc-4.9.4-7117eba<br>0.20.0-IGB-gcc-4.9.4
|NetCDF (network Common Data Form) is a set of software libraries  and machine-independent data formats that support the creation, access, and sharing of array-oriented  scientific data.
+
|A tool designed to provide fast all-in-one preprocessing for FastQ files. This tool is developed in C++ with multithreading supported to afford high performance.
 
|-
 
|-
|[http://www.unidata.ucar.edu/software/netcdf/ netCDF-Fortran]
+
|[https://github.com/adrianlopezroche/fdupes fdupes]
|4.4.1-IGB-gcc-4.9.4
+
|1.6.1-IGB-gcc-4.9.4
|NetCDF (network Common Data Form) is a set of software libraries and machine-independent data formats that support the creation, access, and sharing of array-oriented scientific data.
+
|FDUPES is a program for identifying duplicate files residingwithin specified directories.
 
|-
 
|-
|[http://www.lysator.liu.se/~nisse/nettle/ nettle]
+
|[http://fulcrumgenomics.github.io/fgbio/ fgbio]
|3.3-IGB-gcc-4.9.4
+
|0.6.0-Java-1.8.0_152
|Nettle is a cryptographic library that is designed to fit easily in more or less any context: In crypto toolkits for object-oriented languages (C++, Python, Pike, ...), in applications like LSH or GNUPG, or even in kernel space.
+
|fgbio is a command line toolkit for working with genomic and particularly next generation sequencing data.
 
|-
 
|-
|[https://ninja-build.org/ ninja]
+
|file
|1.8.2-IGB-gcc-4.9.4
+
|
|Ninja is a small build system with a focus on speed. It differs from other build systems in two major respects: it is designed to have its input files generated by a higher-level build system, and it is designed to run builds as fast as possible.
+
|The file command is a file type guesser, that is, a command-line tool that tells you in words what kind of data a file contains.
 
|-
 
|-
|[http://github.com/wolever/nose-parameterized nose-parameterized]
+
|flex
|0.6.0-IGB-gcc-4.9.4-Python-2.7.13
+
|
|Parameterized testing with any Python test framework.
+
|Flex (Fast Lexical Analyzer) is a tool for generating scanners. A scanner,  sometimes called a tokenizer, is a program which recognizes lexical patterns in text. - Homepage: http://flex.sourceforge.net/
 
|-
 
|-
|[http://www.novocraft.com/ novocraft]
+
|[https://github.com/seqan/flexbar flexbar]
|3.08.00
+
|3.0.3-IGB-gcc-4.9.4
|Powerful tool designed for mapping of short reads onto a reference genome from Illumina, Ion Torrent, and 454 NGS platforms.
+
|The program Flexbar preprocesses high-throughput sequencing data efficiently. It demultiplexes barcoded runs and removes adapter sequences. Moreover, trimming and filtering features are provided.  
 
|-
 
|-
|numactl
+
|freetype
 
|
 
|
|The numactl program allows you to run your application program on specific cpus and memory nodes.It does this by supplying a NUMA memory policy to the operating system before running your program.The libnuma library provides convenient ways for you to add NUMA memory policies into your own program.
+
|FreeType 2 is a software font engine that is designed to be small, efficient, highly customizable, and portable while capable of producing high-quality output (glyph images). It can be used in graphics libraries, display servers, font conversion tools, text image generation tools, and many other products as well.
 
|-
 
|-
|[http://numba.pydata.org/ numba]
+
|[http://www.gnu.org/software/gdb/gdb.html gdb]
|0.34.0-IGB-gcc-4.9.4-Python-2.7.13<br>0.34.0-IGB-gcc-4.9.4-Python-3.6.1
+
|8.0.1-IGB-gcc-4.9.4-Python-2.7.13
|Numba is an Open Source NumPy-aware optimizing compiler for Python sponsored by Continuum Analytics, Inc. It uses the remarkable LLVM compiler infrastructure to compile Python syntax to machine code.
+
|The GNU Project Debugger
 
|-
 
|-
|[http://www.numpy.org numpy]
+
|[https://gdc.cancer.gov/access-data/gdc-data-transfer-tool gdc-client]
|1.14.1-IGB-gcc-4.9.4-Python-3.6.1
+
|1.3.0-IGB-gcc-4.9.4-Python-2.7.13
|NumPy is the fundamental package for scientific computing with Python. It contains among other things: a powerful N-dimensional array object, sophisticated (broadcasting) functions, tools for integrating C/C++ and Fortran code, useful linear algebra, Fourier transform, and random number capabilities. Besides its obvious scientific uses, NumPy can also be used as an efficient multi-dimensional container of generic data. Arbitrary data-types can be  defined. This allows NumPy to seamlessly and speedily integrate with a wide variety of databases.
+
|The GDC Data Transfer Tool Client provides a command-line interface supporting both GDC data downloads and submissions.
 
|-
 
|-
|[http://www.bork.embl.de/pal2nal/ pal2nal]
+
|[http://www1.montpellier.inra.fr/CBGP/software/GeneClass/ geneclass]
|14-IGB-gcc-4.9.4
+
|2.0
|PAL2NAL is a program that converts a multiple sequence alignment of proteins and the corresponding DNA (or mRNA) sequences into a codon alignment.
+
|GeneClass2 is a program employing multilocus genotypes to select or exclude populations as origins of individuals (Assignment and Migrants Detection). This is a completely rewritten new version that includes pop100gene features.
 
|-
 
|-
|[http://pandoc.org pandoc]
+
|gengetopt
|2.2.3.2
+
|
|If you need to convert files from one markup format into another, pandoc is your swiss-army knife
+
|Gengetopt is a tool to write command line option parsing code for C programs. - Homepage: https://www.gnu.org/software/gengetopt/gengetopt.html
 
|-
 
|-
|[https://www.gnu.org/software/parallel/ parallel]
+
|[http://genometools.org/ genometools]
|20170622-IGB-gcc-4.9.4
+
|1.5.10-IGB-gcc-4.9.4
|parallel: GNU parallel is a shell tool for executing jobs in parallel using one or more computers.  
+
|The GenomeTools genome analysis system is a free collection of bioinformatics tools (in the realm of genome informatics) combined into a single binary named gt. It is based on a C library named “libgenometools” which consists of several modules.
 
|-
 
|-
|[http://compression.ca/pbzip2/ pbzip2]
+
|[http://trac.osgeo.org/geos geos]
|1.1.13-IGB-gcc-4.9.4
+
|3.7.1-IGB-gcc-4.9.4
|PBZIP2 is a parallel implementation of the bzip2 block-sorting file compressor that uses pthreads and achieves near-linear speedup on SMP machines.
+
|GEOS (Geometry Engine - Open Source) is a C++ port of the JTS Topology Suite
 
|-
 
|-
|[http://perfsuite.ncsa.illinois.edu/ perfsuite]
+
|gettext
|1.1.4-IGB-gcc-4.9.4
+
|
|PerfSuite is a collection of tools, utilities, and libraries for software performance analysis where the primary design goals are ease of use, comprehensibility, interoperability, and simplicity. This software can provide a good "entry point" for more detailed performance analysis and can help point the way towards selecting other tools and/or techniques using more specialized software if necessary (for example, tools/libraries from academic research groups or third-party commercial software).
+
|GNU gettext is an important step for the GNU Translation Project, as it is an asset on which we maybuild many other steps. This package offers to programmers, translators, and even users, a well integrated set of toolsand documentation
 
|-
 
|-
|[ftp://ftp.ebi.ac.uk/pub/databases/Pfam/Tools/README pfamscan]
+
|[http://acgt.cs.tau.ac.il/gevalt/ gevalt]
|1.6-IGB-gcc-4.9.4-Perl-5.24.1
+
|2.0-Java-1.8.0_152
|This readme should help you get started with "pfam_scan.pl", which is for usewith the HMMER3 version of HMMER.
+
|GEVALT (GEnotype Visualization and ALgorithmic Tool) is designed to simplify and expedite the process of genotype analysis and disease association tests by providing a common interface to several common tasks relating to such analyses.  
 
|-
 
|-
|[https://github.com/pgmpy/pgmpy pgmpy]
+
|[http://ccb.jhu.edu/software/stringtie/gffcompare.shtml gffcompare]
|20180320-IGB-gcc-4.9.4-Python-3.6.1
+
|0.10.6-IGB-gcc-4.9.4
|pgmpy is a python library for working with Probabilistic Graphical Models.
+
|The program gffcompare can be used to compare, merge, annotate and estimate accuracy of one or more GFF files (the query files), when compared with a reference annotation (also provided as GFF).  
 
|-
 
|-
|[https://github.com/HRGV/phyloFlash phyloFlash]
+
|[http://ccb.jhu.edu/software/stringtie/gff.shtml gffread]
|3.3-IGB-gcc-4.9.4
+
|ba7535f-IGB-gcc-4.9.4
|phyloFlash is a pipeline to rapidly reconstruct the SSU rRNAs and explore phylogenetic composition of an Illumina (meta)genomic or transcriptomic dataset.
+
|The program gffread can be used to validate, filter, convert and perform various other operations on GFF files
 
|-
 
|-
|[https://bitbucket.org/nsegata/phylophlan/wiki/phylophlan2 phylophlan2]
+
|[http://git-scm.com/ git]
|0.34-IGB-gcc-4.9.4-Python-3.6.1
+
|2.9.5-IGB-gcc-4.9.4
|PhyloPhlAn is an integrated pipeline for large-scale phylogenetic profiling of genomes and metagenomes.
+
|Git is a free and open source distributed version control system designedto handle everything from small to very large projects with speed and efficiency.
 
|-
 
|-
|[http://zlib.net/pigz/ pigz]
+
|[https://git-lfs.github.com/ git-lfs]
|2.3.4-IGB-gcc-4.9.4
+
|2.2.1-IGB-gcc-4.9.4
|pigz, which stands for parallel implementation of gzip, is a fully functional replacement for gzip that exploits multiple processors and multiple cores  to the hilt when compressing data. pigz was written by Mark Adler, and uses the zlib and pthread libraries.  
+
|Git Large File Storage (LFS) replaces large files such as audio samples, videosdatasets, and graphics with text pointers inside Git, while storing the file contents on a remote server like GitHub.com or GitHub Enterprise.
 
|-
 
|-
|pixman
+
|glproto
 
|
 
|
|Pixman is a low-level software library for pixel manipulation, providing features such as imagecompositing and trapezoid rasterization. Important users of pixman are the cairo graphics library and the X server.
+
|X protocol and ancillary headers
 
|-
 
|-
|pkg-config
+
|[http://gnuplot.sourceforge.net/ gnuplot]
 +
|4.6.7-IGB-gcc-4.9.4<br>5.0.6-IGB-gcc-4.9.4
 +
|Portable interactive, function plotting utility - Homepage: http://gnuplot.sourceforge.net/
 +
|-
 +
|gompi
 
|
 
|
|pkg-config is a helper tool used when compiling applications and libraries. It helps you insert the correct compiler options on the command line so an application can use  gcc -o test test.c `pkg-config --libs --cflags glib-2.0` for instance, rather than hard-coding values on where to find glib (or other libraries). - Homepage: http://www.freedesktop.org/wiki/Software/pkg-config/
+
|GNU Compiler Collection (GCC) based compiler toolchain, including OpenMPI for MPI support.
 
|-
 
|-
|[https://github.com/soedinglab/plass plass]
+
|[https://github.com/data61/gossamer gossamer]
|2-c7e35-IGB-gcc-4.9.4
+
|20170105-IGB-gcc-4.9.4
|Plass (Protein-Level ASSembler) is a software to assemble short read sequencing data on a protein level. The main purpose of Plass is the assembly of complex metagenomic datasets.
+
|The gossamer bioinformatics suite contains goss, gossple, xenome, and electus
 
|-
 
|-
|[http://platanus.bio.titech.ac.jp/platanus-assembler platanus]
+
|[https://www.gnu.org/software/gperf/ gperf]
|1.2.4
+
|3.1-IGB-gcc-4.9.4
|Platanus is a novel de novo sequence assembler that can reconstruct genomic sequences ofhighly heterozygous diploids from massively parallel shotgun sequencing data.
+
|GNU gperf is a perfect hash function generator. For a given list of strings, it produces a hash function and hash table, in form of C or C++ code, for looking up a value depending on the input string. The hash function is perfect, which means that the hash table has no collisions, and the hash table lookup needs a single string comparison only.  
 
|-
 
|-
|[https://www.cog-genomics.org/plink2 plink]
+
|[https://bitbucket.org/nsegata/graphlan/ graphlan]
|1.07<br>1.90
+
|6ca8735-IGB-gcc-4.9.4-Python-2.7.13
|This is a comprehensive update to Shaun Purcells PLINK command-line program, developed by Christopher Chang with support from the NIH-NIDDKs Laboratory of Biological Modeling, the Purcell Lab at Mount Sinai School of Medicine, and others.  
+
|GraPhlAn is a software tool for producing high-quality circular representations of taxonomic and phylogenetic trees. It focuses on concise, integrative, informative, and publication-ready representations of phylogenetically- and taxonomically-driven investigation.
 
|-
 
|-
|[https://github.com/nanoporetech/pomoxis pomoxis]
+
|[https://github.com/DecodeGenetics/graphtyper graphtyper]
|0.1.0-IGB-gcc-4.9.4-Python-3.6.1
+
|1.3-IGB-gcc-4.9.4
|Pomoxis contains a set of services to perform analysis of squiggles as they are produced in real-time along with fast pipelines for generating draft assemblies.
+
|Graphtyper is a highly scalable genotyping software. It represents a reference genome and known variants of a genomic region using an acyclic mathematical graph structure (a "pangenome reference"), which high-throughput sequence reads are re-aligned to for the purpose of discovering and genotyping SNPs and small indels.
 
|-
 
|-
|[https://github.com/arq5x/poretools poretools]
+
|[http://www.graphviz.org/ graphviz]
|0.6.0-IGB-gcc-4.9.4-Python-2.7.13
+
|2.40.1-IGB-gcc-4.9.4<br>2.40.1-IGB-gcc-4.9.4-Python-2.7.13
|a toolkit for working with nanopore sequencing data from Oxford Nanopore. - Homepage: https://github.com/arq5x/poretools
+
|Graphviz is open source graph visualization software. Graph visualization is a way of representing structural information as diagrams of abstract graphs and networks. It has important applications in networking, bioinformatics,  software engineering, database and web design, machine learning, and in visual interfaces for other technical domains.
 
|-
 
|-
|[http://matsen.fhcrc.org/pplacer/ pplacer]
+
|[https://github.com/google/googletest gtest]
|1.1.alpha19
+
|1.8.0-IGB-gcc-4.9.4
|Pplacer places query sequences on a fixed reference phylogenetic tree to maximize phylogenetic likelihood or posterior probability according to a reference alignment. Pplacer is designed to be fast, to give useful information about uncertainty, and to offer advanced visualization and downstream analysis.
+
|Googles C++ test framework
 
|-
 
|-
|[http://smithlabresearch.org/software/preseq/ preseq]
+
|[http://www.well.ox.ac.uk/~cfreeman/software/gwas/gtool.html gtool]
|2.0.3-IGB-gcc-4.9.4
+
|0.7.5
|The preseq package is aimed at predicting and estimating the complexity of a genomic sequencing library, equivalent to predicting and estimating the number of redundant reads from a given sequencing depth and how many will be expected from additional sequencing using an initial sequencing experiment.
+
|GTOOL is a program for transforming sets of genotype data for use with the programs SNPTEST and IMPUTE.  
 
|-
 
|-
|[http://www.primer3.org primer3]
+
|[https://cran.r-project.org/web/packages/h2o/index.html h2o]
|2.4.0-IGB-gcc-4.9.4
+
|3.14.0.3-IGB-gcc-4.9.4-R-3.3.3
|Primer3 is a widely used program for designing PCR primers (PCR = "Polymerase Chain Reaction"). PCR is an essential and ubiquitous tool in genetics and molecular biology. Primer3 can also design hybridization probes and sequencing primers.  
+
|R scripting functionality for H2O, the open source math engine for big data that computes parallel distributed machine learning algorithms such as generalized linear models, gradient boosting machines, random forests, and neural networks (deep learning) within various cluster environments.
 
|-
 
|-
|[https://github.com/tseemann/prokka prokka]
+
|h5py
|1.12-IGB-gcc-4.9.4-Perl-5.24.1<br>1.13-IGB-gcc-4.9.4-Perl-5.24.1
+
|
|Whole genome annotation is the process of identifying features of interest in a set of genomic DNA sequences, and labelling them with useful information. Prokka is a software tool to annotate bacterial, archaeal and viral genomes quickly and produce standards-compliant output files.
+
|The h5py package provides both a high- and low-level interface to the HDF5 library from Python.
 
|-
 
|-
|[https://github.com/google/protobuf protobuf]
+
|[https://forge-dga.jouy.inra.fr/projects/hapflk hapflk]
|2.6.1-IGB-gcc-4.9.4<br>3.5.0-IGB-gcc-4.9.4
+
|1.4-IGB-gcc-4.9.4-Python-3.6.1
|Protocol Buffers (a.k.a., protobuf) are Googles language-neutral, platform-neutral, extensible mechanism for serializing structured data.
+
|hapflk is a software implementing the hapFLK and FLK tests for the detection of selection signatures based on multiple population genotyping data.
 
|-
 
|-
|[https://github.com/lilydjwg/pssh pssh]
+
|help2man
|2.3.1-IGB-gcc-4.9.4-Python-2.7.13
+
|
|PSSH provides parallel versions of OpenSSH and related tools, including pssh, pscp, prsync, pnuke and pslurp. This project includes psshlib which can be used within custom applications.
+
|help2man produces simple manual pages from the --help and --version output of other commands.
 
|-
 
|-
|[https://daler.github.io/pybedtools/main.html pybedtools]
+
|hwloc
|0.7.10-IGB-gcc-4.9.4-Python-3.6.1
+
|
|pybedtools is a Python package that wraps BEDTools, so you will need both installed.
+
|The Portable Hardware Locality (hwloc) software package provides a portable abstraction(across OS, versions, architectures, ...) of the hierarchical topology of modern architectures, includingNUMA memory nodes, sockets, shared caches, cores and simultaneous multithreading. It also gathers varioussystem attributes such as cache and memory information as well as the locality of I/O devices such asnetwork interfaces, InfiniBand HCAs or GPUs. It primarily aims at helping applications with gatheringinformation about modern computing hardware so as to exploit it accordingly and efficiently.
 
|-
 
|-
|[https://github.com/brentp/pyfasta/ pyfasta]
+
|[http://icorn.sourceforge.net/documentation.html icorn]
|0.5.2-IGB-gcc-4.9.4-Python-2.7.13
+
|0.97-IGB-gcc-4.9.4
|Stores a flattened version of the fasta file without spaces or headers and uses either a mmap of numpy binary format or fseek/fread so the sequence data is never read into memory.
+
|Inputs: Reference Sequence (FASTA) & reads (FASTQ) & information of short reads
 
|-
 
|-
|[http://deeplearning.net/software/libgpuarray pygpu]
+
|[https://mathgen.stats.ox.ac.uk/impute/impute_v2.html impute2]
|0.6.5-IGB-gcc-4.9.4-Python-2.7.13
+
|2.3.2
|Python bindings for libgpuarray - Homepage: http://deeplearning.net/software/libgpuarray
+
|IMPUTE2 is freely available for academic use. To see rules for non-academic use, please read the LICENCE file, which is included with each software download.  
 
|-
 
|-
|[https://pygraphviz.github.io/ pygraphviz]
+
|[https://github.com/LLNL/ior ior]
|1.3.1-IGB-gcc-4.9.4-Python-3.6.1
+
|3.0.1-IGB-gcc-4.9.4
|PyGraphviz is a Python interface to the Graphviz graph layout and visualization package. With PyGraphviz you can create, edit, read, write, and draw graphs using Python to access the Graphviz graph data structure and layout algorithms.
+
|Parallel filesystem I/O benchmark
 
|-
 
|-
|[https://github.com/lisa-lab/pylearn2 pylearn2]
+
|[http://www.digip.org/jansson/ jansson]
|20170525-IGB-gcc-4.9.4-Python-2.7.13
+
|2.6-IGB-gcc-4.9.4
|Pylearn2 is a library designed to make machine learning research easy. - Homepage: https://github.com/lisa-lab/pylearn2
+
|Jansson is a C library for encoding, decoding and manipulating JSON data.  
 
|-
 
|-
|[http://qualimap.bioinfo.cipf.es/ qualimap]
+
|[http://www.canonware.com/jemalloc jemalloc]
|2.2.1-Java-1.8.0_121
+
|5.0.1-IGB-gcc-4.9.4
|Qualimap 2 is a platform-independent application written in Java and R that provides both a Graphical User Inteface (GUI) and a command-line interface to facilitate the quality control of alignment sequencing data and its derivatives like feature counts.  
+
|jemalloc is a general purpose malloc(3) implementation that emphasizes fragmentation avoidance and scalable concurrency support.
 
|-
 
|-
|[https://sourceforge.net/projects/quast/ quast]
+
|[http://jupyter.org/ jupyter]
|4.6.1-IGB-gcc-4.9.4-Python-2.7.13<br>5.0.0-IGB-gcc-4.9.4-Python-3.6.1
+
|1.0.0-IGB-gcc-4.9.4-Python-3.6.1
|QUAST performs fast and convenient quality evaluation and comparison of genome assemblies.  
+
|Project Jupyter exists to develop open-source software, open-standards, and services for interactive computing across dozens of programming languages.
 
|-
 
|-
|[https://github.com/mahulchak/quickmerge quickmerge]
+
|[http://pachterlab.github.io/kallisto/ kallisto]
|0.2-IGB-gcc-4.9.4-Python-2.7.13
+
|0.43.1-IGB-gcc-4.9.4<br>0.44.0-IGB-gcc-4.9.4
|quickmerge uses a simple concept to improve contiguity of genome assemblies based on long molecule sequences, often with dramatic outcomes. The program uses information from assemblies made with illumina short reads and PacBio long reads to improve contiguities of an assembly generated with PacBio long reads alone. This is counterintuitive because illumina short reads are not typically considered to cover genomic regions which PacBio long reads cannot. Although we have not evaluated this program for assemblies generated with Oxford nanopore sequences, the program should work with ONP-assemblies too.
+
|kallisto is a program for quantifying abundances of transcripts from RNA-Seq data, or more generally of target sequences using high-throughput sequencing reads.
 
|-
 
|-
|[http://rnaseq-mats.sourceforge.net/ rMATS]
+
|[http://genome.cse.ucsc.edu kentUtils]
|3.2.5-IGB-gcc-4.9.4-Python-2.7.13
+
|353-IGB-gcc-4.9.4
|MATS is a computational tool to detect differential alternative splicing events from RNA-Seq data. The statistical model of MATS calculates the P-value and false discovery rate that the difference in the isoform ratio of a gene between two conditions exceeds a given user-defined threshold. From the RNA-Seq data, MATS can automatically detect and analyze alternative splicing events corresponding to all major types of alternative splicing patterns. MATS handles replicate RNA-Seq data from both paired and unpaired study design.
+
|UCSC genome browser kent bioinformatic utilities
 
|-
 
|-
|[https://github.com/isovic/racon racon]
+
|[https://github.com/matthiasplappert/keras-rl keras-rl]
|0.5.0-IGB-gcc-4.9.4-Python-2.7.13<br>0.5.0-IGB-gcc-4.9.4-Python-3.6.1
+
|0.3.0-IGB-gcc-4.9.4-Python-2.7.13
|Racon is intended as a standalone consensus module to correct raw contigs generated by rapid assembly methods which do not include a consensus step, such as Miniasm.The goal of Racon is to generate genomic consensus which is of similar or better quality compared to the output generated by assembly methods which employ both error correction and consensus steps, while providing a speedup of several times compared to those methods.
+
|keras-rl implements some state-of-the art deep reinforcement learning algorithms in Python and seamlessly integrates with the deep learning library Keras.  
 
|-
 
|-
|[http://bioinformatics.psb.ugent.be/supplementary_data/erbon/nov2003/ randfold]
+
|[https://github.com/alticelabs/kyoto kyoto]
|2.0.1-IGB-gcc-4.9.4
+
|20170410-IGB-gcc-4.9.4
|Minimum free energy of folding randomization test software
+
|Kyoto Tycoon is a lightweight network server on top of the Kyoto Cabinet key-value database, built for high-performance and concurrency. Some of its features include:
 
|-
 
|-
|[https://rclone.org/ rclone]
+
|[http://lbzip2.org/ lbzip2]
|1.41
+
|2.5-IGB-gcc-4.9.4
|Rclone is a command line program to sync files and directories to and from different cloud storage
+
|lbzip2 is a free, multi-threaded compression utility with support for bzip2 compressed file format.
 
|-
 
|-
|[https://cran.r-project.org/web/packages/rgeos/index.html rgeos]
+
|[https://lftp.yar.ru/ lftp]
|0.4-2-IGB-gcc-4.9.4-R-3.5.0
+
|4.8.3
|nterface to Geometry Engine - Open Source (GEOS) using the C API for topology operations on geometries.
+
|FTP is a sophisticated file transfer program supporting a number of network protocols (ftp, http, sftp, fish, torrent).  
 
|-
 
|-
|[https://github.com/Kingsford-Group/rnaseqtools rnaseqtools]
+
|libdap
|1.0.2-IGB-gcc-4.9.4
+
|
|This repo rnaseqtools provides a set of tools to process transcripts (mainly in gtf format).  
+
|A C++ SDK which contains an implementation of DAP 2.0 and the development versions of DAP3, up to 3.4. This includes both Client- and Server-side support classes.
 
|-
 
|-
|[https://root.cern.ch/ root]
+
|libdrm
|6.14.06-IGB-gcc-4.9.4
+
|
|A modular scientific software toolkit. It provides all the functionalities needed to deal with big data processing, statistical analysis, visualisation and storage. It is mainly written in C++ but integrated with other languages such as Python and R.
+
|Direct Rendering Manager runtime library.
 
|-
 
|-
|[http://rpy.sourceforge.net/ rpy]
+
|libevent
|1.0.3-IGB-gcc-4.9.4-Python-2.7.13-R-2.15.3
+
|
|RPy is a very simple, yet robust, Python interface to the R Programming Language. Itcan manage all kinds of R objects and can execute arbitrary R functionsincluding the graphic functions.
+
|The libevent API provides a mechanism to execute a callback function when a specific event occurs on a file descriptor or after a timeout has been reached. Furthermore, libevent also support callbacks due to signals or regular timeouts.
 
|-
 
|-
|[https://www.realtimegenomics.com/products/rtg-tools rtg-tools]
+
|libffi
|3.8.4
+
|
|RTG Tools contains utilities to easily manipulate and accurately compare multiple VCF files, as well as utilities for processing other common NGS data formats.
+
|The libffi library provides a portable, high level programming interface to various callingconventions. This allows a programmer to call any function specified by a call interface description at run-time.
 
|-
 
|-
|[https://github.com/najoshi/sabre sabre]
+
|libgd
|20171114-IGB-gcc-4.9.4
+
|
|Next-generation sequencing can currently produce hundreds of millions of reads per lane of sample and that number increases at a dizzying rate. Barcoding individual sequences for multiple lines or multiple species is a cost-efficient method to sequence and analyze a broad range of data.
+
|GD is an open source code library for the dynamic creation of images by programmers. - Homepage: http://libgd.bitbucket.org/
 
|-
 
|-
|[http://lomereiter.github.io/sambamba/ sambamba]
+
|[http://deeplearning.net/software/libgpuarray/ libgpuarray]
|0.6.6
+
|0.6.5-IGB-gcc-4.9.4
|sambamba view allows to efficiently filter SAM/BAM/CRAM files for alignments satisfying various conditions, as well as access its SAM header and information about reference sequences.
+
|Make a common GPU ndarray(n dimensions array) that can be reused by all projects that is as future proof as possible, while keeping it easy to use for simple need/quick test. - Homepage: http://deeplearning.net/software/libgpuarray/
 
|-
 
|-
|[https://github.com/GregoryFaust/samblaster samblaster]
+
|libgtextutils
|0.1.24-IGB-gcc-4.9.4
+
|
|ummary samblaster is a fast and flexible program for marking duplicates in read-id grouped1 paired-end SAM files. It can also optionally output discordant read pairs and/or split read mappings to separate SAM files, and/or unmapped/clipped reads to a separate FASTQ file. When marking duplicates, samblaster will require approximately 20MB of memory per 1M read pairs.
+
|ligtextutils is a dependency of fastx-toolkit and is provided via the same upstream - Homepage: http://hannonlab.cshl.edu/fastx_toolkit/
 
|-
 
|-
|[https://github.com/lebedov/scikit-cuda scikit-cuda]
+
|[http://libharu.org/ libharu]
|0.5.1-IGB-gcc-4.9.4-Python-2.7.13
+
|2.3.0-IGB-gcc-4.9.4
|scikit-cuda provides Python interfaces to many of the functions in the CUDA device/runtime, CUBLAS, CUFFT, and CUSOLVER libraries distributed as part of NVIDIAs CUDA Programming Toolkit, as well as interfaces to select functions in the free and standard versions of the CULA Dense Toolkit. Both low-level wrapper functions similar to their C counterparts and high-level functions comparable to those in NumPy and Scipy are provided.
+
|libHaru is a free, cross platform, open source library for generating PDF files. - Homepage: http://libharu.org/
 
|-
 
|-
|[https://github.com/nanoporetech/scrappie scrappie]
+
|libjpeg-turbo
|1.3.0-IGB-gcc-4.9.4
+
|
|Scrappie is a technology demonstrator for the Oxford Nanopore Research Algorithms group.
+
|libjpeg-turbo is a fork of the original IJG libjpeg which uses SIMD to accelerate baseline JPEGcompression and decompression. libjpeg is a library that implements JPEG image encoding, decoding and transcoding.
 
|-
 
|-
|[https://www.sentieon.com/ sentieon]
+
|libpciaccess
|201808
+
|
|A fast and accurate solution to variant calling from next-generation sequence data
+
|Generic PCI access library.
 
|-
 
|-
|[https://www.seqan.de/ seqan]
+
|libpng
|2.3.2-IGB-gcc-4.9.4
+
|
|SeqAn is an open source C++ library of efficient algorithms and data structures for the analysis of sequences with the focus on biological data
+
|libpng is the official PNG reference library
 
|-
 
|-
|[https://github.com/lh3/seqtk/ seqtk]
+
|libpthread-stubs
|1.2-IGB-gcc-4.9.4
+
|
|Seqtk is a fast and lightweight tool for processing sequences in the FASTA or FASTQ format.  It seamlessly parses both FASTA and FASTQ files which can also be optionally compressed by gzip. - Homepage: https://github.com/lh3/seqtk/
+
|The X protocol C-language Binding (XCB) is a replacement for Xlib featuring a small footprint,latency hiding, direct access to the protocol, improved threading support, and extensibility.
 
|-
 
|-
|[https://mathgen.stats.ox.ac.uk/genetics_software/shapeit/shapeit.html shapeit]
+
|libreadline
|2.20
+
|
|SHAPEIT is a fast and accurate method for estimation of haplotypes (aka phasing) from genotype or sequencing data.
+
|The GNU Readline library provides a set of functions for use by applications that allow users to edit command lines as they are typed in. Both Emacs and vi editing modes are available. The Readline library includes additional functions to maintain a list of previously-entered command lines, to recall and perhaps reedit those lines, and perform csh-like history expansion on previous commands.
 
|-
 
|-
|[https://www.gnu.org/software/sharutils/ sharutils]
+
|libsodium
|4.15.2-IGB-gcc-4.9.4
+
|
|GNU shar makes so-called shell archives out of many files, preparing them for transmission by electronic mail services, while unshar helps unpacking shell archives after reception.
+
|Sodium is a modern, easy-to-use software library for encryption, decryption, signatures, password hashing and more.
 
|-
 
|-
|[http://lowelab.ucsc.edu/snoscan/ snoscan]
+
|libxml2
|0.9.1-IGB-gcc-4.9.4-Perl-5.24.1<br>0.9.1-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded
+
|
|Search for C/D box methylation guide snoRNA genes in a genomic sequence
+
|Libxml2 is the XML C parser and toolchain developed for the Gnome project (but usable outside of the Gnome platform).
 
|-
 
|-
|[http://sourceforge.net/projects/snpeff/ snpEff]
+
|[http://support.10xgenomics.com/genome-exome/software/pipelines/latest/what-is-long-ranger longranger]
|4.3o-Java-1.8.0_121<br>4.3t-Java-1.8.0_152
+
|2.1.3<br>2.1.6<br>2.2.2
|SnpEff is a variant annotation and effect prediction tool.  It annotates and predicts the effects of genetic variants (such as amino acid changes).
+
|Long Ranger is a set of analysis pipelines that processes Chromium sequencing output to align reads and call and phase SNPs, indels, and structural variants. There are five main pipelines, each triggered by a longranger command
 
|-
 
|-
|[https://github.com/magnusmanske/snpomatic snpomatic]
+
|[https://support.10xgenomics.com/genome-exome/software/visualization/latest/what-is-loupe loupe]
|1.0-IGB-gcc-4.9.4
+
|2.1.1
|SNP-o-matic is a fast, stringent short-read mapping software. It supports a multitude of output types and formats, for uses in filtering reads, alignments, sequence-based genotyping calls, assisted reassembly of contigs etc.
+
|Loupe is a genome browser designed to visualize the Linked-Read data produced by the 10x Chromium Platform. Loupe is named for a jewelers loupe, which is used to inspect gems.
 
|-
 
|-
|[https://github.com/sparsehash/sparsehash sparsehash]
+
|lzo
|2.0.3-IGB-gcc-4.9.4
+
|
|This directory contains several hash-map implementations, similar inAPI to SGIs hash_map class, but with different performance characteristics.
+
|Portable lossless data compression library
 
|-
 
|-
|[http://eddylab.org/software.html squid]
+
|[https://bitbucket.org/liulab/mageck-vispr mageck-vispr]
|1.9g-IGB-gcc-4.9.4
+
|0.5.4-IGB-gcc-4.9.4-Python-3.6.1
|A C library that is bundled with much of the above software. C function library for sequence analysis.
+
|MAGeCK-VISPR is a comprehensive quality control, analysis and visualization workflow for CRISPR/Cas9 screens.
 
|-
 
|-
|[http://www.sanger.ac.uk/science/tools/ssaha2-0 ssaha2]
+
|[https://github.com/DpeerLab/magic magic]
|2.5.5-IGB-gcc-4.9.4
+
|0.1-IGB-gcc-4.9.4-Python-3.6.1
|SSAHA2 (Sequence Search and Alignment by Hashing Algorithm) is a pairwise sequence alignment program designed for the efficient mapping of sequencing reads onto genomic reference sequences.
+
|A diffusion-based imputation method reveals gene-gene interactions in single-cell RNA-sequencing data
 
|-
 
|-
|[http://www.sanger.ac.uk/science/tools/ssaha2-0 ssaha_pileup]
+
|[https://github.com/nanoporetech/medaka medaka]
|0.6-IGB-gcc-4.9.4
+
|0.1.0-IGB-gcc-4.9.4-Python-3.6.1
|SSAHA2: Sequence Search and Alignment by Hashing Algorithm
+
|Medaka demonstrates a framework for error correcting sequencing data, particularly aimed at nanopore sequencing. Tools are provided for both training and inference. The code exploits the keras deep learning library.
 
|-
 
|-
|[http://www.crypticlineage.net/pages/software.html strauto]
+
|[https://github.com/IGBIllinois/memprof memprof]
|1-IGB-gcc-4.9.4
+
|1.01
|Automation and Parallelization of STRUCTURE Analysis
+
|Memprof is HPC Cluster Program Profiler. It records the memory, processor, and IO usage of a process. It will then generate a graph of the results.
 
|-
 
|-
|[https://github.com/Illumina/strelka strelka]
+
|[https://bitbucket.org/biobakery/metaphlan2 metaphlan2]
|2.9.9
+
|2.6.0-IGB-gcc-4.9.4-Python-3.6.1<br>2.7.6-IGB-gcc-4.9.4-Python-2.7.13<br>2.7.8-IGB-gcc-4.9.4-Python-2.7.13<br>2.7.8-IGB-gcc-4.9.4-Python-3.6.1
|Strelka2 is a fast and accurate small variant caller optimized for analysis of germline variation in small cohorts and somatic variation in tumor/normal sample pairs.  
+
|MetaPhlAn is a computational tool for profiling the composition of microbial communities (Bacteria, Archaea, Eukaryotes and Viruses) from metagenomic shotgun sequencing data (i.e. not 16S) with species-level. With the newly added StrainPhlAn module, it is now possible to perform accurate strain-level microbial profiling.
 
|-
 
|-
|[https://web.stanford.edu/group/pritchardlab/structure.html structure]
+
|[https://www.agisoft.com/ metashape]
|2.3.4-IGB-gcc-4.9.4
+
|1.5.1-IGB-gcc-4.9.4
|The program structure is a free software package for using multi-locus genotype data to investigate population structure.
+
|photogrammetricprocessing of digital images and 3D spatial data generation
 
|-
 
|-
|[http://swift-lang.org/Swift-T/ swift-t]
+
|[https://github.com/LangilleLab/microbiome_helper microbiome_helper]
|1.3-IGB-gcc-4.9.4
+
|20171114-IGB-gcc-4.9.4
|Swift/T is a completely new implementation of the Swift language for high-performance computing. In this implementation, the Swift script is translated into an MPI program that uses the Turbine (hence, /T) and ADLB runtime libraries for highly scalable dataflow processing over MPI, without single-node bottlenecks.  
+
|An assortment of scripts to help process and automate various microbiome and metagenomic bioinformatic tools. We provide workflows, tutorials and a virtual box image to help researchers process microbial data.
 
|-
 
|-
|[https://www.synapse.org/ synapseclient]
+
|[http://microbiomeutil.sourceforge.net/ microbiomeutil]
|1.9.2-IGB-gcc-4.9.4-Python-3.6.1
+
|20110519-IGB-gcc-4.9.4
|Synapse is an open source software platform that data scientists can use to carry out, track, and communicate their research in real time.
+
|Contains ChimeraSlayer, WigeoN, and NAST-iEr
 
|-
 
|-
|[http://lowelab.ucsc.edu/tRNAscan-SE/ tRNAscan-SE]
+
|[https://github.com/lh3/miniasm miniasm]
|1.3.1-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded
+
|0.2-IGB-gcc-4.9.4
|tRNAscan-SE: a tool for finding transfer RNAs
+
|Miniasm is a very fast OLC-based de novo assembler for noisy long reads. It takes all-vs-all read self-mappings (typically by minimap) as input and outputs an assembly graph in the GFA format. Different from mainstream assemblers, miniasm does not have a consensus step. It simply concatenates pieces of read sequences to generate the final unitig sequences. Thus the per-base error rate is similar to the raw input reads.
 
|-
 
|-
|[http://samtools.sourceforge.net tabix]
+
|[https://github.com/lh3/minimap minimap]
|0.2.6-IGB-gcc-4.9.4
+
|0.2-IGB-gcc-4.9.4<br>2.11-IGB-gcc-4.9.4<br>2.16-IGB-gcc-4.9.4-Python-3.6.1<br>2.3-IGB-gcc-4.9.4<br>2.8-IGB-gcc-4.9.4
|Generic indexer for TAB-delimited genome position files
+
|Minimap is an experimental tool to efficiently find multiple approximate mapping positions between two sets of long sequences, such as between reads and reference genomes, between genomes and between long noisy reads.
 
|-
 
|-
|[https://github.com/lvclark/tagdigger tagdigger]
+
|[https://github.com/PacificBiosciences/minorseq/blob/54ac795d7c119d21a4611d91ac458cd3e2e2b30a/doc/INSTALL.md minorseq]
|1.1-IGB-gcc-4.9.4-Python-3.6.1
+
|20180314-IGB-gcc-4.9.4
|TagDigger is a program for processing FASTQ files from genotyping-by-sequencing (GBS) or restriction site-associated DNA sequencing (RAD-seq) experiments.
+
|Minor Variant Calling and Phasing Tools
 
|-
 
|-
|[http://www.gnu.org/software/tar/tar.html tar]
+
|[https://www.mdc-berlin.de/8551903/en/ mirdeep]
|1.32-IGB-gcc-8.2.0
+
|2.0.0.8-IGB-gcc-4.9.4
|tar: The GNU tape archiver
+
|miRDeep2 is a completely overhauled tool which discovers microRNA genes by analyzing sequenced RNAs.
 
|-
 
|-
|tbb
+
|[https://github.com/wdecoster/nanopack nanopack]
|
+
|1.0.0-IGB-gcc-4.9.4-Python-3.6.1
|Intel Threading Building Blocks 4.0 (Intel TBB) is a widely used, award-winning C++ template library for creating reliable, portable, and scalable parallel applications. Use Intel TBB for a simple and rapid way of developing robust task-based parallel applications that scale to available processor cores, are compatible with multiple environments, and are easier to maintain. Intel TBB is the most proficient way to implement future-proof parallel applications that tap into the power and performance of multicore and manycore hardware platforms.
+
|Easily install all my long read processing and analysis scripts simultaneously.
 
|-
 
|-
|[https://www.ncbi.nlm.nih.gov/genbank/tbl2asn2/ tbl2asn]
+
|[https://github.com/jts/nanopolish nanopolish]
|20180516<br>20190117
+
|0.10.1-IGB-gcc-4.9.4<br>0.10.2-IGB-gcc-4.9.4<br>0.11.0-IGB-gcc-4.9.4<br>0.6.0-IGB-gcc-4.9.4<br>0.7.1-IGB-gcc-4.9.4<br>0.7.1-IGB-gcc-4.9.4-159d92b<br>0.8.3-IGB-gcc-4.9.4<br>0.8.5-IGB-gcc-4.9.4<br>0.9.0-IGB-gcc-4.9.4
|Tbl2asn is a command-line program that automates the creation of sequence records for submission to GenBank
+
|Software package for signal-level analysis of Oxford Nanopore sequencing data.
 
|-
 
|-
|[http://tensorly.org/stable/home.html tensorly]
+
|[https://github.com/kblin/ncbi-genome-download ncbi-genome-download]
|0.4.2-IGB-gcc-4.9.4-Python-3.6.1
+
|0.2.9-IGB-gcc-4.9.4-Python-3.6.1
|Simple and Fast Tensor Learning in Python
+
|Some script to download bacterial and fungal genomes from NCBI after they restructured their FTP a while ago.
 
|-
 
|-
|[https://github.com/nanoporetech/tombo/ tombo]
+
|[https://github.com/ncbi/ncbi-vdb ncbi-vdb]
|1.5-IGB-gcc-4.9.4-Python-3.6.1
+
|2.8.2-IGB-gcc-4.9.4
|Tombo is a suite of tools primarily for the identification of modified nucleotides from nanopore sequencing data. Tombo also provides tools for the analysis and visualization of raw nanopore signal.
+
|The SRA Toolkit and SDK from NCBI is a collection of tools and libraries for using data in the INSDC Sequence Read Archives. - Homepage: https://github.com/ncbi/ncbi-vdb
 
|-
 
|-
|[http://hibberdlab.com/transrate/ transrate]
+
|[http://cran.r-project.org/web/packages/ncdf4 ncdf4]
|1.0.3
+
|1.16-IGB-gcc-4.9.4-R-3.3.3
|Transrate is software for de-novo transcriptome assembly quality analysis. It examines your assembly in detail and compares it to experimental evidence such as the sequencing reads, reporting quality scores for contigs and assemblies.
+
|This package provides a high-level R interface to data files written using Unidatas netCDF library (version 4 or earlier), which are binary data files that are portable across platforms and include metadata information in addition to the data sets.
 
|-
 
|-
|[https://github.com/laurikari/tre tre]
+
|ncurses
|20161208-IGB-gcc-4.9.4
+
|
|TRE is a lightweight, robust, and efficient POSIX compliant regexp matching library with some exciting features such as approximate (fuzzy) matching.The matching algorithm used in TRE uses linear worst-case time in the length of the text being searched, and quadratic worst-case time in the length of the used regular expression.In other words, the time complexity of the algorithm is O(M^2N), where M is the length of the regular expression and N is the length of the text. The used space is also quadratic on the length of the regex, but does not depend on the searched string. This quadratic behaviour occurs only on pathological cases which are probably very rare in practice.
+
|The Ncurses (new curses) library is a free software emulation of curses in System V Release 4.0, and more. It uses Terminfo format, supports pads and color and multiple highlights and forms characters and function-key mapping, and has all the other SYSV-curses enhancements over BSD Curses.
 
|-
 
|-
|[https://bitbucket.org/nygcresearch/treemix treemix]
+
|[http://www.unidata.ucar.edu/software/netcdf/ netCDF]
|1.13-IGB-gcc-4.9.4
+
|4.4.1.1-IGB-gcc-4.9.4
|TreeMix is a method for inferring the patterns of population splits and mixtures in the history of a set of populations. In the underlying model, the modern-day populations in a species are related to a common ancestor via a graph of ancestral populations. We use the allele frequencies in the modern populations to infer the structure of this graph.
+
|NetCDF (network Common Data Form) is a set of software libraries  and machine-independent data formats that support the creation, access, and sharing of array-oriented  scientific data.
 
|-
 
|-
|[http://tandem.bu.edu/trf/trf.html trf]
+
|[http://www.unidata.ucar.edu/software/netcdf/ netCDF-Fortran]
|4.0.9
+
|4.4.1-IGB-gcc-4.9.4
|Tandem Repeats Finder is a program to locate and display tandem repeats in DNA sequences.  
+
|NetCDF (network Common Data Form) is a set of software libraries and machine-independent data formats that support the creation, access, and sharing of array-oriented scientific data.
 
|-
 
|-
|[https://github.com/PacificBiosciences/unanimity/ unanimity]
+
|[http://www.lysator.liu.se/~nisse/nettle/ nettle]
|20180307-IGB-gcc-4.9.4
+
|3.3-IGB-gcc-4.9.4
|C++ library and its applications to generate and process accurate consensus sequences
+
|Nettle is a cryptographic library that is designed to fit easily in more or less any context: In crypto toolkits for object-oriented languages (C++, Python, Pike, ...), in applications like LSH or GNUPG, or even in kernel space.
 
|-
 
|-
|[https://www.rarlab.com/ unrar]
+
|[https://ninja-build.org/ ninja]
|5.7.3-IGB-gcc-4.9.4
+
|1.8.2-IGB-gcc-4.9.4
|RAR is a powerful archive manager.
+
|Ninja is a small build system with a focus on speed. It differs from other build systems in two major respects: it is designed to have its input files generated by a higher-level build system, and it is designed to run builds as fast as possible.
 +
|-
 +
|[http://github.com/wolever/nose-parameterized nose-parameterized]
 +
|0.6.0-IGB-gcc-4.9.4-Python-2.7.13
 +
|Parameterized testing with any Python test framework.
 +
|-
 +
|[http://www.novocraft.com/ novocraft]
 +
|3.08.00
 +
|Powerful tool designed for mapping of short reads onto a reference genome from Illumina, Ion Torrent, and 454 NGS platforms.
 
|-
 
|-
|udunits
+
|numactl
 
|
 
|
|UDUNITS supports conversion of unit specifications between formatted and binary forms, arithmetic manipulation of units, and conversion of values between compatible scales of measurement.
+
|The numactl program allows you to run your application program on specific cpus and memory nodes.It does this by supplying a NUMA memory policy to the operating system before running your program.The libnuma library provides convenient ways for you to add NUMA memory policies into your own program.
 
|-
 
|-
|[http://valgrind.org/downloads/ valgrind]
+
|[http://numba.pydata.org/ numba]
|3.13.0-IGB-gcc-4.9.4
+
|0.34.0-IGB-gcc-4.9.4-Python-2.7.13<br>0.34.0-IGB-gcc-4.9.4-Python-3.6.1
|Valgrind is an instrumentation framework for building dynamic analysis tools. There are Valgrind tools that can automatically detect many memory management and threading bugs, and profile your programs in detail. You can also use Valgrind to build new tools.
+
|Numba is an Open Source NumPy-aware optimizing compiler for Python sponsored by Continuum Analytics, Inc. It uses the remarkable LLVM compiler infrastructure to compile Python syntax to machine code.
 
|-
 
|-
|[http://csg.sph.umich.edu/liyanmin/vcfCodingSnps/index.shtml vcfCodingSnps]
+
|[http://www.numpy.org numpy]
|1.5
+
|1.14.1-IGB-gcc-4.9.4-Python-3.6.1
|vcfCodingSnps is a SNP annotation tool that annotates coding variants in VCF files.  
+
|NumPy is the fundamental package for scientific computing with Python. It contains among other things: a powerful N-dimensional array object, sophisticated (broadcasting) functions, tools for integrating C/C++ and Fortran code, useful linear algebra, Fourier transform, and random number capabilities. Besides its obvious scientific uses, NumPy can also be used as an efficient multi-dimensional container of generic data. Arbitrary data-types can be  defined. This allows NumPy to seamlessly and speedily integrate with a wide variety of databases.
 
|-
 
|-
|[https://github.com/vcflib/vcflib vcflib]
+
|[http://www.bork.embl.de/pal2nal/ pal2nal]
|1.0.0-rc2-IGB-gcc-8.2.0
+
|14-IGB-gcc-4.9.4
|a simple C++ library for parsing and manipulating VCF files, + many command-line utilities
+
|PAL2NAL is a program that converts a multiple sequence alignment of proteins and the corresponding DNA (or mRNA) sequences into a codon alignment.
 
|-
 
|-
|[https://github.com/velocyto-team/velocyto.py velocyto]
+
|[http://pandoc.org pandoc]
|0.17.17-IGB-gcc-4.9.4-Python-3.6.1
+
|2.2.3.2
|Velocyto is a library for the analysis of RNA velocity.
+
|If you need to convert files from one markup format into another, pandoc is your swiss-army knife
 
|-
 
|-
|[https://www.ebi.ac.uk/~zerbino/velvet/ velvet]
+
|[https://www.gnu.org/software/parallel/ parallel]
|1.2.10-IGB-gcc-4.9.4-kmer_121
+
|20170622-IGB-gcc-4.9.4
|Velvet is a de novo genomic assembler specially designed for short read sequencing technologies, such as Solexa or 454, developed by Daniel Zerbino and Ewan Birney at the European Bioinformatics Institute (EMBL-EBI), near Cambridge, in the United Kingdom.  
+
|parallel: GNU parallel is a shell tool for executing jobs in parallel using one or more computers.  
 
|-
 
|-
|[https://github.com/vgteam/vg vg]
+
|[http://compression.ca/pbzip2/ pbzip2]
|1.15.0
+
|1.1.13-IGB-gcc-4.9.4
|variation graph data structures, interchange formats, alignment, genotyping, and variant calling methods
+
|PBZIP2 is a parallel implementation of the bzip2 block-sorting file compressor that uses pthreads and achieves near-linear speedup on SMP machines.
 
|-
 
|-
|[https://github.com/ruanjue/wtdbg2 wtdbg2]
+
|[http://perfsuite.ncsa.illinois.edu/ perfsuite]
|2.3-IGB-gcc-4.9.4
+
|1.1.4-IGB-gcc-4.9.4
|Wtdbg2 is a de novo sequence assembler for long noisy reads produced by PacBio or Oxford Nanopore Technologies (ONT). It assembles raw reads without error correction and then builds the consensus from intermediate assembly output.
+
|PerfSuite is a collection of tools, utilities, and libraries for software performance analysis where the primary design goals are ease of use, comprehensibility, interoperability, and simplicity. This software can provide a good "entry point" for more detailed performance analysis and can help point the way towards selecting other tools and/or techniques using more specialized software if necessary (for example, tools/libraries from academic research groups or third-party commercial software).  
 
|-
 
|-
|x264
+
|[ftp://ftp.ebi.ac.uk/pub/databases/Pfam/Tools/README pfamscan]
|
+
|1.6-IGB-gcc-4.9.4-Perl-5.24.1
|x264 is a free software library and application for encoding video streams into the H.264/MPEG-4 AVC compression format, and is released under the terms of the GNU GPL. - Homepage: http://www.videolan.org/developers/x264.html
+
|This readme should help you get started with "pfam_scan.pl", which is for usewith the HMMER3 version of HMMER.
 +
|-
 +
|[https://github.com/pgmpy/pgmpy pgmpy]
 +
|20180320-IGB-gcc-4.9.4-Python-3.6.1
 +
|pgmpy is a python library for working with Probabilistic Graphical Models.
 
|-
 
|-
|xorg-macros
+
|[https://github.com/HRGV/phyloFlash phyloFlash]
|
+
|3.3-IGB-gcc-4.9.4
|X.org macros utilities.
+
|phyloFlash is a pipeline to rapidly reconstruct the SSU rRNAs and explore phylogenetic composition of an Illumina (meta)genomic or transcriptomic dataset.
 
|-
 
|-
|zlib
+
|[https://bitbucket.org/nsegata/phylophlan/wiki/phylophlan2 phylophlan2]
|
+
|0.34-IGB-gcc-4.9.4-Python-3.6.1
|zlib is designed to be a free, general-purpose, legally unencumbered -- that is, not covered by any patents -- lossless data-compression library for use on virtually any computer hardware and operating system.
+
|PhyloPhlAn is an integrated pipeline for large-scale phylogenetic profiling of genomes and metagenomes.
 
|-
 
|-
|[http://xianyi.github.com/OpenBLAS/ OpenBLAS]
+
|[http://zlib.net/pigz/ pigz]
|0.2.19-GCC-4.9.4-2.28-LAPACK-3.7.0-test
+
|2.3.4-IGB-gcc-4.9.4
|OpenBLAS is an optimized BLAS library based on GotoBLAS2 1.13 BSD version.
+
|pigz, which stands for parallel implementation of gzip, is a fully  functional replacement for gzip that exploits multiple processors and multiple cores  to the hilt when compressing data. pigz was written by Mark Adler, and uses the zlib  and pthread libraries.  
 
|-
 
|-
|[http://www.jalview.org/ Jalview]
+
|pixman
|2.11.0-Java-1.8.0_152
 
 
|
 
|
 +
|Pixman is a low-level software library for pixel manipulation, providing features such as imagecompositing and trapezoid rasterization. Important users of pixman are the cairo graphics library and the X server.
 
|-
 
|-
|Autotools
+
|pkg-config
 
|
 
|
|This bundle collect the standard GNU build tools: Autoconf, Automake and libtool
+
|pkg-config is a helper tool used when compiling applications and libraries. It helps you insert the correct compiler options on the command line so an application can use  gcc -o test test.c `pkg-config --libs --cflags glib-2.0` for instance, rather than hard-coding values on where to find glib (or other libraries). - Homepage: http://www.freedesktop.org/wiki/Software/pkg-config/
 
|-
 
|-
|VarScan
+
|[https://github.com/soedinglab/plass plass]
|2.3.9-Java-1.8.0_152
+
|2-c7e35-IGB-gcc-4.9.4
|
+
|Plass (Protein-Level ASSembler) is a software to assemble short read sequencing data on a protein level. The main purpose of Plass is the assembly of complex metagenomic datasets.
 
|-
 
|-
|[http://www.htslib.org/ HTSlib]
+
|[http://platanus.bio.titech.ac.jp/platanus-assembler platanus]
|1.4-IGB-gcc-4.9.4<br>1.5-IGB-gcc-4.9.4<br>1.9-IGB-gcc-4.9.4<br>1.9-IGB-gcc-8.2.0
+
|1.2.4
|A C library for reading/writing high-throughput sequencing data. This package includes the utilities bgzip and tabix
+
|Platanus is a novel de novo sequence assembler that can reconstruct genomic sequences ofhighly heterozygous diploids from massively parallel shotgun sequencing data.
 
|-
 
|-
|[https://github.com/arq5x/lumpy-sv lumpy]
+
|[https://www.cog-genomics.org/plink2 plink]
|0.3.0-IGB-gcc-4.9.4
+
|1.07<br>1.90
|A probabilistic framework for structural variant discovery.
+
|This is a comprehensive update to Shaun Purcells PLINK command-line program, developed by Christopher Chang with support from the NIH-NIDDKs Laboratory of Biological Modeling, the Purcell Lab at Mount Sinai School of Medicine, and others.  
 
|-
 
|-
|JUnit
+
|[https://github.com/nanoporetech/pomoxis pomoxis]
|
+
|0.1.0-IGB-gcc-4.9.4-Python-3.6.1
|A programmer-oriented testing framework for Java.
+
|Pomoxis contains a set of services to perform analysis of squiggles as they are produced in real-time along with fast pipelines for generating draft assemblies.
 
|-
 
|-
|[https://github.com/nf-core/tools nf-core]
+
|[https://github.com/arq5x/poretools poretools]
|1.6-IGB-gcc-4.9.4-Python-3.6.1
+
|0.6.0-IGB-gcc-4.9.4-Python-2.7.13
|A python package with helper tools for the nf-core community.
+
|a toolkit for working with nanopore sequencing data from Oxford Nanopore. - Homepage: https://github.com/arq5x/poretools
 
|-
 
|-
|[http://www.bioinformatics.babraham.ac.uk/projects/bismark/ Bismark]
+
|[http://matsen.fhcrc.org/pplacer/ pplacer]
|0.17.0-IGB-gcc-4.9.4-Perl-5.24.1<br>0.18.1-IGB-gcc-4.9.4-Perl-5.24.1<br>0.22.1-IGB-gcc-4.9.4-Perl-5.24.1
+
|1.1.alpha19
|A tool to map bisulfite converted sequence reads and determine cytosine methylation states
+
|Pplacer places query sequences on a fixed reference phylogenetic tree to maximize phylogenetic likelihood or posterior probability according to a reference alignment. Pplacer is designed to be fast, to give useful information about uncertainty, and to offer advanced visualization and downstream analysis.
 
|-
 
|-
|[http://www.gtk.org/ GLib]
+
|[http://smithlabresearch.org/software/preseq/ preseq]
|2.62.3-IGB-gcc-4.9.4
+
|2.0.3-IGB-gcc-4.9.4
|GLib is one of the base libraries of the GTK+ project
+
|The preseq package is aimed at predicting and estimating the complexity of a genomic sequencing library, equivalent to predicting and estimating the number of redundant reads from a given sequencing depth and how many will be expected from additional sequencing using an initial sequencing experiment.
 
|-
 
|-
|[http://bioinf.uni-greifswald.de/augustus/ AUGUSTUS]
+
|[http://www.primer3.org primer3]
|3.3-IGB-gcc-4.9.4
+
|2.4.0-IGB-gcc-4.9.4
|AUGUSTUS is a program that predicts genes in eukaryotic genomic sequences
+
|Primer3 is a widely used program for designing PCR primers (PCR = "Polymerase Chain Reaction"). PCR is an essential and ubiquitous tool in genetics and molecular biology. Primer3 can also design hybridization probes and sequencing primers.
 
|-
 
|-
|[http://bioinf.uni-greifswald.de/augustus/ augustus]
+
|[https://github.com/tseemann/prokka prokka]
|3.2.3-IGB-gcc-4.9.4<br>3.3.2-IGB-gcc-4.9.4
+
|1.12-IGB-gcc-4.9.4-Perl-5.24.1<br>1.13-IGB-gcc-4.9.4-Perl-5.24.1
|AUGUSTUS is a program that predicts genes in eukaryotic genomic sequences.  
+
|Whole genome annotation is the process of identifying features of interest in a set of genomic DNA sequences, and labelling them with useful information. Prokka is a software tool to annotate bacterial, archaeal and viral genomes quickly and produce standards-compliant output files.
 
|-
 
|-
|[https://github.com/baoe/AlignGraph AlignGraph]
+
|[https://github.com/google/protobuf protobuf]
|20180222-IGB-gcc-4.9.4
+
|2.6.1-IGB-gcc-4.9.4<br>3.5.0-IGB-gcc-4.9.4
|AlignGraph is a software that extends and joins contigs or scaffolds by reassembling them with help provided by a reference genome of a closely related organism.
+
|Protocol Buffers (a.k.a., protobuf) are Googles language-neutral, platform-neutral, extensible mechanism for serializing structured data.
 
|-
 
|-
|libgdiplus
+
|[https://github.com/lilydjwg/pssh pssh]
|
+
|2.3.1-IGB-gcc-4.9.4-Python-2.7.13
|An Open Source implementation of the GDI+ API
+
|PSSH provides parallel versions of OpenSSH and related tools, including pssh, pscp, prsync, pnuke and pslurp. This project includes psshlib which can be used within custom applications.
 
|-
 
|-
|Mono
+
|[https://daler.github.io/pybedtools/main.html pybedtools]
|
+
|0.7.10-IGB-gcc-4.9.4-Python-3.6.1
|An open source, cross-platform, implementation of C# and the CLR that is binary compatible with Microsoft.NET.
+
|pybedtools is a Python package that wraps BEDTools, so you will need both installed.
 
|-
 
|-
|[http://merenlab.org/software/anvio/ anvio]
+
|[https://github.com/brentp/pyfasta/ pyfasta]
|5.5-IGB-gcc-4.9.4-Python-3.6.1
+
|0.5.2-IGB-gcc-4.9.4-Python-2.7.13
|Anvi’o is an open-source, community-driven analysis and visualization platform for ‘omics data.
+
|Stores a flattened version of the fasta file without spaces or headers and uses either a mmap of numpy binary format or fseek/fread so the sequence data is never read into memory.
 
|-
 
|-
|[http://ant.apache.org/ ant]
+
|[http://deeplearning.net/software/libgpuarray pygpu]
|1.10.1-Java-1.8.0_121<br>1.10.1-Java-1.8.0_152
+
|0.6.5-IGB-gcc-4.9.4-Python-2.7.13
|Apache Ant is a Java library and command-line tool whose mission is to drive processes described in build files as targets and extension points dependent upon each other. The main known usage of Ant is the build of Java applications.
+
|Python bindings for libgpuarray - Homepage: http://deeplearning.net/software/libgpuarray
 
|-
 
|-
|singularity
+
|[https://pygraphviz.github.io/ pygraphviz]
|3.4.1
+
|1.3.1-IGB-gcc-4.9.4-Python-3.6.1
|Application and environment virtualization
+
|PyGraphviz is a Python interface to the Graphviz graph layout and visualization package. With PyGraphviz you can create, edit, read, write, and draw graphs using Python to access the Graphviz graph data structure and layout algorithms.
 
|-
 
|-
|[https://github.com/DRL/blobtools blobtools]
+
|[https://github.com/lisa-lab/pylearn2 pylearn2]
|0.9.19.6-IGB-gcc-4.9.4-Python-2.7.13<br>1.0.1-IGB-gcc-4.9.4-Python-2.7.13<br>1.1.1-IGB-gcc-4.9.4-Python-3.6.1
+
|20170525-IGB-gcc-4.9.4-Python-2.7.13
|Application for the visualisation of (draft) genome assemblies using TAGC (Taxon-annotated Gc-Coverage) plots
+
|Pylearn2 is a library designed to make machine learning research easy. - Homepage: https://github.com/lisa-lab/pylearn2
 
|-
 
|-
|Automake
+
|[http://qualimap.bioinfo.cipf.es/ qualimap]
|
+
|2.2.1-Java-1.8.0_121
|Automake: GNU Standards-compliant Makefile generator
+
|Qualimap 2 is a platform-independent application written in Java and R that provides both a Graphical User Inteface (GUI) and a command-line interface to facilitate the quality control of alignment sequencing data and its derivatives like feature counts.
 
|-
 
|-
|[https://github.com/pezmaster31/bamtools BamTools]
+
|[https://sourceforge.net/projects/quast/ quast]
|2.4.1-IGB-gcc-4.9.4<br>2.5.1-IGB-gcc-4.9.4
+
|4.6.1-IGB-gcc-4.9.4-Python-2.7.13<br>5.0.0-IGB-gcc-4.9.4-Python-3.6.1
|BamTools provides both a programmers API and an end-users toolkit for handling BAM files.
+
|QUAST performs fast and convenient quality evaluation and comparison of genome assemblies.  
 
|-
 
|-
|[https://www.tensorflow.org/ Tensorflow-GPU]
+
|[https://github.com/mahulchak/quickmerge quickmerge]
|1.13.1-IGB-gcc-4.9.4-Python-3.6.1<br>1.14.0-IGB-gcc-4.9.4-Python-3.6.1<br>1.2.1-IGB-gcc-4.9.4-Python-3.6.1<br>1.5.1-IGB-gcc-4.9.4-Python-3.6.1
+
|0.2-IGB-gcc-4.9.4-Python-2.7.13
|An open-source software library for Machine Intelligence
+
|quickmerge uses a simple concept to improve contiguity of genome assemblies based on long molecule sequences, often with dramatic outcomes. The program uses information from assemblies made with illumina short reads and PacBio long reads to improve contiguities of an assembly generated with PacBio long reads alone. This is counterintuitive because illumina short reads are not typically considered to cover genomic regions which PacBio long reads cannot. Although we have not evaluated this program for assemblies generated with Oxford nanopore sequences, the program should work with ONP-assemblies too.
 
|-
 
|-
|[http://www.htslib.org/ BCFtools]
+
|[http://rnaseq-mats.sourceforge.net/ rMATS]
|1.4-IGB-gcc-4.9.4<br>1.5-IGB-gcc-4.9.4<br>1.7-IGB-gcc-4.9.4<br>1.9-IGB-gcc-4.9.4
+
|3.2.5-IGB-gcc-4.9.4-Python-2.7.13
|BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF
+
|MATS is a computational tool to detect differential alternative splicing events from RNA-Seq data. The statistical model of MATS calculates the P-value and false discovery rate that the difference in the isoform ratio of a gene between two conditions exceeds a given user-defined threshold. From the RNA-Seq data, MATS can automatically detect and analyze alternative splicing events corresponding to all major types of alternative splicing patterns. MATS handles replicate RNA-Seq data from both paired and unpaired study design.
 
|-
 
|-
|[https://github.com/Gaius-Augustus/BRAKER BRAKER]
+
|[https://github.com/isovic/racon racon]
|2.1.2-IGB-gcc-4.9.4
+
|0.5.0-IGB-gcc-4.9.4-Python-2.7.13<br>0.5.0-IGB-gcc-4.9.4-Python-3.6.1
|BRAKER2 is an extension of BRAKER1 which allows for fully automated training of the gene prediction tools GeneMark-EX and AUGUSTUS from RNA-Seq and/or protein homology information, and that integrates the extrinsic evidence from RNA-Seq and protein homology information into the prediction.
+
|Racon is intended as a standalone consensus module to correct raw contigs generated by rapid assembly methods which do not include a consensus step, such as Miniasm.The goal of Racon is to generate genomic consensus which is of similar or better quality compared to the output generated by assembly methods which employ both error correction and consensus steps, while providing a speedup of several times compared to those methods.
 
|-
 
|-
|[https://github.com/tseemann/barrnap barrnap]
+
|[http://bioinformatics.psb.ugent.be/supplementary_data/erbon/nov2003/ randfold]
|0.9-IGB-gcc-4.9.4
+
|2.0.1-IGB-gcc-4.9.4
|Barrnap predicts the location of ribosomal RNA genes in genomes.
+
|Minimum free energy of folding randomization test software
 
|-
 
|-
|[https://github.com/biota/sourcetracker2 sourcetracker]
+
|[https://rclone.org/ rclone]
|2.0.1-IGB-gcc-4.9.4-Python-3.6.1
+
|1.41
|Bayesian community-wide culture-independent microbial source tracking
+
|Rclone is a command line program to sync files and directories to and from different cloud storage
 
|-
 
|-
|[http://www.biopython.org Biopython]
+
|[https://cran.r-project.org/web/packages/rgeos/index.html rgeos]
|1.68-IGB-gcc-4.9.4-Python-2.7.13<br>1.68-IGB-gcc-4.9.4-Python-3.6.1<br>1.76-IGB-gcc-4.9.4-Python-3.6.1
+
|0.4-2-IGB-gcc-4.9.4-R-3.5.0
|Biopython is a set of freely available tools for biological computation writtenin Python by an international team of developers. It is a distributed collaborative effort todevelop Python libraries and applications which address the needs of current and future work inbioinformatics.  
+
|nterface to Geometry Engine - Open Source (GEOS) using the C API for topology operations on geometries.
 
|-
 
|-
|[https://support.10xgenomics.com/single-cell-atac/software/pipelines/latest/what-is-cell-ranger-atac cellranger-atac]
+
|[https://github.com/Kingsford-Group/rnaseqtools rnaseqtools]
|1.1.0
+
|1.0.2-IGB-gcc-4.9.4
|Cell Ranger ATAC is a set of analysis pipelines that process Chromium Single Cell ATAC data.  
+
|This repo rnaseqtools provides a set of tools to process transcripts (mainly in gtf format).  
 
|-
 
|-
|[https://support.10xgenomics.com/single-cell-gene-expression/software/pipelines/latest/what-is-cell-ranger cellranger]
+
|[https://root.cern.ch/ root]
|2.1.0<br>2.1.1<br>3.0.0<br>3.0.1<br>3.1.0
+
|6.14.06-IGB-gcc-4.9.4
|Cell Ranger is a set of analysis pipelines that process Chromium single cell 3 RNA-seq output to align reads, generate gene-cell matrices and perform clustering and gene expression analysis.
+
|A modular scientific software toolkit. It provides all the functionalities needed to deal with big data processing, statistical analysis, visualisation and storage. It is mainly written in C++ but integrated with other languages such as Python and R.
 
|-
 
|-
|[http://clusterflow.io/ clusterflow]
+
|[http://rpy.sourceforge.net/ rpy]
|0.5-IGB-gcc-4.9.4-Perl-5.24.1
+
|1.0.3-IGB-gcc-4.9.4-Python-2.7.13-R-2.15.3
|Cluster Flow is workflow manager designed to run bioinformatics pipelines. It is operated through a single command cf, which can be used to launch, configure, monitor and cancel pipelines.
+
|RPy is a very simple, yet robust, Python interface to the R Programming Language. Itcan manage all kinds of R objects and can execute arbitrary R functionsincluding the graphic functions.
 
|-
 
|-
|[https://github.com/dellytools/delly delly]
+
|[https://www.realtimegenomics.com/products/rtg-tools rtg-tools]
|0.8.1-IGB-gcc-4.9.4
+
|3.8.4
|Delly is an integrated structural variant (SV) prediction method that can discover, genotype and visualize deletions, tandem duplications, inversions and translocations at single-nucleotide resolution in short-read massively parallel sequencing data.
+
|RTG Tools contains utilities to easily manipulate and accurately compare multiple VCF files, as well as utilities for processing other common NGS data formats.
 
|-
 
|-
|[http://www.bioinformatics.babraham.ac.uk/projects/fastqc/ FastQC]
+
|[https://github.com/najoshi/sabre sabre]
|0.11.5-IGB-gcc-4.9.4-Java-1.8.0_152<br>0.11.8-IGB-gcc-4.9.4-Java-1.8.0_152<br>0.11.8-Java-1.8.0_152
+
|20171114-IGB-gcc-4.9.4
|FastQC is a quality control application for high throughput sequence data. It reads in sequence data in a variety of formats and can either provide an interactive application to review the results of several different QC checks, or create an HTML based report which can be integrated into a pipeline.
+
|Next-generation sequencing can currently produce hundreds of millions of reads per lane of sample and that number increases at a dizzying rate. Barcoding individual sequences for multiple lines or multiple species is a cost-efficient method to sequence and analyze a broad range of data.
 
|-
 
|-
|GMP
+
|[http://lomereiter.github.io/sambamba/ sambamba]
|
+
|0.6.6
|GMP is a free library for arbitrary precision arithmetic, operating on signed integers, rational numbers, and floating point numbers.  
+
|sambamba view allows to efficiently filter SAM/BAM/CRAM files for alignments satisfying various conditions, as well as access its SAM header and information about reference sequences.
 
|-
 
|-
|[http://genomethreader.org/ GenomeThreader]
+
|[https://github.com/GregoryFaust/samblaster samblaster]
|1.7.1
+
|0.1.24-IGB-gcc-4.9.4
|GenomeThreader is a software tool to compute gene structure predictions. The gene structure predictions are calculated using a similarity-based approach where additional cDNA/EST and/or protein sequences are used to predict gene structures via spliced alignments. GenomeThreader was motivated by disabling limitations in GeneSeqer, a popular gene prediction program which is widely used for plant genome annotation.
+
|ummary samblaster is a fast and flexible program for marking duplicates in read-id grouped1 paired-end SAM files. It can also optionally output discordant read pairs and/or split read mappings to separate SAM files, and/or unmapped/clipped reads to a separate FASTQ file. When marking duplicates, samblaster will require approximately 20MB of memory per 1M read pairs.
 
|-
 
|-
|[http://subread.sourceforge.net/ Subread]
+
|[https://github.com/lebedov/scikit-cuda scikit-cuda]
|1.5.2-IGB-gcc-4.9.4<br>1.6.3-IGB-gcc-4.9.4<br>2.0.0-IGB-gcc-8.2.0
+
|0.5.1-IGB-gcc-4.9.4-Python-2.7.13
|High performance read alignment, quantification and mutation discovery
+
|scikit-cuda provides Python interfaces to many of the functions in the CUDA device/runtime, CUBLAS, CUFFT, and CUSOLVER libraries distributed as part of NVIDIAs CUDA Programming Toolkit, as well as interfaces to select functions in the free and standard versions of the CULA Dense Toolkit. Both low-level wrapper functions similar to their C counterparts and high-level functions comparable to those in NumPy and Scipy are provided.
 
|-
 
|-
|[http://java.com/ Java]
+
|[https://github.com/nanoporetech/scrappie scrappie]
|1.8.0_121<br>1.8.0_152<br>1.8.0_201<br>11.0.5
+
|1.3.0-IGB-gcc-4.9.4
|Java Platform, Standard Edition (Java SE) lets you develop and deploy Java applications on desktops and servers.
+
|Scrappie is a technology demonstrator for the Oxford Nanopore Research Algorithms group.
 
|-
 
|-
|[https://github.com/aidenlab/juicer Juicer]
+
|[https://www.sentieon.com/ sentieon]
|1.13.02-Java-1.8.0_152
+
|201808
|Juicer is a platform for analyzing kilobase resolution Hi-C data. In this distribution, we include the pipeline for generating Hi-C maps from fastq raw data files and command line tools for feature annotation on the Hi-C maps.
+
|A fast and accurate solution to variant calling from next-generation sequence data
 
|-
 
|-
|[https://ccb.jhu.edu/software/kraken/ Kraken2]
+
|[https://www.seqan.de/ seqan]
|2.0.8-beta-IGB-gcc-4.9.4
+
|2.3.2-IGB-gcc-4.9.4
|Kraken is a system for assigning taxonomic labels to short DNA sequences, usually obtained through metagenomic studies. Previous attempts by other bioinformatics software to accomplish this task have often used sequence alignment or machine learning techniques that were quite slow, leading to the development of less sensitive but much faster abundance estimation programs.
+
|SeqAn is an open source C++ library of efficient algorithms and data structures for the analysis of sequences with the focus on biological data
 
|-
 
|-
|[https://github.com/mitoNGS/MToolBox MToolBox]
+
|[https://github.com/lh3/seqtk/ seqtk]
|1.0-IGB-gcc-4.9.4<br>1.2.1-IGB-gcc-4.9.4
+
|1.2-IGB-gcc-4.9.4
|MToolBox is a highly automated bioinformatics pipeline to reconstruct and analyze human mitochondrial DNA from high throughput sequencing data. MToolBox includes an updated computational strategy to assemble mitochondrial genomes from Whole Exome and/or Genome Sequencing (PMID: 22669646) and an improved fragment-classify tool (PMID:22139932) for haplogroup assignment, functional and prioritization analysis of mitochondrial variants. MToolBox provides pathogenicity scores, profiles of genome variability and disease-associations for mitochondrial variants. MToolBox provides also a Variant Call Format file (version 4.0) featuring, for the first time, allele-specific heteroplasmy.
+
|Seqtk is a fast and lightweight tool for processing sequences in the FASTA or FASTQ format. It seamlessly parses both FASTA and FASTQ files which can also be optionally compressed by gzip. - Homepage: https://github.com/lh3/seqtk/
 
|-
 
|-
|[https://github.com/marbl/MashMap MashMap]
+
|[https://mathgen.stats.ox.ac.uk/genetics_software/shapeit/shapeit.html shapeit]
|2.0
+
|2.20
|MashMap implements a fast and approximate algorithm for computing local alignment boundaries between long DNA sequences. It can be useful for mapping genome assembly or long reads (PacBio/ONT) to reference genome(s).
+
|SHAPEIT is a fast and accurate method for estimation of haplotypes (aka phasing) from genotype or sequencing data.
 
|-
 
|-
|[http://www.coxdocs.org/doku.php?id=maxquant:start MaxQuant]
+
|[https://www.gnu.org/software/sharutils/ sharutils]
|1.6.7.0-IGB-gcc-4.9.4
+
|4.15.2-IGB-gcc-4.9.4
|MaxQuant is a proteomics software package designed for analyzing large mass-spectrometric data sets. It is specifically aimed at high-resolution MS data.  
+
|GNU shar makes so-called shell archives out of many files, preparing them for transmission by electronic mail services, while unshar helps unpacking shell archives after reception.
 
|-
 
|-
|[https://github.com/nanoporetech/megalodon/ megalodon]
+
|[http://lowelab.ucsc.edu/snoscan/ snoscan]
|1.0.0-IGB-gcc-4.9.4-Python-3.6.1
+
|0.9.1-IGB-gcc-4.9.4-Perl-5.24.1<br>0.9.1-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded
|Megalodon is a research tool for per-read and aggregated modified base and sequence variant calling by anchoring the information rich basecalling neural network output to a reference genome/transriptome.
+
|Search for C/D box methylation guide snoRNA genes in a genomic sequence
 
|-
 
|-
|[https://mesonbuild.com Meson]
+
|[http://sourceforge.net/projects/snpeff/ snpEff]
|0.51.2-IGB-gcc-4.9.4-Python-3.6.1
+
|4.3o-Java-1.8.0_121<br>4.3t-Java-1.8.0_152
|Meson is a cross-platform build system designed to be both as fast and as user friendly as possible.
+
|SnpEff is a variant annotation and effect prediction tool.  It annotates and predicts the effects of genetic variants (such as amino acid changes).
 
|-
 
|-
|[https://sourceforge.net/projects/lpsolve/ lpsolve]
+
|[https://github.com/magnusmanske/snpomatic snpomatic]
|5.5.2.5-IGB-gcc-4.9.4
+
|1.0-IGB-gcc-4.9.4
|Mixed Integer Linear Programming (MILP) solver
+
|SNP-o-matic is a fast, stringent short-read mapping software. It supports a multitude of output types and formats, for uses in filtering reads, alignments, sequence-based genotyping calls, assisted reassembly of contigs etc.
 
|-
 
|-
|[https://github.com/mcveanlab/mccortex McCortex]
+
|[https://github.com/sparsehash/sparsehash sparsehash]
|1.0.1-IGB-gcc-4.9.4
+
|2.0.3-IGB-gcc-4.9.4
|Multi-sample de novo assembly and variant calling using Linked de bruijn graphs. Variant calling with and without a reference genome. Between closely related samples or highly diverged ones. From bacterial to mammalian genomes. Minimal configuration. And it's free.
+
|This directory contains several hash-map implementations, similar inAPI to SGIs hash_map class, but with different performance characteristics.
 
|-
 
|-
|[https://ninja-build.org/ Ninja]
+
|[http://eddylab.org/software.html squid]
|1.9.0-IGB-gcc-4.9.4
+
|1.9g-IGB-gcc-4.9.4
|Ninja is a small build system with a focus on speed.
+
|A C library that is bundled with much of the above software. C function library for sequence analysis.
 
|-
 
|-
|[http://prinseq.sourceforge.net/ prinseq]
+
|[http://www.sanger.ac.uk/science/tools/ssaha2-0 ssaha2]
|0.20.4-IGB-gcc-4.9.4-Perl-5.24.1
+
|2.5.5-IGB-gcc-4.9.4
|PRINSEQ can be used to filter, reformat, or trim your genomic and metagenomic sequence data.  
+
|SSAHA2 (Sequence Search and Alignment by Hashing Algorithm) is a pairwise sequence alignment program designed for the efficient mapping of sequencing reads onto genomic reference sequences.
 
|-
 
|-
|[https://github.com/cschin/Peregrine Peregrine]
+
|[http://www.sanger.ac.uk/science/tools/ssaha2-0 ssaha_pileup]
|1.5.4
+
|0.6-IGB-gcc-4.9.4
|Peregrine & SHIMMER Genome Assembly Toolkit
+
|SSAHA2: Sequence Search and Alignment by Hashing Algorithm
 
|-
 
|-
|[https://github.com/broadinstitute/pilon pilon]
+
|[http://www.crypticlineage.net/pages/software.html strauto]
|1.22-Java-1.8.0_121<br>1.23-Java-1.8.0_152
+
|1-IGB-gcc-4.9.4
|Pilon is a software tool which can be used to:- Automatically improve draft assemblies- Find variation among strains, including large event detection
+
|Automation and Parallelization of STRUCTURE Analysis
 
|-
 
|-
|poppler
+
|[https://github.com/Illumina/strelka strelka]
|
+
|2.9.9
|Poppler is a PDF rendering library based on the xpdf-3.0 code base.
+
|Strelka2 is a fast and accurate small variant caller optimized for analysis of germline variation in small cohorts and somatic variation in tumor/normal sample pairs.  
 
|-
 
|-
|[http://jupyter.org/ jupyterlab]
+
|[https://web.stanford.edu/group/pritchardlab/structure.html structure]
|0.34.10-IGB-gcc-4.9.4-Python-3.6.1<br>0.35.6-IGB-gcc-4.9.4-Python-3.6.1<br>1.0.4-IGB-gcc-4.9.4-Python-3.6.1
+
|2.3.4-IGB-gcc-4.9.4
|Project Jupyter exists to develop open-source software, open-standards, and services for interactive computing across dozens of programming languages.
+
|The program structure is a free software package for using multi-locus genotype data to investigate population structure.
 
|-
 
|-
|[https://github.com/biocore/redbiom redbiom]
+
|[http://swift-lang.org/Swift-T/ swift-t]
|0.3.2-IGB-gcc-4.9.4-Python-3.6.1
+
|1.3-IGB-gcc-4.9.4
|Redbiom is a cache service for sample metadata and sample data.  
+
|Swift/T is a completely new implementation of the Swift language for high-performance computing. In this implementation, the Swift script is translated into an MPI program that uses the Turbine (hence, /T) and ADLB runtime libraries for highly scalable dataflow processing over MPI, without single-node bottlenecks.  
 
|-
 
|-
|[http://python.org/ Python]
+
|[https://www.synapse.org/ synapseclient]
|2.7.13-IGB-gcc-4.9.4<br>3.6.1-IGB-gcc-4.9.4<br>3.7.2-IGB-gcc-8.2.0
+
|1.9.2-IGB-gcc-4.9.4-Python-3.6.1
|Python is a programming language that lets you work more quickly and integrate your systems more effectively.
+
|Synapse is an open source software platform that data scientists can use to carry out, track, and communicate their research in real time.
 
|-
 
|-
|[http://catchenlab.life.illinois.edu/radinitio/ radinitio]
+
|[http://lowelab.ucsc.edu/tRNAscan-SE/ tRNAscan-SE]
|1.1.0-IGB-gcc-4.9.4-Python-3.6.1<br>1.1.1-IGB-gcc-4.9.4-Python-3.6.1
+
|1.3.1-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded
|RADinitio is a simulation pipeline for the assessment of RADseq experiments. Genetic data are forward simulated for a population of individuals from a designated reference genome.
+
|tRNAscan-SE: a tool for finding transfer RNAs
 
|-
 
|-
|[http://www.sqlite.org/ SQLite]
+
|[http://samtools.sourceforge.net tabix]
|3.17.0-IGB-gcc-4.9.4<br>3.17.0-IGB-gcc-8.2.0<br>3.30.1-IGB-gcc-4.9.4
+
|0.2.6-IGB-gcc-4.9.4
|SQLite: SQL Database Engine in a C Library
+
|Generic indexer for TAB-delimited genome position files
 
|-
 
|-
|[https://www.nextflow.io/ nextflow]
+
|[https://github.com/lvclark/tagdigger tagdigger]
|0.25.7-Java-1.8.0_121<br>0.26.3-Java-1.8.0_152<br>18.10.1-Java-1.8.0_152<br>19.07.0-Java-1.8.0_152
+
|1.1-IGB-gcc-4.9.4-Python-3.6.1
|Nextflow enables scalable and reproducible scientific workflows using software containers. It allows the adaptation of pipelines written in the most common scripting languages.  
+
|TagDigger is a program for processing FASTQ files from genotyping-by-sequencing (GBS) or restriction site-associated DNA sequencing (RAD-seq) experiments.  
 
|-
 
|-
|[https://github.com/Kingsford-Group/scallop scallop]
+
|[http://www.gnu.org/software/tar/tar.html tar]
|0.10.3-IGB-gcc-4.9.4<br>0.10.4-IGB-gcc-4.9.4
+
|1.32-IGB-gcc-8.2.0
|Scallop is an accurate reference-based transcript assembler. Scallop features its high accuracy in assembling multi-exon transcripts as well as lowly expressed transcripts.
+
|tar: The GNU tape archiver
 
|-
 
|-
|[https://skylign.org/ skylign]
+
|tbb
|1.1-IGB-gcc-4.9.4-Perl-5.24.1
+
|
|Skylign is a tool for creating logos representing both sequence alignments and profile hidden Markov models. Submit to the form on the right in order to produce (i) interactive logos for inclusion in webpages, or (ii) static logos for use in documents.
+
|Intel Threading Building Blocks 4.0 (Intel TBB) is a widely used, award-winning C++ template library for creating reliable, portable, and scalable parallel applications. Use Intel TBB for a simple and rapid way of developing robust task-based parallel applications that scale to available processor cores, are compatible with multiple environments, and are easier to maintain. Intel TBB is the most proficient way to implement future-proof parallel applications that tap into the power and performance of multicore and manycore hardware platforms.
 
|-
 
|-
|[https://support.10xgenomics.com/spatial-gene-expression/software/pipelines/latest/what-is-space-ranger spaceranger]
+
|[https://www.ncbi.nlm.nih.gov/genbank/tbl2asn2/ tbl2asn]
|1.0.0
+
|20180516<br>20190117
|Space Ranger is a set of analysis pipelines that process Visium spatial RNA-seq output and brightfield microscope images in order to detect tissue, align reads, generate feature-spot matrices, perform clustering and gene expression analysis, and place spots in spatial context on the slide image.
+
|Tbl2asn is a command-line program that automates the creation of sequence records for submission to GenBank
 
|-
 
|-
|[http://faculty.cse.tamu.edu/davis/suitesparse.html SuiteSparse]
+
|[http://tensorly.org/stable/home.html tensorly]
|5.4.0-IGB-gcc-4.9.4-METIS-5.1.0
+
|0.4.2-IGB-gcc-4.9.4-Python-3.6.1
|SuiteSparse is a collection of libraries manipulate sparse matrices.
+
|Simple and Fast Tensor Learning in Python
 
|-
 
|-
|Szip
+
|[https://github.com/nanoporetech/tombo/ tombo]
|
+
|1.5-IGB-gcc-4.9.4-Python-3.6.1
|Szip compression software, providing lossless compression of scientific data
+
|Tombo is a suite of tools primarily for the identification of modified nucleotides from nanopore sequencing data. Tombo also provides tools for the analysis and visualization of raw nanopore signal.
 
|-
 
|-
|[https://github.com/lanpa/tensorboardX tensorboardX]
+
|[http://hibberdlab.com/transrate/ transrate]
|1.9-IGB-gcc-4.9.4-Python-3.6.1
+
|1.0.3
|TensorBoardX lets you watch Tensors Flow without Tensorflow
+
|Transrate is software for de-novo transcriptome assembly quality analysis. It examines your assembly in detail and compares it to experimental evidence such as the sequencing reads, reporting quality scores for contigs and assemblies.
 
|-
 
|-
|GSL
+
|[https://github.com/laurikari/tre tre]
|
+
|20161208-IGB-gcc-4.9.4
|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.
+
|TRE is a lightweight, robust, and efficient POSIX compliant regexp matching library with some exciting features such as approximate (fuzzy) matching.The matching algorithm used in TRE uses linear worst-case time in the length of the text being searched, and quadratic worst-case time in the length of the used regular expression.In other words, the time complexity of the algorithm is O(M^2N), where M is the length of the regular expression and N is the length of the text. The used space is also quadratic on the length of the regex, but does not depend on the searched string. This quadratic behaviour occurs only on pathological cases which are probably very rare in practice.
 
|-
 
|-
|[http://software.broadinstitute.org/software/igv/ igv]
+
|[https://bitbucket.org/nygcresearch/treemix treemix]
|2.4.4-Java-1.8.0_152<br>2.7.2-Java-11.0.5<br>snapshot-Java-11.0.5
+
|1.13-IGB-gcc-4.9.4
|The Integrative Genomics Viewer (IGV) is a high-performance visualization tool for interactive exploration of large, integrated genomic datasets. It supports a wide variety of data types, including array-based and next-generation sequence data, and genomic annotations.
+
|TreeMix is a method for inferring the patterns of population splits and mixtures in the history of a set of populations. In the underlying model, the modern-day populations in a species are related to a common ancestor via a graph of ancestral populations. We use the allele frequencies in the modern populations to infer the structure of this graph.
 
|-
 
|-
|[https://www.rosettacommons.org/ rosetta]
+
|[http://tandem.bu.edu/trf/trf.html trf]
|2017.52-IGB-gcc-4.9.4
+
|4.0.9
|The Rosetta software suite includes algorithms for computational modeling and analysis of protein structures.  
+
|Tandem Repeats Finder is a program to locate and display tandem repeats in DNA sequences.  
 
|-
 
|-
|[https://github.com/genome/bam-readcount bam-readcount]
+
|[https://github.com/PacificBiosciences/unanimity/ unanimity]
|0.8.0-IGB-gcc-4.9.4
+
|20180307-IGB-gcc-4.9.4
|The purpose of this program is to generate metrics at single nucleotide positions.
+
|C++ library and its applications to generate and process accurate consensus sequences
 
|-
 
|-
|[http://www.usadellab.org/cms/?page=trimmomatic Trimmomatic]
+
|[https://www.rarlab.com/ unrar]
|0.36-Java-1.8.0_121<br>0.36-Java-1.8.0_152<br>0.38-Java-1.8.0_152
+
|5.7.3-IGB-gcc-4.9.4
|Trimmomatic performs a variety of useful trimming tasks for illumina paired-end and single ended data.The selection of trimming steps and their associated parameters are supplied on the command line.  
+
|RAR is a powerful archive manager.
 
|-
 
|-
|[https://trinotate.github.io/ Trinotate]
+
|udunits
|3.1.1-IGB-gcc-4.9.4-Perl-5.24.1
+
|
|Trinotate is a comprehensive annotation suite designed for automatic functional annotation of transcriptomes, particularly de novo assembled transcriptomes, from model or non-model organisms. Trinotate makes use of a number of different well referenced methods for functional annotation including homology search to known sequence data (BLAST+/SwissProt), protein domain identification (HMMER/PFAM), protein signal peptide and transmembrane domain prediction (signalP/tmHMM), and leveraging various annotation databases (eggNOG/GO/Kegg databases). All functional annotation data derived from the analysis of transcripts is integrated into a SQLite database which allows fast efficient searching for terms with specific qualities related to a desired scientific hypothesis or a means to create a whole annotation report for a transcriptome.
+
|UDUNITS supports conversion of unit specifications between formatted and binary forms, arithmetic manipulation of units, and conversion of values between compatible scales of measurement.
 
|-
 
|-
|[https://github.com/rrwick/Unicycler Unicycler]
+
|[http://valgrind.org/downloads/ valgrind]
|0.4.3-IGB-gcc-4.9.4-Python-3.6.1<br>0.4.4-IGB-gcc-4.9.4-Python-3.6.1<br>0.4.8-IGB-gcc-4.9.4-Python-3.6.1
+
|3.13.0-IGB-gcc-4.9.4
|Unicycler is an assembly pipeline for bacterial genomes. It can assemble Illumina-only read sets where it functions as a SPAdes-optimiser. It can also assembly long-read-only sets (PacBio or Nanopore) where it runs a miniasm+Racon pipeline. For the best possible assemblies, give it both Illumina reads and long reads, and it will conduct a hybrid assembly.
+
|Valgrind is an instrumentation framework for building dynamic analysis tools. There are Valgrind tools that can automatically detect many memory management and threading bugs, and profile your programs in detail. You can also use Valgrind to build new tools.
 
|-
 
|-
|[http://www.cse.lehigh.edu/~chen/software.htm VASP-E]
+
|[http://csg.sph.umich.edu/liyanmin/vcfCodingSnps/index.shtml vcfCodingSnps]
|20190225-IGB-gcc-4.9.4<br>20191112-IGB-gcc-4.9.4
+
|1.5
|VASP and VASP-E explore the idea that a solid geometric representation of molecular structures can be used to automatically deconstruct proteins into functional elements for the study of binding specificity.
+
|vcfCodingSnps is a SNP annotation tool that annotates coding variants in VCF files.  
 
|-
 
|-
|[https://www.ks.uiuc.edu/Research/vmd/ VMD]
+
|[https://github.com/vcflib/vcflib vcflib]
|1.9.3-IGB-gcc-4.9.4
+
|1.0.0-rc2-IGB-gcc-8.2.0
|VMD is a molecular visualization program for displaying, animating, and analyzing large biomolecular systems using 3-D graphics and built-in scripting.
+
|a simple C++ library for parsing and manipulating VCF files, + many command-line utilities
 
|-
 
|-
|[https://github.com/dmlc/xgboost xgboost]
+
|[https://github.com/velocyto-team/velocyto.py velocyto]
|0.80-IGB-gcc-4.9.4-Python-3.6.1
+
|0.17.17-IGB-gcc-4.9.4-Python-3.6.1
|XGBoost is an optimized distributed gradient boosting library designed to be highly efficient, flexible and portable. It implements machine learning algorithms under the Gradient Boosting framework.
+
|Velocyto is a library for the analysis of RNA velocity.
 
|-
 
|-
|libcerf
+
|[https://www.ebi.ac.uk/~zerbino/velvet/ velvet]
|
+
|1.2.10-IGB-gcc-4.9.4-kmer_121
|libcerf is a self-contained numeric library that provides an efficient and accurate implementation of complex error functions, along with Dawson, Faddeeva, and Voigt functions.
+
|Velvet is a de novo genomic assembler specially designed for short read sequencing technologies, such as Solexa or 454, developed by Daniel Zerbino and Ewan Birney at the European Bioinformatics Institute (EMBL-EBI), near Cambridge, in the United Kingdom.  
 
|-
 
|-
|[https://github.com/ginolhac/mapDamage mapDamage]
+
|[https://github.com/vgteam/vg vg]
|2.0.5-IGB-gcc-4.9.4-Python-2.7.13<br>2.0.9-IGB-gcc-4.9.4-Python-2.7.13
+
|1.15.0
|mapDamage2 is a computational framework written in Python and R, which tracks and quantifies DNA damage patterns among ancient DNA sequencing reads generated by Next-Generation Sequencing platforms.
+
|variation graph data structures, interchange formats, alignment, genotyping, and variant calling methods
 
|-
 
|-
|[https://github.com/mirnylab/pairtools pairtools]
+
|[https://github.com/ruanjue/wtdbg2 wtdbg2]
|0.3.0-IGB-gcc-4.9.4-Python-3.6.1
+
|2.3-IGB-gcc-4.9.4
|pairtools is a simple and fast command-line framework to process sequencing data from a Hi-C experiment.
+
|Wtdbg2 is a de novo sequence assembler for long noisy reads produced by PacBio or Oxford Nanopore Technologies (ONT). It assembles raw reads without error correction and then builds the consensus from intermediate assembly output.
 
|-
 
|-
|[http://www.hdfgroup.org/HDF5/ HDF5]
+
|x264
|1.10.4-IGB-gcc-8.2.0<br>1.8.12-IGB-gcc-4.9.4<br>1.8.18-IGB-gcc-4.9.4<br>1.8.18-IGB-gcc-8.2.0
+
|
|HDF5 is a unique technology suite that makes possible the management of extremely large and complex data collections.
+
|x264 is a free software library and application for encoding video streams into the H.264/MPEG-4 AVC compression format, and is released under the terms of the GNU GPL. - Homepage: http://www.videolan.org/developers/x264.html
 
|-
 
|-
|[http://bowtie-bio.sourceforge.net/bowtie2/index.shtml Bowtie2]
+
|xorg-macros
|2.1.0-IGB-gcc-4.9.4<br>2.3.1-IGB-gcc-4.9.4<br>2.3.2-IGB-gcc-4.9.4<br>2.3.5.1-IGB-gcc-4.9.4
+
|
|Bowtie 2 is an ultrafast and memory-efficient tool for aligning sequencing reads  to long reference sequences. It is particularly good at aligning reads of about 50 up to 100s or 1,000s  of characters, and particularly good at aligning to relatively long (e.g. mammalian) genomes.  Bowtie 2 indexes the genome with an FM Index to keep its memory footprint small: for the human genome,  its memory footprint is typically around 3.2 GB. Bowtie 2 supports gapped, local, and paired-end alignment modes.
+
|X.org macros utilities.
 
|-
 
|-
|[https://github.com/marbl/canu Canu]
+
|zlib
|1.4-IGB-gcc-4.9.4-Perl-5.24.1<br>1.5-IGB-gcc-4.9.4-Perl-5.24.1<br>1.6-IGB-gcc-4.9.4-Perl-5.24.1<br>1.7-IGB-gcc-4.9.4-Perl-5.24.1<br>1.7.1-IGB-gcc-4.9.4-Perl-5.24.1<br>1.8-IGB-gcc-4.9.4-Perl-5.24.1<br>1.9-IGB-gcc-8.2.0-Perl-5.28.1
+
|
|Canu is a fork of the Celera Assembler, designed for high-noise single-molecule sequencing (such as the PacBio RS II or Oxford Nanopore MinION).
+
|zlib is designed to be a free, general-purpose, legally unencumbered -- that is, not covered by any patents -- lossless data-compression library for use on virtually any computer hardware and operating system.
 
|-
 
|-
|[http://www.broadinstitute.org/gatk/ GATK]
+
|[http://www.jalview.org/ Jalview]
|3.7-Java-1.8.0_121<br>3.8-0-Java-1.8.0_121<br>3.8-0-Java-1.8.0_152<br>3.8-1-0-Java-1.8.0_152<br>4.0.4.0-IGB-gcc-4.9.4-Java-1.8.0_152-Python-3.6.1<br>4.0.9.0-IGB-gcc-4.9.4-Java-1.8.0_152-Python-3.6.1<br>4.1.4.0-Java-1.8.0_152
+
|2.11.0-Java-1.8.0_152
|Developed in the Data Sciences Platform at the Broad Institute, the toolkit offers a wide variety of tools with a primary focus on variant discovery and genotyping. Its powerful processing engine and high-performance computing features make it capable of taking on projects of any size.
+
|
 
|-
 
|-
|[http://easybuilders.github.com/easybuild/ EasyBuild]
+
|VarScan
|3.5.3<br>3.6.0<br>3.6.2<br>3.9.3
+
|2.3.9-Java-1.8.0_152
|EasyBuild is a software build and installation frameworkwritten in Python that allows you to install software in a structured,repeatable and robust way.
+
|
 
|-
 
|-
|[https://github.com/fchollet/keras Keras]
+
|[https://github.com/arq5x/lumpy-sv lumpy]
|2.0.6-IGB-gcc-4.9.4-Python-2.7.13<br>2.0.8-IGB-gcc-4.9.4-Python-3.6.1<br>2.1.2-IGB-gcc-4.9.4-Python-3.6.1<br>2.1.5-IGB-gcc-4.9.4-Python-3.6.1<br>2.2.0-IGB-gcc-4.9.4-Python-3.6.1<br>2.2.4-IGB-gcc-4.9.4-Python-3.6.1
+
|0.3.0-IGB-gcc-4.9.4
|Keras is a high-level neural networks API, written in Python and capable of running on top of TensorFlow, CNTK, or Theano.  
+
|A probabilistic framework for structural variant discovery.
 
|-
 
|-
|[http://glaros.dtc.umn.edu/gkhome/metis/metis/overview METIS]
+
|JUnit
|5.1.0-IGB-gcc-4.9.4
+
|
|METIS is a set of serial programs for partitioning graphs, partitioning finite element meshes,and producing fill reducing orderings for sparse matrices. The algorithms implemented in METIS are based on themultilevel recursive-bisection, multilevel k-way, and multi-constraint partitioning schemes.
+
|A programmer-oriented testing framework for Java.
 
|-
 
|-
|[https://github.com/taoliu/MACS/ MACS2]
+
|[https://github.com/nf-core/tools nf-core]
|2.1.1.20160309-IGB-gcc-4.9.4-Python-2.7.13<br>2.1.2-IGB-gcc-4.9.4-Python-2.7.13<br>2.2.5-IGB-gcc-4.9.4-Python-3.6.1
+
|1.6-IGB-gcc-4.9.4-Python-3.6.1
|Model Based Analysis for ChIP-Seq data
+
|A python package with helper tools for the nf-core community.
 
|-
 
|-
|[http://multiqc.info/ MultiQC]
+
|[http://www.bioinformatics.babraham.ac.uk/projects/bismark/ Bismark]
|0.9-IGB-gcc-4.9.4-Python-2.7.13<br>1.2-IGB-gcc-4.9.4-Python-2.7.13<br>1.6-IGB-gcc-4.9.4-Python-3.6.1<br>1.7-IGB-gcc-4.9.4-Python-3.6.1<br>1.7-IGB-gcc-8.2.0-Python-3.7.2
+
|0.17.0-IGB-gcc-4.9.4-Perl-5.24.1<br>0.18.1-IGB-gcc-4.9.4-Perl-5.24.1<br>0.22.1-IGB-gcc-4.9.4-Perl-5.24.1
|MultiQC searches a given directory for analysis logs and compiles a HTML report. Its a general use tool, perfect for summarising the output from numerous bioinformatics tools.
+
|A tool to map bisulfite converted sequence reads and determine cytosine methylation states
 
|-
 
|-
|[http://nodejs.org nodejs]
+
|[http://bioinf.uni-greifswald.de/augustus/ AUGUSTUS]
|10.16.2-IGB-gcc-4.9.4<br>9.9.0-IGB-gcc-4.9.4
+
|3.3-IGB-gcc-4.9.4
|Node.js is a platform built on Chromes JavaScript runtime  for easily building fast, scalable network applications. Node.js uses an  event-driven, non-blocking I/O model that makes it lightweight and efficient,  perfect for data-intensive real-time applications that run across distributed devices.
+
|AUGUSTUS is a program that predicts genes in eukaryotic genomic sequences
 
|-
 
|-
|[https://github.com/luntergroup/octopus octopus]
+
|[http://bioinf.uni-greifswald.de/augustus/ augustus]
|0.6.3-beta-IGB-gcc-8.2.0
+
|3.2.3-IGB-gcc-4.9.4<br>3.3.2-IGB-gcc-4.9.4
|Octopus is a mapping-based variant caller that implements several calling models within a unified haplotype-aware framework. Octopus takes inspiration from particle filtering by constructing a tree of haplotypes and dynamically pruning and extending the tree based on haplotype posterior probabilities in a sequential manner.  
+
|AUGUSTUS is a program that predicts genes in eukaryotic genomic sequences.  
 
|-
 
|-
|[https://github.com/PacificBiosciences/pb-assembly pb-assembly]
+
|[https://github.com/baoe/AlignGraph AlignGraph]
|0.0.6
+
|20180222-IGB-gcc-4.9.4
|PacBio Assembly Tool Suite
+
|AlignGraph is a software that extends and joins contigs or scaffolds by reassembling them with help provided by a reference genome of a closely related organism.
 
|-
 
|-
|[http://broadinstitute.github.io/picard/ picard]
+
|libgdiplus
|2.10.1-Java-1.8.0_121<br>2.10.1-Java-1.8.0_152<br>2.9.0-Java-1.8.0_121<br>2.9.4-Java-1.8.0_121
+
|
|A set of tools (in Java) for working with next generation sequencing data in the BAM  (http://samtools.github.io/hts-specs) format.
+
|An Open Source implementation of the GDI+ API
 
|-
 
|-
|[https://github.com/davidemms/OrthoFinder OrthoFinder]
+
|Mono
|2.2.7<br>2.3.7-IGB-gcc-4.9.4
+
|
|OrthoFinder is a fast, accurate and comprehensive platform for comparative genomics. It finds orthologs and orthogroups, infers rooted gene trees for all orthogroups and identifies all of the gene duplcation events in those gene trees.  
+
|An open source, cross-platform, implementation of C# and the CLR that is binary compatible with Microsoft.NET.
 
|-
 
|-
|[https://github.com/tbischler/PEAKachu peakachu]
+
|[http://merenlab.org/software/anvio/ anvio]
|1.1.3-IGB-gcc-4.9.4-Python-3.6.1
+
|5.5-IGB-gcc-4.9.4-Python-3.6.1
|Peak calling tool for CLIP-seq data
+
|Anvi’o is an open-source, community-driven analysis and visualization platform for ‘omics data.
 
|-
 
|-
|[https://github.com/pysam-developers/pysam Pysam]
+
|[http://ant.apache.org/ ant]
|0.13.0-IGB-gcc-4.9.4-Python-2.7.13<br>0.13.0-IGB-gcc-4.9.4-Python-3.6.1<br>0.15.3-IGB-gcc-4.9.4-Python-3.6.1
+
|1.10.1-Java-1.8.0_121<br>1.10.1-Java-1.8.0_152
|Pysam is a python module for reading and manipulating Samfiles. Its a lightweight wrapper of the samtools C-API. Pysam also includes an interface for tabix.
+
|Apache Ant is a Java library and command-line tool whose mission is to drive processes described in build files as targets and extension points dependent upon each other. The main known usage of Ant is the build of Java applications.
 
|-
 
|-
|[https://community.nanoporetech.com/posts/pre-release-of-stand-alone guppy-gpu]
+
|[https://github.com/DRL/blobtools blobtools]
|2.3.1<br>2.3.5<br>2.3.7<br>3.0.3<br>3.1.5<br>3.2.2<br>3.4.3
+
|0.9.19.6-IGB-gcc-4.9.4-Python-2.7.13<br>1.0.1-IGB-gcc-4.9.4-Python-2.7.13<br>1.1.1-IGB-gcc-4.9.4-Python-3.6.1
|Guppy is a stand-alone data bioinformatic toolkit that provides Oxford Nanopore Technologies basecalling algorithm, along with a number of post-processing tools.
+
|Application for the visualisation of (draft) genome assemblies using TAGC (Taxon-annotated Gc-Coverage) plots
 
|-
 
|-
|[http://qiime.org/ QIIME2]
+
|singularity
|2017.10<br>2017.11<br>2017.12<br>2017.6<br>2017.8<br>2018.11<br>2018.2<br>2018.4<br>2018.6<br>2018.8<br>2019.10<br>2019.4<br>2019.7
+
|3.4.1
|QIIME is an open-source bioinformatics pipeline for performing microbiome analysis from raw DNA sequencing data.
+
|Application and environment virtualization
 
|-
 
|-
|[https://github.com/velocyto-team/velocyto.R velocyto.R]
+
|Automake
|20190527-IGB-gcc-4.9.4-R-3.4.2
+
|
|RNA velocity estimation in R
+
|Automake: GNU Standards-compliant Makefile generator
 
|-
 
|-
|[http://cab.spbu.ru/software/spades/ SPAdes]
+
|[https://github.com/Gaius-Augustus/BRAKER BRAKER]
|3.10.1-IGB-gcc-4.9.4-Python-2.7.13<br>3.11.0-IGB-gcc-4.9.4-Python-2.7.13<br>3.11.0-IGB-gcc-4.9.4-Python-3.6.1<br>3.11.1-IGB-gcc-4.9.4-Python-3.6.1<br>3.13.1-IGB-gcc-8.2.0-Python-3.7.2
+
|2.1.2-IGB-gcc-4.9.4
|SPAdes . St. Petersburg genome assembler . is intended for both standard isolates and single-cell MDA bacteria assemblies.
+
|BRAKER2 is an extension of BRAKER1 which allows for fully automated training of the gene prediction tools GeneMark-EX and AUGUSTUS from RNA-Seq and/or protein homology information, and that integrates the extrinsic evidence from RNA-Seq and protein homology information into the prediction.
 
|-
 
|-
|[http://www.htslib.org/ SAMtools]
+
|[https://github.com/tseemann/barrnap barrnap]
|0.1.20-IGB-gcc-4.9.4<br>1.3.1-IGB-gcc-4.9.4<br>1.4-IGB-gcc-4.9.4<br>1.4.1-IGB-gcc-4.9.4<br>1.5-IGB-gcc-4.9.4<br>1.7-IGB-gcc-4.9.4<br>1.9-IGB-gcc-4.9.4
+
|0.9-IGB-gcc-4.9.4
|SAM Tools provide various utilities for manipulating alignments in the SAM format,  including sorting, merging, indexing and generating alignments in a per-position format.
+
|Barrnap predicts the location of ribosomal RNA genes in genomes.  
 
|-
 
|-
|[https://github.com/COMBINE-lab/salmon Salmon]
+
|[https://github.com/biota/sourcetracker2 sourcetracker]
|0.11.3-IGB-gcc-4.9.4<br>0.12.0-IGB-gcc-8.2.0<br>0.13.1-IGB-gcc-8.2.0<br>0.14.1-IGB-gcc-8.2.0<br>0.8.2-IGB-gcc-4.9.4-Python-2.7.13<br>0.9.1-IGB-gcc-4.9.4<br>1.0.0-IGB-gcc-8.2.0
+
|2.0.1-IGB-gcc-4.9.4-Python-3.6.1
|Salmon is a wicked-fast program to produce a highly-accurate, transcript-level quantification estimates from RNA-seq data.
+
|Bayesian community-wide culture-independent microbial source tracking
 
|-
 
|-
|[http://www.r-project.org/ R]
+
|[http://www.gtk.org/ GLib]
|2.15.3-IGB-gcc-4.9.4<br>3.1.2-IGB-gcc-4.9.4<br>3.2.5-IGB-gcc-4.9.4<br>3.3.3-IGB-gcc-4.9.4<br>3.4.1-IGB-gcc-4.9.4<br>3.4.2-IGB-gcc-4.9.4<br>3.5.0-IGB-gcc-4.9.4<br>3.6.0-IGB-gcc-8.2.0
+
|2.62.3-IGB-gcc-4.9.4
|R is a free software environment for statistical computing and graphics.
+
|GLib is one of the base libraries of the GTK+ project
 
|-
 
|-
|[https://www.kernel.org/pub/linux/utils/util-linux util-linux]
+
|[https://github.com/pezmaster31/bamtools BamTools]
|2.34-IGB-gcc-4.9.4
+
|2.4.1-IGB-gcc-4.9.4<br>2.5.1-IGB-gcc-4.9.4
|Set of Linux utilities
+
|BamTools provides both a programmers API and an end-users toolkit for handling BAM files.
 
|-
 
|-
|[http://meme-suite.org/ MEME]
+
|[https://www.tensorflow.org/ Tensorflow-GPU]
|4.11.2-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13<br>4.12.0-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13<br>5.0.1-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13<br>5.0.5-IGB-gcc-4.9.4
+
|1.13.1-IGB-gcc-4.9.4-Python-3.6.1<br>1.14.0-IGB-gcc-4.9.4-Python-3.6.1<br>1.2.1-IGB-gcc-4.9.4-Python-3.6.1<br>1.5.1-IGB-gcc-4.9.4-Python-3.6.1
|The MEME Suite allows you to: * discover motifs using MEME, DREME (DNA only) or  GLAM2 on groups of related DNA or protein sequences, * search sequence databases with motifs using  MAST, FIMO, MCAST or GLAM2SCAN, * compare a motif to all motifs in a database of motifs, * associate  motifs with Gene Ontology terms via their putative target genes, and * analyse motif enrichment  using SpaMo or CentriMo.
+
|An open-source software library for Machine Intelligence
 
|-
 
|-
|[https://developer.nvidia.com/cudnn cuDNN]
+
|[http://www.htslib.org/ HTSlib]
|5.1-IGB-gcc-4.9.4-CUDA-8.0.61<br>6.0-IGB-gcc-4.9.4-CUDA-8.0.61<br>7.0.5-IGB-gcc-4.9.4-CUDA-9.0.176<br>7.1.4-IGB-gcc-4.9.4-CUDA-9.0.176<br>7.6.1.34-CUDA-10.0.130
+
|1.4-IGB-gcc-4.9.4<br>1.5-IGB-gcc-4.9.4<br>1.9-IGB-gcc-4.9.4<br>1.9-IGB-gcc-8.2.0
|The NVIDIA CUDA Deep Neural Network library (cuDNN) is a GPU-accelerated library of primitives for    deep neural networks.
+
|A C library for reading/writing high-throughput sequencing data. This package includes the utilities bgzip and tabix
 
|-
 
|-
|[https://github.com/andyrimmer/Platypus Platypus]
+
|[http://www.htslib.org/ BCFtools]
|20180622-IGB-gcc-4.9.4-Python-2.7.13
+
|1.4-IGB-gcc-4.9.4<br>1.5-IGB-gcc-4.9.4<br>1.7-IGB-gcc-4.9.4<br>1.9-IGB-gcc-4.9.4
|The Platypus variant caller.
+
|BCFtools is a set of utilities that manipulate variant calls in the  Variant Call Format (VCF) and its binary counterpart BCF
 
|-
 
|-
|[https://github.com/chanzuckerberg/shasta shasta]
+
|[http://broadinstitute.github.io/picard/ picard]
|0.2.0
+
|2.10.1-Java-1.8.0_121<br>2.10.1-Java-1.8.0_152<br>2.9.0-Java-1.8.0_121<br>2.9.4-Java-1.8.0_121
|The goal of the Shasta long read assembler is to rapidly produce accurate assembled sequence using as input DNA reads generated by Oxford Nanopore flow cells.
+
|A set of tools (in Java) for working with next generation sequencing data in the BAM  (http://samtools.github.io/hts-specs) format.
 
|-
 
|-
|[https://cytoscape.org/ cytoscape]
+
|[http://www.biopython.org Biopython]
|3.3.0-Java-1.8.0_152-2.8tb<br>3.3.0-Java-1.8.0_152-350gb<br>3.7.0-Java-1.8.0_152-2.8tb<br>3.7.0-Java-1.8.0_152-350gb
+
|1.68-IGB-gcc-4.9.4-Python-2.7.13<br>1.68-IGB-gcc-4.9.4-Python-3.6.1<br>1.76-IGB-gcc-4.9.4-Python-3.6.1
|Cytoscape is an open source software platform for visualizing complex networks and integrating these with any type of attribute data.
+
|Biopython is a set of freely available tools for biological computation writtenin Python by an international team of developers. It is a distributed collaborative effort todevelop Python libraries and applications which address the needs of current and future work inbioinformatics.  
 
|-
 
|-
|[https://community.nanoporetech.com/posts/pre-release-of-stand-alone guppy]
+
|[http://bowtie-bio.sourceforge.net/bowtie2/index.shtml Bowtie2]
|2.1.3<br>2.2.2<br>2.3.1<br>2.3.7<br>3.0.3<br>3.1.5<br>3.2.2<br>3.4.3
+
|2.1.0-IGB-gcc-4.9.4<br>2.3.1-IGB-gcc-4.9.4<br>2.3.2-IGB-gcc-4.9.4<br>2.3.5.1-IGB-gcc-4.9.4
|Guppy is a stand-alone data bioinformatic toolkit that provides Oxford Nanopore Technologies basecalling algorithm, along with a number of post-processing tools.  
+
|Bowtie 2 is an ultrafast and memory-efficient tool for aligning sequencing reads  to long reference sequences. It is particularly good at aligning reads of about 50 up to 100s or 1,000s  of characters, and particularly good at aligning to relatively long (e.g. mammalian) genomes.  Bowtie 2 indexes the genome with an FM Index to keep its memory footprint small: for the human genome,  its memory footprint is typically around 3.2 GB. Bowtie 2 supports gapped, local, and paired-end alignment modes.
 
|-
 
|-
|[http://trinityrnaseq.github.io/ Trinity]
+
|[https://github.com/marbl/canu Canu]
|2.4.0-IGB-gcc-4.9.4<br>2.5.0-IGB-gcc-4.9.4<br>2.6.5-IGB-gcc-4.9.4<br>2.8.5-IGB-gcc-4.9.4
+
|1.4-IGB-gcc-4.9.4-Perl-5.24.1<br>1.5-IGB-gcc-4.9.4-Perl-5.24.1<br>1.6-IGB-gcc-4.9.4-Perl-5.24.1<br>1.7-IGB-gcc-4.9.4-Perl-5.24.1<br>1.7.1-IGB-gcc-4.9.4-Perl-5.24.1<br>1.8-IGB-gcc-4.9.4-Perl-5.24.1<br>1.9-IGB-gcc-8.2.0-Perl-5.28.1
|Trinity represents a novel method for the efficient and robust de novo reconstruction of transcriptomes from RNA-Seq data. Trinity combines three independent software modules: Inchworm, Chrysalis, and Butterfly, applied sequentially to process large volumes of RNA-Seq reads.
+
|Canu is a fork of the Celera Assembler, designed for high-noise single-molecule sequencing (such as the PacBio RS II or Oxford Nanopore MinION).
 
|-
 
|-
|[https://github.com/COMBINE-lab/SalmonTools SalmonTools]
+
|[https://support.10xgenomics.com/single-cell-atac/software/pipelines/latest/what-is-cell-ranger-atac cellranger-atac]
|20190604-IGB-gcc-8.2.0
+
|1.1.0
|Useful tools for working with Salmon output
+
|Cell Ranger ATAC is a set of analysis pipelines that process Chromium Single Cell ATAC data.
 
|-
 
|-
|[https://github.com/PacificBiosciences/ccs pbccs]
+
|[https://support.10xgenomics.com/single-cell-gene-expression/software/pipelines/latest/what-is-cell-ranger cellranger]
|4.0
+
|2.1.0<br>2.1.1<br>3.0.0<br>3.0.1<br>3.1.0
|ccs takes multiple subreads of the same SMRTbell molecule and combines them using a statistical model to produce one highly accurate consensus sequence, also called HiFi read, with base quality values.
+
|Cell Ranger is a set of analysis pipelines that process Chromium single cell 3 RNA-seq output to align reads, generate gene-cell matrices and perform clustering and gene expression analysis.
 
|-
 
|-
|[https://github.com/alexdobin/STAR STAR]
+
|[http://clusterflow.io/ clusterflow]
|2.5.3a-IGB-gcc-4.9.4<br>2.6.0c-IGB-gcc-4.9.4<br>2.6.1b-IGB-gcc-4.9.4<br>2.7.0d-IGB-gcc-8.2.0<br>2.7.0f-IGB-gcc-8.2.0<br>2.7.3a-IGB-gcc-8.2.0
+
|0.5-IGB-gcc-4.9.4-Perl-5.24.1
|STAR aligns RNA-seq reads to a reference genome using uncompressed suffix arrays.
+
|Cluster Flow is workflow manager designed to run bioinformatics pipelines. It is operated through a single command cf, which can be used to launch, configure, monitor and cancel pipelines.
 
|-
 
|-
|[https://github.com/Discngine/fpocket fpocket]
+
|[https://github.com/dellytools/delly delly]
|3.1.3-IGB-gcc-4.9.4
+
|0.8.1-IGB-gcc-4.9.4
|fpocket is a very fast open source protein pocket detection algorithm based on Voronoi tessellation.  
+
|Delly is an integrated structural variant (SV) prediction method that can discover, genotype and visualize deletions, tandem duplications, inversions and translocations at single-nucleotide resolution in short-read massively parallel sequencing data.
 +
|-
 +
|[http://www.broadinstitute.org/gatk/ GATK]
 +
|3.7-Java-1.8.0_121<br>3.8-0-Java-1.8.0_121<br>3.8-0-Java-1.8.0_152<br>3.8-1-0-Java-1.8.0_152<br>4.0.4.0-IGB-gcc-4.9.4-Java-1.8.0_152-Python-3.6.1<br>4.0.9.0-IGB-gcc-4.9.4-Java-1.8.0_152-Python-3.6.1<br>4.1.4.0-Java-1.8.0_152
 +
|Developed in the Data Sciences Platform at the Broad Institute, the toolkit offers a wide variety of tools with a primary focus on variant discovery and genotyping. Its powerful processing engine and high-performance computing features make it capable of taking on projects of any size.
 +
|-
 +
|[http://www.bioinformatics.babraham.ac.uk/projects/fastqc/ FastQC]
 +
|0.11.5-IGB-gcc-4.9.4-Java-1.8.0_152<br>0.11.8-IGB-gcc-4.9.4-Java-1.8.0_152<br>0.11.8-Java-1.8.0_152
 +
|FastQC is a quality control application for high throughput sequence data. It reads in sequence data in a variety of formats and can either provide an interactive application to review the results of several different QC checks, or create an HTML based report which can be integrated into a pipeline.
 +
|-
 +
|GMP
 +
|
 +
|GMP is a free library for arbitrary precision arithmetic, operating on signed integers, rational numbers, and floating point numbers.
 +
|-
 +
|[http://genomethreader.org/ GenomeThreader]
 +
|1.7.1
 +
|GenomeThreader is a software tool to compute gene structure predictions. The gene structure predictions are calculated using a similarity-based approach where additional cDNA/EST and/or protein sequences are used to predict gene structures via spliced alignments. GenomeThreader was motivated by disabling limitations in GeneSeqer, a popular gene prediction program which is widely used for plant genome annotation.
 +
|-
 +
|[http://subread.sourceforge.net/ Subread]
 +
|1.5.2-IGB-gcc-4.9.4<br>1.6.3-IGB-gcc-4.9.4<br>2.0.0-IGB-gcc-8.2.0
 +
|High performance read alignment, quantification and mutation discovery
 +
|-
 +
|[http://www.hdfgroup.org/HDF5/ HDF5]
 +
|1.10.4-IGB-gcc-8.2.0<br>1.8.12-IGB-gcc-4.9.4<br>1.8.18-IGB-gcc-4.9.4<br>1.8.18-IGB-gcc-8.2.0
 +
|HDF5 is a unique technology suite that makes possible the management of extremely large and complex data collections.
 +
|-
 +
|[https://cytoscape.org/ cytoscape]
 +
|3.3.0-Java-1.8.0_152-2.8tb<br>3.3.0-Java-1.8.0_152-350gb<br>3.7.0-Java-1.8.0_152-2.8tb<br>3.7.0-Java-1.8.0_152-350gb
 +
|Cytoscape is an open source software platform for visualizing complex networks and integrating these with any type of attribute data.
 
|-
 
|-
|[http://rpy.sourceforge.net/ rpy2]
+
|[http://easybuilders.github.com/easybuild/ EasyBuild]
|2.8.6-IGB-gcc-4.9.4-Python-2.7.13-R-3.3.3<br>2.8.6-IGB-gcc-4.9.4-Python-2.7.13-R-3.5.0<br>2.9.0-IGB-gcc-4.9.4-Python-3.6.1-R-3.3.3<br>3.0.1-IGB-gcc-4.9.4-Python-3.6.1-R-3.5.0<br>3.2.4-IGB-gcc-4.9.4-Python-3.6.1-R-3.5.0
+
|3.5.3<br>3.6.0<br>3.6.2<br>3.9.3
 +
|EasyBuild is a software build and installation frameworkwritten in Python that allows you to install software in a structured,repeatable and robust way.
 +
|-
 +
|[https://community.nanoporetech.com/posts/pre-release-of-stand-alone guppy-gpu]
 +
|2.3.1<br>2.3.5<br>2.3.7<br>3.0.3<br>3.1.5<br>3.2.2<br>3.4.3
 +
|Guppy is a stand-alone data bioinformatic toolkit that provides Oxford Nanopore Technologies basecalling algorithm, along with a number of post-processing tools.
 +
|-
 +
|[https://community.nanoporetech.com/posts/pre-release-of-stand-alone guppy]
 +
|2.1.3<br>2.2.2<br>2.3.1<br>2.3.7<br>3.0.3<br>3.1.5<br>3.2.2<br>3.4.3
 +
|Guppy is a stand-alone data bioinformatic toolkit that provides Oxford Nanopore Technologies basecalling algorithm, along with a number of post-processing tools.
 +
|-
 +
|[http://java.com/ Java]
 +
|1.8.0_121<br>1.8.0_152<br>1.8.0_201<br>11.0.5
 +
|Java Platform, Standard Edition (Java SE) lets you develop and deploy Java applications on desktops and servers.
 +
|-
 +
|[https://github.com/aidenlab/juicer Juicer]
 +
|1.13.02-Java-1.8.0_152
 +
|Juicer is a platform for analyzing kilobase resolution Hi-C data. In this distribution, we include the pipeline for generating Hi-C maps from fastq raw data files and command line tools for feature annotation on the Hi-C maps.
 +
|-
 +
|[https://github.com/fchollet/keras Keras]
 +
|2.0.6-IGB-gcc-4.9.4-Python-2.7.13<br>2.0.8-IGB-gcc-4.9.4-Python-3.6.1<br>2.1.2-IGB-gcc-4.9.4-Python-3.6.1<br>2.1.5-IGB-gcc-4.9.4-Python-3.6.1<br>2.2.0-IGB-gcc-4.9.4-Python-3.6.1<br>2.2.4-IGB-gcc-4.9.4-Python-3.6.1
 +
|Keras is a high-level neural networks API, written in Python and capable of running on top of TensorFlow, CNTK, or Theano.
 +
|-
 +
|[https://ccb.jhu.edu/software/kraken/ Kraken2]
 +
|2.0.8-beta-IGB-gcc-4.9.4
 +
|Kraken is a system for assigning taxonomic labels to short DNA sequences, usually obtained through metagenomic studies. Previous attempts by other bioinformatics software to accomplish this task have often used sequence alignment or machine learning techniques that were quite slow, leading to the development of less sensitive but much faster abundance estimation programs.
 +
|-
 +
|[http://glaros.dtc.umn.edu/gkhome/metis/metis/overview METIS]
 +
|5.1.0-IGB-gcc-4.9.4
 +
|METIS is a set of serial programs for partitioning graphs, partitioning finite element meshes,and producing fill reducing orderings for sparse matrices. The algorithms implemented in METIS are based on themultilevel recursive-bisection, multilevel k-way, and multi-constraint partitioning schemes.
 +
|-
 +
|[https://github.com/mitoNGS/MToolBox MToolBox]
 +
|1.0-IGB-gcc-4.9.4<br>1.2.1-IGB-gcc-4.9.4
 +
|MToolBox is a highly automated bioinformatics pipeline to reconstruct and analyze human mitochondrial DNA from high throughput sequencing data. MToolBox includes an updated computational strategy to assemble mitochondrial genomes from Whole Exome and/or Genome Sequencing (PMID: 22669646) and an improved fragment-classify tool (PMID:22139932) for haplogroup assignment, functional and prioritization analysis of mitochondrial variants. MToolBox provides pathogenicity scores, profiles of genome variability and disease-associations for mitochondrial variants. MToolBox provides also a Variant Call Format file (version 4.0) featuring, for the first time, allele-specific heteroplasmy.
 +
|-
 +
|[https://github.com/marbl/MashMap MashMap]
 +
|2.0
 +
|MashMap implements a fast and approximate algorithm for computing local alignment boundaries between long DNA sequences. It can be useful for mapping genome assembly or long reads (PacBio/ONT) to reference genome(s).
 +
|-
 +
|[http://www.coxdocs.org/doku.php?id=maxquant:start MaxQuant]
 +
|1.6.7.0-IGB-gcc-4.9.4
 +
|MaxQuant is a proteomics software package designed for analyzing large mass-spectrometric data sets. It is specifically aimed at high-resolution MS data.
 +
|-
 +
|[https://github.com/nanoporetech/megalodon/ megalodon]
 +
|1.0.0-IGB-gcc-4.9.4-Python-3.6.1
 +
|Megalodon is a research tool for per-read and aggregated modified base and sequence variant calling by anchoring the information rich basecalling neural network output to a reference genome/transriptome.
 +
|-
 +
|[https://mesonbuild.com Meson]
 +
|0.51.2-IGB-gcc-4.9.4-Python-3.6.1
 +
|Meson is a cross-platform build system designed to be both as fast and as user friendly as possible.
 +
|-
 +
|[https://sourceforge.net/projects/lpsolve/ lpsolve]
 +
|5.5.2.5-IGB-gcc-4.9.4
 +
|Mixed Integer Linear Programming (MILP) solver
 +
|-
 +
|[https://github.com/taoliu/MACS/ MACS2]
 +
|2.1.1.20160309-IGB-gcc-4.9.4-Python-2.7.13<br>2.1.2-IGB-gcc-4.9.4-Python-2.7.13<br>2.2.5-IGB-gcc-4.9.4-Python-3.6.1
 +
|Model Based Analysis for ChIP-Seq data
 +
|-
 +
|[https://github.com/mcveanlab/mccortex McCortex]
 +
|1.0.1-IGB-gcc-4.9.4
 +
|Multi-sample de novo assembly and variant calling using Linked de bruijn graphs. Variant calling with and without a reference genome. Between closely related samples or highly diverged ones. From bacterial to mammalian genomes. Minimal configuration. And it's free.
 +
|-
 +
|[http://xianyi.github.com/OpenBLAS/ OpenBLAS]
 +
|0.2.19-GCC-4.9.4-2.28-LAPACK-3.7.0-test
 +
|OpenBLAS is an optimized BLAS library based on GotoBLAS2 1.13 BSD version.
 +
|-
 +
|[https://www.nextflow.io/ nextflow]
 +
|0.25.7-Java-1.8.0_121<br>0.26.3-Java-1.8.0_152<br>18.10.1-Java-1.8.0_152<br>19.07.0-Java-1.8.0_152
 +
|Nextflow enables scalable and reproducible scientific workflows using software containers. It allows the adaptation of pipelines written in the most common scripting languages.
 +
|-
 +
|[http://multiqc.info/ MultiQC]
 +
|0.9-IGB-gcc-4.9.4-Python-2.7.13<br>1.2-IGB-gcc-4.9.4-Python-2.7.13<br>1.6-IGB-gcc-4.9.4-Python-3.6.1<br>1.7-IGB-gcc-4.9.4-Python-3.6.1<br>1.7-IGB-gcc-8.2.0-Python-3.7.2
 +
|MultiQC searches a given directory for analysis logs and compiles a HTML report. Its a general use tool, perfect for summarising the output from numerous bioinformatics tools.
 +
|-
 +
|[https://ninja-build.org/ Ninja]
 +
|1.9.0-IGB-gcc-4.9.4
 +
|Ninja is a small build system with a focus on speed.
 +
|-
 +
|[http://nodejs.org nodejs]
 +
|10.16.2-IGB-gcc-4.9.4<br>9.9.0-IGB-gcc-4.9.4
 +
|Node.js is a platform built on Chromes JavaScript runtime  for easily building fast, scalable network applications. Node.js uses an  event-driven, non-blocking I/O model that makes it lightweight and efficient,  perfect for data-intensive real-time applications that run across distributed devices.
 +
|-
 +
|[https://github.com/luntergroup/octopus octopus]
 +
|0.6.3-beta-IGB-gcc-8.2.0
 +
|Octopus is a mapping-based variant caller that implements several calling models within a unified haplotype-aware framework. Octopus takes inspiration from particle filtering by constructing a tree of haplotypes and dynamically pruning and extending the tree based on haplotype posterior probabilities in a sequential manner.
 +
|-
 +
|[https://github.com/davidemms/OrthoFinder OrthoFinder]
 +
|2.2.7<br>2.3.7-IGB-gcc-4.9.4
 +
|OrthoFinder is a fast, accurate and comprehensive platform for comparative genomics. It finds orthologs and orthogroups, infers rooted gene trees for all orthogroups and identifies all of the gene duplcation events in those gene trees.
 +
|-
 +
|[http://prinseq.sourceforge.net/ prinseq]
 +
|0.20.4-IGB-gcc-4.9.4-Perl-5.24.1
 +
|PRINSEQ can be used to filter, reformat, or trim your genomic and metagenomic sequence data.
 +
|-
 +
|[https://github.com/PacificBiosciences/pb-assembly pb-assembly]
 +
|0.0.6
 +
|PacBio Assembly Tool Suite
 +
|-
 +
|[https://github.com/tbischler/PEAKachu peakachu]
 +
|1.1.3-IGB-gcc-4.9.4-Python-3.6.1
 +
|Peak calling tool for CLIP-seq data
 +
|-
 +
|[https://github.com/cschin/Peregrine Peregrine]
 +
|1.5.4
 +
|Peregrine & SHIMMER Genome Assembly Toolkit
 +
|-
 +
|[https://github.com/broadinstitute/pilon pilon]
 +
|1.22-Java-1.8.0_121<br>1.23-Java-1.8.0_152
 +
|Pilon is a software tool which can be used to:- Automatically improve draft assemblies- Find variation among strains, including large event detection
 +
|-
 +
|poppler
 +
|
 +
|Poppler is a PDF rendering library based on the xpdf-3.0 code base.
 +
|-
 +
|[http://jupyter.org/ jupyterlab]
 +
|0.34.10-IGB-gcc-4.9.4-Python-3.6.1<br>0.35.6-IGB-gcc-4.9.4-Python-3.6.1<br>1.0.4-IGB-gcc-4.9.4-Python-3.6.1
 +
|Project Jupyter exists to develop open-source software, open-standards, and services for interactive computing across dozens of programming languages.
 +
|-
 +
|[https://github.com/pysam-developers/pysam Pysam]
 +
|0.13.0-IGB-gcc-4.9.4-Python-2.7.13<br>0.13.0-IGB-gcc-4.9.4-Python-3.6.1<br>0.15.3-IGB-gcc-4.9.4-Python-3.6.1
 +
|Pysam is a python module for reading and manipulating Samfiles.  Its a lightweight wrapper of the samtools C-API. Pysam also includes an interface for tabix.
 +
|-
 +
|[http://catchenlab.life.illinois.edu/radinitio/ radinitio]
 +
|1.1.0-IGB-gcc-4.9.4-Python-3.6.1<br>1.1.1-IGB-gcc-4.9.4-Python-3.6.1
 +
|RADinitio is a simulation pipeline for the assessment of RADseq experiments. Genetic data are forward simulated for a population of individuals from a designated reference genome.
 +
|-
 +
|[https://github.com/velocyto-team/velocyto.R velocyto.R]
 +
|20190527-IGB-gcc-4.9.4-R-3.4.2
 +
|RNA velocity estimation in R
 +
|-
 +
|[https://github.com/biocore/redbiom redbiom]
 +
|0.3.2-IGB-gcc-4.9.4-Python-3.6.1
 +
|Redbiom is a cache service for sample metadata and sample data.
 +
|-
 +
|[http://python.org/ Python]
 +
|2.7.13-IGB-gcc-4.9.4<br>3.6.1-IGB-gcc-4.9.4<br>3.7.2-IGB-gcc-8.2.0
 +
|Python is a programming language that lets you work more quickly and integrate your systems more effectively.
 +
|-
 +
|[http://cab.spbu.ru/software/spades/ SPAdes]
 +
|3.10.1-IGB-gcc-4.9.4-Python-2.7.13<br>3.11.0-IGB-gcc-4.9.4-Python-2.7.13<br>3.11.0-IGB-gcc-4.9.4-Python-3.6.1<br>3.11.1-IGB-gcc-4.9.4-Python-3.6.1<br>3.13.1-IGB-gcc-8.2.0-Python-3.7.2
 +
|SPAdes . St. Petersburg genome assembler . is intended for both standard isolates and single-cell MDA bacteria assemblies.
 +
|-
 +
|[http://www.sqlite.org/ SQLite]
 +
|3.17.0-IGB-gcc-4.9.4<br>3.17.0-IGB-gcc-8.2.0<br>3.30.1-IGB-gcc-4.9.4
 +
|SQLite: SQL Database Engine in a C Library
 +
|-
 +
|[https://github.com/COMBINE-lab/salmon Salmon]
 +
|0.11.3-IGB-gcc-4.9.4<br>0.12.0-IGB-gcc-8.2.0<br>0.13.1-IGB-gcc-8.2.0<br>0.14.1-IGB-gcc-8.2.0<br>0.8.2-IGB-gcc-4.9.4-Python-2.7.13<br>0.9.1-IGB-gcc-4.9.4<br>1.0.0-IGB-gcc-8.2.0
 +
|Salmon is a wicked-fast program to produce a highly-accurate, transcript-level quantification estimates from RNA-seq data.
 +
|-
 +
|[https://github.com/Kingsford-Group/scallop scallop]
 +
|0.10.3-IGB-gcc-4.9.4<br>0.10.4-IGB-gcc-4.9.4
 +
|Scallop is an accurate reference-based transcript assembler. Scallop features its high accuracy in assembling multi-exon transcripts as well as lowly expressed transcripts.
 +
|-
 +
|[https://www.kernel.org/pub/linux/utils/util-linux util-linux]
 +
|2.34-IGB-gcc-4.9.4
 +
|Set of Linux utilities
 +
|-
 +
|[https://skylign.org/ skylign]
 +
|1.1-IGB-gcc-4.9.4-Perl-5.24.1
 +
|Skylign is a tool for creating logos representing both sequence alignments and profile hidden Markov models. Submit to the form on the right in order to produce (i) interactive logos for inclusion in webpages, or (ii) static logos for use in documents.
 +
|-
 +
|[https://support.10xgenomics.com/spatial-gene-expression/software/pipelines/latest/what-is-space-ranger spaceranger]
 +
|1.0.0
 +
|Space Ranger is a set of analysis pipelines that process Visium spatial RNA-seq output and brightfield microscope images in order to detect tissue, align reads, generate feature-spot matrices, perform clustering and gene expression analysis, and place spots in spatial context on the slide image.
 +
|-
 +
|[http://faculty.cse.tamu.edu/davis/suitesparse.html SuiteSparse]
 +
|5.4.0-IGB-gcc-4.9.4-METIS-5.1.0
 +
|SuiteSparse is a collection of libraries manipulate sparse matrices.
 +
|-
 +
|Szip
 +
|
 +
|Szip compression software, providing lossless compression of scientific data
 +
|-
 +
|[https://github.com/lanpa/tensorboardX tensorboardX]
 +
|1.9-IGB-gcc-4.9.4-Python-3.6.1
 +
|TensorBoardX lets you watch Tensors Flow without Tensorflow
 +
|-
 +
|GSL
 +
|
 +
|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.
 +
|-
 +
|Autotools
 +
|
 +
|This bundle collect the standard GNU build tools: Autoconf, Automake and libtool
 +
|-
 +
|[http://software.broadinstitute.org/software/igv/ igv]
 +
|2.4.4-Java-1.8.0_152<br>2.7.2-Java-11.0.5<br>snapshot-Java-11.0.5
 +
|The Integrative Genomics Viewer (IGV) is a high-performance visualization tool for interactive exploration of large, integrated genomic datasets. It supports a wide variety of data types, including array-based and next-generation sequence data, and genomic annotations.
 +
|-
 +
|[https://github.com/alexdobin/STAR STAR]
 +
|2.5.3a-IGB-gcc-4.9.4<br>2.6.0c-IGB-gcc-4.9.4<br>2.6.1b-IGB-gcc-4.9.4<br>2.7.0d-IGB-gcc-8.2.0<br>2.7.0f-IGB-gcc-8.2.0<br>2.7.3a-IGB-gcc-8.2.0
 +
|STAR aligns RNA-seq reads to a reference genome using uncompressed suffix arrays.
 +
|-
 +
|[http://www.htslib.org/ SAMtools]
 +
|0.1.20-IGB-gcc-4.9.4<br>1.3.1-IGB-gcc-4.9.4<br>1.4-IGB-gcc-4.9.4<br>1.4.1-IGB-gcc-4.9.4<br>1.5-IGB-gcc-4.9.4<br>1.7-IGB-gcc-4.9.4<br>1.9-IGB-gcc-4.9.4
 +
|SAM Tools provide various utilities for manipulating alignments in the SAM format,  including sorting, merging, indexing and generating alignments in a per-position format.
 +
|-
 +
|[http://meme-suite.org/ MEME]
 +
|4.11.2-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13<br>4.12.0-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13<br>5.0.1-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13<br>5.0.5-IGB-gcc-4.9.4
 +
|The MEME Suite allows you to: * discover motifs using MEME, DREME (DNA only) or  GLAM2 on groups of related DNA or protein sequences, * search sequence databases with motifs using  MAST, FIMO, MCAST or GLAM2SCAN, * compare a motif to all motifs in a database of motifs, * associate  motifs with Gene Ontology terms via their putative target genes, and * analyse motif enrichment  using SpaMo or CentriMo.
 +
|-
 +
|[http://www.r-project.org/ R]
 +
|2.15.3-IGB-gcc-4.9.4<br>3.1.2-IGB-gcc-4.9.4<br>3.2.5-IGB-gcc-4.9.4<br>3.3.3-IGB-gcc-4.9.4<br>3.4.1-IGB-gcc-4.9.4<br>3.4.2-IGB-gcc-4.9.4<br>3.5.0-IGB-gcc-4.9.4<br>3.6.0-IGB-gcc-8.2.0
 +
|R is a free software environment for statistical computing and graphics.
 +
|-
 +
|[http://qiime.org/ QIIME2]
 +
|2017.10<br>2017.11<br>2017.12<br>2017.6<br>2017.8<br>2018.11<br>2018.2<br>2018.4<br>2018.6<br>2018.8<br>2019.10<br>2019.4<br>2019.7
 +
|QIIME is an open-source bioinformatics pipeline for performing microbiome analysis from raw DNA sequencing data.
 +
|-
 +
|[https://developer.nvidia.com/cudnn cuDNN]
 +
|5.1-IGB-gcc-4.9.4-CUDA-8.0.61<br>6.0-IGB-gcc-4.9.4-CUDA-8.0.61<br>7.0.5-IGB-gcc-4.9.4-CUDA-9.0.176<br>7.1.4-IGB-gcc-4.9.4-CUDA-9.0.176<br>7.6.1.34-CUDA-10.0.130
 +
|The NVIDIA CUDA Deep Neural Network library (cuDNN) is a GPU-accelerated library of primitives for    deep neural networks.
 +
|-
 +
|[https://github.com/andyrimmer/Platypus Platypus]
 +
|20180622-IGB-gcc-4.9.4-Python-2.7.13
 +
|The Platypus variant caller.
 +
|-
 +
|[https://www.rosettacommons.org/ rosetta]
 +
|2017.52-IGB-gcc-4.9.4
 +
|The Rosetta software suite includes algorithms for computational modeling and analysis of protein structures.
 +
|-
 +
|[https://github.com/chanzuckerberg/shasta shasta]
 +
|0.2.0
 +
|The goal of the Shasta long read assembler is to rapidly produce accurate assembled sequence using as input DNA reads generated by Oxford Nanopore flow cells.
 +
|-
 +
|[https://github.com/genome/bam-readcount bam-readcount]
 +
|0.8.0-IGB-gcc-4.9.4
 +
|The purpose of this program is to generate metrics at single nucleotide positions.
 +
|-
 +
|[http://www.usadellab.org/cms/?page=trimmomatic Trimmomatic]
 +
|0.36-Java-1.8.0_121<br>0.36-Java-1.8.0_152<br>0.38-Java-1.8.0_152
 +
|Trimmomatic performs a variety of useful trimming tasks for illumina paired-end and single ended data.The selection of trimming steps and their associated parameters are supplied on the command line.
 +
|-
 +
|[http://trinityrnaseq.github.io/ Trinity]
 +
|2.4.0-IGB-gcc-4.9.4<br>2.5.0-IGB-gcc-4.9.4<br>2.6.5-IGB-gcc-4.9.4<br>2.8.5-IGB-gcc-4.9.4
 +
|Trinity represents a novel method for the efficient and robust de novo reconstruction of transcriptomes from RNA-Seq data. Trinity combines three independent software modules: Inchworm, Chrysalis, and Butterfly, applied sequentially to process large volumes of RNA-Seq reads.
 +
|-
 +
|[https://trinotate.github.io/ Trinotate]
 +
|3.1.1-IGB-gcc-4.9.4-Perl-5.24.1
 +
|Trinotate is a comprehensive annotation suite designed for automatic functional annotation of transcriptomes, particularly de novo assembled transcriptomes, from model or non-model organisms. Trinotate makes use of a number of different well referenced methods for functional annotation including homology search to known sequence data (BLAST+/SwissProt), protein domain identification (HMMER/PFAM), protein signal peptide and transmembrane domain prediction (signalP/tmHMM), and leveraging various annotation databases (eggNOG/GO/Kegg databases). All functional annotation data derived from the analysis of transcripts is integrated into a SQLite database which allows fast efficient searching for terms with specific qualities related to a desired scientific hypothesis or a means to create a whole annotation report for a transcriptome.
 +
|-
 +
|[https://github.com/rrwick/Unicycler Unicycler]
 +
|0.4.3-IGB-gcc-4.9.4-Python-3.6.1<br>0.4.4-IGB-gcc-4.9.4-Python-3.6.1<br>0.4.8-IGB-gcc-4.9.4-Python-3.6.1
 +
|Unicycler is an assembly pipeline for bacterial genomes. It can assemble Illumina-only read sets where it functions as a SPAdes-optimiser. It can also assembly long-read-only sets (PacBio or Nanopore) where it runs a miniasm+Racon pipeline. For the best possible assemblies, give it both Illumina reads and long reads, and it will conduct a hybrid assembly.
 +
|-
 +
|[https://github.com/COMBINE-lab/SalmonTools SalmonTools]
 +
|20190604-IGB-gcc-8.2.0
 +
|Useful tools for working with Salmon output
 +
|-
 +
|[http://www.cse.lehigh.edu/~chen/software.htm VASP-E]
 +
|20190225-IGB-gcc-4.9.4<br>20191112-IGB-gcc-4.9.4
 +
|VASP and VASP-E explore the idea that a solid geometric representation of molecular structures can be used to automatically deconstruct proteins into functional elements for the study of binding specificity.
 +
|-
 +
|[https://www.ks.uiuc.edu/Research/vmd/ VMD]
 +
|1.9.3-IGB-gcc-4.9.4
 +
|VMD is a molecular visualization program for displaying, animating, and analyzing large biomolecular systems using 3-D graphics and built-in scripting.
 +
|-
 +
|[https://github.com/dmlc/xgboost xgboost]
 +
|0.80-IGB-gcc-4.9.4-Python-3.6.1
 +
|XGBoost is an optimized distributed gradient boosting library designed to be highly efficient, flexible and portable. It implements machine learning algorithms under the Gradient Boosting framework.
 +
|-
 +
|[https://github.com/PacificBiosciences/ccs pbccs]
 +
|4.0
 +
|ccs takes multiple subreads of the same SMRTbell molecule and combines them using a statistical model to produce one highly accurate consensus sequence, also called HiFi read, with base quality values.
 +
|-
 +
|[https://github.com/Discngine/fpocket fpocket]
 +
|3.1.3-IGB-gcc-4.9.4
 +
|fpocket is a very fast open source protein pocket detection algorithm based on Voronoi tessellation.
 +
|-
 +
|libcerf
 +
|
 +
|libcerf is a self-contained numeric library that provides an efficient and accurate implementation of complex error functions, along with Dawson, Faddeeva, and Voigt functions.
 +
|-
 +
|[https://github.com/ginolhac/mapDamage mapDamage]
 +
|2.0.5-IGB-gcc-4.9.4-Python-2.7.13<br>2.0.9-IGB-gcc-4.9.4-Python-2.7.13
 +
|mapDamage2 is a computational framework written in Python and R, which tracks and quantifies DNA damage patterns among ancient DNA sequencing reads generated by Next-Generation Sequencing platforms.
 +
|-
 +
|[https://github.com/mirnylab/pairtools pairtools]
 +
|0.3.0-IGB-gcc-4.9.4-Python-3.6.1
 +
|pairtools is a simple and fast command-line framework to process sequencing data from a Hi-C experiment.
 +
|-
 +
|[http://rpy.sourceforge.net/ rpy2]
 +
|2.8.6-IGB-gcc-4.9.4-Python-2.7.13-R-3.3.3<br>2.8.6-IGB-gcc-4.9.4-Python-2.7.13-R-3.5.0<br>2.9.0-IGB-gcc-4.9.4-Python-3.6.1-R-3.3.3<br>3.0.1-IGB-gcc-4.9.4-Python-3.6.1-R-3.5.0<br>3.2.4-IGB-gcc-4.9.4-Python-3.6.1-R-3.5.0
 
|rpy2 is a redesign and rewrite of rpy. It is providing a low-level interface to R from Python, a proposed high-level interface, including wrappers to graphical libraries, as well as R-like structures and functions.  
 
|rpy2 is a redesign and rewrite of rpy. It is providing a low-level interface to R from Python, a proposed high-level interface, including wrappers to graphical libraries, as well as R-like structures and functions.  
 +
|-
 +
|[https://t3f.readthedocs.io/en/latest/index.html t3f]
 +
|1.1.0-IGB-gcc-4.9.4-Python-3.6.1
 +
|t3f is a library for working with Tensor Train decomposition.
 
|}
 
|}

Revision as of 05:00, 10 January 2020

Application Installed Versions Description
efiest/beta beta
efiest/beta_private beta_private
efiest/devel devel
efiest/devlocal devlocal
efiest/prod prod
efiest/prod_private prod_private
shortbred/prod prod
efiest/efitools efitools/devlocal
454 2.8 The GS Data Analysis Software package includes the tools to investigate complex genomic variation in samples including de novo assembly, reference guided alignment and variant calling, and low abundance variant identification and quantification. - Homepage: http://454.com/products/analysis-software/index.asp
ABySS 2.0.2-IGB-gcc-4.9.4 ABySS is a de novo, parallel, paired-end sequence assembler that is designed for short reads. The single-processor version is useful for assembling genomes up to 100 Mbases in size. The parallel version is implemented using MPI and is capable of assembling larger genomes.
ADOL-C 2.6.3-IGB-gcc-4.9.4 ADOL-C is an open-source package for the automatic differentiation of C and C++ programs.
AGEnt 0.2.1-IGB-gcc-4.9.4 AGEnt performs in silico subtractive hybridization of core genome sequences, such as those produced by Spine, against a query genomic sequence to identify accessory genomic sequences (AGEs) in the query genome. Sequences are aligned using Nucmer, outputting sequences and sequence characteristics of those regions in the query genome that are not found in the core genome. If gene coordinate information is provided, a list of accessory genes in the query genome will also be output.
AMPHORA2 20190104-IGB-gcc-4.9.4 An Automated Phylogenomic Inference Pipeline for Bacterial and Archaeal Sequences.
ANTLR ANTLR, ANother Tool for Language Recognition, (formerly PCCTS) is a language tool that provides a framework for constructing recognizers, compilers, and translators from grammatical descriptions containing Java, C#, C++, or Python actions.
ARCS 1.0.0-IGB-gcc-4.9.4-Perl-5.24.1 Scaffolding genome sequence assemblies using 10X Genomics GemCode/Chromium data. - Homepage: https://github.com/bcgsc/arcs
ATK ATK provides the set of accessibility interfaces that are implemented by other toolkits and applications. Using the ATK interfaces, accessibility tools have full access to view and control running applications.
AdapterRemoval 2.1.7-IGB-gcc-4.9.4 This program searches for and removes remnant adapter sequences from High-Throughput Sequencing (HTS) data and (optionally) trims low quality bases from the 3 end of reads following adapter removal.
AdmixTools 1.0.1-IGB-gcc-4.9.4 The ADMIXTOOLS package implements 5 methods described in Patterson et al. (2012) Ancient Admixture in Human History. Details of the methods and algorithm can be found in this paper.
Anaconda2 4.3.1 Built to complement the rich, open source Python community,the Anaconda platform provides an enterprise-ready data analytics platform that empowers companies to adopt a modern open data science analytics architecture. - Homepage: https://www.continuum.io/anaconda-overview
Anaconda3 5.0.1
5.1.0
Built to complement the rich, open source Python community,the Anaconda platform provides an enterprise-ready data analytics platform that empowers companies to adopt a modern open data science analytics architecture.
ArcadeLearningEnvironment 0.5.1-IGB-gcc-4.9.4-Python-2.7.13 The Arcade Learning Environment (ALE) -- a platform for AI research. - Homepage: https://github.com/mgbellemare/Arcade-Learning-Environment
Assemblytics 3f570cd-IGB-gcc-4.9.4
df5361f-IGB-gcc-4.9.4
Analyze your assembly by comparing it to a reference genome
Autoconf 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. - Homepage: http://www.gnu.org/software/autoconf/
BBMap 38.36-Java-1.8.0_152 BBTools is a suite of fast, multithreaded bioinformatics tools designed for analysis of DNA and RNA sequence data.
BEDTools 2.21.0-IGB-gcc-4.9.4
2.26.0-IGB-gcc-4.9.4
2.28.0-IGB-gcc-8.2.0
The BEDTools utilities allow one to address common genomics tasks such as finding feature overlaps and computing coverage. The utilities are largely based on four widely-used file formats: BED, GFF/GTF, VCF, and SAM/BAM.
BLASR 4.0.0-IGB-gcc-4.9.4 BLASR (Basic Local Alignment with Successive Refinement) rapidly maps reads to genomes by finding the highest scoring local alignment or set of local alignments between the read and the genome. Optimized for PacBios extraordinarily long reads and taking advantage of rich quality values, BLASR maps reads rapidly with high accuracy.
DIAMOND 0.8.38-IGB-gcc-4.9.4
0.9.10-IGB-gcc-4.9.4
0.9.16-IGB-gcc-4.9.4
0.9.22-IGB-gcc-4.9.4
0.9.24-IGB-gcc-4.9.4
0.9.24-IGB-gcc-8.2.0
0.9.9-IGB-gcc-4.9.4
Accelerated BLAST compatible local sequence aligner
BLAST 2.2.26-Linux_x86_64 Basic Local Alignment Search Tool, or BLAST, is an algorithm for comparing primary biological sequence information, such as the amino-acid sequences of different proteins or the nucleotides of DNA sequences.
BLAST+ 2.6.0-IGB-gcc-4.9.4
2.7.1-IGB-gcc-4.9.4
2.9.0-IGB-gcc-4.9.4
Basic Local Alignment Search Tool, or BLAST, is an algorithm for comparing primary biological sequence information, such as the amino-acid sequences of different proteins or the nucleotides of DNA sequences.
BLAT 3.5-IGB-gcc-4.9.4 BLAT on DNA is designed to quickly find sequences of 95% and greater similarity of length 25 bases or more.
BS-Seeker 2.1.2-IGB-gcc-4.9.4-Python-2.7.13 BS Seeker 2 is a seamless and versatile pipeline for accurately and fast mapping the bisulfite-treated short reads.
BS-Snper 20170222-IGB-gcc-4.9.4-Perl-5.24.1 BS-SNPer is an ultrafast and memory-efficient package, a program for BS-Seq variation detection from alignments in standard BAM/SAM format using approximate Bayesian modeling.
BUSCO 3.0.1-IGB-gcc-4.9.4-Python-2.7.13 BUSCO v3 provides quantitative measures for the assessment of genome assembly, gene set, and transcriptome completeness, based on evolutionarily-informed expectations of gene content from near-universal single-copy orthologs selected from OrthoDB v9.
BWA 0.5.9-IGB-gcc-4.9.4
0.6.2-IGB-gcc-4.9.4
0.7.15-IGB-gcc-4.9.4
0.7.17-IGB-gcc-4.9.4
Burrows-Wheeler Aligner (BWA) is an efficient program that aligns relatively short nucleotide sequences against a long reference sequence such as the human genome.
BiG-SCAPE 20181115-IGB-gcc-4.9.4-Python-3.6.1 BiG-SCAPE (Biosynthetic Gene Similarity Clustering and Prospecting Engine) is a software package, written in Python, that constructs sequence similarity networks of Biosynthetic Gene Clusters (BGCs) and groups them into Gene Cluster Families (GCFs)
BioPerl 1.7.1-IGB-gcc-4.9.4-Perl-5.24.1
1.7.1-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded
Bioperl is the product of a community effort to produce Perl code which is useful in biology. Examples include Sequence objects, Alignment objects and database searching objects.
Biopieces 2.0-IGB-gcc-4.9.4-Perl-5.24.1 Biopieces is a bioinformatic framework of tools easily used and easily created.
Bison Bison is a general-purpose parser generator that converts an annotated context-free grammarinto a deterministic LR or generalized LR (GLR) parser employing LALR(1) parser tables.
Boost Boost provides free peer-reviewed portable C++ source libraries.
Bowtie 1.1.2-IGB-gcc-4.9.4
1.2.0-IGB-gcc-4.9.4
1.2.2-IGB-gcc-4.9.4
Bowtie is an ultrafast, memory-efficient short read aligner.It aligns short DNA sequences (reads) to the human genome.
CD-HIT 4.6.6-IGB-gcc-4.9.4 CD-HIT is a very widely used program for clustering and comparing protein or nucleotide sequences. - Homepage: http://weizhong-lab.ucsd.edu/cd-hit/
CMake CMake, the cross-platform, open-source build system. CMake is a family of tools designed to build, test and package software.
CONCOCT 1.0.0-IGB-gcc-4.9.4-Python-3.6.1 A program for unsupervised binning of metagenomic contigs by using nucleotide composition, coverage data in multiple samples and linkage data from paired end reads.
CUnit 2.1-3-IGB-gcc-4.9.4 CUnit is a lightweight system for writing, administering, and running unit tests in C. It provides C programmers a basic testing functionality with a flexible variety of user interfaces.
Circlator 1.5.1-IGB-gcc-4.9.4-Python-3.6.1 A tool to circularize genome assemblies.
CUDA 10.0.130
8.0.61
8.0.61-IGB-gcc-4.9.4
9.0.176-IGB-gcc-4.9.4
9.1.85
CUDA (formerly Compute Unified Device Architecture) is a parallel computing platform and programming model created by NVIDIA and implemented by the graphics processing units (GPUs) that they produce. CUDA gives developers access to the virtual instruction set and memory of the parallel computational elements in CUDA GPUs.
Clp Clp (Coin-or linear programming) is an open-source linear programming solver written in C++.
ConsensusCore 1.0.1-IGB-gcc-4.9.4-Python-2.7.13 ConsensusCore is a library of C++ algorithms for PacBio multiple sequence consensus that powers Quiver (Python) and ConsensusTools (.NET).
Cufflinks 2.2.1
2.2.1-IGB-gcc-4.9.4-b4fa050
Transcript assembly, differential expression, and differential regulation for RNA-Seq
Cython 0.27.3-IGB-gcc-4.9.4-Python-2.7.13 Cython is an optimising static compiler for both the Python programming language and the extended Cython programming language (based on Pyrex). It makes writing C extensions for Python as easy as Python itself.
DANPOS 2.2.2-IGB-gcc-4.9.4-Python-2.7.13-R-3.3.3 A toolkit for Dynamic Analysis of Nucleosome and Protein Occupancy by Sequencing, version 2
DB Berkeley DB enables the development of custom data management solutions, without the overhead traditionally associated with such custom projects.
Doxygen 1.8.13-IGB-gcc-4.9.4 Doxygen is a documentation system for C++, C, Java, Objective-C, Python, IDL (Corba and Microsoft flavors), Fortran, VHDL, PHP, C#, and to some extent D.
EMIRGE 0.61.1-IGB-gcc-4.9.4-Python-2.7.13 EMIRGE reconstructs full length ribosomal genes from short readsequencing data. In the process, it also provides estimates of thesequences abundances.
Eigen Eigen is a C++ template library for linear algebra: matrices, vectors, numerical solvers, and related algorithms. - Homepage: http://eigen.tuxfamily.org/index.php?title=Main_Page
FALCON 1.8.8-IGB-gcc-4.9.4-Python-2.7.13 FALCON is a diploid aware genome assembler designed for Pacific Biosciences long read data.
FASTX-Toolkit 0.0.14-IGB-gcc-4.9.4 The FASTX-Toolkit is a collection of command line tools for Short-Reads FASTA/FASTQ files preprocessing. - Homepage: http://hannonlab.cshl.edu/fastx_toolkit/
FEELnc 20180117-IGB-gcc-4.9.4 This document is intended to give a technical description of the FEELnc pipeline in order to annotate long non-coding RNAs (lncRNAs) based on reconstructed transcripts from RNA-seq data (either with or without a reference genome).
FFmpeg 3.3-IGB-gcc-4.9.4 A complete, cross-platform solution to record, convert and stream audio and video. - Homepage: https://www.ffmpeg.org/
FLAC 1.3.1-IGB-gcc-4.9.4 Programs and libraries for working with Free Lossless Audio Codec (FLAC) files.
Falcon2Fastg 0.3.1-IGB-gcc-4.9.4-Python-2.7.13 This software converts the results of PacBio assembly using FALCON, to a FASTG graph that can be visualized using Bandage.
FastME 2.1.6.1-IGB-gcc-4.9.4 FastME provides distance algorithms to infer phylogenies. FastME is based on balanced minimum evolution, which is the very principle of NJ. FastME improves over NJ by performing topological moves using fast, sophisticated algorithms.
FreeBayes 1.1.0-IGB-gcc-4.9.4 FreeBayes is a Bayesian genetic variant detector designed to find small polymorphisms, specifically SNPs (single-nucleotide polymorphisms), indels (insertions and deletions), MNPs (multi-nucleotide polymorphisms), and complex events (composite insertion and substitution events) smaller than the length of a short-read sequencing alignment.
GAMS 23.6.5 The General Algebraic Modeling System (GAMS) is a high-level modeling system for mathematical programming and optimization. It consists of a language compiler and a stable of integrated high-performance solvers.
GBS-SNP-CROP 4.0-IGB-gcc-4.9.4 The GBS SNP Calling Reference Optional Pipeline (GBS-SNP-CROP) is executed via a sequence of seven Perl scripts that integrate custom parsing and filtering procedures with well-known, vetted bioinformatic tools, giving the user full access to all intermediate files.
GCC The GNU Compiler Collection includes front ends for C, C++, Objective-C, Fortran, Java, and Ada, as well as libraries for these languages (libstdc++, libgcj,...).
GD 2.66-IGB-gcc-4.9.4-Perl-5.24.1 GD.pm - Interface to Gd Graphics Library
GFOLD 1.1.4-IGB-gcc-4.9.4 GFOLD stands for Generalized FOLD change for ranking differentially expressed genes from RNA-seq data. GFOLD is especially useful when no replicate is available. GFOLD generalizes the fold change by considering the posterior distribution of log fold change, such that each gene is assigned a reliable fold change.
GLIMMER 3.02b-IGB-gcc-4.9.4 Glimmer is a system for finding genes in microbial DNA, especiallythe genomes of bacteria, archaea, and viruses.
GMAP 2018-05-30-IGB-gcc-4.9.4 A Genomic Mapping and Alignment Program for mRNA and EST Sequences, andGSNAP: Genomic Short-read Nucleotide Alignment Program
GMTK 1.4.4-IGB-gcc-4.9.4 The Graphical Models Toolkit (GMTK) is an open source, publicly available toolkit for rapidly prototyping statistical models using dynamic graphical models (DGMs) and dynamic Bayesian networks (DBNs). GMTK can be used for applications and research in speech and language processing, bioinformatics, activity recognition, and any time series application. GMTK has many features, including exact and approximate inference; a large variety of built-in factors including dense, sparse, and deterministic conditional probability tables, native support for ARPA backoff-based factors and factored language models, parameter sharing, gamma and beta distributions, dense and sparse Gaussian factors, heterogeneous mixtures, deep neural network factors, and time-inhomogeneous trellis factors; arbitrary order embedded Markov chains; a GUI-based graph viewer; flexible feature-file support and processing tools (supporting pfiles, HTK files, ASCII/binary, and HDF5 files); and both offline and streaming online inference methods that can be used for both parameter learning and prediction. More information is available in the documentation. All in all, GMTK offers a flexible, concise, and expressive probabilistic modeling framework with which one may rapidly specify a vast collection of temporal statistical models.
GeneMark-ES 4.33-IGB-gcc-4.9.4-Perl-5.24.1
4.33-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded
Novel genomes can be analyzed by the program GeneMark-ES utilizing unsupervised training.
GeneMarkS 4.30-IGB-gcc-4.9.4 GeneMarkS: a self-training method for prediction of gene starts in microbial genomes
GenomicConsensus 3.0.2-IGB-gcc-4.9.4-Python-2.7.13 The GenomicConsensus package provides the variantCaller tool, which allows you to apply the Quiver or Arrow algorithm to mapped PacBio reads to get consensus and variant calls.
GlimmerHMM 3.0.4-IGB-gcc-4.9.4 GlimmerHMM is a new gene finder based on a Generalized Hidden Markov Model. Although the gene finder conforms to the overall mathematical framework of a GHMM, additionally it incorporates splice site models adapted from the GeneSplicer program and a decision tree adapted from GlimmerM. It also utilizes Interpolated Markov Models for the coding and noncoding models.
Gradle 4.7 Complete Gradle install.From mobile apps to microservices, from small startups to big enterprises,Gradle helps teams build, automate and deliver better software, faster.
HMMER 2.3.2-IGB-gcc-4.9.4
3.1b2-IGB-gcc-4.9.4
3.2.1-IGB-gcc-4.9.4
HMMER is used for searching sequence databases for homologs of protein sequences, and for making protein sequence alignments. It implements methods using probabilistic models called profile hidden Markov models (profile HMMs). Compared to BLAST, FASTA, and other sequence alignment and database search tools based on older scoring methodology, HMMER aims to be significantly more accurate and more able to detect remote homologs because of the strength of its underlying mathematical models. In the past, this strength came at significant computational expense, but in the new HMMER3 project, HMMER is now essentially as fast as BLAST.
HOMER 4.9.1-IGB-gcc-4.9.4-Perl-5.24.1 HOMER (Hypergeometric Optimization of Motif EnRichment) is a suite of tools for Motif Discovery and ChIP-Seq analysis. It is a collection of command line programs for unix-style operating systems written in mostly perl and c++. Homer was primarily written as a de novo motif discovery algorithm that is well suited for finding 8-12 bp motifs in large scale genomics data.
HTSeq 0.9.0-IGB-gcc-4.9.4-Python-2.7.13
0.9.1-IGB-gcc-4.9.4-Python-2.7.13
A framework to process and analyze data from high-throughput sequencing (HTS) assays
HarfBuzz HarfBuzz is an OpenType text shaping engine. - Homepage: http://www.freedesktop.org/wiki/Software/HarfBuzz
HiC-Pro 2.9.0-IGB-gcc-4.9.4-Python-2.7.13 HiC-Pro was designed to process Hi-C data, from raw fastq files (paired-end Illumina data) to the normalized contact maps. Since version 2.7.0, HiC-Pro supports the main Hi-C protocols, including digestion protocols as well as protocols that do not require restriction enzyme such as DNase Hi-C.
IGB-gcc GNU Compiler Collection (GCC) based compiler toolchain, including OpenMPI for MPI support, OpenBLAS (BLAS and LAPACK support), FFTW and ScaLAPACK.
IM-TORNADO 2.0.3.3-IGB-gcc-4.9.4-Python-2.7.13 A pipeline for 16S reads from paired-end libraries
IPython 5.3.0-IGB-gcc-4.9.4-Python-3.6.1 IPython provides a rich architecture for interactive computing with: Powerful interactive shells (terminal and Qt-based). A browser-based notebook with support for code, text, mathematical expressions, inline plots and other rich media. Support for interactive data visualization and use of GUI toolkits. Flexible, embeddable interpreters to load into your own projects. Easy to use, high performance tools for parallel computing.
JasPer 1.900.1-IGB-gcc-4.9.4
2.0.10-IGB-gcc-4.9.4
The JasPer Project is an open-source initiative to provide a free software-based reference implementation of the codec specified in the JPEG-2000 Part-1 standard. - Homepage: http://www.ece.uvic.ca/~frodo/jasper/
KAT 2.4.1-IGB-gcc-4.9.4 KAT is a suite of tools that analyse jellyfish hashes or sequence files (fasta or fastq) using kmer counts.
KneadData 0.6.1-IGB-gcc-4.9.4-Python-3.6.1 KneadData is a tool designed to perform quality control on metagenomic sequencing data, especially data from microbiome experiments. In these experiments, samples are typically taken from a host in hopes of learning something about the microbial community on the host. However, metagenomic sequencing data from such experiments will often contain a high ratio of host to bacterial reads. This tool aims to perform principled in silico separation of bacterial reads from these contaminant reads, be they from the host, from bacterial 16S sequences, or other user-defined sources.
LAME 3.99.5-IGB-gcc-4.9.4 LAME is a high quality MPEG Audio Layer III (MP3) encoder licensed under the LGPL.
LEfSe 20180219-IGB-gcc-4.9.4-Python-2.7.13 LEfSe
LibTIFF tiff: Library and tools for reading and writing TIFF data files
Lua 5.1.5-IGB-gcc-4.9.4
5.3.4-IGB-gcc-4.9.4
Lua is a powerful, fast, lightweight, embeddable scripting language. Lua combines simple procedural syntax with powerful data description constructs based on associative arrays and extensible semantics. Lua is dynamically typed, runs by interpreting bytecode for a register-based virtual machine, and has automatic memory management with incremental garbage collection, making it ideal for configuration, scripting, and rapid prototyping.
MACS 1.4.2-1-IGB-gcc-4.9.4-Python-2.7.13 Model-based Analysis of ChIP-Seq (MACS) on short reads sequencers such as Genome Analyzer (Illumina / Solexa). MACS empirically models the length of the sequenced ChIP fragments, which tends to be shorter than sonication or library construction size estimates, and uses it to improve the spatial resolution of predicted binding sites. MACS also uses a dynamic Poisson distribution to effectively capture local biases in the genome sequence, allowing for more sensitive and robust prediction.
MAKER 2.31.9-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded
3.00.0-beta-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded
3.01.1-beta-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded
MAKER is a portable and easily configurable genome annotation pipeline. Its purpose is to allow smaller eukaryotic and prokaryotic genome projects to independently annotate their genomes and to create genome databases. MAKER identifies repeats, aligns ESTs and proteins to a genome, produces ab-initio gene predictions and automatically synthesizes these data into gene annotations having evidence-based quality values. MAKER is also easily trainable: outputs of preliminary runs can be used to automatically retrain its gene prediction algorithm, producing higher quality gene-models on seusequent runs. MAKERs inputs are minimal and its ouputs can be directly loaded into a GMOD database. They can also be viewed in the Apollo genome browser; this feature of MAKER provides an easy means to annotate, view and edit individual contigs and BACs without the overhead of a database. MAKER should prove especially useful for emerging model organism projects with minimal bioinformatics expertise and computer resources.
MAPGD 0.4.26-IGB-gcc-4.9.4 MAPGD is a series of related programs that estimate allele frequency, heterozygosity, Hardy-Weinberg disequilibrium, linkage disequilibrium and identity-by-descent (IBD) coefficients from population genomic data using a statistically rigorous maximum likelihood approach.
MATLAB-python 2017b-IGB-gcc-4.9.4-Python-3.6.1 The MATLAB Engine API for Python provides a package for Python to call MATLAB as a computational engine. The engine supports the reference implementation (CPython) for Python versions 2.7, 3.5, and 3.6.
MEGAHIT 1.1.1-IGB-gcc-4.9.4 MEGAHIT is a single node assembler for large and complex metagenomics NGS reads, such as soil. It makes use of succinct de Bruijn graph (SdBG) to achieve low memory assembly. - Homepage: https://github.com/voutcn/megahit
MPICH 3.0.4-GCC-4.9.4-2.28 MPICH v3.x is an open source high-performance MPI 3.0 implementation.It does not support InfiniBand (use MVAPICH2 with InfiniBand devices).
MUMmer 3.23-IGB-gcc-4.9.4
4.0.0beta2-IGB-gcc-4.9.4
MUMmer is a system for rapidly aligning entire genomes
MUSCLE 3.8.31-IGB-gcc-4.9.4 MUSCLE is one of the best-performing multiple alignment programs according to published benchmark tests, with accuracy and speed that are consistently better than CLUSTALW. MUSCLE can align hundreds of sequences in seconds. Most users learn everything they need to know about MUSCLE in a few minutes—only a handful of command-line options are needed to perform common alignment tasks. - Homepage: http://drive5.com/muscle/
MaSuRCA 3.2.3-IGB-gcc-4.9.4 MaSuRCA is whole genome assembly software. It combines the efficiency of the de Bruijn graph and Overlap-Layout-Consensus (OLC) approaches. MaSuRCA can assemble data sets containing only short reads from Illumina sequencing or a mixture of short reads and long reads (Sanger, 454, Pacbio and Nanopore).
Mako 1.0.6-IGB-gcc-4.9.4-Python-3.6.1 A super-fast templating language that borrows the best ideas from the existing templating languages
MaskRCNN 20190227-IGB-gcc-4.9.4-Python-3.6.1 This is an implementation of Mask R-CNN on Python 3, Keras, and TensorFlow. The model generates bounding boxes and segmentation masks for each instance of an object in the image.
MetaVelvet 1.2.02-IGB-gcc-4.9.4 An extension of Velvet assembler to de novo metagenome assembly from short sequence reads
Miniconda3 Built to complement the rich, open source Python community,the Anaconda platform provides an enterprise-ready data analytics platform that empowers companies to adopt a modern open data science analytics architecture.
Mothur 1.38.1.1
1.39.5
1.39.5-IGB-gcc-4.9.4
Mothur is a single piece of open-source, expandable software to fill the bioinformatics needs of the microbial ecology community.
OligoMiner 20181123-IGB-gcc-4.9.4 A rapid, flexible environment for the design of genome-scale oligonucleotide in situ hybridization probes
OpenCV 3.1.0-IGB-gcc-4.9.4-Python-2.7.13
3.3.0-IGB-gcc-4.9.4-Python-3.6.1
OpenCV (Open Source Computer Vision Library) is an open source computer vision and machine learning software library. OpenCV was built to provide a common infrastructure for computer vision applications and to accelerate the use of machine perception in the commercial products.
OpenMPI 2.1.0-GCC-4.9.4-2.28
4.0.0-GCC-8.2.0-2.32
The Open MPI Project is an open source MPI-3 implementation.
PAML 4.9e-IGB-gcc-4.9.4 PAML is a package of programs for phylogenetic analyses of DNA or protein sequences using maximum likelihood. - Homepage: http://abacus.gene.ucl.ac.uk/software/paml.html
PANDAseq 2.11-IGB-gcc-4.9.4 PANDAseq assembles Illumina Solexa overlapping pair-end reads. - Homepage: https://github.com/neufeld/pandaseq
PCRE The PCRE library is a set of functions that implement regular expression pattern matching using the same syntax and semantics as Perl 5.
PROJ Program proj is a standard Unix filter function which converts geographic longitude and latitude coordinates into cartesian coordinates - Homepage: http://trac.osgeo.org/proj/
Pango Pango is a library for laying out and rendering of text, with an emphasis on internationalization.Pango can be used anywhere that text layout is needed, though most of the work on Pango so far has been done in thecontext of the GTK+ widget toolkit. Pango forms the core of text and font handling for GTK+-2.x. - Homepage: http://www.pango.org/
Phantompeaktools-spp Custom SPP for Phantompeaktools
PhiSpy 2.3-IGB-gcc-4.9.4-Python-2.7.13 A novel algorithm for finding prophages in microbial genomes that combines similarity-based and composition-based strategies
PhyloSift 1.0.0_01-IGB-gcc-4.9.4-Perl-5.24.1 PhyloSift is a suite of software tools to conduct phylogeneticanalysis of genomes and metagenomes.
Pillow 5.1.0-IGB-gcc-4.9.4-Python-2.7.13
5.1.0-IGB-gcc-4.9.4-Python-3.6.1
Pillow is the friendly PIL fork by Alex Clark and Contributors. PIL is the Python Imaging Library by Fredrik Lundh and Contributors.
PyCUDA 2017.1-IGB-gcc-4.9.4-Python-2.7.13 PyCUDA lets you access Nvidia‘s CUDA parallel computation API from Python. - Homepage: https://mathema.tician.de/software/pycuda/
PyZMQ 16.0.2-IGB-gcc-4.9.4-Python-3.6.1 Python bindings for ZeroMQ
RAxML 8.2.12-IGB-gcc-4.9.4 RAxML search algorithm for maximum likelihood based inference of phylogenetic trees.
RDPClassifier 2.12-Java-1.8.0_152
2.2-Java-1.8.0_152
The RDP Classifier is a naive Bayesian classifier which was developed to provide rapid taxonomic placement based on rRNA sequence data. The RDP Classifier can rapidly and accurately classify bacterial and archaeal 16s rRNA sequences, and Fungal LSU sequences. It provides taxonomic assignments from domain to genus, with confidence estimates for each assignment.
REAPR 1.0.18-IGB-gcc-4.9.4 REAPR is a tool that evaluates the accuracy of a genome assembly using mapped paired end reads, without the use of a reference genome for comparison. It can be used in any stage of an assembly pipeline to automatically break incorrect scaffolds and flag other errors in an assembly for manual inspection. It reports mis-assemblies and other warnings, and produces a new broken assembly based on the error calls. - Homepage: http://www.sanger.ac.uk/science/tools/reapr
RFMix 20180503-IGB-gcc-4.9.4 A discriminative method for local ancestry inference
RGT 0.11.3-IGB-gcc-4.9.4-Python-2.7.13 Regulatory Genomics Toolbox (RGT) is an open source python library for analysis of regulatory genomics. RGT is programmed in an oriented object fashion and its core classes provide functionality for handling regulatory genomics data.
RMBlast 2.6.0-IGB-gcc-4.9.4 RMBlast is a RepeatMasker compatible version of the standard NCBI blastn program. The primary difference between this distribution and the NCBI distribution is the addition of a new program "rmblastn" for use with RepeatMasker and RepeatModeler.
RNAmmer 1.2-IGB-gcc-4.9.4-Perl-5.24.1 Ribosomal RNA sub units
cairo Cairo is a 2D graphics library with support for multiple output devices. Currently supported output targets include the X Window System (via both Xlib and XCB), Quartz, Win32, image buffers, PostScript, PDF, and SVG file output. Experimental backends include OpenGL, BeOS, OS/2, and DirectFB
BreakSeq2 2.2-IGB-gcc-4.9.4-Python-2.7.13 Ultrafast and accurate nucleotide-resolution analysis of structural variants - Homepage: http://bioinform.github.io/breakseq2/
CNVnator 0.3.3-IGB-gcc-4.9.4 a tool for CNV discovery and genotyping from depth-of-coverage by mapped reads
CheckM 1.0.7-IGB-gcc-4.9.4-Python-2.7.13 CheckM provides a set of tools for assessing the quality of genomes recovered from isolates, single cells, or metagenomes.
Circos 0.69-4-IGB-gcc-4.9.4-Perl-5.24.1 Circos is a software package for visualizing data and information. It visualizes data in a circular layout - this makes Circos ideal for exploring relationships between objects or positions. - Homepage: http://www.circos.ca/
Clustal-Omega 1.2.4-IGB-gcc-4.9.4 Clustal Omega is a multiple sequence alignment program for proteins. It produces biologically meaningful multiple sequence alignments of divergent sequences. Evolutionary relationships can be seen via viewing Cladograms or Phylograms - Homepage: http://www.clustal.org/omega/
ClustalW2 2.1-IGB-gcc-4.9.4 ClustalW2 is a general purpose multiple sequence alignment program for DNA or proteins. - Homepage: http://www.ebi.ac.uk/Tools/msa/clustalw2/
DISCOVARdenovo 52488-IGB-gcc-4.9.4 DISCOVAR de novo can generate de novo assemblies for both large and small genomes. It currently does not call variants.
DIYABC 2.1.0 a user-friendly approach to Approximate Bayesian Computation for inference on population history using molecular markers
DendroPy 4.4.0-IGB-gcc-4.9.4-Python-3.6.1 DendroPy is a Python library for phylogenetic computing.
EMBOSS 6.6.0-IGB-gcc-4.9.4-Java-1.8.0_121 EMBOSS, The European Molecular Biology Open Software Suite. EMBOSS is a free Open Source software analysis package specially developed for the needs of the molecular biology (e.g. EMBnet) user community.
FALCON_unzip 0.4.0-IGB-gcc-4.9.4-Python-2.7.13 FALCON-Unzip contains the modules that works with FALCON for full diploid assembly (representing haplotype specific contigs as "haplotigs" as assembly output).
FFTW FFTW is a C subroutine library for computing the discrete Fourier transform (DFT) in one or more dimensions, of arbitrary input size, and of both real and complex data.
FLASH2 2.2.00-IGB-gcc-4.9.4 FLASH (Fast Length Adjustment of SHort reads) is an accurate and fast toolto merge paired-end reads that were generated from DNA fragments whoselengths are shorter than twice the length of reads. Merged read pairs resultin unpaired longer reads, which are generally more desired in genomeassembly and genome analysis processes.
FastTree 2.1.10-IGB-gcc-4.9.4 FastTree infers approximately-maximum-likelihood phylogenetic trees from alignments of nucleotide or protein sequences. FastTree can handle alignments with up to a million of sequences in a reasonable amount of time and memory.
Flye 2.4.2-IGB-gcc-4.9.4-Python-2.7.13 Flye is a de novo assembler for single molecule sequencing reads, such as those produced by PacBio and Oxford Nanopore Technologies.
GCCcore The GNU Compiler Collection includes front ends for C, C++, Objective-C, Fortran, Java, and Ada, as well as libraries for these languages (libstdc++, libgcj,...).
GDAL 2.3.1-IGB-gcc-4.9.4 GDAL is a translator library for raster geospatial data formats that is released under an X/MIT style Open Source license by the Open Source Geospatial Foundation. As a library, it presents a single abstract data model to the calling application for all supported formats. It also comes with a variety of useful commandline utilities for data translation and processing.
GMAP-GSNAP 2017-11-15-IGB-gcc-4.9.4 GMAP: A Genomic Mapping and Alignment Program for mRNA and EST Sequences GSNAP: Genomic Short-read Nucleotide Alignment Program
GObject-Introspection GObject introspection is a middleware layer between C libraries (using GObject) and language bindings. The C library can be scanned at compile time and generate a metadata file, in addition to the actual native C library. Then at runtime, language bindings can read this metadata and automatically provide bindings to call into the C library.
GTK+ 2.24.31-IGB-gcc-4.9.4-Python-2.7.13
2.24.31-IGB-gcc-4.9.4-Python-3.6.1
The GTK+ 2 package contains libraries used for creating graphical user interfaces for applications.
GUIDANCE 2.02-IGB-gcc-4.9.4-Perl-5.24.1 GUIDANCE is meant to be used for weighting, filtering or masking unreliably aligned positions in sequence alignments before subsequent analysis. For example, align codon sequences (nucleotide sequences that code for proteins) using PAGAN, remove columns with low GUIDANCE scores, and use the remaining alignment to infer positive selection using the branch-site dN/dS test. Other analyses where GUIDANCE filtering could be useful include phylogeny reconstruction, reconstruction of the history of specific insertion and deletion events, inference of recombination events, etc. - Homepage: http://guidance.tau.ac.il/ver2/
M4 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. - Homepage: http://www.gnu.org/software/m4/m4.html
Gdk-Pixbuf The Gdk Pixbuf is a toolkit for image loading and pixel buffer manipulation. It is used by GTK+ 2 and GTK+ 3 to load and manipulate images. In the past it was distributed as part of GTK+ 2 but it was split off into a separate package in preparation for the change to GTK+ 3.
GhostScript 9.21-IGB-gcc-4.9.4 Ghostscript is a versatile processor for PostScript data with the ability to render PostScript to different targets. It used to be part of the cups printing stack, but is no longer used for that. - Homepage: http://ghostscript.com
GraphicsMagick 1.3.26-IGB-gcc-4.9.4 GraphicsMagick is the swiss army knife of image processing.
Grinder 0.5.4-IGB-gcc-4.9.4-Perl-5.24.1 Grinder is a versatile open-source bioinformatic tool to create simulated omic shotgun and amplicon sequence libraries for all main sequencing platforms.
Gurobi 7.5.2 The Gurobi Optimizer was designed from the ground up to be the fastest, most powerful solver available for your LP, QP, QCP, and MIP (MILP, MIQP, and MIQCP) problems.
HISAT2 2.0.5-IGB-gcc-4.9.4
2.1.0-IGB-gcc-4.9.4
HISAT2 is a fast and sensitive alignment program for mapping next-generation sequencing reads (both DNA and RNA) against the general human population (as well as against a single reference genome).
HUMAnN2 0.11.1-IGB-gcc-4.9.4-Python-3.6.1
0.11.2-IGB-gcc-4.9.4-Python-3.6.1
HUMAnN is a pipeline for efficiently and accurately profiling the presence/absence and abundance of microbial pathways in a community from metagenomic or metatranscriptomic sequencing data (typically millions of short DNA/RNA reads).
IDR 2.0.4-IGB-gcc-4.9.4-Python-3.6.1 The IDR (Irreproducible Discovery Rate) framework is a unified approach to measure the reproducibility of findings identified from replicate experiments and provide highly stable thresholds based on reproducibility. Unlike the usual scalar measures of reproducibility, the IDR approach creates a curve, which quantitatively assesses when the findings are no longer consistent across replicates. In laymans terms, the IDR method compares a pair of ranked lists of identifications (such as ChIP-seq peaks).
ITSx 1.1.1-IGB-gcc-4.9.4 TSx: Improved software detection and extraction of ITS1 and ITS2 from ribosomal ITS sequences of fungi and other eukaryotes for use in environmental sequencing
IllinoisDataBank 1.0-IGB-gcc-4.9.4-Python-3.6.1 The Illinois Data Bank is a public access repository for publishing research data from the University of Illinois at Urbana-Champaign
ImageMagick 7.0.5-5-IGB-gcc-4.9.4 ImageMagick is a software suite to create, edit, compose, or convert bitmap images - Homepage: http://www.imagemagick.org/
Infernal 1.1.2-IGB-gcc-4.9.4 Infernal,INFERence of RNA ALignment, is for searching DNA sequence databases for RNA structure and sequence similarities.
InterProScan 5.27-66.0-IGB-gcc-4.9.4-Java-1.8.0_152
5.28-67.0-IGB-gcc-4.9.4-Java-1.8.0_152
5.33-72.0-IGB-gcc-4.9.4-Java-1.8.0_152
5.33-72.0-IGB-gcc-4.9.4-Java-1.8.0_201
InterProScan is the software package that allows sequences (protein and nucleic) to be scanned against InterPros signatures. Signatures are predictive models, provided by several different databases, that make up the InterPro consortium.
Jellyfish 1.1.12-IGB-gcc-4.9.4
2.2.10-IGB-gcc-8.2.0
2.2.6-IGB-gcc-4.9.4
Jellyfish is a tool for fast, memory-efficient counting of k-mers in DNA.
fontconfig Fontconfig is a library designed to provide system-wide font configuration, customization andapplication access.
Kraken 1.0-IGB-gcc-4.9.4 Kraken is a system for assigning taxonomic labels to short DNA sequences, usually obtained through metagenomic studies. Previous attempts by other bioinformatics software to accomplish this task have often used sequence alignment or machine learning techniques that were quite slow, leading to the development of less sensitive but much faster abundance estimation programs.
Krona 2.7-IGB-gcc-4.9.4-Perl-5.24.1 Interactively explore metagenomes and more from a web browser.
LASTZ 1.04.00-IGB-gcc-4.9.4 LASTZ is a program for aligning DNA sequences, a pairwise aligner. Originally designed to handle sequences the size of human chromosomes and from different species, it is also useful for sequences produced by NGS sequencing technologies such as Roche 454. - Homepage: http://www.bx.psu.edu/~rsharris/lastz/
LINKS 1.8.5-IGB-gcc-4.9.4-Perl-5.24.1 LINKS is a scalable genomics application for scaffolding or re-scaffolding genome assembly drafts with long reads, such as those produced by Oxford Nanopore Technologies Ltd and Pacific Biosciences. It provides a generic alignment-free framework for scaffolding and can work on any sequences. It is versatile and supports not only long sequences as a source of long-range information, but also MPET pairs and linked-reads, such as those from the 10X Genomics GemCode and Chromium platform, via ARCS (http://www.bcgsc.ca/platform/bioinfo/software/arcs). Fill gaps in LINKS-derived scaffolds using Sealer (http://www.bcgsc.ca/platform/bioinfo/software/sealer).
LLVM 4.0.1-IGB-gcc-4.9.4
6.0.0-IGB-gcc-4.9.4
The LLVM Core libraries provide a modern source- and target-independent optimizer, along with code generation support for many popular CPUs (as well as some less common ones!) These libraries are built around a well specified code representation known as the LLVM intermediate representation ("LLVM IR"). The LLVM Core libraries are well documented, and it is particularly easy to invent your own language (or port an existing compiler) to use LLVM as an optimizer and code generator.
LMDB 0.9.22-IGB-gcc-4.9.4 LMDB is a fast, memory-efficient database. With memory-mapped files, it has the read performance of a pure in-memory database while retaining the persistence of standard disk-based databases.
Lasagne 20170606-IGB-gcc-4.9.4-Python-2.7.13 Lasagne is a lightweight library to build and train neural networks in Theano. - Homepage: http://lasagne.readthedocs.io/en/latest/index.html
LibUUID 1.0.3-IGB-gcc-4.9.4 Portable uuid C library
LittleCMS 2.8-IGB-gcc-4.9.4 Little CMS intends to be an OPEN SOURCE small-footprint color management engine, with special focus on accuracy and performance. - Homepage: http://www.littlecms.com/
MAFFT 7.310-IGB-gcc-4.9.4 MAFFT is a multiple sequence alignment program for unix-like operating systems. It offers a range of multiple alignment methods, L-INS-i (accurate; for alignment of <∼200 sequences), FFT-NS-2 (fast; for alignment of <∼10,000 sequences), etc. - Homepage: http://mafft.cbrc.jp/alignment/software/
MATLAB 2017a
2017b
MATLAB is a high-level language and interactive environment that enables you to perform computationally intensive tasks faster than with traditional programming languages such as C, C++, and Fortran.
MCL 14.137-IGB-gcc-4.9.4 The MCL algorithm is short for the Markov Cluster Algorithm, a fastand scalable unsupervised cluster algorithm for graphs (also known as networks) basedon simulation of (stochastic) flow in graphs. - Homepage: http://micans.org/mcl/
MEGAN 6.12.2-Java-1.8.0_152 MEGAN6 is a comprehensive toolbox for interactively analyzing microbiome data. All the interactive tools you need in one application.
MapSplice 2.2.1-IGB-gcc-4.9.4-Python-2.7.13 MapSplice is a software for mapping RNA-seq data to reference genome for splice junction discovery that depends only on reference genome, and not on any further annotations.
MariaDB 10.1.31-IGB-gcc-4.9.4
10.1.31-IGB-gcc-8.2.0
5.5.58-IGB-gcc-4.9.4
MariaDB An enhanced, drop-in replacement for MySQL.
Meraculous-2d 2.2.6-IGB-gcc-4.9.4 Meraculous-2D is a whole genome assembler for NGS reads (Illumina) that is capable of assembling large, diploid genomes with modest computational requirements.
MetaBAT 2.12.1 MetaBAT, an efficient tool for accurately reconstructing single genomes from complex microbial communities
MetaGeneAnnotator 20080819-x86-64 MetaGeneAnnotator is a gene-finding program for prokaryote and phage.
NASM 2.12.02-IGB-gcc-4.9.4 NASM: General-purpose x86 assembler
NCO 4.7.2-IGB-gcc-4.9.4 manipulates and analyzes data stored in netCDF-accessible formats, including DAP, HDF4, and HDF5
NWChem 6.6.revision27746-IGB-gcc-4.9.4-Python-2.7.13 NWChem aims to provide its users with computational chemistry tools that are scalable both in their ability to treat large scientific computational chemistry problems efficiently, and in their use of available parallel computing resources from high-performance parallel supercomputers to conventional workstation clusters. NWChem software can handle: biomolecules, nanostructures, and solid-state; from quantum to classical, and all combinations; Gaussian basis functions or plane-waves; scaling from one to thousands of processors; properties and relativity.
Perl 5.24.1-IGB-gcc-4.9.4
5.24.1-IGB-gcc-4.9.4-bare
5.26.1-IGB-gcc-4.9.4-unthreaded
5.28.1-IGB-gcc-8.2.0
Larry Wall Practical Extraction and Report Language
NGS 1.3.0-IGB-gcc-4.9.4 NGS is a new, domain-specific API for accessing reads, alignments and pileups produced from Next Generation Sequencing. - Homepage: https://github.com/ncbi/ngs
libxslt Libxslt is the XSLT C library developed for the GNOME project (but usable outside of the Gnome platform).
NanoPlot 1.18.2-IGB-gcc-4.9.4-Python-3.6.1 Plotting tool for long read sequencing data and alignments.
NetLogo 5.2.1
6.0.3
NetLogo is a multi-agent programmable modeling environment. It is used by many tens of thousands of students, teachers and researchers worldwide.
NucleoATAC 0.3.4-IGB-gcc-4.9.4-Python-2.7.13 NucleoATAC is a python package for calling nucleosome positions and occupancy using ATAC-Seq data. Functions for calling nucleosomes are included in the nucleoatac command-line function. NucleoATAC also includes other utlities for working with ATAC-seq data under the pyatac function.
OCaml 4.05.0-IGB-gcc-4.9.4 OCaml is a general purpose industrial-strength programming language with an emphasis on expressiveness and safety. Developed for more than 20 years at Inria it benefits from one of the most advanced type systems and supports functional, imperative and object-oriented styles of programming.
OpenPGM OpenPGM is an open source implementation of the Pragmatic General Multicast (PGM) specification in RFC 3208 available at www.ietf.org. PGM is a reliable and scalable multicast protocol that enables receivers to detect loss, request retransmission of lost data, or notify an application of unrecoverable loss. PGM is a receiver-reliable protocol, which means the receiver is responsible for ensuring all data is received, absolving the sender of reception responsibility.
OrthoMCL 2.0.9-IGB-gcc-4.9.4-Perl-5.24.1 OrthoMCL is a genome-scale algorithm for grouping orthologous protein sequences. - Homepage: http://orthomcl.org/
PAGAN 20150723-IGB-gcc-4.9.4 PAGAN is a general-purpose method for the alignment of sequence graphs. PAGAN is based on the phylogeny-aware progressive alignment algorithm and uses graphs to describe the uncertainty in the presence of characters at certain sequence positions. However, graphs also allow describing the uncertainty in input sequences and modelling e.g. homopolymer errors in Roche 454 reads, or representing inferred ancestral sequences against which other sequences can then be aligned. PAGAN is still under development and will hopefully evolve to an easy-to-use, general-purpose method for phylogenetic sequence alignment.
PEAR 0.9.8-IGB-gcc-4.9.4 PEAR is an ultrafast, memory-efficient and highly accurate pair-end read merger. It is fully parallelized and can run with as low as just a few kilobytes of memory. - Homepage: http://sco.h-its.org/exelixis/web/software/pear/
PICRUSt 1.1.1-IGB-gcc-4.9.4-Python-2.7.13
1.1.3-IGB-gcc-4.9.4-Python-2.7.13
PICRUSt (pronounced pie crust) is a bioinformatics software package designed to predict metagenome functional content from marker gene (e.g., 16S rRNA) surveys and full genomes.
PITA 6-IGB-gcc-4.9.4 The PITA executable allows you to identify and score microRNA targets on UTRs.
PRANK 170427-IGB-gcc-4.9.4 PRANK is a probabilistic multiple alignment program for DNA, codon and amino-acid sequences. It’s based on a novel algorithm that treats insertions correctly and avoids over-estimation of the number of deletion events. In addition, PRANK borrows ideas from maximum likelihood methods used in phylogenetics and correctly takes into account the evolutionary distances between sequences. Lastly, PRANK allows for defining a potential structure for sequences to be aligned and then, simultaneously with the alignment, predicts the locations of structural units in the sequences.
PePr 1.1.21-IGB-gcc-4.9.4-Python-2.7.13 PePr is a ChIP-Seq Peak-calling and Prioritization pipeline that uses a sliding window approach and models read counts across replicates and between groups with a negative binomial distribution.
Phantompeaktools 1.2-IGB-gcc-4.9.4-R-3.4.1 Custom SPP for Phantompeaktools
Porechop 0.2.3-IGB-gcc-4.9.4-Python-3.6.1 Porechop is a tool for finding and removing adapters from Oxford Nanopore reads.
Prodigal 2.6.3 Fast, reliable protein-coding gene prediction for prokaryotic genomes.
Prost 0.7.45-IGB-gcc-4.9.4-Python-2.7.13 Prost (PRocessing Of Small Transcripts) is a python application that quantifies and annotates microRNA (miRNA) expression in metazoans with assembled genomes. Prost works by counting short transcripts within a user-specifiable length range. These counted transcripts are aligned to a user specifiable genome allowing for post-transcriptional modification (e.g. untemplated additions, editing, alternative cutting) and then "binned" together based on genomic location. Each bin is then annotated with databases of mature miRNAs, hairpins, and other types of RNAs (the databases may be derived from miRBase, Ensembls BioMart, other databases, or may be custom built by the user).
PyTorch 0.3.0-IGB-gcc-4.9.4-Python-3.6.1
0.4.0-IGB-gcc-4.9.4-Python-3.6.1
0.4.1-IGB-gcc-4.9.4-Python-2.7.13
1.0.1.post2-IGB-gcc-4.9.4-Python-3.6.1
Tensors and Dynamic neural networks in Pythonwith strong GPU acceleration.
QIIME 1.9.1 QIIME is an open-source bioinformatics pipeline for performing microbiome analysis from raw DNA sequencing data.
Qt 4.8.7-IGB-gcc-4.9.4 Qt is a comprehensive cross-platform C++ application framework.
RECON 1.08-IGB-gcc-4.9.4-Perl-5.24.1 a package for automated de novo identification of repeat families from genomic sequences
RNAhybrid 2.1.2-IGB-gcc-4.9.4 RNAhybrid is a tool for finding the minimum free energy hybridization of a long and a short RNA. The hybridization is performed in a kind of domain mode, ie. the short sequence is hybridized to the best fitting part of the long one. The tool is primarily meant as a means for microRNA target prediction.
RNAstructure 6.0-IGB-gcc-4.9.4 RNAstructure is a complete package for RNA and DNA secondary structure prediction and analysis. It includes algorithms for secondary structure prediction, including facility to predict base pairing probabilities.
ROSE 20150210-IGB-gcc-4.9.4-Python-2.7.13 To create stitched enhancers, and to separate super-enhancers from typical enhancers using sequencing data (.bam)
RSAT 2018-08-04-IGB-gcc-4.9.4 We offer tools to analyse cis-regulatory elements in genome sequences, motif discovery (support genome-wide data sets like ChIP-seq), transcription factor binding motif analysis (quality assessment, comparisons and clustering), comparative genomics, analysis of regulatory variations
RSEM 1.3.0-IGB-gcc-4.9.4
1.3.1-IGB-gcc-4.9.4
RNA-Seq by Expectation-Maximization
libtool GNU libtool is a generic library support script. Libtool hides the complexity of using shared libraries behind a consistent, portable interface. - Homepage: http://www.gnu.org/software/libtool
RSeQC 2.6.4-IGB-gcc-4.9.4-Python-2.7.13 RSeQC package provides a number of useful modules that can comprehensively evaluate high throughput sequence data especially RNA-seq data. Some basic modules quickly inspect sequence quality, nucleotide composition bias, PCR bias and GC bias, while RNA-seq specific modules evaluate sequencing saturation, mapped reads distribution, coverage uniformity, strand specificity, transcript level RNA integrity etc.
Ragout 2.0-IGB-gcc-4.9.4 Ragout (Reference-Assisted Genome Ordering UTility) is a tool for chromosome assembly using multiple references.
RcppGSL 0.3.2-IGB-gcc-4.9.4-R-3.3.3 Rcpp integration for GNU GSL vectors and matrices The GNU Scientific Library (or GSL) is a collection of numerical routines for scientific computing. It is particularly useful for C and C++ programs as it provides a standard C interface to a wide range of mathematical routines. There are over 1000 functions in total with an extensive test suite. The RcppGSL package provides an easy-to-use interface between GSL data structures and R using concepts from Rcpp which is itself a package that eases the interfaces between R and C++. This package also serves as a prime example of how to build a package that uses Rcpp to connect to another third-party library. The autoconf script, inline plugin and example package can all be used as a stanza to write a similar package against another library.
RepeatMasker 4.0.7-IGB-gcc-4.9.4-Perl-5.24.1
4.0.7-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded
RepeatMasker is a program that screens DNA sequences for interspersed repeats and low complexity DNA sequences.
RepeatModeler 1.0.11-IGB-gcc-4.9.4-Perl-5.24.1 1.0.11
RepeatScout 1.0.5-IGB-gcc-4.9.4 De Novo Repeat Finder,
Rmpi 0.6-6-IGB-gcc-4.9.4-R-3.4.2 An interface (wrapper) to MPI APIs. It also provides interactive R manager and worker environment.
Ruby 2.4.2-IGB-gcc-4.9.4 Ruby is a dynamic, open source programming language with a focus on simplicity and productivity. It has an elegant syntax that is natural to read and easy to write.
Rust 1.30.0-IGB-gcc-4.9.4 Rust is a systems programming language that runs blazingly fast, prevents segfaults, and guarantees thread safety.
SCons 3.0.1-IGB-gcc-4.9.4-Python-2.7.13
3.0.1-IGB-gcc-4.9.4-Python-3.6.1
SCons is a software construction tool.
SDL2 2.0.4-IGB-gcc-4.9.4 SDL: Simple DirectMedia Layer, a cross-platform multimedia library
SEPP 20180223-IGB-gcc-4.9.4-Python-2.7.13 SEPP stands for "SATe-enabled Phylogenetic Placement", and addresses the problem of phylogenetic placement of short reads into reference alignments and trees.
SMARTdenovo 20170916-IGB-gcc-4.9.4-Perl-5.24.1 SMARTdenovo is a de novo assembler for PacBio and Oxford Nanopore (ONT) data. It produces an assembly from all-vs-all raw read alignments without an error correction stage. It also provides tools to generate accurate consensus sequences, though a platform dependent consensus polish tools (e.g. Quiver for PacBio or Nanopolish for ONT) are still required for higher accuracy.
SNAP 2013-11-29-IGB-gcc-4.9.4 (Semi-HMM-based Nucleic Acid Parser) gene prediction tool
SNVer 0.5.3-Java-1.8.0_121
0.5.3-Java-1.8.0_152
SNVer is a statistical tool for calling common and rare variants in analysis of pool or individual next-generation sequencing data. It reports one single overall p-value for evaluating the significance of a candidate locus being a variant, based on which multiplicity control can be obtained.
SOAPdenovo-Trans 1.03 SOAPdenovo-Trans is a de novo transcriptome assembler basing on the SOAPdenovo framework, adapt to alternative splicing and different expression level among transcripts.The assembler provides a more accurate, complete and faster way to construct the full-length transcript sets.
STAR-Fusion 1.6.0-IGB-gcc-4.9.4 STAR-Fusion is a component of the Trinity Cancer Transcriptome Analysis Toolkit (CTAT). STAR-Fusion uses the STAR aligner to identify candidate fusion transcripts supported by Illumina reads.
SUNDIALS 2.6.2-IGB-gcc-4.9.4 SUNDIALS: SUite of Nonlinear and DIfferential/ALgebraic Equation Solvers
SWIG 2.0.12-IGB-gcc-4.9.4-Python-2.7.13
3.0.12-IGB-gcc-4.9.4-Python-2.7.13
3.0.12-IGB-gcc-4.9.4-Python-2.7.13-Perl-5.24.1
SWIG is a software development tool that connects programs written in C and C++ with a variety of high-level programming languages. - Homepage: http://www.swig.org/
Segway 2.0.1-IGB-gcc-4.9.4-Python-2.7.13 Segway is a tool for easy pattern discovery and identification in functional genomics data.
Sibelia 3.0.7-IGB-gcc-4.9.4 Sibelia is a tool for finding synteny blocks in closely related genomes, like different strains of the same bacterial species.
SignalP 4.1 Signal peptide and cleavage sites in gram+, gram- and eukaryotic amino acid sequences
SoX 14.4.2-IGB-gcc-4.9.4 Sound eXchange, the Swiss Army knife of audio manipulation
Spine 0.2.1-IGB-gcc-4.9.4 Spine identifies a core genome from input genomic sequences. Sequences are aligned using Nucmer and regions found to be in common between all or a user-defined subset of genomes will be returned.
Stacks 1.47-IGB-gcc-4.9.4 Stacks is a software pipeline for building loci from short-read sequences, such as those generated on the Illumina platform. Stacks was developed to work with restriction enzyme-based data, such as RAD-seq, for the purpose of building genetic maps and conducting population genomics and phylogeography.
StringTie 1.3.3-IGB-gcc-4.9.4
1.3.6-IGB-gcc-4.9.4
StringTie is a fast and highly efficient assembler of RNA-Seq alignments into potential transcripts.
Supernova 1.1.5
1.2.0
1.2.1
2.0.0
2.0.1
2.1.0
2.1.1
Supernova is a software package for de novo assembly from Chromium Linked-Reads that are made from a single whole-genome library from an individual DNA source. A key feature of Supernova is that it creates diploid assemblies, thus separately representing maternal and paternal chromosomes over very long distances.
Tcl 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.
SRA-Toolkit 2.8.2-1 The NCBI SRA Toolkit enables reading (dumping) of sequencing files from the SRA database and writing (loading) files into the .sra format - Homepage: http://trace.ncbi.nlm.nih.gov/Traces/sra/sra.cgi?view=std
ScaLAPACK The ScaLAPACK (or Scalable LAPACK) library includes a subset of LAPACK routines redesigned for distributed memory MIMD parallel computers.
TASSEL 5.2.28-Java-1.8.0_121 While TASSEL has changed considerably since its initial public release in 2001, its primary function continues to be providing tools to investigate the relationship between phenotypes and genotypes
TMHMM 2.0c-IGB-gcc-4.9.4 Transmembrane helices in proteins
TULIP 20170513-IGB-gcc-4.9.4-Perl-5.24.1 Tulipseed takes as input alignments files of long reads to sparse short seeds, and outputs a graph and scaffold structures. Tulipbulb adds long read sequencing data to these.
TensorFlowModels 1.11-IGB-gcc-4.9.4-Python-3.6.1
20171113-IGB-gcc-4.9.4-Python-3.6.1
This repository contains a number of different models implemented in TensorFlow:
Tensorflow 1.2.1-IGB-gcc-4.9.4-Python-2.7.13 An open-source software library for Machine Intelligence
Theano 0.9.0-IGB-gcc-4.9.4-Python-2.7.13 Theano is a Python library that allows you to define, optimize,and evaluate mathematical expressions involving multi-dimensional arrays efficiently. - Homepage: http://deeplearning.net/software/theano
Tk Tk is an open source, cross-platform widget toolchain that provides a library of basic elements for building a graphical user interface (GUI) in many different programming languages.
TopHat 1.4.1
2.1.1-IGB-gcc-4.9.4
TopHat is a fast splice junction mapper for RNA-Seq reads.
Torch 20171018-IGB-gcc-4.9.4-Python-3.6.1 Torch is a scientific computing framework with wide support for machine learning algorithms that puts GPUs first. It is easy to use and efficient, thanks to an easy and fast scripting language, LuaJIT, and an underlying C/CUDA implementation.
TransDecoder 5.1.0-IGB-gcc-4.9.4-Perl-5.24.1 TransDecoder identifies candidate coding regions within transcript sequences, such as those generated by de novo RNA-Seq transcript assembly using Trinity, or constructed based on RNA-Seq alignments to the genome using Tophat and Cufflinks.
Trim_Galore 0.4.4-IGB-gcc-4.9.4 A wrapper tool around Cutadapt and FastQC to consistently apply quality and adapter trimming to FastQ files, with some extra functionality for MspI-digested RRBS-type (Reduced Representation Bisufite-Seq) libraries.
USEARCH 6.1.544
7.0.1090
9.2.64
USEARCH is a unique sequence analysis tool which offers search and clustering algorithms that are often orders of magnitude faster than BLAST.
VCFtools 0.1.15-IGB-gcc-4.9.4-Perl-5.24.1 The aim of VCFtools is to provide easily accessible methods for working with complex genetic variation data in the form of VCF files. - Homepage: https://vcftools.github.io
VEP 92.4-IGB-gcc-4.9.4-Perl-5.24.1 VEP (Variant Effect Predictor) predicts the functional effects of genomic variants.
VICSIN 0.5-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13
0.5.1-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13
0.5.2-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13
dev
VICSIN = Viral, Integrative, and Conjugative Sequence Identification and Networking
VSEARCH 2.4.3-IGB-gcc-4.9.4 VSEARCH stands for vectorized search, as the tool takes advantage of parallelism in the form of SIMD vectorization as well as multiple threads to perform accurate alignments at high speed. - Homepage: https://github.com/torognes/vsearch
ViennaRNA 2.4.2-IGB-gcc-4.9.4 The ViennaRNA Package consists of a C code library and several stand-alone programs for the prediction and comparison of RNA secondary structures.
VirSorter 20170215-IGB-gcc-4.9.4-Perl-5.24.1 VirSorter: mining viral signal from microbial genomic data.
XZ 5.2.3-IGB-gcc-4.9.4
5.2.3-IGB-gcc-8.2.0
xz: XZ utilities
Yasm Yasm: Complete rewrite of the NASM assembler with BSD license
ZeroMQ 4.2.2-IGB-gcc-4.9.4 ZeroMQ looks like an embeddable networking library but acts like a concurrency framework. It gives you sockets that carry atomic messages across various transports like in-process, inter-process, TCP, and multicast. You can connect sockets N-to-N with patterns like fanout, pub-sub, task distribution, and request-reply. It is fast enough to be the fabric for clustered products. Its asynchronous I/O model gives you scalable multicore applications, built as asynchronous message-processing tasks. It has a score of language APIs and runs on most operating systems.
a2ps 4.14-IGB-gcc-4.9.4 a2ps-4.14: Formats an ascii file for printing on a postscript printer
admixture 1.3.0 ADMIXTURE is a software tool for maximum likelihood estimation of individual ancestries from multilocus SNP genotype datasets. It uses the same statistical model as STRUCTURE but calculates estimates much more rapidly using a fast numerical optimization algorithm.
albacore 2.0.2-IGB-gcc-4.9.4-Python-3.6.1
2.1.10-IGB-gcc-4.9.4-Python-3.6.1
2.3.1-IGB-gcc-4.9.4-Python-3.6.1
Local basecalling for MinKNOW
antismash 4.1.0 antiSMASH allows the rapid genome-wide identification, annotation and analysis of secondary metabolite biosynthesis gene clusters in bacterial and fungal genomes. It integrates and cross-links with a large number of in silico secondary metabolite analysis tools that have been published earlier.
argtable Argtable is an ANSI C library for parsing GNU style command line options with a minimum of fuss. - Homepage: http://argtable.sourceforge.net/
aspera 3.7.6 Aspera’s unwavering mission is to create the next-generation software technologies that move the world’s data at maximum speed, regardless of file size, transfer distance and network conditions.
atactk 0.1.6-IGB-gcc-4.9.4-Python-2.7.13 a toolkit for ATAC-seq data
awscli 1.16.113-IGB-gcc-4.9.4-Python-3.6.1 The AWS Command Line Interface (CLI) is a unified tool to manage your AWS services. With just one tool to download and configure, you can control multiple AWS services from the command line and automate them through scripts.
bammds 20140602-IGB-gcc-4.9.4 Software that allows to create a multidimensional scaling (MDS) plot of populations for genetic data.
bax2bam 20171114-IGB-gcc-4.9.4 bax2bam converts the legacy PacBio basecall format (bax.h5) into the BAMbasecall format.
bazel 0.6.0-Java-1.8.0_121 Bazel is a build tool that builds code quickly and reliably. It is used to build the majority of Googles software.
beagle 03Jul18.40b-Java-1.8.0_152 Beagle is a software package for phasing genotypes and for imputing ungenotyped markers. Version 5.0 has new, fast algorithms for genotype phasing and imputation.
bedops 2.4.30 BEDOPS is an open-source command-line toolkit that performs highly efficient and scalable Boolean and other set operations, statistical calculations, archiving, conversion and other management of genomic data of arbitrary scale.
binutils binutils: GNU binary utilities
bio-rocker 1.2.0-IGB-gcc-4.9.4-Ruby-2.4.2 Accurately detecting functional genes in metagenomes.
biodatabase 1.0-IGB-gcc-4.9.4 Scripts to create databases on the biodatabase machine.
biom-format 2.1.6-IGB-gcc-4.9.4-Python-2.7.13
2.1.6-IGB-gcc-4.9.4-Python-3.6.1
The BIOM file format (canonically pronounced biome) is designed to be a general-use format for representing biological sample by observation contingency tables.
breseq 0.31.0-IGB-gcc-4.9.4 is a computational pipeline for the analysis of short-read re-sequencing data (e.g. Illumina, 454, IonTorrent, etc.). It uses reference-based alignment approaches to predict mutations in a sample relative to an already sequenced genome.
byacc 20170709-IGB-gcc-4.9.4 Berkeley Yacc (byacc) is generally conceded to be the best yacc variant available.In contrast to bison, it is written to avoid dependencies upon a particular compiler.
bzip2 1.0.6-IGB-gcc-4.9.4
1.0.6-IGB-gcc-8.2.0
bzip2 is a freely available, patent free, high-quality data compressor. It typically compresses files to within 10% to 15% of the best available techniques (the PPM family of statistical compressors), whilst being around twice as fast at compression and six times faster at decompression.
cURL libcurl is a free and easy-to-use client-side URL transfer library, supporting DICT, FILE, FTP, FTPS, Gopher, HTTP, HTTPS, IMAP, IMAPS, LDAP, LDAPS, POP3, POP3S, RTMP, RTSP, SCP, SFTP, SMTP, SMTPS, Telnet and TFTP. libcurl supports SSL certificates, HTTP POST, HTTP PUT, FTP uploading, HTTP form based upload, proxies, cookies, user+password authentication (Basic, Digest, NTLM, Negotiate, Kerberos), file transfer resume, http proxy tunneling and more.
cactus 20180705-IGB-gcc-4.9.4-Python-2.7.13 Cactus is a reference-free whole-genome multiple alignment program.
cdbfasta 20170316-IGB-gcc-4.9.4 CDB (Constant DataBase) indexing and retrieval tools for FASTA files
centrifuge 1.0.3-beta-IGB-gcc-4.9.4
1.0.4-beta-IGB-gcc-4.9.4
Centrifuge is a very rapid and memory-efficient system for the classification of DNA sequences from microbial samples, with better sensitivity than and comparable accuracy to other leading systems.
chopchop 20190211-IGB-gcc-4.9.4-Python-2.7.13 CHOPCHOP is a python script that allows quick and customizable design of guide RNA. We support selecting target sites for CRISPR/Cas9, CRISPR/Cpf1 or TALEN with wide range of customization. We even support C2c2 for isoform targeting.
cisgenome 2.0-IGB-gcc-4.9.4 An integrated tool for tiling array, ChIP-seq, genome and cis-regulatory element analysis
cocoapi 20190218-IGB-gcc-4.9.4-Python-3.6.1 OCO is a large image dataset designed for object detection, segmentation, person keypoints detection, stuff segmentation, and caption generation.
coreutils 8.28-IGB-gcc-4.9.4 The GNU Core Utilities are the basic file, shell and text manipulation utilities of the GNU operating system.These are the core utilities which are expected to exist on every operating system.
cortex 1.0.5.21-IGB-gcc-4.9.4 reference free variant assembly
crb-blast 0.6.9-IGB-gcc-4.9.4 Conditional Reciprocal Best BLAST - high confidence ortholog assignment. CRB-BLAST is a novel method for finding orthologs between one set of sequences and another. This is particularly useful in genome and transcriptome annotation.
cromwell 39-Java-1.8.0_152 Scientific workflow engine designed for simplicity & scalability. Trivially transition between one off use cases to massive scale production environments
cutadapt 1.14-IGB-gcc-4.9.4-Python-2.7.13
1.17-IGB-gcc-4.9.4-Python-3.6.1
Cutadapt finds and removes adapter sequences, primers, poly-A tails and other types of unwanted sequence from your high-throughput sequencing reads.
damidseq 1.4-IGB-gcc-4.9.4 Processing DamID-seq data involves extending single-end reads, aligning the reads to the genome and determining the coverage, similar to processing regular ChIP-seq datasets.
deepTools 2.5.3-IGB-gcc-4.9.4-Python-2.7.13
3.0.1-IGB-gcc-4.9.4-Python-2.7.13
3.2.1-IGB-gcc-4.9.4-Python-3.6.1
deepTools addresses the challenge of handling the large amounts of data that are now routinely generated from DNA sequencing centers. deepTools contains useful modules to process the mapped reads data for multiple quality checks, creating normalized coverage files in standard bedGraph and bigWig file formats, that allow comparison between different files (for example, treatment and control). Finally, using such normalized and standardized files, deepTools can create many publication-ready visualizations to identify enrichments and for functional annotations of the genome.
deep_q_rl 20160603-IGB-gcc-4.9.4-Python-2.7.13 This package provides a Lasagne/Theano-based implementation of the deep Q-learning algorithm described in:Playing Atari with Deep Reinforcement Learning Volodymyr Mnih, Koray Kavukcuoglu, David Silver, Alex Graves, Ioannis Antonoglou, Daan Wierstra, Martin RiedmillerandMnih, Volodymyr, et al. "Human-level control through deep reinforcement learning." Nature 518.7540 (2015): 529-533.
diffReps 1.55.6-IGB-gcc-4.9.4-Perl-5.24.1 ChIP-seq is now widely used to profile the protein DNA interactions on a genome. It is of high interest to compare the differential enrichment of a histone mark or transcription factor between two contrasting conditions, such as disease vs. control. diffReps is developed to serve this purpose. It scans the whole genome using a sliding window, performing millions of statistical tests and report the significant hits. - Homepage: https://github.com/shenlab-sinai/diffreps
distruct 2.2-IGB-gcc-4.9.4 Modified version of the original distruct.py
ea-utils 1.04.807-IGB-gcc-4.9.4 Command-line tools for processing biological sequencing data. Barcode demultiplexing, adapter trimming, etc. Primarily written to support an Illumina based pipeline - but should work with any FASTQs.
eigensoft 7.2.1-IGB-gcc-4.9.4 The EIGENSOFT package combines functionality from our population genetics methods (Patterson et al. 2006) and our EIGENSTRAT stratification correction method (Price et al. 2006).
epic 0.2.9-IGB-gcc-4.9.4-Python-2.7.13 epic is a software package for finding medium to diffusely enriched domains in chip-seq data. It is a fast, parallel and memory-efficient implementation of the incredibly popular SICER algorithm.
exonerate 2.2.0-IGB-gcc-4.9.4 Exonerate is a generic tool for pairwise sequence comparison. It allows you to align sequences using a many alignment models, either exhaustive dynamic programming or a variety of heuristics.
expat Expat is an XML parser library written in C. It is a stream-oriented parser in which an application registers handlers for things the parser might find in the XML document (like start tags)
fast5 0.6.2-IGB-gcc-4.9.4
0.6.3-IGB-gcc-4.9.4
0.6.5-IGB-gcc-4.9.4
A lightweight C++ library for accessing Oxford Nanopore Technologies sequencing data.
fastPHASE 20160330 astPHASE is a program to estimate missing genotypes and unobserved haplotypes.
fastp 0.19.5-IGB-gcc-4.9.4
0.19.6-IGB-gcc-4.9.4-7117eba
0.20.0-IGB-gcc-4.9.4
A tool designed to provide fast all-in-one preprocessing for FastQ files. This tool is developed in C++ with multithreading supported to afford high performance.
fdupes 1.6.1-IGB-gcc-4.9.4 FDUPES is a program for identifying duplicate files residingwithin specified directories.
fgbio 0.6.0-Java-1.8.0_152 fgbio is a command line toolkit for working with genomic and particularly next generation sequencing data.
file The file command is a file type guesser, that is, a command-line tool that tells you in words what kind of data a file contains.
flex Flex (Fast Lexical Analyzer) is a tool for generating scanners. A scanner, sometimes called a tokenizer, is a program which recognizes lexical patterns in text. - Homepage: http://flex.sourceforge.net/
flexbar 3.0.3-IGB-gcc-4.9.4 The program Flexbar preprocesses high-throughput sequencing data efficiently. It demultiplexes barcoded runs and removes adapter sequences. Moreover, trimming and filtering features are provided.
freetype FreeType 2 is a software font engine that is designed to be small, efficient, highly customizable, and portable while capable of producing high-quality output (glyph images). It can be used in graphics libraries, display servers, font conversion tools, text image generation tools, and many other products as well.
gdb 8.0.1-IGB-gcc-4.9.4-Python-2.7.13 The GNU Project Debugger
gdc-client 1.3.0-IGB-gcc-4.9.4-Python-2.7.13 The GDC Data Transfer Tool Client provides a command-line interface supporting both GDC data downloads and submissions.
geneclass 2.0 GeneClass2 is a program employing multilocus genotypes to select or exclude populations as origins of individuals (Assignment and Migrants Detection). This is a completely rewritten new version that includes pop100gene features.
gengetopt Gengetopt is a tool to write command line option parsing code for C programs. - Homepage: https://www.gnu.org/software/gengetopt/gengetopt.html
genometools 1.5.10-IGB-gcc-4.9.4 The GenomeTools genome analysis system is a free collection of bioinformatics tools (in the realm of genome informatics) combined into a single binary named gt. It is based on a C library named “libgenometools” which consists of several modules.
geos 3.7.1-IGB-gcc-4.9.4 GEOS (Geometry Engine - Open Source) is a C++ port of the JTS Topology Suite
gettext GNU gettext is an important step for the GNU Translation Project, as it is an asset on which we maybuild many other steps. This package offers to programmers, translators, and even users, a well integrated set of toolsand documentation
gevalt 2.0-Java-1.8.0_152 GEVALT (GEnotype Visualization and ALgorithmic Tool) is designed to simplify and expedite the process of genotype analysis and disease association tests by providing a common interface to several common tasks relating to such analyses.
gffcompare 0.10.6-IGB-gcc-4.9.4 The program gffcompare can be used to compare, merge, annotate and estimate accuracy of one or more GFF files (the query files), when compared with a reference annotation (also provided as GFF).
gffread ba7535f-IGB-gcc-4.9.4 The program gffread can be used to validate, filter, convert and perform various other operations on GFF files
git 2.9.5-IGB-gcc-4.9.4 Git is a free and open source distributed version control system designedto handle everything from small to very large projects with speed and efficiency.
git-lfs 2.2.1-IGB-gcc-4.9.4 Git Large File Storage (LFS) replaces large files such as audio samples, videos, datasets, and graphics with text pointers inside Git, while storing the file contents on a remote server like GitHub.com or GitHub Enterprise.
glproto X protocol and ancillary headers
gnuplot 4.6.7-IGB-gcc-4.9.4
5.0.6-IGB-gcc-4.9.4
Portable interactive, function plotting utility - Homepage: http://gnuplot.sourceforge.net/
gompi GNU Compiler Collection (GCC) based compiler toolchain, including OpenMPI for MPI support.
gossamer 20170105-IGB-gcc-4.9.4 The gossamer bioinformatics suite contains goss, gossple, xenome, and electus
gperf 3.1-IGB-gcc-4.9.4 GNU gperf is a perfect hash function generator. For a given list of strings, it produces a hash function and hash table, in form of C or C++ code, for looking up a value depending on the input string. The hash function is perfect, which means that the hash table has no collisions, and the hash table lookup needs a single string comparison only.
graphlan 6ca8735-IGB-gcc-4.9.4-Python-2.7.13 GraPhlAn is a software tool for producing high-quality circular representations of taxonomic and phylogenetic trees. It focuses on concise, integrative, informative, and publication-ready representations of phylogenetically- and taxonomically-driven investigation.
graphtyper 1.3-IGB-gcc-4.9.4 Graphtyper is a highly scalable genotyping software. It represents a reference genome and known variants of a genomic region using an acyclic mathematical graph structure (a "pangenome reference"), which high-throughput sequence reads are re-aligned to for the purpose of discovering and genotyping SNPs and small indels.
graphviz 2.40.1-IGB-gcc-4.9.4
2.40.1-IGB-gcc-4.9.4-Python-2.7.13
Graphviz is open source graph visualization software. Graph visualization is a way of representing structural information as diagrams of abstract graphs and networks. It has important applications in networking, bioinformatics, software engineering, database and web design, machine learning, and in visual interfaces for other technical domains.
gtest 1.8.0-IGB-gcc-4.9.4 Googles C++ test framework
gtool 0.7.5 GTOOL is a program for transforming sets of genotype data for use with the programs SNPTEST and IMPUTE.
h2o 3.14.0.3-IGB-gcc-4.9.4-R-3.3.3 R scripting functionality for H2O, the open source math engine for big data that computes parallel distributed machine learning algorithms such as generalized linear models, gradient boosting machines, random forests, and neural networks (deep learning) within various cluster environments.
h5py The h5py package provides both a high- and low-level interface to the HDF5 library from Python.
hapflk 1.4-IGB-gcc-4.9.4-Python-3.6.1 hapflk is a software implementing the hapFLK and FLK tests for the detection of selection signatures based on multiple population genotyping data.
help2man help2man produces simple manual pages from the --help and --version output of other commands.
hwloc The Portable Hardware Locality (hwloc) software package provides a portable abstraction(across OS, versions, architectures, ...) of the hierarchical topology of modern architectures, includingNUMA memory nodes, sockets, shared caches, cores and simultaneous multithreading. It also gathers varioussystem attributes such as cache and memory information as well as the locality of I/O devices such asnetwork interfaces, InfiniBand HCAs or GPUs. It primarily aims at helping applications with gatheringinformation about modern computing hardware so as to exploit it accordingly and efficiently.
icorn 0.97-IGB-gcc-4.9.4 Inputs: Reference Sequence (FASTA) & reads (FASTQ) & information of short reads
impute2 2.3.2 IMPUTE2 is freely available for academic use. To see rules for non-academic use, please read the LICENCE file, which is included with each software download.
ior 3.0.1-IGB-gcc-4.9.4 Parallel filesystem I/O benchmark
jansson 2.6-IGB-gcc-4.9.4 Jansson is a C library for encoding, decoding and manipulating JSON data.
jemalloc 5.0.1-IGB-gcc-4.9.4 jemalloc is a general purpose malloc(3) implementation that emphasizes fragmentation avoidance and scalable concurrency support.
jupyter 1.0.0-IGB-gcc-4.9.4-Python-3.6.1 Project Jupyter exists to develop open-source software, open-standards, and services for interactive computing across dozens of programming languages.
kallisto 0.43.1-IGB-gcc-4.9.4
0.44.0-IGB-gcc-4.9.4
kallisto is a program for quantifying abundances of transcripts from RNA-Seq data, or more generally of target sequences using high-throughput sequencing reads.
kentUtils 353-IGB-gcc-4.9.4 UCSC genome browser kent bioinformatic utilities
keras-rl 0.3.0-IGB-gcc-4.9.4-Python-2.7.13 keras-rl implements some state-of-the art deep reinforcement learning algorithms in Python and seamlessly integrates with the deep learning library Keras.
kyoto 20170410-IGB-gcc-4.9.4 Kyoto Tycoon is a lightweight network server on top of the Kyoto Cabinet key-value database, built for high-performance and concurrency. Some of its features include:
lbzip2 2.5-IGB-gcc-4.9.4 lbzip2 is a free, multi-threaded compression utility with support for bzip2 compressed file format.
lftp 4.8.3 FTP is a sophisticated file transfer program supporting a number of network protocols (ftp, http, sftp, fish, torrent).
libdap A C++ SDK which contains an implementation of DAP 2.0 and the development versions of DAP3, up to 3.4. This includes both Client- and Server-side support classes.
libdrm Direct Rendering Manager runtime library.
libevent The libevent API provides a mechanism to execute a callback function when a specific event occurs on a file descriptor or after a timeout has been reached. Furthermore, libevent also support callbacks due to signals or regular timeouts.
libffi The libffi library provides a portable, high level programming interface to various callingconventions. This allows a programmer to call any function specified by a call interface description at run-time.
libgd GD is an open source code library for the dynamic creation of images by programmers. - Homepage: http://libgd.bitbucket.org/
libgpuarray 0.6.5-IGB-gcc-4.9.4 Make a common GPU ndarray(n dimensions array) that can be reused by all projects that is as future proof as possible, while keeping it easy to use for simple need/quick test. - Homepage: http://deeplearning.net/software/libgpuarray/
libgtextutils ligtextutils is a dependency of fastx-toolkit and is provided via the same upstream - Homepage: http://hannonlab.cshl.edu/fastx_toolkit/
libharu 2.3.0-IGB-gcc-4.9.4 libHaru is a free, cross platform, open source library for generating PDF files. - Homepage: http://libharu.org/
libjpeg-turbo libjpeg-turbo is a fork of the original IJG libjpeg which uses SIMD to accelerate baseline JPEGcompression and decompression. libjpeg is a library that implements JPEG image encoding, decoding and transcoding.
libpciaccess Generic PCI access library.
libpng libpng is the official PNG reference library
libpthread-stubs The X protocol C-language Binding (XCB) is a replacement for Xlib featuring a small footprint,latency hiding, direct access to the protocol, improved threading support, and extensibility.
libreadline The GNU Readline library provides a set of functions for use by applications that allow users to edit command lines as they are typed in. Both Emacs and vi editing modes are available. The Readline library includes additional functions to maintain a list of previously-entered command lines, to recall and perhaps reedit those lines, and perform csh-like history expansion on previous commands.
libsodium Sodium is a modern, easy-to-use software library for encryption, decryption, signatures, password hashing and more.
libxml2 Libxml2 is the XML C parser and toolchain developed for the Gnome project (but usable outside of the Gnome platform).
longranger 2.1.3
2.1.6
2.2.2
Long Ranger is a set of analysis pipelines that processes Chromium sequencing output to align reads and call and phase SNPs, indels, and structural variants. There are five main pipelines, each triggered by a longranger command
loupe 2.1.1 Loupe is a genome browser designed to visualize the Linked-Read data produced by the 10x Chromium Platform. Loupe is named for a jewelers loupe, which is used to inspect gems.
lzo Portable lossless data compression library
mageck-vispr 0.5.4-IGB-gcc-4.9.4-Python-3.6.1 MAGeCK-VISPR is a comprehensive quality control, analysis and visualization workflow for CRISPR/Cas9 screens.
magic 0.1-IGB-gcc-4.9.4-Python-3.6.1 A diffusion-based imputation method reveals gene-gene interactions in single-cell RNA-sequencing data
medaka 0.1.0-IGB-gcc-4.9.4-Python-3.6.1 Medaka demonstrates a framework for error correcting sequencing data, particularly aimed at nanopore sequencing. Tools are provided for both training and inference. The code exploits the keras deep learning library.
memprof 1.01 Memprof is HPC Cluster Program Profiler. It records the memory, processor, and IO usage of a process. It will then generate a graph of the results.
metaphlan2 2.6.0-IGB-gcc-4.9.4-Python-3.6.1
2.7.6-IGB-gcc-4.9.4-Python-2.7.13
2.7.8-IGB-gcc-4.9.4-Python-2.7.13
2.7.8-IGB-gcc-4.9.4-Python-3.6.1
MetaPhlAn is a computational tool for profiling the composition of microbial communities (Bacteria, Archaea, Eukaryotes and Viruses) from metagenomic shotgun sequencing data (i.e. not 16S) with species-level. With the newly added StrainPhlAn module, it is now possible to perform accurate strain-level microbial profiling.
metashape 1.5.1-IGB-gcc-4.9.4 photogrammetricprocessing of digital images and 3D spatial data generation
microbiome_helper 20171114-IGB-gcc-4.9.4 An assortment of scripts to help process and automate various microbiome and metagenomic bioinformatic tools. We provide workflows, tutorials and a virtual box image to help researchers process microbial data.
microbiomeutil 20110519-IGB-gcc-4.9.4 Contains ChimeraSlayer, WigeoN, and NAST-iEr
miniasm 0.2-IGB-gcc-4.9.4 Miniasm is a very fast OLC-based de novo assembler for noisy long reads. It takes all-vs-all read self-mappings (typically by minimap) as input and outputs an assembly graph in the GFA format. Different from mainstream assemblers, miniasm does not have a consensus step. It simply concatenates pieces of read sequences to generate the final unitig sequences. Thus the per-base error rate is similar to the raw input reads.
minimap 0.2-IGB-gcc-4.9.4
2.11-IGB-gcc-4.9.4
2.16-IGB-gcc-4.9.4-Python-3.6.1
2.3-IGB-gcc-4.9.4
2.8-IGB-gcc-4.9.4
Minimap is an experimental tool to efficiently find multiple approximate mapping positions between two sets of long sequences, such as between reads and reference genomes, between genomes and between long noisy reads.
minorseq 20180314-IGB-gcc-4.9.4 Minor Variant Calling and Phasing Tools
mirdeep 2.0.0.8-IGB-gcc-4.9.4 miRDeep2 is a completely overhauled tool which discovers microRNA genes by analyzing sequenced RNAs.
nanopack 1.0.0-IGB-gcc-4.9.4-Python-3.6.1 Easily install all my long read processing and analysis scripts simultaneously.
nanopolish 0.10.1-IGB-gcc-4.9.4
0.10.2-IGB-gcc-4.9.4
0.11.0-IGB-gcc-4.9.4
0.6.0-IGB-gcc-4.9.4
0.7.1-IGB-gcc-4.9.4
0.7.1-IGB-gcc-4.9.4-159d92b
0.8.3-IGB-gcc-4.9.4
0.8.5-IGB-gcc-4.9.4
0.9.0-IGB-gcc-4.9.4
Software package for signal-level analysis of Oxford Nanopore sequencing data.
ncbi-genome-download 0.2.9-IGB-gcc-4.9.4-Python-3.6.1 Some script to download bacterial and fungal genomes from NCBI after they restructured their FTP a while ago.
ncbi-vdb 2.8.2-IGB-gcc-4.9.4 The SRA Toolkit and SDK from NCBI is a collection of tools and libraries for using data in the INSDC Sequence Read Archives. - Homepage: https://github.com/ncbi/ncbi-vdb
ncdf4 1.16-IGB-gcc-4.9.4-R-3.3.3 This package provides a high-level R interface to data files written using Unidatas netCDF library (version 4 or earlier), which are binary data files that are portable across platforms and include metadata information in addition to the data sets.
ncurses The Ncurses (new curses) library is a free software emulation of curses in System V Release 4.0, and more. It uses Terminfo format, supports pads and color and multiple highlights and forms characters and function-key mapping, and has all the other SYSV-curses enhancements over BSD Curses.
netCDF 4.4.1.1-IGB-gcc-4.9.4 NetCDF (network Common Data Form) is a set of software libraries and machine-independent data formats that support the creation, access, and sharing of array-oriented scientific data.
netCDF-Fortran 4.4.1-IGB-gcc-4.9.4 NetCDF (network Common Data Form) is a set of software libraries and machine-independent data formats that support the creation, access, and sharing of array-oriented scientific data.
nettle 3.3-IGB-gcc-4.9.4 Nettle is a cryptographic library that is designed to fit easily in more or less any context: In crypto toolkits for object-oriented languages (C++, Python, Pike, ...), in applications like LSH or GNUPG, or even in kernel space.
ninja 1.8.2-IGB-gcc-4.9.4 Ninja is a small build system with a focus on speed. It differs from other build systems in two major respects: it is designed to have its input files generated by a higher-level build system, and it is designed to run builds as fast as possible.
nose-parameterized 0.6.0-IGB-gcc-4.9.4-Python-2.7.13 Parameterized testing with any Python test framework.
novocraft 3.08.00 Powerful tool designed for mapping of short reads onto a reference genome from Illumina, Ion Torrent, and 454 NGS platforms.
numactl The numactl program allows you to run your application program on specific cpus and memory nodes.It does this by supplying a NUMA memory policy to the operating system before running your program.The libnuma library provides convenient ways for you to add NUMA memory policies into your own program.
numba 0.34.0-IGB-gcc-4.9.4-Python-2.7.13
0.34.0-IGB-gcc-4.9.4-Python-3.6.1
Numba is an Open Source NumPy-aware optimizing compiler for Python sponsored by Continuum Analytics, Inc. It uses the remarkable LLVM compiler infrastructure to compile Python syntax to machine code.
numpy 1.14.1-IGB-gcc-4.9.4-Python-3.6.1 NumPy is the fundamental package for scientific computing with Python. It contains among other things: a powerful N-dimensional array object, sophisticated (broadcasting) functions, tools for integrating C/C++ and Fortran code, useful linear algebra, Fourier transform, and random number capabilities. Besides its obvious scientific uses, NumPy can also be used as an efficient multi-dimensional container of generic data. Arbitrary data-types can be defined. This allows NumPy to seamlessly and speedily integrate with a wide variety of databases.
pal2nal 14-IGB-gcc-4.9.4 PAL2NAL is a program that converts a multiple sequence alignment of proteins and the corresponding DNA (or mRNA) sequences into a codon alignment.
pandoc 2.2.3.2 If you need to convert files from one markup format into another, pandoc is your swiss-army knife
parallel 20170622-IGB-gcc-4.9.4 parallel: GNU parallel is a shell tool for executing jobs in parallel using one or more computers.
pbzip2 1.1.13-IGB-gcc-4.9.4 PBZIP2 is a parallel implementation of the bzip2 block-sorting file compressor that uses pthreads and achieves near-linear speedup on SMP machines.
perfsuite 1.1.4-IGB-gcc-4.9.4 PerfSuite is a collection of tools, utilities, and libraries for software performance analysis where the primary design goals are ease of use, comprehensibility, interoperability, and simplicity. This software can provide a good "entry point" for more detailed performance analysis and can help point the way towards selecting other tools and/or techniques using more specialized software if necessary (for example, tools/libraries from academic research groups or third-party commercial software).
pfamscan 1.6-IGB-gcc-4.9.4-Perl-5.24.1 This readme should help you get started with "pfam_scan.pl", which is for usewith the HMMER3 version of HMMER.
pgmpy 20180320-IGB-gcc-4.9.4-Python-3.6.1 pgmpy is a python library for working with Probabilistic Graphical Models.
phyloFlash 3.3-IGB-gcc-4.9.4 phyloFlash is a pipeline to rapidly reconstruct the SSU rRNAs and explore phylogenetic composition of an Illumina (meta)genomic or transcriptomic dataset.
phylophlan2 0.34-IGB-gcc-4.9.4-Python-3.6.1 PhyloPhlAn is an integrated pipeline for large-scale phylogenetic profiling of genomes and metagenomes.
pigz 2.3.4-IGB-gcc-4.9.4 pigz, which stands for parallel implementation of gzip, is a fully functional replacement for gzip that exploits multiple processors and multiple cores to the hilt when compressing data. pigz was written by Mark Adler, and uses the zlib and pthread libraries.
pixman Pixman is a low-level software library for pixel manipulation, providing features such as imagecompositing and trapezoid rasterization. Important users of pixman are the cairo graphics library and the X server.
pkg-config pkg-config is a helper tool used when compiling applications and libraries. It helps you insert the correct compiler options on the command line so an application can use gcc -o test test.c `pkg-config --libs --cflags glib-2.0` for instance, rather than hard-coding values on where to find glib (or other libraries). - Homepage: http://www.freedesktop.org/wiki/Software/pkg-config/
plass 2-c7e35-IGB-gcc-4.9.4 Plass (Protein-Level ASSembler) is a software to assemble short read sequencing data on a protein level. The main purpose of Plass is the assembly of complex metagenomic datasets.
platanus 1.2.4 Platanus is a novel de novo sequence assembler that can reconstruct genomic sequences ofhighly heterozygous diploids from massively parallel shotgun sequencing data.
plink 1.07
1.90
This is a comprehensive update to Shaun Purcells PLINK command-line program, developed by Christopher Chang with support from the NIH-NIDDKs Laboratory of Biological Modeling, the Purcell Lab at Mount Sinai School of Medicine, and others.
pomoxis 0.1.0-IGB-gcc-4.9.4-Python-3.6.1 Pomoxis contains a set of services to perform analysis of squiggles as they are produced in real-time along with fast pipelines for generating draft assemblies.
poretools 0.6.0-IGB-gcc-4.9.4-Python-2.7.13 a toolkit for working with nanopore sequencing data from Oxford Nanopore. - Homepage: https://github.com/arq5x/poretools
pplacer 1.1.alpha19 Pplacer places query sequences on a fixed reference phylogenetic tree to maximize phylogenetic likelihood or posterior probability according to a reference alignment. Pplacer is designed to be fast, to give useful information about uncertainty, and to offer advanced visualization and downstream analysis.
preseq 2.0.3-IGB-gcc-4.9.4 The preseq package is aimed at predicting and estimating the complexity of a genomic sequencing library, equivalent to predicting and estimating the number of redundant reads from a given sequencing depth and how many will be expected from additional sequencing using an initial sequencing experiment.
primer3 2.4.0-IGB-gcc-4.9.4 Primer3 is a widely used program for designing PCR primers (PCR = "Polymerase Chain Reaction"). PCR is an essential and ubiquitous tool in genetics and molecular biology. Primer3 can also design hybridization probes and sequencing primers.
prokka 1.12-IGB-gcc-4.9.4-Perl-5.24.1
1.13-IGB-gcc-4.9.4-Perl-5.24.1
Whole genome annotation is the process of identifying features of interest in a set of genomic DNA sequences, and labelling them with useful information. Prokka is a software tool to annotate bacterial, archaeal and viral genomes quickly and produce standards-compliant output files.
protobuf 2.6.1-IGB-gcc-4.9.4
3.5.0-IGB-gcc-4.9.4
Protocol Buffers (a.k.a., protobuf) are Googles language-neutral, platform-neutral, extensible mechanism for serializing structured data.
pssh 2.3.1-IGB-gcc-4.9.4-Python-2.7.13 PSSH provides parallel versions of OpenSSH and related tools, including pssh, pscp, prsync, pnuke and pslurp. This project includes psshlib which can be used within custom applications.
pybedtools 0.7.10-IGB-gcc-4.9.4-Python-3.6.1 pybedtools is a Python package that wraps BEDTools, so you will need both installed.
pyfasta 0.5.2-IGB-gcc-4.9.4-Python-2.7.13 Stores a flattened version of the fasta file without spaces or headers and uses either a mmap of numpy binary format or fseek/fread so the sequence data is never read into memory.
pygpu 0.6.5-IGB-gcc-4.9.4-Python-2.7.13 Python bindings for libgpuarray - Homepage: http://deeplearning.net/software/libgpuarray
pygraphviz 1.3.1-IGB-gcc-4.9.4-Python-3.6.1 PyGraphviz is a Python interface to the Graphviz graph layout and visualization package. With PyGraphviz you can create, edit, read, write, and draw graphs using Python to access the Graphviz graph data structure and layout algorithms.
pylearn2 20170525-IGB-gcc-4.9.4-Python-2.7.13 Pylearn2 is a library designed to make machine learning research easy. - Homepage: https://github.com/lisa-lab/pylearn2
qualimap 2.2.1-Java-1.8.0_121 Qualimap 2 is a platform-independent application written in Java and R that provides both a Graphical User Inteface (GUI) and a command-line interface to facilitate the quality control of alignment sequencing data and its derivatives like feature counts.
quast 4.6.1-IGB-gcc-4.9.4-Python-2.7.13
5.0.0-IGB-gcc-4.9.4-Python-3.6.1
QUAST performs fast and convenient quality evaluation and comparison of genome assemblies.
quickmerge 0.2-IGB-gcc-4.9.4-Python-2.7.13 quickmerge uses a simple concept to improve contiguity of genome assemblies based on long molecule sequences, often with dramatic outcomes. The program uses information from assemblies made with illumina short reads and PacBio long reads to improve contiguities of an assembly generated with PacBio long reads alone. This is counterintuitive because illumina short reads are not typically considered to cover genomic regions which PacBio long reads cannot. Although we have not evaluated this program for assemblies generated with Oxford nanopore sequences, the program should work with ONP-assemblies too.
rMATS 3.2.5-IGB-gcc-4.9.4-Python-2.7.13 MATS is a computational tool to detect differential alternative splicing events from RNA-Seq data. The statistical model of MATS calculates the P-value and false discovery rate that the difference in the isoform ratio of a gene between two conditions exceeds a given user-defined threshold. From the RNA-Seq data, MATS can automatically detect and analyze alternative splicing events corresponding to all major types of alternative splicing patterns. MATS handles replicate RNA-Seq data from both paired and unpaired study design.
racon 0.5.0-IGB-gcc-4.9.4-Python-2.7.13
0.5.0-IGB-gcc-4.9.4-Python-3.6.1
Racon is intended as a standalone consensus module to correct raw contigs generated by rapid assembly methods which do not include a consensus step, such as Miniasm.The goal of Racon is to generate genomic consensus which is of similar or better quality compared to the output generated by assembly methods which employ both error correction and consensus steps, while providing a speedup of several times compared to those methods.
randfold 2.0.1-IGB-gcc-4.9.4 Minimum free energy of folding randomization test software
rclone 1.41 Rclone is a command line program to sync files and directories to and from different cloud storage
rgeos 0.4-2-IGB-gcc-4.9.4-R-3.5.0 nterface to Geometry Engine - Open Source (GEOS) using the C API for topology operations on geometries.
rnaseqtools 1.0.2-IGB-gcc-4.9.4 This repo rnaseqtools provides a set of tools to process transcripts (mainly in gtf format).
root 6.14.06-IGB-gcc-4.9.4 A modular scientific software toolkit. It provides all the functionalities needed to deal with big data processing, statistical analysis, visualisation and storage. It is mainly written in C++ but integrated with other languages such as Python and R.
rpy 1.0.3-IGB-gcc-4.9.4-Python-2.7.13-R-2.15.3 RPy is a very simple, yet robust, Python interface to the R Programming Language. Itcan manage all kinds of R objects and can execute arbitrary R functionsincluding the graphic functions.
rtg-tools 3.8.4 RTG Tools contains utilities to easily manipulate and accurately compare multiple VCF files, as well as utilities for processing other common NGS data formats.
sabre 20171114-IGB-gcc-4.9.4 Next-generation sequencing can currently produce hundreds of millions of reads per lane of sample and that number increases at a dizzying rate. Barcoding individual sequences for multiple lines or multiple species is a cost-efficient method to sequence and analyze a broad range of data.
sambamba 0.6.6 sambamba view allows to efficiently filter SAM/BAM/CRAM files for alignments satisfying various conditions, as well as access its SAM header and information about reference sequences.
samblaster 0.1.24-IGB-gcc-4.9.4 ummary samblaster is a fast and flexible program for marking duplicates in read-id grouped1 paired-end SAM files. It can also optionally output discordant read pairs and/or split read mappings to separate SAM files, and/or unmapped/clipped reads to a separate FASTQ file. When marking duplicates, samblaster will require approximately 20MB of memory per 1M read pairs.
scikit-cuda 0.5.1-IGB-gcc-4.9.4-Python-2.7.13 scikit-cuda provides Python interfaces to many of the functions in the CUDA device/runtime, CUBLAS, CUFFT, and CUSOLVER libraries distributed as part of NVIDIAs CUDA Programming Toolkit, as well as interfaces to select functions in the free and standard versions of the CULA Dense Toolkit. Both low-level wrapper functions similar to their C counterparts and high-level functions comparable to those in NumPy and Scipy are provided.
scrappie 1.3.0-IGB-gcc-4.9.4 Scrappie is a technology demonstrator for the Oxford Nanopore Research Algorithms group.
sentieon 201808 A fast and accurate solution to variant calling from next-generation sequence data
seqan 2.3.2-IGB-gcc-4.9.4 SeqAn is an open source C++ library of efficient algorithms and data structures for the analysis of sequences with the focus on biological data
seqtk 1.2-IGB-gcc-4.9.4 Seqtk is a fast and lightweight tool for processing sequences in the FASTA or FASTQ format. It seamlessly parses both FASTA and FASTQ files which can also be optionally compressed by gzip. - Homepage: https://github.com/lh3/seqtk/
shapeit 2.20 SHAPEIT is a fast and accurate method for estimation of haplotypes (aka phasing) from genotype or sequencing data.
sharutils 4.15.2-IGB-gcc-4.9.4 GNU shar makes so-called shell archives out of many files, preparing them for transmission by electronic mail services, while unshar helps unpacking shell archives after reception.
snoscan 0.9.1-IGB-gcc-4.9.4-Perl-5.24.1
0.9.1-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded
Search for C/D box methylation guide snoRNA genes in a genomic sequence
snpEff 4.3o-Java-1.8.0_121
4.3t-Java-1.8.0_152
SnpEff is a variant annotation and effect prediction tool. It annotates and predicts the effects of genetic variants (such as amino acid changes).
snpomatic 1.0-IGB-gcc-4.9.4 SNP-o-matic is a fast, stringent short-read mapping software. It supports a multitude of output types and formats, for uses in filtering reads, alignments, sequence-based genotyping calls, assisted reassembly of contigs etc.
sparsehash 2.0.3-IGB-gcc-4.9.4 This directory contains several hash-map implementations, similar inAPI to SGIs hash_map class, but with different performance characteristics.
squid 1.9g-IGB-gcc-4.9.4 A C library that is bundled with much of the above software. C function library for sequence analysis.
ssaha2 2.5.5-IGB-gcc-4.9.4 SSAHA2 (Sequence Search and Alignment by Hashing Algorithm) is a pairwise sequence alignment program designed for the efficient mapping of sequencing reads onto genomic reference sequences.
ssaha_pileup 0.6-IGB-gcc-4.9.4 SSAHA2: Sequence Search and Alignment by Hashing Algorithm
strauto 1-IGB-gcc-4.9.4 Automation and Parallelization of STRUCTURE Analysis
strelka 2.9.9 Strelka2 is a fast and accurate small variant caller optimized for analysis of germline variation in small cohorts and somatic variation in tumor/normal sample pairs.
structure 2.3.4-IGB-gcc-4.9.4 The program structure is a free software package for using multi-locus genotype data to investigate population structure.
swift-t 1.3-IGB-gcc-4.9.4 Swift/T is a completely new implementation of the Swift language for high-performance computing. In this implementation, the Swift script is translated into an MPI program that uses the Turbine (hence, /T) and ADLB runtime libraries for highly scalable dataflow processing over MPI, without single-node bottlenecks.
synapseclient 1.9.2-IGB-gcc-4.9.4-Python-3.6.1 Synapse is an open source software platform that data scientists can use to carry out, track, and communicate their research in real time.
tRNAscan-SE 1.3.1-IGB-gcc-4.9.4-Perl-5.26.1-unthreaded tRNAscan-SE: a tool for finding transfer RNAs
tabix 0.2.6-IGB-gcc-4.9.4 Generic indexer for TAB-delimited genome position files
tagdigger 1.1-IGB-gcc-4.9.4-Python-3.6.1 TagDigger is a program for processing FASTQ files from genotyping-by-sequencing (GBS) or restriction site-associated DNA sequencing (RAD-seq) experiments.
tar 1.32-IGB-gcc-8.2.0 tar: The GNU tape archiver
tbb Intel Threading Building Blocks 4.0 (Intel TBB) is a widely used, award-winning C++ template library for creating reliable, portable, and scalable parallel applications. Use Intel TBB for a simple and rapid way of developing robust task-based parallel applications that scale to available processor cores, are compatible with multiple environments, and are easier to maintain. Intel TBB is the most proficient way to implement future-proof parallel applications that tap into the power and performance of multicore and manycore hardware platforms.
tbl2asn 20180516
20190117
Tbl2asn is a command-line program that automates the creation of sequence records for submission to GenBank
tensorly 0.4.2-IGB-gcc-4.9.4-Python-3.6.1 Simple and Fast Tensor Learning in Python
tombo 1.5-IGB-gcc-4.9.4-Python-3.6.1 Tombo is a suite of tools primarily for the identification of modified nucleotides from nanopore sequencing data. Tombo also provides tools for the analysis and visualization of raw nanopore signal.
transrate 1.0.3 Transrate is software for de-novo transcriptome assembly quality analysis. It examines your assembly in detail and compares it to experimental evidence such as the sequencing reads, reporting quality scores for contigs and assemblies.
tre 20161208-IGB-gcc-4.9.4 TRE is a lightweight, robust, and efficient POSIX compliant regexp matching library with some exciting features such as approximate (fuzzy) matching.The matching algorithm used in TRE uses linear worst-case time in the length of the text being searched, and quadratic worst-case time in the length of the used regular expression.In other words, the time complexity of the algorithm is O(M^2N), where M is the length of the regular expression and N is the length of the text. The used space is also quadratic on the length of the regex, but does not depend on the searched string. This quadratic behaviour occurs only on pathological cases which are probably very rare in practice.
treemix 1.13-IGB-gcc-4.9.4 TreeMix is a method for inferring the patterns of population splits and mixtures in the history of a set of populations. In the underlying model, the modern-day populations in a species are related to a common ancestor via a graph of ancestral populations. We use the allele frequencies in the modern populations to infer the structure of this graph.
trf 4.0.9 Tandem Repeats Finder is a program to locate and display tandem repeats in DNA sequences.
unanimity 20180307-IGB-gcc-4.9.4 C++ library and its applications to generate and process accurate consensus sequences
unrar 5.7.3-IGB-gcc-4.9.4 RAR is a powerful archive manager.
udunits UDUNITS supports conversion of unit specifications between formatted and binary forms, arithmetic manipulation of units, and conversion of values between compatible scales of measurement.
valgrind 3.13.0-IGB-gcc-4.9.4 Valgrind is an instrumentation framework for building dynamic analysis tools. There are Valgrind tools that can automatically detect many memory management and threading bugs, and profile your programs in detail. You can also use Valgrind to build new tools.
vcfCodingSnps 1.5 vcfCodingSnps is a SNP annotation tool that annotates coding variants in VCF files.
vcflib 1.0.0-rc2-IGB-gcc-8.2.0 a simple C++ library for parsing and manipulating VCF files, + many command-line utilities
velocyto 0.17.17-IGB-gcc-4.9.4-Python-3.6.1 Velocyto is a library for the analysis of RNA velocity.
velvet 1.2.10-IGB-gcc-4.9.4-kmer_121 Velvet is a de novo genomic assembler specially designed for short read sequencing technologies, such as Solexa or 454, developed by Daniel Zerbino and Ewan Birney at the European Bioinformatics Institute (EMBL-EBI), near Cambridge, in the United Kingdom.
vg 1.15.0 variation graph data structures, interchange formats, alignment, genotyping, and variant calling methods
wtdbg2 2.3-IGB-gcc-4.9.4 Wtdbg2 is a de novo sequence assembler for long noisy reads produced by PacBio or Oxford Nanopore Technologies (ONT). It assembles raw reads without error correction and then builds the consensus from intermediate assembly output.
x264 x264 is a free software library and application for encoding video streams into the H.264/MPEG-4 AVC compression format, and is released under the terms of the GNU GPL. - Homepage: http://www.videolan.org/developers/x264.html
xorg-macros X.org macros utilities.
zlib zlib is designed to be a free, general-purpose, legally unencumbered -- that is, not covered by any patents -- lossless data-compression library for use on virtually any computer hardware and operating system.
Jalview 2.11.0-Java-1.8.0_152
VarScan 2.3.9-Java-1.8.0_152
lumpy 0.3.0-IGB-gcc-4.9.4 A probabilistic framework for structural variant discovery.
JUnit A programmer-oriented testing framework for Java.
nf-core 1.6-IGB-gcc-4.9.4-Python-3.6.1 A python package with helper tools for the nf-core community.
Bismark 0.17.0-IGB-gcc-4.9.4-Perl-5.24.1
0.18.1-IGB-gcc-4.9.4-Perl-5.24.1
0.22.1-IGB-gcc-4.9.4-Perl-5.24.1
A tool to map bisulfite converted sequence reads and determine cytosine methylation states
AUGUSTUS 3.3-IGB-gcc-4.9.4 AUGUSTUS is a program that predicts genes in eukaryotic genomic sequences
augustus 3.2.3-IGB-gcc-4.9.4
3.3.2-IGB-gcc-4.9.4
AUGUSTUS is a program that predicts genes in eukaryotic genomic sequences.
AlignGraph 20180222-IGB-gcc-4.9.4 AlignGraph is a software that extends and joins contigs or scaffolds by reassembling them with help provided by a reference genome of a closely related organism.
libgdiplus An Open Source implementation of the GDI+ API
Mono An open source, cross-platform, implementation of C# and the CLR that is binary compatible with Microsoft.NET.
anvio 5.5-IGB-gcc-4.9.4-Python-3.6.1 Anvi’o is an open-source, community-driven analysis and visualization platform for ‘omics data.
ant 1.10.1-Java-1.8.0_121
1.10.1-Java-1.8.0_152
Apache Ant is a Java library and command-line tool whose mission is to drive processes described in build files as targets and extension points dependent upon each other. The main known usage of Ant is the build of Java applications.
blobtools 0.9.19.6-IGB-gcc-4.9.4-Python-2.7.13
1.0.1-IGB-gcc-4.9.4-Python-2.7.13
1.1.1-IGB-gcc-4.9.4-Python-3.6.1
Application for the visualisation of (draft) genome assemblies using TAGC (Taxon-annotated Gc-Coverage) plots
singularity 3.4.1 Application and environment virtualization
Automake Automake: GNU Standards-compliant Makefile generator
BRAKER 2.1.2-IGB-gcc-4.9.4 BRAKER2 is an extension of BRAKER1 which allows for fully automated training of the gene prediction tools GeneMark-EX and AUGUSTUS from RNA-Seq and/or protein homology information, and that integrates the extrinsic evidence from RNA-Seq and protein homology information into the prediction.
barrnap 0.9-IGB-gcc-4.9.4 Barrnap predicts the location of ribosomal RNA genes in genomes.
sourcetracker 2.0.1-IGB-gcc-4.9.4-Python-3.6.1 Bayesian community-wide culture-independent microbial source tracking
GLib 2.62.3-IGB-gcc-4.9.4 GLib is one of the base libraries of the GTK+ project
BamTools 2.4.1-IGB-gcc-4.9.4
2.5.1-IGB-gcc-4.9.4
BamTools provides both a programmers API and an end-users toolkit for handling BAM files.
Tensorflow-GPU 1.13.1-IGB-gcc-4.9.4-Python-3.6.1
1.14.0-IGB-gcc-4.9.4-Python-3.6.1
1.2.1-IGB-gcc-4.9.4-Python-3.6.1
1.5.1-IGB-gcc-4.9.4-Python-3.6.1
An open-source software library for Machine Intelligence
HTSlib 1.4-IGB-gcc-4.9.4
1.5-IGB-gcc-4.9.4
1.9-IGB-gcc-4.9.4
1.9-IGB-gcc-8.2.0
A C library for reading/writing high-throughput sequencing data. This package includes the utilities bgzip and tabix
BCFtools 1.4-IGB-gcc-4.9.4
1.5-IGB-gcc-4.9.4
1.7-IGB-gcc-4.9.4
1.9-IGB-gcc-4.9.4
BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF
picard 2.10.1-Java-1.8.0_121
2.10.1-Java-1.8.0_152
2.9.0-Java-1.8.0_121
2.9.4-Java-1.8.0_121
A set of tools (in Java) for working with next generation sequencing data in the BAM (http://samtools.github.io/hts-specs) format.
Biopython 1.68-IGB-gcc-4.9.4-Python-2.7.13
1.68-IGB-gcc-4.9.4-Python-3.6.1
1.76-IGB-gcc-4.9.4-Python-3.6.1
Biopython is a set of freely available tools for biological computation writtenin Python by an international team of developers. It is a distributed collaborative effort todevelop Python libraries and applications which address the needs of current and future work inbioinformatics.
Bowtie2 2.1.0-IGB-gcc-4.9.4
2.3.1-IGB-gcc-4.9.4
2.3.2-IGB-gcc-4.9.4
2.3.5.1-IGB-gcc-4.9.4
Bowtie 2 is an ultrafast and memory-efficient tool for aligning sequencing reads to long reference sequences. It is particularly good at aligning reads of about 50 up to 100s or 1,000s of characters, and particularly good at aligning to relatively long (e.g. mammalian) genomes. Bowtie 2 indexes the genome with an FM Index to keep its memory footprint small: for the human genome, its memory footprint is typically around 3.2 GB. Bowtie 2 supports gapped, local, and paired-end alignment modes.
Canu 1.4-IGB-gcc-4.9.4-Perl-5.24.1
1.5-IGB-gcc-4.9.4-Perl-5.24.1
1.6-IGB-gcc-4.9.4-Perl-5.24.1
1.7-IGB-gcc-4.9.4-Perl-5.24.1
1.7.1-IGB-gcc-4.9.4-Perl-5.24.1
1.8-IGB-gcc-4.9.4-Perl-5.24.1
1.9-IGB-gcc-8.2.0-Perl-5.28.1
Canu is a fork of the Celera Assembler, designed for high-noise single-molecule sequencing (such as the PacBio RS II or Oxford Nanopore MinION).
cellranger-atac 1.1.0 Cell Ranger ATAC is a set of analysis pipelines that process Chromium Single Cell ATAC data.
cellranger 2.1.0
2.1.1
3.0.0
3.0.1
3.1.0
Cell Ranger is a set of analysis pipelines that process Chromium single cell 3 RNA-seq output to align reads, generate gene-cell matrices and perform clustering and gene expression analysis.
clusterflow 0.5-IGB-gcc-4.9.4-Perl-5.24.1 Cluster Flow is workflow manager designed to run bioinformatics pipelines. It is operated through a single command cf, which can be used to launch, configure, monitor and cancel pipelines.
delly 0.8.1-IGB-gcc-4.9.4 Delly is an integrated structural variant (SV) prediction method that can discover, genotype and visualize deletions, tandem duplications, inversions and translocations at single-nucleotide resolution in short-read massively parallel sequencing data.
GATK 3.7-Java-1.8.0_121
3.8-0-Java-1.8.0_121
3.8-0-Java-1.8.0_152
3.8-1-0-Java-1.8.0_152
4.0.4.0-IGB-gcc-4.9.4-Java-1.8.0_152-Python-3.6.1
4.0.9.0-IGB-gcc-4.9.4-Java-1.8.0_152-Python-3.6.1
4.1.4.0-Java-1.8.0_152
Developed in the Data Sciences Platform at the Broad Institute, the toolkit offers a wide variety of tools with a primary focus on variant discovery and genotyping. Its powerful processing engine and high-performance computing features make it capable of taking on projects of any size.
FastQC 0.11.5-IGB-gcc-4.9.4-Java-1.8.0_152
0.11.8-IGB-gcc-4.9.4-Java-1.8.0_152
0.11.8-Java-1.8.0_152
FastQC is a quality control application for high throughput sequence data. It reads in sequence data in a variety of formats and can either provide an interactive application to review the results of several different QC checks, or create an HTML based report which can be integrated into a pipeline.
GMP GMP is a free library for arbitrary precision arithmetic, operating on signed integers, rational numbers, and floating point numbers.
GenomeThreader 1.7.1 GenomeThreader is a software tool to compute gene structure predictions. The gene structure predictions are calculated using a similarity-based approach where additional cDNA/EST and/or protein sequences are used to predict gene structures via spliced alignments. GenomeThreader was motivated by disabling limitations in GeneSeqer, a popular gene prediction program which is widely used for plant genome annotation.
Subread 1.5.2-IGB-gcc-4.9.4
1.6.3-IGB-gcc-4.9.4
2.0.0-IGB-gcc-8.2.0
High performance read alignment, quantification and mutation discovery
HDF5 1.10.4-IGB-gcc-8.2.0
1.8.12-IGB-gcc-4.9.4
1.8.18-IGB-gcc-4.9.4
1.8.18-IGB-gcc-8.2.0
HDF5 is a unique technology suite that makes possible the management of extremely large and complex data collections.
cytoscape 3.3.0-Java-1.8.0_152-2.8tb
3.3.0-Java-1.8.0_152-350gb
3.7.0-Java-1.8.0_152-2.8tb
3.7.0-Java-1.8.0_152-350gb
Cytoscape is an open source software platform for visualizing complex networks and integrating these with any type of attribute data.
EasyBuild 3.5.3
3.6.0
3.6.2
3.9.3
EasyBuild is a software build and installation frameworkwritten in Python that allows you to install software in a structured,repeatable and robust way.
guppy-gpu 2.3.1
2.3.5
2.3.7
3.0.3
3.1.5
3.2.2
3.4.3
Guppy is a stand-alone data bioinformatic toolkit that provides Oxford Nanopore Technologies basecalling algorithm, along with a number of post-processing tools.
guppy 2.1.3
2.2.2
2.3.1
2.3.7
3.0.3
3.1.5
3.2.2
3.4.3
Guppy is a stand-alone data bioinformatic toolkit that provides Oxford Nanopore Technologies basecalling algorithm, along with a number of post-processing tools.
Java 1.8.0_121
1.8.0_152
1.8.0_201
11.0.5
Java Platform, Standard Edition (Java SE) lets you develop and deploy Java applications on desktops and servers.
Juicer 1.13.02-Java-1.8.0_152 Juicer is a platform for analyzing kilobase resolution Hi-C data. In this distribution, we include the pipeline for generating Hi-C maps from fastq raw data files and command line tools for feature annotation on the Hi-C maps.
Keras 2.0.6-IGB-gcc-4.9.4-Python-2.7.13
2.0.8-IGB-gcc-4.9.4-Python-3.6.1
2.1.2-IGB-gcc-4.9.4-Python-3.6.1
2.1.5-IGB-gcc-4.9.4-Python-3.6.1
2.2.0-IGB-gcc-4.9.4-Python-3.6.1
2.2.4-IGB-gcc-4.9.4-Python-3.6.1
Keras is a high-level neural networks API, written in Python and capable of running on top of TensorFlow, CNTK, or Theano.
Kraken2 2.0.8-beta-IGB-gcc-4.9.4 Kraken is a system for assigning taxonomic labels to short DNA sequences, usually obtained through metagenomic studies. Previous attempts by other bioinformatics software to accomplish this task have often used sequence alignment or machine learning techniques that were quite slow, leading to the development of less sensitive but much faster abundance estimation programs.
METIS 5.1.0-IGB-gcc-4.9.4 METIS is a set of serial programs for partitioning graphs, partitioning finite element meshes,and producing fill reducing orderings for sparse matrices. The algorithms implemented in METIS are based on themultilevel recursive-bisection, multilevel k-way, and multi-constraint partitioning schemes.
MToolBox 1.0-IGB-gcc-4.9.4
1.2.1-IGB-gcc-4.9.4
MToolBox is a highly automated bioinformatics pipeline to reconstruct and analyze human mitochondrial DNA from high throughput sequencing data. MToolBox includes an updated computational strategy to assemble mitochondrial genomes from Whole Exome and/or Genome Sequencing (PMID: 22669646) and an improved fragment-classify tool (PMID:22139932) for haplogroup assignment, functional and prioritization analysis of mitochondrial variants. MToolBox provides pathogenicity scores, profiles of genome variability and disease-associations for mitochondrial variants. MToolBox provides also a Variant Call Format file (version 4.0) featuring, for the first time, allele-specific heteroplasmy.
MashMap 2.0 MashMap implements a fast and approximate algorithm for computing local alignment boundaries between long DNA sequences. It can be useful for mapping genome assembly or long reads (PacBio/ONT) to reference genome(s).
MaxQuant 1.6.7.0-IGB-gcc-4.9.4 MaxQuant is a proteomics software package designed for analyzing large mass-spectrometric data sets. It is specifically aimed at high-resolution MS data.
megalodon 1.0.0-IGB-gcc-4.9.4-Python-3.6.1 Megalodon is a research tool for per-read and aggregated modified base and sequence variant calling by anchoring the information rich basecalling neural network output to a reference genome/transriptome.
Meson 0.51.2-IGB-gcc-4.9.4-Python-3.6.1 Meson is a cross-platform build system designed to be both as fast and as user friendly as possible.
lpsolve 5.5.2.5-IGB-gcc-4.9.4 Mixed Integer Linear Programming (MILP) solver
MACS2 2.1.1.20160309-IGB-gcc-4.9.4-Python-2.7.13
2.1.2-IGB-gcc-4.9.4-Python-2.7.13
2.2.5-IGB-gcc-4.9.4-Python-3.6.1
Model Based Analysis for ChIP-Seq data
McCortex 1.0.1-IGB-gcc-4.9.4 Multi-sample de novo assembly and variant calling using Linked de bruijn graphs. Variant calling with and without a reference genome. Between closely related samples or highly diverged ones. From bacterial to mammalian genomes. Minimal configuration. And it's free.
OpenBLAS 0.2.19-GCC-4.9.4-2.28-LAPACK-3.7.0-test OpenBLAS is an optimized BLAS library based on GotoBLAS2 1.13 BSD version.
nextflow 0.25.7-Java-1.8.0_121
0.26.3-Java-1.8.0_152
18.10.1-Java-1.8.0_152
19.07.0-Java-1.8.0_152
Nextflow enables scalable and reproducible scientific workflows using software containers. It allows the adaptation of pipelines written in the most common scripting languages.
MultiQC 0.9-IGB-gcc-4.9.4-Python-2.7.13
1.2-IGB-gcc-4.9.4-Python-2.7.13
1.6-IGB-gcc-4.9.4-Python-3.6.1
1.7-IGB-gcc-4.9.4-Python-3.6.1
1.7-IGB-gcc-8.2.0-Python-3.7.2
MultiQC searches a given directory for analysis logs and compiles a HTML report. Its a general use tool, perfect for summarising the output from numerous bioinformatics tools.
Ninja 1.9.0-IGB-gcc-4.9.4 Ninja is a small build system with a focus on speed.
nodejs 10.16.2-IGB-gcc-4.9.4
9.9.0-IGB-gcc-4.9.4
Node.js is a platform built on Chromes JavaScript runtime for easily building fast, scalable network applications. Node.js uses an event-driven, non-blocking I/O model that makes it lightweight and efficient, perfect for data-intensive real-time applications that run across distributed devices.
octopus 0.6.3-beta-IGB-gcc-8.2.0 Octopus is a mapping-based variant caller that implements several calling models within a unified haplotype-aware framework. Octopus takes inspiration from particle filtering by constructing a tree of haplotypes and dynamically pruning and extending the tree based on haplotype posterior probabilities in a sequential manner.
OrthoFinder 2.2.7
2.3.7-IGB-gcc-4.9.4
OrthoFinder is a fast, accurate and comprehensive platform for comparative genomics. It finds orthologs and orthogroups, infers rooted gene trees for all orthogroups and identifies all of the gene duplcation events in those gene trees.
prinseq 0.20.4-IGB-gcc-4.9.4-Perl-5.24.1 PRINSEQ can be used to filter, reformat, or trim your genomic and metagenomic sequence data.
pb-assembly 0.0.6 PacBio Assembly Tool Suite
peakachu 1.1.3-IGB-gcc-4.9.4-Python-3.6.1 Peak calling tool for CLIP-seq data
Peregrine 1.5.4 Peregrine & SHIMMER Genome Assembly Toolkit
pilon 1.22-Java-1.8.0_121
1.23-Java-1.8.0_152
Pilon is a software tool which can be used to:- Automatically improve draft assemblies- Find variation among strains, including large event detection
poppler Poppler is a PDF rendering library based on the xpdf-3.0 code base.
jupyterlab 0.34.10-IGB-gcc-4.9.4-Python-3.6.1
0.35.6-IGB-gcc-4.9.4-Python-3.6.1
1.0.4-IGB-gcc-4.9.4-Python-3.6.1
Project Jupyter exists to develop open-source software, open-standards, and services for interactive computing across dozens of programming languages.
Pysam 0.13.0-IGB-gcc-4.9.4-Python-2.7.13
0.13.0-IGB-gcc-4.9.4-Python-3.6.1
0.15.3-IGB-gcc-4.9.4-Python-3.6.1
Pysam is a python module for reading and manipulating Samfiles. Its a lightweight wrapper of the samtools C-API. Pysam also includes an interface for tabix.
radinitio 1.1.0-IGB-gcc-4.9.4-Python-3.6.1
1.1.1-IGB-gcc-4.9.4-Python-3.6.1
RADinitio is a simulation pipeline for the assessment of RADseq experiments. Genetic data are forward simulated for a population of individuals from a designated reference genome.
velocyto.R 20190527-IGB-gcc-4.9.4-R-3.4.2 RNA velocity estimation in R
redbiom 0.3.2-IGB-gcc-4.9.4-Python-3.6.1 Redbiom is a cache service for sample metadata and sample data.
Python 2.7.13-IGB-gcc-4.9.4
3.6.1-IGB-gcc-4.9.4
3.7.2-IGB-gcc-8.2.0
Python is a programming language that lets you work more quickly and integrate your systems more effectively.
SPAdes 3.10.1-IGB-gcc-4.9.4-Python-2.7.13
3.11.0-IGB-gcc-4.9.4-Python-2.7.13
3.11.0-IGB-gcc-4.9.4-Python-3.6.1
3.11.1-IGB-gcc-4.9.4-Python-3.6.1
3.13.1-IGB-gcc-8.2.0-Python-3.7.2
SPAdes . St. Petersburg genome assembler . is intended for both standard isolates and single-cell MDA bacteria assemblies.
SQLite 3.17.0-IGB-gcc-4.9.4
3.17.0-IGB-gcc-8.2.0
3.30.1-IGB-gcc-4.9.4
SQLite: SQL Database Engine in a C Library
Salmon 0.11.3-IGB-gcc-4.9.4
0.12.0-IGB-gcc-8.2.0
0.13.1-IGB-gcc-8.2.0
0.14.1-IGB-gcc-8.2.0
0.8.2-IGB-gcc-4.9.4-Python-2.7.13
0.9.1-IGB-gcc-4.9.4
1.0.0-IGB-gcc-8.2.0
Salmon is a wicked-fast program to produce a highly-accurate, transcript-level quantification estimates from RNA-seq data.
scallop 0.10.3-IGB-gcc-4.9.4
0.10.4-IGB-gcc-4.9.4
Scallop is an accurate reference-based transcript assembler. Scallop features its high accuracy in assembling multi-exon transcripts as well as lowly expressed transcripts.
util-linux 2.34-IGB-gcc-4.9.4 Set of Linux utilities
skylign 1.1-IGB-gcc-4.9.4-Perl-5.24.1 Skylign is a tool for creating logos representing both sequence alignments and profile hidden Markov models. Submit to the form on the right in order to produce (i) interactive logos for inclusion in webpages, or (ii) static logos for use in documents.
spaceranger 1.0.0 Space Ranger is a set of analysis pipelines that process Visium spatial RNA-seq output and brightfield microscope images in order to detect tissue, align reads, generate feature-spot matrices, perform clustering and gene expression analysis, and place spots in spatial context on the slide image.
SuiteSparse 5.4.0-IGB-gcc-4.9.4-METIS-5.1.0 SuiteSparse is a collection of libraries manipulate sparse matrices.
Szip Szip compression software, providing lossless compression of scientific data
tensorboardX 1.9-IGB-gcc-4.9.4-Python-3.6.1 TensorBoardX lets you watch Tensors Flow without Tensorflow
GSL 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.
Autotools This bundle collect the standard GNU build tools: Autoconf, Automake and libtool
igv 2.4.4-Java-1.8.0_152
2.7.2-Java-11.0.5
snapshot-Java-11.0.5
The Integrative Genomics Viewer (IGV) is a high-performance visualization tool for interactive exploration of large, integrated genomic datasets. It supports a wide variety of data types, including array-based and next-generation sequence data, and genomic annotations.
STAR 2.5.3a-IGB-gcc-4.9.4
2.6.0c-IGB-gcc-4.9.4
2.6.1b-IGB-gcc-4.9.4
2.7.0d-IGB-gcc-8.2.0
2.7.0f-IGB-gcc-8.2.0
2.7.3a-IGB-gcc-8.2.0
STAR aligns RNA-seq reads to a reference genome using uncompressed suffix arrays.
SAMtools 0.1.20-IGB-gcc-4.9.4
1.3.1-IGB-gcc-4.9.4
1.4-IGB-gcc-4.9.4
1.4.1-IGB-gcc-4.9.4
1.5-IGB-gcc-4.9.4
1.7-IGB-gcc-4.9.4
1.9-IGB-gcc-4.9.4
SAM Tools provide various utilities for manipulating alignments in the SAM format, including sorting, merging, indexing and generating alignments in a per-position format.
MEME 4.11.2-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13
4.12.0-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13
5.0.1-IGB-gcc-4.9.4-Perl-5.24.1-Python-2.7.13
5.0.5-IGB-gcc-4.9.4
The MEME Suite allows you to: * discover motifs using MEME, DREME (DNA only) or GLAM2 on groups of related DNA or protein sequences, * search sequence databases with motifs using MAST, FIMO, MCAST or GLAM2SCAN, * compare a motif to all motifs in a database of motifs, * associate motifs with Gene Ontology terms via their putative target genes, and * analyse motif enrichment using SpaMo or CentriMo.
R 2.15.3-IGB-gcc-4.9.4
3.1.2-IGB-gcc-4.9.4
3.2.5-IGB-gcc-4.9.4
3.3.3-IGB-gcc-4.9.4
3.4.1-IGB-gcc-4.9.4
3.4.2-IGB-gcc-4.9.4
3.5.0-IGB-gcc-4.9.4
3.6.0-IGB-gcc-8.2.0
R is a free software environment for statistical computing and graphics.
QIIME2 2017.10
2017.11
2017.12
2017.6
2017.8
2018.11
2018.2
2018.4
2018.6
2018.8
2019.10
2019.4
2019.7
QIIME is an open-source bioinformatics pipeline for performing microbiome analysis from raw DNA sequencing data.
cuDNN 5.1-IGB-gcc-4.9.4-CUDA-8.0.61
6.0-IGB-gcc-4.9.4-CUDA-8.0.61
7.0.5-IGB-gcc-4.9.4-CUDA-9.0.176
7.1.4-IGB-gcc-4.9.4-CUDA-9.0.176
7.6.1.34-CUDA-10.0.130
The NVIDIA CUDA Deep Neural Network library (cuDNN) is a GPU-accelerated library of primitives for deep neural networks.
Platypus 20180622-IGB-gcc-4.9.4-Python-2.7.13 The Platypus variant caller.
rosetta 2017.52-IGB-gcc-4.9.4 The Rosetta software suite includes algorithms for computational modeling and analysis of protein structures.
shasta 0.2.0 The goal of the Shasta long read assembler is to rapidly produce accurate assembled sequence using as input DNA reads generated by Oxford Nanopore flow cells.
bam-readcount 0.8.0-IGB-gcc-4.9.4 The purpose of this program is to generate metrics at single nucleotide positions.
Trimmomatic 0.36-Java-1.8.0_121
0.36-Java-1.8.0_152
0.38-Java-1.8.0_152
Trimmomatic performs a variety of useful trimming tasks for illumina paired-end and single ended data.The selection of trimming steps and their associated parameters are supplied on the command line.
Trinity 2.4.0-IGB-gcc-4.9.4
2.5.0-IGB-gcc-4.9.4
2.6.5-IGB-gcc-4.9.4
2.8.5-IGB-gcc-4.9.4
Trinity represents a novel method for the efficient and robust de novo reconstruction of transcriptomes from RNA-Seq data. Trinity combines three independent software modules: Inchworm, Chrysalis, and Butterfly, applied sequentially to process large volumes of RNA-Seq reads.
Trinotate 3.1.1-IGB-gcc-4.9.4-Perl-5.24.1 Trinotate is a comprehensive annotation suite designed for automatic functional annotation of transcriptomes, particularly de novo assembled transcriptomes, from model or non-model organisms. Trinotate makes use of a number of different well referenced methods for functional annotation including homology search to known sequence data (BLAST+/SwissProt), protein domain identification (HMMER/PFAM), protein signal peptide and transmembrane domain prediction (signalP/tmHMM), and leveraging various annotation databases (eggNOG/GO/Kegg databases). All functional annotation data derived from the analysis of transcripts is integrated into a SQLite database which allows fast efficient searching for terms with specific qualities related to a desired scientific hypothesis or a means to create a whole annotation report for a transcriptome.
Unicycler 0.4.3-IGB-gcc-4.9.4-Python-3.6.1
0.4.4-IGB-gcc-4.9.4-Python-3.6.1
0.4.8-IGB-gcc-4.9.4-Python-3.6.1
Unicycler is an assembly pipeline for bacterial genomes. It can assemble Illumina-only read sets where it functions as a SPAdes-optimiser. It can also assembly long-read-only sets (PacBio or Nanopore) where it runs a miniasm+Racon pipeline. For the best possible assemblies, give it both Illumina reads and long reads, and it will conduct a hybrid assembly.
SalmonTools 20190604-IGB-gcc-8.2.0 Useful tools for working with Salmon output
VASP-E 20190225-IGB-gcc-4.9.4
20191112-IGB-gcc-4.9.4
VASP and VASP-E explore the idea that a solid geometric representation of molecular structures can be used to automatically deconstruct proteins into functional elements for the study of binding specificity.
VMD 1.9.3-IGB-gcc-4.9.4 VMD is a molecular visualization program for displaying, animating, and analyzing large biomolecular systems using 3-D graphics and built-in scripting.
xgboost 0.80-IGB-gcc-4.9.4-Python-3.6.1 XGBoost is an optimized distributed gradient boosting library designed to be highly efficient, flexible and portable. It implements machine learning algorithms under the Gradient Boosting framework.
pbccs 4.0 ccs takes multiple subreads of the same SMRTbell molecule and combines them using a statistical model to produce one highly accurate consensus sequence, also called HiFi read, with base quality values.
fpocket 3.1.3-IGB-gcc-4.9.4 fpocket is a very fast open source protein pocket detection algorithm based on Voronoi tessellation.
libcerf libcerf is a self-contained numeric library that provides an efficient and accurate implementation of complex error functions, along with Dawson, Faddeeva, and Voigt functions.
mapDamage 2.0.5-IGB-gcc-4.9.4-Python-2.7.13
2.0.9-IGB-gcc-4.9.4-Python-2.7.13
mapDamage2 is a computational framework written in Python and R, which tracks and quantifies DNA damage patterns among ancient DNA sequencing reads generated by Next-Generation Sequencing platforms.
pairtools 0.3.0-IGB-gcc-4.9.4-Python-3.6.1 pairtools is a simple and fast command-line framework to process sequencing data from a Hi-C experiment.
rpy2 2.8.6-IGB-gcc-4.9.4-Python-2.7.13-R-3.3.3
2.8.6-IGB-gcc-4.9.4-Python-2.7.13-R-3.5.0
2.9.0-IGB-gcc-4.9.4-Python-3.6.1-R-3.3.3
3.0.1-IGB-gcc-4.9.4-Python-3.6.1-R-3.5.0
3.2.4-IGB-gcc-4.9.4-Python-3.6.1-R-3.5.0
rpy2 is a redesign and rewrite of rpy. It is providing a low-level interface to R from Python, a proposed high-level interface, including wrappers to graphical libraries, as well as R-like structures and functions.
t3f 1.1.0-IGB-gcc-4.9.4-Python-3.6.1 t3f is a library for working with Tensor Train decomposition.