生息软件安装

## Download and install picardtools

## https://sourceforge.net/projects/picard/

## https://github.com/broadinstitute/picard

cd ~/biosoft

mkdir picardtools && cd picardtools

wget http://ncu.dl.sourceforge.net/project/picard/picard-tools/1.119/picard-tools-1.119.zip

unzip picard-tools-1.119.zip

## 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 ~/biosoft

mkdir sratoolkit && cd sratoolkit

wget 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 -h

mkdir -p ~/biosoft/myBin

echo 'export PATH=/home/jianmingzeng/biosoft/myBin/bin:$PATH' >>~/.bashrc

source ~/.bashrc

cd ~/biosoft

mkdir cmake && cd cmake

wget http://cmake.org/files/v3.3/cmake-3.3.2.tar.gz

tar xvfz cmake-3.3.2.tar.gz

cd cmake-3.3.2

./configure --prefix=/home/jianmingzeng/biosoft/myBin

make

make install

## Download and install samtools

## http://samtools.sourceforge.net/

## http://www.htslib.org/doc/samtools.html

cd ~/biosoft

mkdir samtools && cd samtools

wget https://github.com/samtools/samtools/releases/download/1.3.1/samtools-1.3.1.tar.bz2

tar xvfj samtools-1.3.1.tar.bz2

cd samtools-1.3.1

./configure --prefix=/home/jianmingzeng/biosoft/myBin

make

make install

~/biosoft/myBin/bin/samtools --help

## Download and install bcftools

## http://www.htslib.org/download/

## http://www.htslib.org/doc/bcftools-1.0.html

cd ~/biosoft

mkdir bcftools && cd bcftools

wget https://github.com/samtools/bcftools/releases/download/1.3.1/bcftools-1.3.1.tar.bz2

tar xvfj bcftools-1.3.1.tar.bz2

cd bcftools-1.3.1

make

cp 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.html

cd ~/biosoft

mkdir 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 --help

## Download and install ANNOVAR

cd ~/biosoft

# The latest version of ANNOVAR (2016Feb01) can be downloaded here (registration required)

# http://www.openbioinformatics.org/annovar/annovar_download_form.php

mkdir ANNOVAR && cd ANNOVAR

## Download and install tabix

cd ~/biosoft

mkdir tabix && cd tabix

# http://genometoolbox.blogspot.com/2013/11/install

ing-tabix-on-unix.html

tar xvfj tabix-0.2.6.tar.bz2

cd tabix-0.2.6

make

## Download and install samstat

## http://samstat.sourceforge.net/

## http://www.htslib.org/doc/samtools.html

cd ~/biosoft

mkdir samstat && cd samstat

wget http://liquidtelecom.dl.sourceforge.net/project/samstat/samstat-1.5.tar.gz

tar zxvf samstat-1.5.tar.gz

cd samstat-1.5

./configure --prefix=/home/jianmingzeng/biosoft/myBin

make

make install

~/biosoft/myBin/bin/samstat --help

## Download and install picardtools

## https://sourceforge.net/projects/picard/

## https://github.com/broadinstitute/picard

cd ~/biosoft

mkdir picardtools && cd picardtools

wget http://ncu.dl.sourceforge.net/project/picard/picard-tools/1.119/picard-tools-1.119.zip

unzip picard-tools-1.119.zip

## Download and install freebayes

## https://github.com/ekg/freebayes

## http://clavius.bc.edu/~erik/CSHL-advanced-sequencing/freebayes-tutorial.html

cd ~/biosoft

mkdir freebayes && cd freebayes

## wget -O freebayes-master.zip https://codeload.github.com/ekg/freebayes/zip/master

## unzip freebayes-master.zip

wget http://clavius.bc.edu/~erik/freebayes/freebayes-5d5b8ac0.tar.gz

tar xzvf freebayes-5d5b8ac0.tar.gz

cd freebayes

make

~/biosoft/freebayes/freebayes/bin/freebayes

cd ~/biosoft

## https://sourceforge.net/projects/varscan/files/

## http://varscan.sourceforge.net/index.html

mkdir VarScan && cd VarScan

wget https://sourceforge.net/projects/varscan/files/VarScan.v2.3.9.jar

cd ~/biosoft

mkdir SnpEff && cd SnpEff

## http://snpeff.sourceforge.net/

## http://snpeff.sourceforge.net/SnpSift.html

## http://snpeff.sourceforge.net/SnpEff_manual.html

wget 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.vcf

unzip snpEff_latest_core.zip

## https://github.com/najoshi/sickle

cd ~/biosoft

mkdir sickle && cd sickle

wget https://codeload.github.com/najoshi/sickle/zip/master -O sickle.zip

