生物信息学常见1000个软件的安装代码!
昨天发推文后,很多朋友问这生物信息学常见1000个软件的安装代码啥意思。其实我在论坛发过,但是公众号很多人居然不知道我们的生信技能树论坛,只好搬过来一下!
安装软件是入行生物信息学着最常见的坑,毕竟你不得不用别人写的工具,但是写工具的人的水平参差不齐,所以必然有些难以安装,有些简单。
但是一定安装软件超过一定次数,你再回过头来看,就会觉得是非常简单的。 我这里把我安装的软件的所有代码全部共享出来,理论上,你只要是linux或者mac,就用我的代码就可以复现一下。
## annovar and GATK## Download and install sratoolkit## http://www.ncbi.nlm.nih.gov/Traces/sra/sra.cgi?view=software## http://www.ncbi.nlm.nih.gov/books/NBK158900/cd ~/biosoftmkdir sratoolkit && cd sratoolkitwget http://ftp-trace.ncbi.nlm.nih.gov/sra/sdk/2.6.3/sratoolkit.2.6.3-centos_linux64.tar.gz#### Length: 63453761 (61M) [application/x-gzip]## Saving to: "sratoolkit.2.6.3-centos_linux64.tar.gz"tar zxvf sratoolkit.2.6.3-centos_linux64.tar.gz~/biosoft/sratoolkit/sratoolkit.2.6.3-centos_linux64/bin/fastdump -hmkdir -p ~/biosoft/myBinecho 'export PATH=/home/jianmingzeng/biosoft/myBin/bin:$PATH' >>~/.bashrcsource ~/.bashrccd ~/biosoftmkdir cmake && cd cmakewget http://cmake.org/files/v3.3/cmake-3.3.2.tar.gztar xvfz cmake-3.3.2.tar.gzcd cmake-3.3.2./configure --prefix=/home/jianmingzeng/biosoft/myBinmakemake install## Download and install samtools## http://samtools.sourceforge.net/## http://www.htslib.org/doc/samtools.htmlcd ~/biosoftmkdir samtools && cd samtoolswget https://github.com/samtools/samtools/releases/download/1.3.1/samtools-1.3.1.tar.bz2tar xvfj samtools-1.3.1.tar.bz2cd samtools-1.3.1./configure --prefix=/home/jianmingzeng/biosoft/myBinmakemake install~/biosoft/myBin/bin/samtools --help~/biosoft/myBin/bin/plot-bamstats --helpcd htslib-1.3.1./configure --prefix=/home/jianmingzeng/biosoft/myBinmakemake install~/biosoft/myBin/bin/tabix# ## Download and install tabix# cd ~/biosoft# mkdir tabix && cd tabix# # http://genometoolbox.blogspot.com/2013/11/installing-tabix-on-unix.html# tar xvfj tabix-0.2.6.tar.bz2# cd tabix-0.2.6# make# cd ~/biosoft# ## http://samtools.github.io/bcftools/# mkdir htslib && cd htslib# git clone git://github.com/samtools/htslib.git# cd htslib# make## Download and install bcftools## http://www.htslib.org/download/## http://www.htslib.org/doc/bcftools-1.0.htmlcd ~/biosoftmkdir bcftools && cd bcftoolswget https://github.com/samtools/bcftools/releases/download/1.3.1/bcftools-1.3.1.tar.bz2tar xvfj bcftools-1.3.1.tar.bz2cd bcftools-1.3.1makecp bcftools /home/jianmingzeng/biosoft/myBin~/biosoft/myBin/bin/bcftools --help## Download and install vcftools## https://vcftools.github.io/index.html## http://vcftools.sourceforge.net/specs.htmlcd ~/biosoftmkdir vcftools && cd vcftools# wget https://codeload.github.com/vcftools/vcftools/legacy.zip/master -O vcftools-vcftools-v0.1.14-24-gac1bfd5.zip# unzip vcftools-vcftools-v0.1.14-24-gac1bfd5.zip# mv vcftools-vcftools-ac1bfd5 vcftools-v0.1.14-24# cd vcftools-v0.1.14-24# export PERL5LIB=/home/jianmingzeng/biosoft/vcftools/vcftools-v0.1.14-24/src/perl/# ./autogen.sh# ./configure --prefix=/home/jianmingzeng/biosoft/myBin# make# make install# ~/biosoft/myBin/bin/vcftools --helpwget https://sourceforge.net/projects/vcftools/files/vcftools_0.1.13.tar.gztar zxvf vcftools_0.1.13.tar.gzcd vcftools_0.1.13make## Download and install ANNOVARcd ~/biosoft# The latest version of ANNOVAR (2016Feb01) can be downloaded here (registration required)# http://www.openbioinformatics.org/annovar/annovar_download_form.phpmkdir ANNOVAR && cd ANNOVAR## Download and install samstat## http://samstat.sourceforge.net/## http://www.htslib.org/doc/samtools.htmlcd ~/biosoftmkdir samstat && cd samstatwget http://liquidtelecom.dl.sourceforge.net/project/samstat/samstat-1.5.tar.gztar zxvf samstat-1.5.tar.gzcd samstat-1.5./configure --prefix=/home/jianmingzeng/biosoft/myBinmakemake install~/biosoft/myBin/bin/samstat --help## Download and install picardtools## https://sourceforge.net/projects/picard/## https://github.com/broadinstitute/picardcd ~/biosoftmkdir picardtools && cd picardtoolswget http://ncu.dl.sourceforge.net/project/picard/picard-tools/1.119/picard-tools-1.119.zipunzip picard-tools-1.119.zip## Download and install freebayes## https://github.com/ekg/freebayes## http://clavius.bc.edu/~erik/CSHL-advanced-sequencing/freebayes-tutorial.htmlcd ~/biosoftmkdir freebayes && cd freebayes## wget -O freebayes-master.zip https://codeload.github.com/ekg/freebayes/zip/master## unzip freebayes-master.zipwget http://clavius.bc.edu/~erik/freebayes/freebayes-5d5b8ac0.tar.gztar xzvf freebayes-5d5b8ac0.tar.gzcd freebayesmake~/biosoft/freebayes/freebayes/bin/freebayescd ~/biosoft## https://sourceforge.net/projects/varscan/files/## http://varscan.sourceforge.net/index.htmlmkdir VarScan && cd VarScanwget https://sourceforge.net/projects/varscan/files/VarScan.v2.3.9.jarcd ~/biosoftmkdir SnpEff && cd SnpEff## http://snpeff.sourceforge.net/## http://snpeff.sourceforge.net/SnpSift.html## http://snpeff.sourceforge.net/SnpEff_manual.htmlwget http://sourceforge.net/projects/snpeff/files/snpEff_latest_core.zip## java -jar snpEff.jar download GRCh37.75## java -Xmx4G -jar snpEff.jar -i vcf -o vcf GRCh37.75 example.vcf > example_snpeff.vcfunzip snpEff_latest_core.zip## https://github.com/najoshi/sicklecd ~/biosoftmkdir sickle && cd sicklewget https://codeload.github.com/najoshi/sickle/zip/master -O sickle.zipunzip sickle.zipcd sickle-mastermake~/biosoft/sickle/sickle-master/sickle -hcd ~/biosoft## http://www.usadellab.org/cms/?page=trimmomatic## http://www.usadellab.org/cms/uploads/supplementary/Trimmomatic/TrimmomaticManual_V0.32.pdfmkdir Trimmomatic && cd Trimmomaticwget http://www.usadellab.org/cms/uploads/supplementary/Trimmomatic/Trimmomatic-0.36.zipunzip Trimmomatic-0.36.zipjava -jar ~/biosoft/Trimmomatic/Trimmomatic-0.36/trimmomatic-0.36.jar -h## Download and install bedtoolscd ~/biosoftmkdir bedtools && cd bedtoolswget https://github.com/arq5x/bedtools2/releases/download/v2.25.0/bedtools-2.25.0.tar.gz## Length: 19581105 (19M) [application/octet-stream]tar -zxvf bedtools-2.25.0.tar.gzcd bedtools2make#~/biosoft/bedtools/bedtools2/bin/## Download and install PeakRangercd ~/biosoftmkdir PeakRanger && cd PeakRangerwget https://sourceforge.net/projects/ranger/files/PeakRanger-1.18-Linux-x86_64.zip## Length: 1517587 (1.4M) [application/octet-stream]unzip PeakRanger-1.18-Linux-x86_64.zip~/biosoft/PeakRanger/bin/peakranger -h## Download and install bowtiecd ~/biosoftmkdir bowtie && cd bowtiewget https://sourceforge.net/projects/bowtie-bio/files/bowtie2/2.2.9/bowtie2-2.2.9-linux-x86_64.zip#Length: 27073243 (26M) [application/octet-stream]#Saving to: "download" ## I made a mistake here for downloading the bowtie2mv download bowtie2-2.2.9-linux-x86_64.zipunzip bowtie2-2.2.9-linux-x86_64.zip## Download and install BWAcd ~/biosoftmkdir bwa && cd bwa#http://sourceforge.net/projects/bio-bwa/files/wget https://sourceforge.net/projects/bio-bwa/files/bwa-0.7.15.tar.bz2tar xvfj bwa-0.7.15.tar.bz2 # x extracts, v is verbose (details of what it is doing), f skips prompting for each individual file, and j tells it to unzip .bz2 filescd bwa-0.7.15make#export PATH=$PATH:/path/to/bwa-0.7.15 # Add bwa to your PATH by editing ~/.bashrc file (or .bash_profile or .profile file)# /path/to/ is an placeholder. Replace with real path to BWA on your machine#source ~/.bashrc## Download and install macs2## // https://pypi.python.org/pypi/MACS2/cd ~/biosoftmkdir macs2 && cd macs2## just stick to PyPI release: https://pypi.python.org/pypi/MACS2wget https://pypi.python.org/packages/9f/99/a8ac96b357f6b0a6f559fe0f5a81bcae12b98579551620ce07c5183aee2c/MACS2-2.1.1.20160309.tar.gz -O MACS2-2.1.1.tar.gztar zxvf MACS2-2.1.1.tar.gzcd MACS2-2.1.1.20160309/python setup.py install --user## https://docs.python.org/2/install/~/.local/bin/macs2 --help#wget https://codeload.github.com/taoliu/MACS/zip/master -O MACS-master.zip#unzip MACS-master.zip#cd MACS-master## So you can't just pull github snapshot then run setup.py to install MACS2. Instead# ImageMagickcd ~/biosoftmkdir ImageMagick && cd ImageMagick## http://www.imagemagick.org/cd ~/biosoftmkdir weblogo && cd weblogo## http://weblogo.berkeley.edu/wget http://weblogo.berkeley.edu/release/weblogo.2.8.2.tar.gztar zxvf weblogo.2.8.2.tar.gzcd weblogoexport PATH=$PATH:/home/jianmingzeng/biosoft/weblogo/weblogosource ~/.bashrccd ~/biosoftmkdir Ghostscript && cd Ghostscript# http://www.ghostscript.com/download/gsdnld.html# http://www.ghostscript.com/doc/9.20/Readme.htmwget https://github.com/ArtifexSoftware/ghostpdl-downloads/releases/download/gs920/ghostscript-9.20-linux-x86_64.tgztar zxvf ghostscript-9.20-linux-x86_64.tgzcp ghostscript-9.20-linux-x86_64/gs-920-linux_x86_64 ~/biosoft/myBin/bin/gs## make sure the "gs" program is executable## Download and install homer (Hypergeometric Optimization of Motif EnRichment)## // http://homer.salk.edu/homer/## // http://blog.qiubio.com:8080/archives/3024## The commands gs, seqlogo, blat, and samtools should now work from the command linecd ~/biosoftmkdir homer && cd homerwget http://homer.salk.edu/homer/configureHomer.plperl configureHomer.pl -installperl configureHomer.pl -install hg19## Download and install SWEMBLcd ~/biosoftmkdir SWEMBL && cd SWEMBL#### readme: http://www.ebi.ac.uk/~swilder/SWEMBL/beginners.htmlwget http://www.ebi.ac.uk/~swilder/SWEMBL/SWEMBL.3.3.1.tar.bz2tar xvfj SWEMBL.3.3.1.tar.bz2cd SWEMBL.3.3.1/make## error## Download and install SISSRscd ~/biosoftmkdir SISSRs && cd SISSRs#### readme: https://dir.nhlbi.nih.gov/papers/lmi/epigenomes/sissrs/SISSRs-Manual.pdfwget http://dir.nhlbi.nih.gov/papers/lmi/epigenomes/sissrs/sissrs_v1.4.tar.gztar xzvf sissrs_v1.4.tar.gz~/biosoft/SISSRs/sissrs.pl## Download and install SISSRscd ~/biosoftmkdir QuEST && cd QuEST#### http://mendel.stanford.edu/SidowLab/downloads/quest/wget http://mendel.stanford.edu/SidowLab/downloads/quest/QuEST_2.4.tar.gztar xzvf QuEST_2.4.tar.gzcd QuEST_2.4## Download and install fastqccd ~/biosoftmkdir fastqc && cd fastqcwget http://www.bioinformatics.bbsrc.ac.uk/projects/fastqc/fastqc_v0.11.5.zipunzip fastqc_v0.11.5.zip## Download and install CEAS## http://liulab.dfci.harvard.edu/CEAS/download.htmlcd ~/biosoftmkdir CEAS && cd CEASwget http://liulab.dfci.harvard.edu/CEAS/src/CEAS-Package-1.0.2.tar.gztar zxvf CEAS-Package-1.0.2.tar.gzcd CEAS-Package-1.0.2python setup.py install --user## http://liulab.dfci.harvard.edu/CEAS/usermanual.html~/.local/bin/ceas --helpmkdir annotation && cd annotationwget http://liulab.dfci.harvard.edu/CEAS/src/hg19.refGene.gz ; gunzip hg19.refGene.gz# http://hgdownload.cse.ucsc.edu/goldenPath/hg19/database/refGene.txt.gz ## gunzip refGene.txt.gz ; mv refGene.txt hg19refGene.txt## Download and install CEAS## http://liulab.dfci.harvard.edu/CEAS/download.htmlcd ~/biosoftmkdir crossmap && cd crossmappip install CrossMap --user## http://crossmap.sourceforge.net/#use-pip-to-install-crossmapmkdir chain_files && cd chain_fileswget http://hgdownload.soe.ucsc.edu/goldenPath/mm10/liftOver/mm10ToMm9.over.chain.gzwget http://hgdownload.soe.ucsc.edu/goldenPath/mm9/liftOver/mm9ToMm10.over.chain.gzwget http://hgdownload.soe.ucsc.edu/goldenPath/hg38/liftOver/hg38ToHg19.over.chain.gzwget http://hgdownload.soe.ucsc.edu/goldenPath/hg38/liftOver/hg38ToHg19.over.chain.gz# http://hgdownload.cse.ucsc.edu/goldenPath/hg19/database/refGene.txt.gz ## gunzip refGene.txt.gz ; mv refGene.txt hg19refGene.txt# Usage: CrossMap.py bed ~/biosoft/crossmap/chain_files/mm9ToMm10.over.chain.gz test.mm9.bed3cd ~/biosoft# http://www.broadinstitute.org/cancer/cga/rnaseqc_run# http://www.broadinstitute.org/cancer/cga/rnaseqc_downloadmkdir RNA-SeQC && cd RNA-SeQC#### readme: http://www.broadinstitute.org/cancer/cga/sites/default/files/data/tools/rnaseqc/RNA-SeQC_Help_v1.1.2.pdfwget http://www.broadinstitute.org/cancer/cga/tools/rnaseqc/RNA-SeQC_v1.1.8.jar#TopHat+Cufflinks+ pipeline## Download and install TopHat# https://ccb.jhu.edu/software/tophat/index.shtmlcd ~/biosoftmkdir TopHat && cd TopHat#### readme: https://ccb.jhu.edu/software/tophat/manual.shtmlwget https://ccb.jhu.edu/software/tophat/downloads/tophat-2.1.1.Linux_x86_64.tar.gztar xzvf tophat-2.1.1.Linux_x86_64.tar.gzln -s tophat-2.1.1.Linux_x86_64 current# ~/biosoft/TopHat/current/tophat2## Download and install Cufflinks# http://cole-trapnell-lab.github.io/cufflinks/cd ~/biosoftmkdir Cufflinks && cd Cufflinks#### readme: http://cole-trapnell-lab.github.io/cufflinks/manual/#### install:http://cole-trapnell-lab.github.io/cufflinks/install/wget http://cole-trapnell-lab.github.io/cufflinks/assets/downloads/cufflinks-2.2.1.Linux_x86_64.tar.gztar xzvf cufflinks-2.2.1.Linux_x86_64.tar.gzln -s cufflinks-2.2.1.Linux_x86_64 current~/biosoft/Cufflinks/current/cufflinks#HISAT-Stringtie2-Ballgown pipeline## Download and install HISAT# https://ccb.jhu.edu/software/hisat2/index.shtmlcd ~/biosoftmkdir HISAT && cd HISAT#### readme: https://ccb.jhu.edu/software/hisat2/manual.shtmlwget ftp://ftp.ccb.jhu.edu/pub/infphilo/hisat2/downloads/hisat2-2.0.4-Linux_x86_64.zipunzip hisat2-2.0.4-Linux_x86_64.zipln -s hisat2-2.0.4 current## ~/biosoft/HISAT/current/hisat2-build## ~/biosoft/HISAT/current/hisat2## Download and install StringTie## https://ccb.jhu.edu/software/stringtie/ ## https://ccb.jhu.edu/software/stringtie/index.shtml?t=manualcd ~/biosoftmkdir StringTie && cd StringTiewget http://ccb.jhu.edu/software/stringtie/dl/stringtie-1.2.3.Linux_x86_64.tar.gztar zxvf stringtie-1.2.3.Linux_x86_64.tar.gzln -s stringtie-1.2.3.Linux_x86_64 current# ~/biosoft/StringTie/current/stringtiecd ~/biosoftmkdir RSEM && cd RSEMwget https://codeload.github.com/deweylab/RSEM/tar.gz/v1.2.31mv v1.2.31 RSEM.v1.2.31.tar.gztar zxvf RSEM.v1.2.31.tar.gz## Download and install HTSeq## http://www-huber.embl.de/users/anders/HTSeq/doc/overview.html## https://pypi.python.org/pypi/HTSeqcd ~/biosoftmkdir HTSeq && cd HTSeqwget https://pypi.python.org/packages/72/0f/566afae6c149762af301a19686cd5fd1876deb2b48d09546dbd5caebbb78/HTSeq-0.6.1.tar.gztar zxvf HTSeq-0.6.1.tar.gzcd HTSeq-0.6.1python setup.py install --user~/.local/bin/htseq-count --help## ftp://ftp.sanger.ac.uk/pub/gencode/Gencode_mouse/release_M1/## http://hgdownload-test.cse.ucsc.edu/goldenPath/mm10/liftOver/## GRCm38/mm10 (Dec, 2011)## ls *bam |while read id;do ( ~/.local/bin/htseq-count -f bam $id genecode/mm9/gencode.vM1.annotation.gtf.gz 1>${id%%.*}.gene.counts ) ;done## ls *bam |while read id;do ( ~/.local/bin/htseq-count -f bam -i exon_id $id genecode/mm9/gencode.vM1.annotation.gtf.gz 1>${id%%.*}.exon.counts ) ;done## Download and install kallisto## https://pachterlab.github.io/kallisto/startingcd ~/biosoftmkdir kallisto && cd kallistowget https://github.com/pachterlab/kallisto/releases/download/v0.43.0/kallisto_linux-v0.43.0.tar.gz#tar zxvf## Download and install Sailfish## http://www.cs.cmu.edu/~ckingsf/software/sailfish/ ##cd ~/biosoftmkdir Sailfish && cd Sailfishwget https://github.com/kingsfordgroup/sailfish/releases/download/v0.9.2/SailfishBeta-0.9.2_DebianSqueeze.tar.gz#tar zxvf## Download and install salmon## http://salmon.readthedocs.io/en/latest/salmon.html ##cd ~/biosoftmkdir salmon && cd salmon## https://github.com/COMBINE-lab/salmon#tar zxvfcd ~/biosoftmkdir GDC && cd GDC# https://gdc.cancer.gov/access-data/gdc-data-transfer-tool# http://gdc-docs.nci.nih.gov/Data_Transfer_Tool/Users_Guide/Getting_Started/wget https://gdc.nci.nih.gov/files/public/file/gdc-client_v1.2.0_Ubuntu14.04_x64.zipunzip gdc-client_v1.2.0_Ubuntu14.04_x64.zipcd ~/biosoft/myBin/bin## http://hgdownload.cse.ucsc.edu/admin/exe/wget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/bedToBigBedwget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/bedSortwget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/bedGraphToBigWigwget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/fetchChromSizeswget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/wigToBigWigwget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/liftOverwget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/bigWigToBedGraphwget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/bigBedToBedwget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/blat/blatwget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/blat/gfClientwget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/blat/gfServer## Download and install variationtoolkit## https://code.google.com/archive/p/variationtoolkit/downloadscd ~/biosoftmkdir variationtoolkit && cd variationtoolkitwget https://storage.googleapis.com/google-code-archive-downloads/v2/code.google.com/variationtoolkit/archive.tar.gztar zxvf archive.tar.gzcd variationtoolkitmake## Download and install transvar# http://bioinformatics.mdanderson.org/main/Transvarcd ~/biosoft# https://bitbucket.org/wanding/transvarmkdir transvar && cd transvarwget https://bitbucket.org/wanding/transvar/get/v2.1.19.20160221.zipunzip v2.1.19.20160221.zipcd wanding-transvar-5dd8a7366999python setup.py install --usercd ~/biosoft# http://kobas.cbi.pku.edu.cn/download.phpmkdir kobas && cd kobas# wget http://kobas.cbi.pku.edu.cn/download_file.php?type=seq_pep&filename=hsa.pep.fasta.gz# wget http://kobas.cbi.pku.edu.cn/download_file.php?type=sqlite3&filename=hsa.db.gzwget http://kobas.cbi.pku.edu.cn/kobas-2.1.1/kobas-2.1.1.tar.gztar zxvf kobas-2.1.1.tar.gzcd kobas-2.1.1_20160822# * Download the KOBAS organism data package (organism.db.gz) from KOBAS Backend databases download website# * Download the KOBAS specific species data package from KOBAS Backend databases download website (for example, hsa.db.gz)# * Download the specific sequence file from KOBAS sequence files download website (for example, hsa.pep.fasta.gz)# * `gunzip organism.db.gz`# * `gunzip hsa.db.gz`# * Move all databases into ${kobas_home}/sqlite3/ (for example, organism.db, hsa.db)# * `gunzip hsa.pep.fasta.gz`# * Move the fasta sequence file into ${kobas_home}/seq_pep/# * `makeblastdb -in hsa.pep.fasta -dbtype prot`pip install RPy2 --userpip install Numpy --userpip install Pandas --userpip install BioPython --userpip install matplotlib --userpip install PySQLite --usersource("http://bioconductor.org/biocLite.R")biocLite("qvalue")## Download and install bamtools## https://github.com/pezmaster31/bamtools/wiki/Building-and-installingcd ~/biosoftmkdir bamtools && cd bamtoolsgit clone git://github.com/pezmaster31/bamtools.gitcd bamtoolscmake --version ## BamTools requires CMake (version >= 2.6.4).mkdir build && cd buildcmake ../make~/biosoft/bamtools/bamtools/bin/bamtools## Download and install BAMStats## http://bamstats.sourceforge.net/## https://sourceforge.net/projects/bamstats/files/cd ~/biosoftmkdir BAMStats && cd BAMStatswget https://nchc.dl.sourceforge.net/project/bamstats/BAMStats-1.25.zipunzip BAMStats-1.25.zip#java -jar ~/biosoft/BAMStats/BAMStats-1.25/BAMStats-1.25.jar --help## Download and install Qualimap## http://qualimap.bioinfo.cipf.es/cd ~/biosoftmkdir Qualimap && cd Qualimapwget https://bitbucket.org/kokonech/qualimap/downloads/qualimap_v2.2.1.zip## readme http://qualimap.bioinfo.cipf.es/doc_html/index.html## example results :http://kokonech.github.io/qualimap/HG00096.chr20_bamqc/qualimapReport.htmlunzip qualimap_v2.2.1.zip~/biosoft/bamtools/bamtools/bin/bamtools~/biosoft/Qualimap/qualimap_v2.2.1/qualimap --help ## --java-mem-size=4G## modify ~/.bashrc by adding PATH=$PATH:~/.local/bin/## Download and install deepTools## https://github.com/fidelram/deepTools## http://deeptools.readthedocs.io/en/latest/content/example_usage.htmlpip install pyBigWig --usercd ~/biosoftmkdir deepTools && cd deepToolsgit clone https://github.com/fidelram/deepTools ## 130M,cd deepToolspython setup.py install --user## 17 tools in ~/.local/bin/~/.local/bin/deeptoolscd ~/biosoftmkdir ngsplot && cd ngsplot## download by yourself :https://drive.google.com/drive/folders/0B1PVLadG_dCKN1liNFY0MVM1Ulktar -zxvf ngsplot-2.61.tar.gztar zxvf ngsplot.eg.bam.tar.gzecho 'export PATH=/home/jianmingzeng/biosoft/ngsplot/ngsplot/bin:$PATH' >>~/.bashrcecho 'export NGSPLOT=/home/jianmingzeng/biosoft/ngsplot/ngsplot' >>~/.bashrcsource ~/.bashrcinstall.packages("doMC", dep=T)install.packages("caTools", dep=T)install.packages("utils", dep=T)source("http://bioconductor.org/biocLite.R")biocLite( "BSgenome" )biocLite( "Rsamtools" )biocLite( "ShortRead" )cd ~/biosoftmkdir breakdancer && cd breakdancer# http://breakdancer.sourceforge.net/# you need to install 2 perl module by yourself : http://breakdancer.sourceforge.net/moreperl.htmlwget https://sourceforge.net/projects/breakdancer/files/breakdancer-1.1.2_2013_03_08.zipunzip breakdancer-1.1.2_2013_03_08.zipcd breakdancer-1.1.2/cppmake ##something wrong !## usage: http://breakdancer.sourceforge.net/pipeline.htmlcd ~/biosoft# http://boevalab.com/FREEC/mkdir Control-FREEC && cd Control-FREEC# https://github.com/BoevaLab/FREEC/releaseswget https://github.com/BoevaLab/FREEC/archive/v10.3.zipunzip v10.3.zip# https://www.ncbi.nlm.nih.gov/pubmed/22155870# http://boevalab.com/FREEC/tutorial.html# http://samtools.sourceforge.net/pileup.shtmlcd ~/biosoft# https://github.com/dellytools/dellymkdir delly && cd delly# git clone --recursive https://github.com/dellytools/delly.git# cd delly# make all# make PARALLEL=1 -B src/dellywget https://github.com/dellytools/delly/releases/download/v0.7.6/delly_v0.7.6_linux_x86_64bitchmod 777 delly_v0.7.6_linux_x86_64bit~/biosoft/delly/delly_v0.7.6_linux_x86_64bit --help## delly call -t DEL -g hg19.fa -o s1.bcf -x hg19.excl sample1.bam## ./delly/src/bcftools/bcftools view delly.bcf > delly.vcf## The SV type can be DEL, DUP, INV, TRA, or INS for deletions, tandem duplications, inversions, translocations and small insertions, respectively.## In addition, you can filter input reads more stringently using -q 20 and -s 15.cd ~/biosoft# https://www.cog-genomics.org/plink2/data#merge_listmkdir PLINK && cd PLINKwget https://www.cog-genomics.org/static/bin/plink170113/plink_linux_x86_64.zipunzip plink_linux_x86_64.zip~/biosoft/PLINK/plink## Download and install Scalpelcd ~/biosoftmkdir Scalpel && cd Scalpelwget https://downloads.sourceforge.net/project/scalpel/scalpel-0.5.3.tar.gztar zxvf scalpel-0.5.3.tar.gzcd scalpel-0.5.3make~/biosoft/Scalpel/scalpel-0.5.3/scalpel-discovery --help~/biosoft/Scalpel/scalpel-0.5.3/scalpel-export --helpcd ~/biosoft# https://www.cog-genomics.org/plink2/data#merge_listmkdir firehose && cd firehosewget http://gdac.broadinstitute.org/runs/code/firehose_get_latest.zipunzip firehose_get_latest.zip~/biosoft/firehose/firehose_get~/biosoft/firehose/firehose_get -tasks clinical analyses latest brcacd ~/biosoft# https://www.cog-genomics.org/plink2/data#merge_listmkdir fastpop && cd fastpopwget https://sourceforge.net/projects/fastpop/files/FastPop.tar.gzwget https://jaist.dl.sourceforge.net/project/fastpop/FastPop_Instruction.pdftar zxvf FastPop.tar.gzpip install cnvkit --user
再来一个转录组 de novo分析流程的软件全代码安装咯: Trinotate/Trinity/TransDecoder/sqlite/NCBI BLAST+/HMMER/PFAM signalP v4 /tmhmm v2 /RNAMMER 有些软件需要教育邮箱注册才行哦~~
## Trinotate/Trinity/TransDecoder/sqlite/NCBI BLAST+/HMMER/PFAM## signalP v4 /tmhmm v2 /RNAMMERcd ~/biosoftmkdir hmmer && cd hmmerwget http://eddylab.org/software/hmmer/2.3/hmmer-2.3.tar.gztar zxvf hmmer-2.3.tar.gzcd hmmer-2.3./configure --prefix=/home/jmzeng/my-bin#./configure --prefix=/home/jianmingzeng/biosoft/myBinmakemake install#for file in hmmalign hmmbuild hmmcalibrate hmmconvert hmmemit hmmfetch hmmindex hmmpfam hmmsearch ; do\# cp src/$file /home/jmzeng/my-bin/bin/;\# done#for file in hmmer hmmalign hmmbuild hmmcalibrate hmmconvert hmmemit hmmfetch hmmindex hmmpfam hmmsearch; do\# cp documentation/man/$file.man /home/jmzeng/my-bin/man/man1/$file.1;\# donecp /home/jmzeng/my-bin/bin/hmmsearch /home/jmzeng/my-bin/bin/hmmsearch2cd ~/biosoftmkdir CBS && cd CBS# signalP v4 (free academic download) http://www.cbs.dtu.dk/cgi-bin/nph-sw_request?signalp# tmhmm v2 (free academic download) http://www.cbs.dtu.dk/cgi-bin/nph-sw_request?tmhmm# RNAMMER (free academic download) http://www.cbs.dtu.dk/cgi-bin/sw_request?rnammermkdir signalp-4.1mkdir rnammer-1.2## be sure to untar it in a new directory## it's a perl script, we need to modify it according to readme http://trinotate.github.io/#SoftwareRequired## vi ~/biosoft/CBS/signalp-4.1/signalptar zxvf signalp-4.1e.Linux.tar.gztar zxvf rnammer-1.2.src.tar.Ztar zxvf tmhmm-2.0c.Linux.tar.gz## it's a perl script, we need to modify it according to readme http://trinotate.github.io/#SoftwareRequired## vi ~/biosoft/CBS/tmhmm-2.0c/bin/tmhmm## vi ~/biosoft/CBS/tmhmm-2.0c/bin/tmhmmformat.plwhich perl ## /usr/bin/perlcd ~/biosoftmkdir blastPlus && cd blastPlus# ftp://ftp.ncbi.nlm.nih.gov/blast/executables/LATESTwget ftp://ftp.ncbi.nlm.nih.gov/blast/executables/LATEST/ncbi-blast-2.5.0+-x64-linux.tar.gzblastBinFolder=~/biosoft/blastPlus/ncbi-blast-2.5.0+/bin$blastBinFolder/makeblastdb -help# http://www.cbs.dtu.dk/services/doc/signalp-4.1.readmecd ~/biosoftmkdir TransDecoder && cd TransDecoder# https://transdecoder.github.io/# https://github.com/TransDecoder/TransDecoder/releaseswget https://github.com/TransDecoder/TransDecoder/archive/v3.0.0.tar.gz -O TransDecoder.v3.0.0.tar.gztar zxvf TransDecoder.v3.0.0.tar.gzcd TransDecoder-3.0.0make~/biosoft/TransDecoder/TransDecoder-3.0.0/TransDecoder.LongOrfs -h~/biosoft/TransDecoder/TransDecoder-3.0.0/TransDecoder.Predict -h## sqlite3 --helpcd ~/biosoftmkdir Trinotate && cd Trinotate# http://trinotate.github.io/# https://github.com/Trinotate/Trinotate/releaseswget https://github.com/Trinotate/Trinotate/archive/v3.0.1.tar.gz -O Trinotate.v3.0.1.tar.gztar zxvf Trinotate.v3.0.1.tar.gz~/biosoft/Trinotate/Trinotate-3.0.1/Trinotate -hwget https://data.broadinstitute.org/Trinity/Trinotate_v3_RESOURCES/Pfam-A.hmm.gzwget https://data.broadinstitute.org/Trinity/Trinotate_v3_RESOURCES/uniprot_sprot.pep.gzwget https://data.broadinstitute.org/Trinity/Trinotate_v3_RESOURCES/Trinotate_v3.sqlite.gz -O Trinotate.sqlite.gzgunzip Trinotate.sqlite.gzgunzip uniprot_sprot.pep.gzmakeblastdb -in uniprot_sprot.pep -dbtype protgunzip Pfam-A.hmm.gzhmmpress Pfam-A.hmm
当然啦,代码没有一千个,但是是在持续累积的,只要我用过的软件我都记录下来了。 !
软件安装在我看来分成3类
第一就是二进制可执行程序,直接下载软件包解压后就可以全路径调用啦!
第二就是所有的语言代码啦,比如perl,R,python,java,matlab,ruby,C等等 其中C源码就是./configure,make,make install,也有的就是make,取决于readme,这个也是报错最多的,一般就是没有权限,缺库,很头疼。 然后perl和python软件呢,主要就是模块依赖的问题。 R,java,软件非常简单了。 matlab软件,你要是在windows界面用到还好,想去linux用,也折腾好几个星期。 ruby其它我没有用过啦。
最后就是系统或者语言自带的各种软件中心安装器啦,apt-get,yum,bioconda,cpan,cran,pip等等
其实前些天的推文,我讲到了很多软件安装的基础知识,如果你只需要收藏代码,就不需要看啦。计算资源及编程-仅针对生信人员