unzip sickle.zip

cd sickle-master

make

~/biosoft/sickle/sickle-master/sickle -h

cd ~/biosoft

## http://www.usadellab.org/cms/?page=trimmomatic

## http://www.usadellab.org/cms/uploads/supplementary/Trimmomatic/TrimmomaticManual_V0.32.pdf

mkdir Trimmomatic && cd Trimmomatic

wget http://www.usadellab.org/cms/uploads/supplementary/Trimmomatic/Trimmomatic-0.36.zip

unzip Trimmomatic-0.36.zip

java -jar ~/biosoft/Trimmomatic/Trimmomatic-0.36/trimmomatic-0.36.jar -h

## Download and install bedtools

cd ~/biosoft

mkdir bedtools && cd bedtools

wget 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.gz

cd bedtools2

make

#~/biosoft/bedtools/bedtools2/bin/

## Download and install PeakRanger

cd ~/biosoft

mkdir PeakRanger && cd PeakRanger

wget https://sour

ceforge.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 bowtie

cd ~/biosoft

mkdir bowtie && cd bowtie

wget 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 bowtie2

mv download bowtie2-2.2.9-linux-x86_64.zip

unzip bowtie2-2.2.9-linux-x86_64.zip

## Download and install BWA

cd ~/biosoft

mkdir bwa && cd bwa

#http://sourceforge.net/projects/bio-bwa/files/

wget https://sourceforge.net/projects/bio-bwa/files/bwa-0.7.15.tar.bz2

tar 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 files

cd bwa-0.7.15

make

#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 ~/biosoft

mkdir macs2 && cd macs2

## just stick to PyPI release: https://pypi.python.org/pypi/MACS2

wget https://pypi.python.org/packages/9f/99/a8ac96b357f6b0a6f559fe0f5a81bcae12b98579551620ce07c5183aee2c/MACS2-2.1.1.20160309.tar.gz -O MACS2-2.1.1.tar.gz

tar zxvf MACS2-2.1.1.tar.gz

cd 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

# ImageMagick

cd ~/biosoft

mkdir ImageMagick && cd ImageMagick

## http://www.imagemagick.org/

cd ~/biosoft

mkdir weblogo && cd weblogo

## http://weblogo.berkeley.edu/

wget http://weblogo.berkeley.edu/release/weblogo.2.8.2.tar.gz

tar zxvf weblogo.2.8.2.tar.gz

cd weblogo

export PATH=$PATH:/home/jianmingzeng/biosoft/weblogo/weblogo

source ~/.bashrc

cd ~/biosoft

mkdir Ghostscript && cd Ghostscript

# http://www.ghostscript.com/download/gsdnld.html

# http://www.ghostscript.com/doc/9.20/Readme.htm

wget https://github.com/ArtifexSoftware/ghostpdl-downloads/releases/download/gs920/ghostscript-9.20-linux-x86_64.tgz

tar zxvf ghostscript-9.20-linux-x86_64.tgz

cp 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 line

cd ~/biosoft

mkdir ho

mer && cd homer

wget http://homer.salk.edu/homer/configureHomer.pl

perl configureHomer.pl -install

perl configureHomer.pl -install hg19

## Download and install SWEMBL

cd ~/biosoft

mkdir SWEMBL && cd SWEMBL

#### readme: http://www.ebi.ac.uk/~swilder/SWEMBL/beginners.html

wget http://www.ebi.ac.uk/~swilder/SWEMBL/SWEMBL.3.3.1.tar.bz2

tar xvfj SWEMBL.3.3.1.tar.bz2

cd SWEMBL.3.3.1/

make

## error

## Download and install SISSRs

cd ~/biosoft

mkdir SISSRs && cd SISSRs

#### readme: https://dir.nhlbi.nih.gov/papers/lmi/epigenomes/sissrs/SISSRs-Manual.pdf

wget http://dir.nhlbi.nih.gov/papers/lmi/epigenomes/sissrs/sissrs_v1.4.tar.gz

tar xzvf sissrs_v1.4.tar.gz

~/biosoft/SISSRs/sissrs.pl

## Download and install SISSRs

cd ~/biosoft

mkdir QuEST && cd QuEST

#### http://mendel.stanford.edu/SidowLab/downloads/quest/

wget http://mendel.stanford.edu/SidowLab/downloads/quest/QuEST_2.4.tar.gz

tar xzvf QuEST_2.4.tar.gz

cd QuEST_2.4

## Download and install fastqc

cd ~/biosoft

mkdir fastqc && cd fastqc

wget http://www.bioinformatics.bbsrc.ac.uk/projects/fastqc/fastqc_v0.11.5.zip

unzip fastqc_v0.11.5.zip

## Download and install CEAS

## http://liulab.dfci.harvard.edu/CEAS/download.html

cd ~/biosoft

mkdir CEAS && cd CEAS

wget http://liulab.dfci.harvard.edu/CEAS/src/CEAS-Package-1.0.2.tar.gz

tar zxvf CEAS-Package-1.0.2.tar.gz

cd CEAS-Package-1.0.2

python setup.py install --user

## http://liulab.dfci.harvard.edu/CEAS/usermanual.html

~/.local/bin/ceas --help

mkdir annotation && cd annotation

wget 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

cd ~/biosoft

# http://www.broadinstitute.org/cancer/cga/rnaseqc_run

# http://www.broadinstitute.org/cancer/cga/rnaseqc_download

mkdir RNA-SeQC && cd RNA-SeQC

#### readme: http://www.broadinstitute.org/cancer/cga/sites/default/files/data/tools/rnaseqc/RNA-SeQC_Help_v1.1.2.pdf

wget 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.shtml

cd ~/biosoft

mkdir TopHat && cd TopHat

#### readme: https://ccb.jhu.edu/software/tophat/manual.shtml

wget https://ccb.jhu.edu/software/tophat/downloads/tophat-2.1.1.Linux_x86_64.tar.gz

tar xzvf tophat-2.1.1.Linux_x86_64.tar.gz

ln -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 ~/biosoft

mkdir 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.gz

tar xzvf cufflin

ks-2.2.1.Linux_x86_64.tar.gz

ln -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.shtml

cd ~/biosoft

mkdir HISAT && cd HISAT

#### readme: https://ccb.jhu.edu/software/hisat2/manual.shtml

wget ftp://ftp.ccb.jhu.edu/pub/infphilo/hisat2/downloads/hisat2-2.0.4-Linux_x86_64.zip

unzip hisat2-2.0.4-Linux_x86_64.zip

ln -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=manual

cd ~/biosoft

mkdir StringTie && cd StringTie

wget http://ccb.jhu.edu/software/stringtie/dl/stringtie-1.2.3.Linux_x86_64.tar.gz

tar zxvf stringtie-1.2.3.Linux_x86_64.tar.gz

ln -s stringtie-1.2.3.Linux_x86_64 current

# ~/biosoft/StringTie/current/stringtie

cd ~/biosoft

mkdir RSEM && cd RSEM

wget https://codeload.github.com/deweylab/RSEM/tar.gz/v1.2.31

mv v1.2.31 RSEM.v1.2.31.tar.gz

tar 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/HTSeq

cd ~/biosoft

mkdir HTSeq && cd HTSeq

wget https://pypi.python.org/packages/72/0f/566afae6c149762af301a19686cd5fd1876deb2b48d09546dbd5caebbb78/HTSeq-0.6.1.tar.gz

tar zxvf HTSeq-0.6.1.tar.gz

cd HTSeq-0.6.1

python 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/starting

cd ~/biosoft

mkdir kallisto && cd kallisto

wget 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 ~/biosoft

mkdir Sailfish && cd Sailfish

wget 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 ~/biosoft

mkdir salmon && cd salmon

## https://github.com/COMBINE-lab/salmon

#tar zxvf

cd ~/biosoft

mkdir 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-c

lient_v1.2.0_Ubuntu14.04_x64.zip

unzip gdc-client_v1.2.0_Ubuntu14.04_x64.zip

cd ~/biosoft/myBin/bin

## http://hgdownload.cse.ucsc.edu/admin/exe/

wget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/bedToBigBed

wget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/bedSort

wget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/bedGraphToBigWig

wget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/fetchChromSizes

wget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/wigToBigWig

wget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/liftOver

wget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/bigWigToBedGraph

wget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/bigBedToBed

wget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/blat/blat

wget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/blat/gfClient

wget http://hgdownload.cse.ucsc.edu/admin/exe/linux.x86_64/blat/gfServer

## Download and install variationtoolkit

## https://code.google.com/archive/p/variationtoolkit/downloads

cd ~/biosoft

mkdir variationtoolkit && cd variationtoolkit

wget https://storage.googleapis.com/google-code-archive-downloads/v2/code.google.com/variationtoolkit/archive.tar.gz

tar zxvf archive.tar.gz

cd variationtoolkit

make

## Download and install transvar

# http://bioinformatics.mdanderson.org/main/Transvar

cd ~/biosoft

# https://bitbucket.org/wanding/transvar

mkdir transvar && cd transvar

wget https://bitbucket.org/wanding/transvar/get/v2.1.19.20160221.zip

unzip v2.1.19.20160221.zip

cd wanding-transvar-5dd8a7366999

python setup.py install --user

cd ~/biosoft

# http://kobas.cbi.pku.edu.cn/download.php

mkdir 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.gz

wget http://kobas.cbi.pku.edu.cn/kobas-2.1.1/kobas-2.1.1.tar.gz

tar zxvf kobas-2.1.1.tar.gz

cd 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 --user

pip install Numpy --user

pip install Pandas --user

pip install BioPython --user

pip install matplotlib --user

pip install PySQLite --user

source("http://bioconductor.org/biocLite.R")

biocLite("qvalue")

## Trinotate/Trinity/TransDecoder/sq

lite/NCBI BLAST+/HMMER/PFAM

## signalP v4 /tmhmm v2 /RNAMMER

cd ~/biosoft

mkdir hmmer && cd hmmer

wget http://eddylab.org/software/hmmer/2.3/hmmer-2.3.tar.gz

tar zxvf hmmer-2.3.tar.gz

cd hmmer-2.3

./configure --prefix=/home/jmzeng/my-bin

#./configure --prefix=/home/jianmingzeng/biosoft/myBin

make

make 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;\

# done

cp /home/jmzeng/my-bin/bin/hmmsearch /home/jmzeng/my-bin/bin/hmmsearch2

cd ~/biosoft

mkdir 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?rnammer

mkdir signalp-4.1

mkdir 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/signalp

tar zxvf signalp-4.1e.Linux.tar.gz

tar zxvf rnammer-1.2.src.tar.Z

tar 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.pl

which perl ## /usr/bin/perl

cd ~/biosoft

mkdir blastPlus && cd blastPlus

# ftp://ftp.ncbi.nlm.nih.gov/blast/executables/LATEST

wget ftp://ftp.ncbi.nlm.nih.gov/blast/executables/LATEST/ncbi-blast-2.5.0+-x64-linux.tar.gz

blastBinFolder=~/biosoft/blastPlus/ncbi-blast-2.5.0+/bin

$blastBinFolder/makeblastdb -help

# http://www.cbs.dtu.dk/services/doc/signalp-4.1.readme

cd ~/biosoft

mkdir TransDecoder && cd TransDecoder

# https://transdecoder.github.io/

# https://github.com/TransDecoder/TransDecoder/releases

wget https://github.com/TransDecoder/TransDecoder/archive/v3.0.0.tar.gz -O TransDecoder.v3.0.0.tar.gz

tar zxvf TransDecoder.v3.0.0.tar.gz

cd TransDecoder-3.0.0

make

~/biosoft/TransDecoder/TransDecoder-3.0.0/TransDecoder.LongOrfs -h

~/biosoft/TransDecoder/TransDecoder-3.0.0/TransDecoder.Predict -h

## sqlite3 --help

cd ~/biosoft

mkdir Trinotate && cd Trinotate

# http://trinotate.github.io/

# https://github.com/Trinotate/Trinotate/releases

wget https://github.com/Trinotate/Trinotate/archive/v3.0.1.tar.gz -O Trinotate.v3.0.1.tar.gz

tar zxvf Trinotate.v3.0.1.tar.gz

~/biosoft/Trinotate/Trinotate-3.0.1/Trinotate -h

wget https://data.broadinstitute.org/Trinity/Trinotate_v3_RESOURCES/Pfam-A.hmm.gz

wget https://data.broadinstitute.org/Trinity/Trinotate_v3_RESOURCES/uniprot_sprot.pep.gz

wget https://data.broadinstitute.org/Tr

inity/Trinotate_v3_RESOURCES/Trinotate_v3.sqlite.gz -O Trinotate.sqlite.gz

gunzip Trinotate.sqlite.gz

gunzip uniprot_sprot.pep.gz

makeblastdb -in uniprot_sprot.pep -dbtype prot

gunzip Pfam-A.hmm.gz

hmmpress Pfam-A.hmm

  • 0
    点赞
  • 15
    收藏
    觉得还不错? 一键收藏
  • 0
    评论

“相关推荐”对你有帮助么?

  • 非常没帮助
  • 没帮助
  • 一般
  • 有帮助
  • 非常有帮助
提交
评论
添加红包

请填写红包祝福语或标题

红包个数最小为10个

红包金额最低5元

当前余额3.43前往充值 >
需支付:10.00
成就一亿技术人!
领取后你会自动成为博主和红包主的粉丝 规则
hope_wisdom
发出的红包
实付
使用余额支付
点击重新获取
扫码支付
钱包余额 0

抵扣说明:

1.余额是钱包充值的虚拟货币,按照1:1的比例进行支付金额的抵扣。
2.余额无法直接购买下载,可以购买VIP、付费专栏及课程。

余额充值