Skip to content

Instantly share code, notes, and snippets.

@darencard
Last active March 7, 2024 08:50
Show Gist options
  • Star 94 You must be signed in to star a gist
  • Fork 45 You must be signed in to fork a gist
  • Save darencard/bb1001ac1532dd4225b030cf0cd61ce2 to your computer and use it in GitHub Desktop.
Save darencard/bb1001ac1532dd4225b030cf0cd61ce2 to your computer and use it in GitHub Desktop.
In-depth description of running MAKER for genome annotation.

Please see the most up-to-date version of this protocol on my blog at https://darencard.net/blog/.

Genome Annotation using MAKER

MAKER is a great tool for annotating a reference genome using empirical and ab initio gene predictions. GMOD, the umbrella organization that includes MAKER, has some nice tutorials online for running MAKER. However, these were quite simplified examples and it took a bit of effort to wrap my head completely around everything. Here I will describe a de novo genome annotation for Boa constrictor in detail, so that there is a record and that it is easy to use this as a guide to annotate any genome.

Software & Data

Software prerequisites:

  1. RepeatModeler and RepeatMasker with all dependencies (I used NCBI BLAST) and RepBase (version used was 20150807).
  2. MAKER MPI version 2.31.8 (though any other version 2 releases should be okay).
  3. Augustus version 3.2.3.
  4. BUSCO version 2.0.1.
  5. SNAP version 2006-07-28.
  6. BEDtools version 2.17.0.

Raw data/resources:

  1. Boa_constrictor_SGA_7C_scaffolds.fa: The de novo Boa constrictor reference genome assembled as part of Assemblathon2. This is the SGA team assembly (snake 7C). This is in FASTA format.
  2. Boa_Trinity_15May2015.Txome_assembly.fasta: A de novo transcriptome assembly created using Trinity and mRNAseq data from 10 Boa tissues. It may make sense to do some post-processing of this assembly, but I did not do so here. Trinity is pretty easy to run so I won't describe that here. This is in FASTA format.
  3. Full protein amino acid sequences, in FASTA format, for three other Squamate species from NCBI or Ensembl: Anolis carolinensis, Python molurus bivittatus, and Thamnophis sirtalis.
  4. A curated snake repeat library derived from 14 snake species (from internal efforts).

Running commands:

I've become accustomed to running most programs (especially those that take hours/days) using screen. I would create new screens for each command below. I also like to use tee to keep track of run logs, as you will see in the commands below.

Repeat Annotation

1. De Novo Repeat Identification

The first, and very important, step to genome annotation is identifying repetitive content. Existing libraries from Repbase or from internal efforts are great, but it is also important to identify repeats de novo from your reference genome using RepeatModeler. This is pretty easy to do and normally only takes a couple days using 8-12 cores.

BuildDatabase -name Boa_constrictor -engine ncbi Boa_constrictor_SGA_7C_scaffolds.fa
RepeatModeler -pa 8 -engine ncbi -database Boa_constrictor 2>&1 | tee repeatmodeler.log

Further steps can be taken to annotate the resulting library, but the most important reason for this library is for downstream gene prediction. In this example, this Boa library was combined with several other snakes and annotated.

2. Full Repeat Annotation

Depending on the species, the de novo library can be fed right into MAKER. We normally do more complex repeat identification with snakes so I will describe that here.

First, we mask using a currated BovB/CR1 line library to overcome a previously-identified issue with the Repbase annotation. This probably won't be necessary in other species.

mkdir BovB_mask
RepeatMasker -pa 8 -e ncbi -lib bovb_cr1_species.lib -dir BovB_mask Boa_constrictor_SGA_7C_scaffolds.fa

Then the maksed FASTA from this search can be used as input for the next search, using the tetrapoda library from Repbase. I also normally rename the outputs after each round so they are more representative of what they contain.

mkdir Tetrapoda_mask
RepeatMasker -pa 8 -e ncbi -species tetrapoda -dir Tetrapoda_mask Boa_constrictor_SGA_7C.scaffolds.BovB.fa

And then I finished using two more rounds using a library of known and unknown snake repeats (including those from Boa). These rounds were split so that known elements would be preferentially annotated over unknown, to the degree possible.

mkdir 14Snake_known_mask 14Snake_unknown_mask
RepeatMasker -pa 8 -e ncbi -species 14Snakes_Known_TElib.fasta -dir 14Snake_known_mask Boa_constrictor_SGA_7C.scaffolds.Tetrapoda.fa
RepeatMasker -pa 8 -e ncbi -species 14Snakes_Known_TElib.fasta -dir 14Snake_known_mask Boa_constrictor_SGA_7C.scaffolds.14SnakeKnown.fa

Finally, results from each round must be analyzed together to produce the final repeat annotation

mkdir Full_mask
cp 14snake_unknown_mask/Boa_constrictor_SGA_7C.scaffolds.14SnakeUnknown.fa Full_mask/Boa_constrictor_SGA_7C.scaffolds.full_mask.fa
cp 14snake_unknown_mask/Boa_constrictor_SGA_7C.scaffolds.14SnakeUnknown.out Full_mask/Boa_constrictor_SGA_7C.scaffolds.full_mask.out
gunzip BovB_mask/*.cat.gz Tetrapoda_mask/*.cat.gz 14snake_known_mask/*.cat.gz 14snake_unknown_mask/*.cat.gz
cat BovB_mask/*.cat Tetrapoda_mask/*.cat 14snake_known_mask/*.cat 14snake_unknown_mask/*.cat \
  > Final_mask/Boa_constrictor_SGA_7C.scaffolds.full_mask.cat
cd Full_mask
ProcessRepeats -species tetrapoda Final_mask/Boa_constrictor_SGA_7C.scaffolds.Full_mask.cat

Finally, in order to feed these repeats into MAKER properly, we must separate out the complex repeats (more info on this below).

# create GFF3
rmOutToGFF3.pl Full_mask/Boa_constrictor_SGA_7C.scaffolds.full_mask.out > Full_mask/Boa_constrictor_SGA_7C.scaffolds.full_mask.out.gff3
# isolate complex repeats
grep -v -e "Satellite" -e ")n" -e "-rich" Boa_constrictor_SGA_7C_scaffolds.full_mask.gff3 \
  > Boa_constrictor_SGA_7C_scaffolds.full_mask.complex.gff3
# reformat to work with MAKER
cat Boa_constrictor_SGA_7C_scaffolds.full_mask.complex.gff3 | \
  perl -ane '$id; if(!/^\#/){@F = split(/\t/, $_); chomp $F[-1];$id++; $F[-1] .= "\;ID=$id"; $_ = join("\t", @F)."\n"} print $_' \
  > Boa_constrictor_SGA_7C_scaffolds.full_mask.complex.reformat.gff3

Now we have the prerequesite data for running MAKER.

3. Initial MAKER Analysis

MAKER is pretty easy to get going and relies on properly completed control files. These can be generated by issuing the command maker -CTL. The only control file we will be the maker_opts.ctl file. In this first round, we will obviously providing the data files for the repeat annotation (rm_gff), the transcriptome assembly (est), and for the other Squamate protein sequences (protein). We will also set the model_org to 'simple' so that only simple repeats are annotated (along with RepeatRunner). Here is the full control file for reference.

cat round1_maker_opts.ctl

#-----Genome (these are always required)
genome=/home/castoelab/Desktop/daren/boa_annotation/Boa_constrictor_SGA_7C_scaffolds.fa #genome sequence (fasta file or fasta embeded in GFF3 file)
organism_type=eukaryotic #eukaryotic or prokaryotic. Default is eukaryotic

#-----Re-annotation Using MAKER Derived GFF3
maker_gff= #MAKER derived GFF3 file
est_pass=0 #use ESTs in maker_gff: 1 = yes, 0 = no
altest_pass=0 #use alternate organism ESTs in maker_gff: 1 = yes, 0 = no
protein_pass=0 #use protein alignments in maker_gff: 1 = yes, 0 = no
rm_pass=0 #use repeats in maker_gff: 1 = yes, 0 = no
model_pass=0 #use gene models in maker_gff: 1 = yes, 0 = no
pred_pass=0 #use ab-initio predictions in maker_gff: 1 = yes, 0 = no
other_pass=0 #passthrough anyything else in maker_gff: 1 = yes, 0 = no

#-----EST Evidence (for best results provide a file for at least one)
est=/home/castoelab/Desktop/daren/boa_annotation/Boa_Trinity_15May2015.Txome_assembly.fasta #set of ESTs or assembled mRNA-seq in fasta format
altest= #EST/cDNA sequence file in fasta format from an alternate organism
est_gff= #aligned ESTs or mRNA-seq from an external GFF3 file
altest_gff= #aligned ESTs from a closly relate species in GFF3 format

#-----Protein Homology Evidence (for best results provide a file for at least one)
protein=/home/castoelab/Desktop/daren/boa_annotation/protein_files_other_squamates/Anolis_carolinensis.AnoCar2.0.pep.all.fa,/home/castoelab/Desktop/daren/boa_annotation/protein_files_other_squamates/GCF_000186305.1_Python_molurus_bivittatus-5.0.2_protein.faa,/home/castoelab/Desktop/daren/boa_annotation/protein_files_other_squamates/GCF_001077635.1_Thamnophis_sirtalis-6.0_protein.faa  #protein sequence file in fasta format (i.e. from mutiple oransisms)
protein_gff=  #aligned protein homology evidence from an external GFF3 file

#-----Repeat Masking (leave values blank to skip repeat masking)
model_org=simple #select a model organism for RepBase masking in RepeatMasker
rmlib= #provide an organism specific repeat library in fasta format for RepeatMasker
repeat_protein=/opt/maker/data/te_proteins.fasta #provide a fasta file of transposable element proteins for RepeatRunner
rm_gff=/home/castoelab/Desktop/daren/boa_annotation/Full_mask/Boa_constrictor_SGA_7C_scaffolds.full_mask.complex.reformat.gff3 #pre-identified repeat elements from an external GFF3 file
prok_rm=0 #forces MAKER to repeatmask prokaryotes (no reason to change this), 1 = yes, 0 = no
softmask=1 #use soft-masking rather than hard-masking in BLAST (i.e. seg and dust filtering)

#-----Gene Prediction
snaphmm= #SNAP HMM file
gmhmm= #GeneMark HMM file
augustus_species= #Augustus gene prediction species model
fgenesh_par_file= #FGENESH parameter file
pred_gff= #ab-initio predictions from an external GFF3 file
model_gff= #annotated gene models from an external GFF3 file (annotation pass-through)
est2genome=1 #infer gene predictions directly from ESTs, 1 = yes, 0 = no
protein2genome=1 #infer predictions from protein homology, 1 = yes, 0 = no
trna=0 #find tRNAs with tRNAscan, 1 = yes, 0 = no
snoscan_rrna= #rRNA file to have Snoscan find snoRNAs
unmask=0 #also run ab-initio prediction programs on unmasked sequence, 1 = yes, 0 = no

#-----Other Annotation Feature Types (features MAKER doesn't recognize)
other_gff= #extra features to pass-through to final MAKER generated GFF3 file

#-----External Application Behavior Options
alt_peptide=C #amino acid used to replace non-standard amino acids in BLAST databases
cpus=1 #max number of cpus to use in BLAST and RepeatMasker (not for MPI, leave 1 when using MPI)

#-----MAKER Behavior Options
max_dna_len=100000 #length for dividing up contigs into chunks (increases/decreases memory usage)
min_contig=1 #skip genome contigs below this length (under 10kb are often useless)

pred_flank=200 #flank for extending evidence clusters sent to gene predictors
pred_stats=0 #report AED and QI statistics for all predictions as well as models
AED_threshold=1 #Maximum Annotation Edit Distance allowed (bound by 0 and 1)
min_protein=0 #require at least this many amino acids in predicted proteins
alt_splice=0 #Take extra steps to try and find alternative splicing, 1 = yes, 0 = no
always_complete=0 #extra steps to force start and stop codons, 1 = yes, 0 = no
map_forward=0 #map names and attributes forward from old GFF3 genes, 1 = yes, 0 = no
keep_preds=0 #Concordance threshold to add unsupported gene prediction (bound by 0 and 1)

split_hit=10000 #length for the splitting of hits (expected max intron size for evidence alignments)
single_exon=0 #consider single exon EST evidence when generating annotations, 1 = yes, 0 = no
single_length=250 #min length required for single exon ESTs if 'single_exon is enabled'
correct_est_fusion=0 #limits use of ESTs in annotation to avoid fusion genes

tries=2 #number of times to try a contig if there is a failure for some reason
clean_try=0 #remove all data from previous run before retrying, 1 = yes, 0 = no
clean_up=0 #removes theVoid directory with individual analysis files, 1 = yes, 0 = no
TMP= #specify a directory other than the system default temporary directory for temporary files

Specifying the GFF3 annotation file for the annotated complex repeats (rm_gff) has the effect of hard masking these repeats so that they do not confound our ability to identify coding genes. We let MAKER identify simple repeats internally, since it will soft mask these, allowing them to be available for gene annotation. This isn't a typical approach but has to be done if you want to do more than one succeessive round of RepeatMasker. I verified this would work with the MAKER maintainers here.

Two other important settings are est2genome and protein2genome, which are set to 1 so that MAKER gene predictions are based on the aligned transcripts and proteins (the only form of evidence we currently have). I also construct the MAKER command in a Bash script so it is easy to run and keep track of.

cat round1_run_maker.sh

mpiexec -n 12 maker -base Bcon_rnd1 round1_maker_opts.ctl maker_bopts.ctl maker_exe.ctl

Then we run MAKER.

bash ./round1_run_maker.sh 2>&1 | tee round1_run_maker.log

Given MAKER will be using BLAST to align transcripts and proteins to the genome, this will take at least a couple days with 12 cores. Speed is a product of the resources you allow (more cores == faster) and the assembly quality (smaller, less contiguous scaffolds == longer). We conclude by assembling together the GFF and FASTA outputs.

cd Bcon_rnd1.maker.output
gff3_merge -s -d Bcon_rnd1_master_datastore_index.log > Bcon_rnd1.all.maker.gff
fasta_merge -d Bcon_rnd1_master_datastore_index.log
# GFF w/o the sequences
gff3_merge -n -s -d Bcon_rnd1_master_datastore_index.log > Bcon_rnd1.all.maker.noseq.gff

4. Training Gene Prediction Software

Besides mapping the empirical transcript and protein evidence to the reference genome and repeat annotation (not much of this in our example, given we've done so much up front), the most important product of this MAKER run is the gene models. These are what is used for training gene prediction software like augustus and snap.

SNAP

SNAP is pretty quick and easy to train. Issuing the following commands will perform the training. It is best to put some thought into what kind of gene models you use from MAKER. In this case, we use models with an AED of 0.25 or better and a length of 50 or more amino acids, which helps get rid of junky models.

mkdir snap
mkdir snap/round1
cd snap/round1
# export 'confident' gene models from MAKER and rename to something meaningful
maker2zff -x 0.25 -l 50 -d ../../Bcon_rnd1.maker.output/Bcon_rnd1_master_datastore_index.log
rename 's/genome/Bcon_rnd1.zff.length50_aed0.25/g' *
# gather some stats and validate
fathom Bcon_rnd1.zff.length50_aed0.25.ann Bcon_rnd1.zff.length50_aed0.25.dna -gene-stats > gene-stats.log 2>&1
fathom Bcon_rnd1.zff.length50_aed0.25.ann Bcon_rnd1.zff.length50_aed0.25.dna -validate > validate.log 2>&1
# collect the training sequences and annotations, plus 1000 surrounding bp for training
fathom Bcon_rnd1.zff.length50_aed0.25.ann Bcon_rnd1.zff.length50_aed0.25.dna -categorize 1000 > categorize.log 2>&1
fathom uni.ann uni.dna -export 1000 -plus > uni-plus.log 2>&1
# create the training parameters
mkdir params
cd params
forge ../export.ann ../export.dna > ../forge.log 2>&1
cd ..
# assembly the HMM
hmm-assembler.pl Bcon_rnd1.zff.length50_aed0.25 params > Bcon_rnd1.zff.length50_aed0.25.hmm
Augustus

Training Augustus is a more laborious process. Luckily, the recent release of BUSCO provides a nice pipeline for performing the training, while giving you an idea of how good your annotation already is. If you don't want to go this route, there are scripts provided with Augustus to perform the training. First, the Parallel::ForkManager module for Perl is required to run BUSCO with more than one core. You can easily install it before the first time you use BUSCO by running sudo apt-get install libparallel-forkmanager-perl.

This probably isn't an ideal training environment, but appears to work well. First, we must put together training sequences using the gene models we created in our first run of MAKER. We do this by issuing the following command to excise the regions that contain mRNA annotations based on our initial MAKER run (with 1000bp on each side).

awk -v OFS="\t" '{ if ($3 == "mRNA") print $1, $4, $5 }' ../../Bcon_rnd1.maker.output/Bcon_rnd1.all.maker.noseq.gff | \
  awk -v OFS="\t" '{ if ($2 < 1000) print $1, "0", $3+1000; else print $1, $2-1000, $3+1000 }' | \
  bedtools getfasta -fi ../../Boa_constrictor_SGA_7C_scaffolds.fa -bed - -fo Bcon_rnd1.all.maker.transcripts1000.fasta

There are some important things to note based on this approach. First is that you will likely get warnings from BEDtools that certain coordinates could not be used to extract FASTA sequences. This is because the end coordinate of a transcript plus 1000 bp is beyond the total length of a given scaffold. This script does account for transcripts being within the beginning 1000bp of the scaffold, but there was no easy way to do the same with transcrpts within the last 1000bp of the scaffold. This is okay, however, as we still end up with sequences from thousands of gene models and BUSCO will only be searching for a small subset of genes itself.

While we've only provided sequences from regions likely to contain genes, we've totally eliminated any existing annotation data about the starts/stops of gene elements. Augustus would normally use this as part of the training process. However, BUSCO will essentially do a reannotation of these regions using BLAST and built-in HMMs for a set of conserved genes (hundreds to thousands). This has the effect of recreating some version of our gene models for these conserved genes. We then leverage the internal training that BUSCO can perform (the --long argument) to optimize the HMM search model to train Augustus and produce a trained HMM for MAKER. Here is the command we use to perform the Augustus training inside BUSCO.

BUSCO.py -i Bcon_rnd2.all.maker.transcripts1000.fasta  -o Bcon_rnd1_maker -l tetrapoda_odb9/ \
  -m genome -c 8 --long -sp human -z --augustus_parameters='--progress=true'

In this case, we are using the Tetrapoda set of conserved genes (N = 3950 genes), so BUSCO will try to identify those gene using BLAST and an initial HMM model for each that comes stocked within BUSCO. We specify the -m genome option since we are giving BUSCO regions that include more than just transcripts. The initial HMM model we'll use is the human one (-sp human), which is a reasonably close species. Finally, the --long option tells BUSCO to use the initial gene models it creates to optimize the HMM settings of the raw human HMM, thus training it for our use on Boa. We can have this run in parallel on several cores, but it will still likely take days, so be patient.

Once BUSCO is complete, it will give you an idea of how complete your annotation is (though be cautious, because we haven't filtered away known alternative transcripts that will be binned as duplicates). We need to do some post-processing of the HMM models to get them ready for MAKER. First, we'll rename the files within run_Bcon_rnd1_maker/augustus_output/retraining_paramters.

rename 's/BUSCO_Bcon_rnd2_maker_2277442865/Boa_constrictor/g' *

We also need to rename the files cited within certain HMM configuration files.

sed -i 's/BUSCO_Bcon_rnd2_maker_2277442865/Boa_constrictor/g' Boa_constrictor_parameters.cfg
sed -i 's/BUSCO_Bcon_rnd2_maker_2277442865/Boa_constrictor/g' Boa_constrictor_parameters.cfg.orig1

Finally, we must copy these into the $AUGUSTUS_CONFIG_PATH species HMM location so they are accessible by Augustus and MAKER.

# may need to sudo
mkdir $AUGUSTUS_CONFIG_PATH/species/Boa_constrictor
cp Boa_constrictor*  $AUGUSTUS_CONFIG_PATH/species/Boa_constrictor/

5. MAKER With Ab Initio Gene Predictors

Now let's run a second round of MAKER, but this time we will have SNAP and Augustus run within MAKER to help create more sound gene models. MAKER will use the annotations from these two prediction programs when constructing its models. Before running, let's first recycle the mapping of empicial evidence we have from the first MAKER round, so we don't have to perform all the BLASTs, etc. again.

# transcript alignments
awk '{ if ($2 == "est2genome") print $0 }' Bcon_rnd1.all.maker.noseq.gff > Bcon_rnd1.all.maker.est2genome.gff
# protein alignments
awk '{ if ($2 == "protein2genome") print $0 }' Bcon_rnd1.all.maker.noseq.gff > Bcon_rnd1.all.maker.protein2genome.gff
# repeat alignments
awk '{ if ($2 ~ "repeat") print $0 }' Bcon_rnd1.all.maker.noseq.gff > Bcon_rnd1.all.maker.repeats.gff

Then we will modify the previous control file, removing the FASTA sequences files to map and replacing them with the GFFs (est_gff, protein_gff, and rm_gff, respectively. We can also specify the path to the SNAP HMM and the species name for Augustus, so that these gene prediciton programs are run. We will also switch est2genome and protein2genome to 0 so that gene predictions are based on the Augustus and SNAP gene models. Here is the full version of this control file.

cat round2_maker_opts.ctl

#-----Genome (these are always required)
genome=/home/castoelab/Desktop/daren/boa_annotation/Boa_constrictor_SGA_7C_scaffolds.fa #genome sequence (fasta file or fasta embeded in GFF3 file)
organism_type=eukaryotic #eukaryotic or prokaryotic. Default is eukaryotic

#-----Re-annotation Using MAKER Derived GFF3
maker_gff= #MAKER derived GFF3 file
est_pass=0 #use ESTs in maker_gff: 1 = yes, 0 = no
altest_pass=0 #use alternate organism ESTs in maker_gff: 1 = yes, 0 = no
protein_pass=0 #use protein alignments in maker_gff: 1 = yes, 0 = no
rm_pass=0 #use repeats in maker_gff: 1 = yes, 0 = no
model_pass=0 #use gene models in maker_gff: 1 = yes, 0 = no
pred_pass=0 #use ab-initio predictions in maker_gff: 1 = yes, 0 = no
other_pass=0 #passthrough anyything else in maker_gff: 1 = yes, 0 = no

#-----EST Evidence (for best results provide a file for at least one)
est= #set of ESTs or assembled mRNA-seq in fasta format
altest= #EST/cDNA sequence file in fasta format from an alternate organism
est_gff=/home/castoelab/Desktop/daren/boa_annotation/Bcon_rnd1.maker.output/Bcon_rnd1.all.maker.est2genome.gff #aligned ESTs or mRNA-seq from an external GFF3 file
altest_gff= #aligned ESTs from a closly relate species in GFF3 format

#-----Protein Homology Evidence (for best results provide a file for at least one)
protein= #protein sequence file in fasta format (i.e. from mutiple oransisms)
protein_gff=/home/castoelab/Desktop/daren/boa_annotation/Bcon_rnd1.maker.output/Bcon_rnd1.all.maker.protein2genome.gff  #aligned protein homology evidence from an external GFF3 file

#-----Repeat Masking (leave values blank to skip repeat masking)
model_org= #select a model organism for RepBase masking in RepeatMasker
rmlib= #provide an organism specific repeat library in fasta format for RepeatMasker
repeat_protein= #provide a fasta file of transposable element proteins for RepeatRunner
rm_gff=/home/castoelab/Desktop/daren/boa_annotation/Bcon_rnd1.maker.output/Bcon_rnd1.all.maker.repeats.gff #pre-identified repeat elements from an external GFF3 file
prok_rm=0 #forces MAKER to repeatmask prokaryotes (no reason to change this), 1 = yes, 0 = no
softmask=1 #use soft-masking rather than hard-masking in BLAST (i.e. seg and dust filtering)

#-----Gene Prediction
snaphmm=/home/castoelab/Desktop/daren/boa_annotation/snap/round1/Bcon_rnd1.zff.length50_aed0.25.hmm #SNAP HMM file
gmhmm= #GeneMark HMM file
augustus_species=Boa_constrictor #Augustus gene prediction species model
fgenesh_par_file= #FGENESH parameter file
pred_gff= #ab-initio predictions from an external GFF3 file
model_gff= #annotated gene models from an external GFF3 file (annotation pass-through)
est2genome=0 #infer gene predictions directly from ESTs, 1 = yes, 0 = no
protein2genome=0 #infer predictions from protein homology, 1 = yes, 0 = no
trna=1 #find tRNAs with tRNAscan, 1 = yes, 0 = no
snoscan_rrna= #rRNA file to have Snoscan find snoRNAs
unmask=0 #also run ab-initio prediction programs on unmasked sequence, 1 = yes, 0 = no

#-----Other Annotation Feature Types (features MAKER doesn't recognize)
other_gff= #extra features to pass-through to final MAKER generated GFF3 file

#-----External Application Behavior Options
alt_peptide=C #amino acid used to replace non-standard amino acids in BLAST databases
cpus=1 #max number of cpus to use in BLAST and RepeatMasker (not for MPI, leave 1 when using MPI)

#-----MAKER Behavior Options
max_dna_len=300000 #length for dividing up contigs into chunks (increases/decreases memory usage)
min_contig=1 #skip genome contigs below this length (under 10kb are often useless)

pred_flank=200 #flank for extending evidence clusters sent to gene predictors
pred_stats=0 #report AED and QI statistics for all predictions as well as models
AED_threshold=1 #Maximum Annotation Edit Distance allowed (bound by 0 and 1)
min_protein=0 #require at least this many amino acids in predicted proteins
alt_splice=0 #Take extra steps to try and find alternative splicing, 1 = yes, 0 = no
always_complete=0 #extra steps to force start and stop codons, 1 = yes, 0 = no
map_forward=0 #map names and attributes forward from old GFF3 genes, 1 = yes, 0 = no
keep_preds=0 #Concordance threshold to add unsupported gene prediction (bound by 0 and 1)

split_hit=20000 #length for the splitting of hits (expected max intron size for evidence alignments)
single_exon=0 #consider single exon EST evidence when generating annotations, 1 = yes, 0 = no
single_length=250 #min length required for single exon ESTs if 'single_exon is enabled'
correct_est_fusion=0 #limits use of ESTs in annotation to avoid fusion genes

tries=2 #number of times to try a contig if there is a failure for some reason
clean_try=0 #remove all data from previous run before retrying, 1 = yes, 0 = no
clean_up=0 #removes theVoid directory with individual analysis files, 1 = yes, 0 = no
TMP= #specify a directory other than the system default temporary directory for temporary files

Then we can run MAKER, substituting this new control file, and summarize the output, as we did before.

6. Iteratively Running MAKER to Improve Annotation

One of the beauties of MAKER is that it can be run iteratively, using the gene models from the one round to train ab initio software to improve the inference of gene models in the next round. Essentially, all one has to do is repeat steps 4 and 5 to perform another round of annotation. The MAKER creators/maintainers recommend at least a couple rounds of ab initio software training and MAKER annotation (i.e., 3 rounds total) and returns start to diminish (at differing rates) thereafter. One needs to be careful not to overtrain Augustus and SNAP, so more rounds isn't necessarily always better. Below are a few ways of evaluating your gene models after successive rounds of MAKER to identify when you have sound models.

A. Count the number of gene models and the gene lengths after each round.

cat <roundN.full.gff> | awk '{ if ($3 == "gene") print $0 }' | awk '{ sum += ($5 - $4) } END { print NR, sum / NR }'

B. Visualize the AED distribution. AED ranges from 0 to 1 and quantifies the confidence in a gene model based on empirical evidence. Basically, the lower the AED, the better a gene model is likely to be. Ideally, 95% or more of the gene models will have an AED of 0.5 or better in the case of good assemblies. You can use this AED_cdf_generator.pl script to help with this.

perl AED_cdf_generator.pl -b 0.025 <roundN.full.gff>

C. Run BUSCO one last time using the species Augustus HMM and take a look at the results (this will be quick since we are not training Augustus). Also, only include the transcript sequences (not the 1000 bp on each side) and be sure to take the best (i.e., longest) transcript for each gene so you aren't artificially seeding duplicates. You can also run it on the best protein sequence per gene instead. Your command will be some derivative of the following:

BUSCO.py -i <roundN.transcripts.fasta>  -o annotation_eval -l tetrapoda_odb9/ \
  -m transcriptome -c 8 -sp Boa_constrictor -z --augustus_parameters='--progress=true'

D. Visualize the gene models from Augustus, SNAP, and MAKER using a genome browser. JBrowse is a good option for this. You can essentially follow this guide to get this started. A helpful resource is this gff2jbrowse.pl script, which automates adding tracks to the browser based on the GFF output of your MAKER run. It is best to use 5-10 longer, gene dense scaffolds and visually inspect them. When SNAP and Augustus are well trained, their models should overlap pretty closely with the final MAKER models. Moreover, there will be spurious hits from SNAP and Augustus, but they are usually short, 1-2 exon annotations and don't have empirical support. You'll get a sense of a good annotation with some experience. Also, it is possible SNAP won't produce good results, depending on your organism, which the MAKER folks have pointed out in the past (Augustus usually does pretty well).

7. Downstream Processing and Homology Inference

After running MAKER one now has protein models, but that isn't all together very useful. First, the MAKER default names are long, ugly, and likely difficult for programs to parse. Moreover, even if they were named "gene1", etc. that doesn't tell you anything about what the genes actually are. Therefore, it is necessary to do some downstream processing of the MAKER output and to use homology searches against existing databases to annotate more functional information about genes.

A. First, let's rename the IDs that MAKER sets by default for genes and transcripts. MAKER comes with some scripts to do just this and to swap them out in the GFF and FASTA output (instructions for generated are above). The commands below first create custom IDs and store them as a table, and then use that table to rename the original GFF and FASTA files (they are overwritten, but it is possible to regenerate the raw ones again).

# create naming table (there are additional options for naming beyond defaults)
maker_map_ids --prefix BoaCon --justify 5  Bcon_rnd3.all.maker.gff > Bcon_rnd3.all.maker.name.map
# replace names in GFF files
map_gff_ids Bcon_rnd3.all.maker.name.map Bcon_rnd3.all.maker.gff
map_gff_ids Bcon_rnd3.all.maker.name.map Bcon_rnd3.all.maker.noseq.gff
# replace names in FASTA headers
map_fasta_ids Bcon_rnd3.all.maker.name.map Bcon_rnd3.all.maker.transcripts.fasta
map_fasta_ids Bcon_rnd3.all.maker.name.map Bcon_rnd3.all.maker.proteins.fasta
@ckeeling
Copy link

ckeeling commented Mar 28, 2018

Thanks for writing about this process. On the second line of code, I think:
RepeatModeler -pa 8 -engine ncbi Boa_constrictor 2>&1 | tee repeatmodeler.log
should be:
RepeatModeler -pa 8 -engine ncbi -database Boa_constrictor 2>&1 | tee repeatmodeler.log

@Toral-Manvar
Copy link

Thank you very much darencard. Without this post, it was not possible for me to run maker so smoothly.

@darencard
Copy link
Author

Sorry @lakhujanivijay I haven't been monitoring this gist much. If they are quick changes/corrections, you can just post another comment. If more detailed, you should be able to fork the gist and modify. There is apparently no way to submit a pull request, but you can point me to any changes you have and I can manually update my gist accordingly.

And thanks for catching that mistake @ckeeling.

@JonasBohn
Copy link

Hey, I´m busy with Genome annotation using MAKER and GeMoMa of an Ant genome and I want to get a detailed repeat annotation. So I followed this Guide and did RepeatModeler analysis based on my assembly and now I want to merge classified fasta files (generated by using RepeatClassifier from RepeatModeler for predicted TE fasta file from REPET and the hymenoptera fasta from Repbase). I want to merge my TE prediction, the output of RepeatModeler, and the classified hymenoptera fasta file from Repbase. I merged this files and run RepeatMasker with this DB over a test dataset with -lib option (This gives me not the classified repeat annotation). But you used the -species option which is not working because RepeatMasker do not accept my fasta file in this option. Is there a trick to do RepeatMasking with -species option with custom fasta file like you did?

Thanks for the answers.

Regards,
Jonas

@alexdthomas
Copy link

Thanks for the example of how you use Maker and setup the config file. I'm a little confused why you parse the Maker gff file into Bcon_rnd1.all.maker.est2genome.gff, Bcon_rnd1.all.maker.protein2genome.gff, and Bcon_rnd1.all.maker.repeats.gff to assign to est2genome, protein2genome, and rm_gff instead of using the convenience section #-----Re-annotation Using MAKER Derived GFF3 to provide the Maker gff and simply set est_pass=1, protein_pass=1, and rm_pass=1. This seems to be clearly documented in the below reference, but maybe I am missing something... Campbell MS, Holt C, Moore B, Yandell M (2014) Genome Annotation and Curation Using MAKER and MAKER-P, Vol. 2014. 4.11.1-4.11.39 p.

@alslonik
Copy link

@alexdthomas, exactly what I thought and Maker just ignored it for some reason. It did not when I put the parsed est2genome sections into the option file. Not sure what the reason is, but it works this way and does not work the other one.

@ShaowenJ
Copy link

Hi @darencard, this is a very good post! Many thanks for creating this. I am trying to use MAKER for annotating a new assembly mouse genome from our lab, and your post helps me a lot. But I have some questions hope you don't mind to explain. What's the function of running the initial maker?
And how's necessary to use the protein amino acids from the relative species?
Thanks for any answer.

@pkfsantos
Copy link

Thank you very much. Your post helped me a lot to understand about using and training Maker.

@olechnwin
Copy link

Anyone experience error when running RepeatModeler? Mine ran for ~ 11 days then died with the following error.

RepeatModeler Round # 5
========================
Searching for Repeats
 -- Sampling from the database...
   - Gathering up to 81000000 bp
 -- Running TRFMask on the sequence...
 -- Sample Stats:
       Sample Size 81039572 bp
       Num Contigs Represented = 1689
       Non ambiguous bp:
             Initial: 81039572 bp
             After Masking: 81039572 bp
             Masked: 0.00 % 
 -- Input Database Coverage: 120076855 bp out of 4340197656 bp ( 2.77 % )
Sampling Time: 00:05:39 (hh:mm:ss) Elapsed Time
Running all-by-other comparisons...
        0% completed,  03:25:18 (hh:mm:ss) est. time remaining.
        0% completed,  33:58:57 (hh:mm:ss) est. time remaining.
        :
       100% completed,  00:0:00 (hh:mm:ss) est. time remaining.
Comparison Time: 07:33:34 (hh:mm:ss) Elapsed Time, 794926613 HSPs Collected
  - RECON: Running imagespread..
RECON Elapsed: 00:26:24 (hh:mm:ss) Elapsed Time
  - RECON: Running initial definition of elements ( eledef )..
RECON Elapsed: 101:13:35 (hh:mm:ss) Elapsed Time
  - RECON: Running re-definition of elements ( eleredef )..
eleredef failed. Exit code 9

any idea? FYI, My genome is human.

@majogomezhughes
Copy link

Hi, I am having some problems when running maker and keep having this error:

#---------------------------------------------------------------------
Now starting the contig!!
SeqID: 1
Length: 14116249
#---------------------------------------------------------------------


flock: Function not implemented
--> rank=NA, hostname=node-19.local
 at /hpcfs/apps/maker/2.31.9/bin/../lib/Error.pm line 38.
	Error::_throw_Error_Simple(HASH(0x6118c88)) called at /hpcfs/apps/maker/2.31.9/bin/../lib/Error.pm line 306
	Error::subs::run_clauses(HASH(0x6131f60), "flock: Function not implemented\x{a}--> rank=NA, hostname=node-19"..., undef, ARRAY(0x6118028)) called at /hpcfs/apps/maker/2.31.9/bin/../lib/Error.pm line 42
6
	Error::subs::try(CODE(0x6130f00), HASH(0x6131f60)) called at /hpcfs/apps/maker/2.31.9/bin/../lib/FastaSeq.pm line 95
	FastaSeq::seq(FastaSeq=HASH(0x6130f60)) called at /hpcfs/apps/maker/2.31.9/bin/../lib/Process/MpiChunk.pm line 478
	Process::MpiChunk::_go(Process::MpiChunk=HASH(0x6118160), "run", HASH(0x61181d8), 0, 0) called at /hpcfs/apps/maker/2.31.9/bin/../lib/Process/MpiChunk.pm line 341
	Process::MpiChunk::run(Process::MpiChunk=HASH(0x6118160), 0) called at /hpcfs/apps/maker/2.31.9/bin/../lib/Process/MpiChunk.pm line 357
	Process::MpiChunk::run_all(Process::MpiChunk=HASH(0x6118160), 0) called at /hpcfs/apps/maker/2.31.9/bin/../lib/Process/MpiTiers.pm line 287
	Process::MpiTiers::run_all(Process::MpiTiers=HASH(0x60957d8), 0) called at /lustre/apps/maker/2.31.9/bin/maker line 683
flock: Function not implemented
--> rank=NA, hostname=node-19.local
--> rank=NA, hostname=node-19.local
--> rank=NA, hostname=node-19.local
ERROR: Failed while examining contents of the fasta file and run log
ERROR: Chunk failed at level:0, tier_type:0
FAILED CONTIG:1

examining contents of the fasta file and run log

On every contain, do you know what might be going on?

Thanks so much!!!

@ViriatoII
Copy link

ViriatoII commented Oct 18, 2019

Great tutorial, thank you very much! It's not finished, is it? There should be a point 8 as well??

@mason-lab
Copy link

This is so useful, thank you for taking the time to document your process.

@ptranvan
Copy link

Hi, Why have you changed your split_hit parameter for the 2nd round ?

@noor-albader
Copy link

Gret Tutorial! Quick Question:

have you ever encountered 0 values for every AED bin from running AED_cdf_generator.pl (except the last)?

Does anyone have any idea why that would be? Just to note my previous iteration of Maker output had a 92.6 for the 0.5 AED bin.

@davidecarlson
Copy link

Thanks for this great resource!

I just wanted to point out that the MAKER developers recommend against using Busco to train Augustus after the first round due to inherent biases present in using only highly conserved genes. More info here.

@noor-albader
Copy link

noor-albader commented Feb 3, 2020 via email

@ValentinaBoP
Copy link

Thank you so much for this tutorial! It made Maker much clearer. I don't think I would have been able to run Maker so smoothly without your help! :)

@Tdanis
Copy link

Tdanis commented Mar 20, 2020

Hello, @darencard thank you for your amazing tutorial. I have a question about the Snap training. I am trying this command "maker2zff pilon_rnd1.all.maker.gff3 " but the outputs *.ann and *.dna are empty>? Any idea what is going wrong? I am following your commands.

Thank you

@mattheatley
Copy link

mattheatley commented Jul 27, 2020

Awesome guide! I had one question about the training step though. In step 4 you use 'human' as the species when doing the initial training of Augustus via busco and then use 'Boa_constrictor' in step 5 when running maker. Only steps 4 and 5 need to be repeated when iteratively running maker but when repeating step 4 (to train Augustus via busco again) do you change the Augustus species to the new one ('Boa_constrictor') or keep it as the default ('human')? In other words would it be initial training: human, re-training 1: boa, re-training 2: boa or initial: human, re-training 1: human, re-training 2: human. The training sequences obviously vary here between rounds but I was less clear what to do for the species and am unclear how it affects the training/predictions.

@darencard
Copy link
Author

Sorry for the delayed reply, @mattheatley. I think in practice, you could use either human or some targeted species for any run of BUSCO for training. BUSCO will use the species that you designate for the initial BUSCO search and then will put together custom gene model parameters that are species specific. So for the purposes of training, I don't think it matters much whether you select human or any other (reasonable) species. It might lead to some differences in the BUSCOs identified if you use human vs. a certain species, but that is not really the goal of using the tool in this context. I don't have the files in front of me, but I think when I re-ran BUSCO, I specified Boa as the species. To say for sure whether there is an impact from this, you could run with both options and then do the gene annotation on a single, longer scaffold. Then you can compare the output GFFs using something like gffcompare.

@niconm89
Copy link

niconm89 commented Dec 17, 2020

Hi @darencard, thank you again for this great tutorial!

I'm reannotating a genome and having some problem with the repeat masking.
I constructed the repeat library using your tutorial this time (re-annotation) but last time I followed the MAKER Repeat Library Construction-Advanced. I'm having some troubles making MAKER works!

I have been trying to solve this by a couple of weeks and I have no idea how to fix this. I read this post where the problem seems to be related to the bioperl installation but I reinstall it by different ways (perl brew, conda, cpan, and by hand downloading the package) and nothing change. Another post Holt says that the problem is in the repeat gff file, probably because in the third column my file only has 'dispersed_repeat' and not match/match_part. I exactly followed your tutorial. Do you have any idea where the error can be found?

Bellow some lines of the gff3 file and log of maker.

Repeat GFF3:

##gff-version 3
##sequence-region Backbone_11 1 9531409
Backbone_11	RepeatMasker	dispersed_repeat	29	130	228	+	.	Target=rnd-6_family-13457 925 1026;ID=1
Backbone_11	RepeatMasker	dispersed_repeat	232	692	3604	-	.	Target=rnd-1_family-70 1 466;ID=2
Backbone_11	RepeatMasker	dispersed_repeat	685	964	2299	-	.	Target=rnd-1_family-70 1670 1949;ID=3
Backbone_11	RepeatMasker	dispersed_repeat	1045	1592	4381	-	.	Target=rnd-1_family-70 1119 1669;ID=4
Backbone_11	RepeatMasker	dispersed_repeat	1690	1960	6708	-	.	Target=rnd-1_family-70 1260 1662;ID=5
Backbone_11	RepeatMasker	dispersed_repeat	2014	2857	6708	-	.	Target=rnd-1_family-70 1 1259;ID=6
Backbone_11	RepeatMasker	dispersed_repeat	2917	3275	5070	+	.	Target=rnd-1_family-82 1 361;ID=7
Backbone_11	RepeatMasker	dispersed_repeat	3313	3676	5070	+	.	Target=rnd-1_family-82 362 729;ID=8
Backbone_11	RepeatMasker	dispersed_repeat	3754	3802	235	+	.	Target=TAHRE 2173 2221;ID=9
Backbone_11	RepeatMasker	dispersed_repeat	3916	3997	549	+	.	Target=rnd-1_family-103 1 82;ID=10

MAKER Log File:

STATUS: Parsing control files...
STATUS: Processing and indexing input FASTA files...
STATUS: Setting up database for any GFF3 input...
A data structure will be created for you at:
/home/nmoreyra/Data/MAKER_test/Dbuz-jz3/D.buzzatii_jz3_v01.maker.output/D.buzzatii_jz3_v01_datastore

To access files for individual sequences use the datastore index:
/home/nmoreyra/Data/MAKER_test/Dbuz-jz3/D.buzzatii_jz3_v01.maker.output/D.buzzatii_jz3_v01_master_datastore_index.log

STATUS: Now running MAKER...
examining contents of the fasta file and run log



--Next Contig--

#---------------------------------------------------------------------
Now starting the contig!!
SeqID: scaffold1|size657019
Length: 657019
#---------------------------------------------------------------------


setting up GFF3 output and fasta chunks
doing repeat masking
doing blastx repeats
formating database...
#--------- command -------------#
Widget::formater:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/makeblastdb -dbtype prot -in /tmp/maker_dfhOnw/0/blastprep/te_proteins%2Efasta.mpi.10.0
#-------------------------------#
running  blast search.
#--------- command -------------#
Widget::blastx:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/blastx -db /tmp/maker_dfhOnw/te_proteins%2Efasta.mpi.10.0 -query /tmp/maker_dfhOnw/0/scaffold1%7Csize657019.0 -num_alignments 10000 -num_descriptions 10000 -evalue 1e-06 -dbsize 300 -searchsp 500000000 -num_threads 1 -seg yes -soft_masking true -lcase_masking -show_gis -out /home/nmoreyra/Data/MAKER_test/Dbuz-jz3/D.buzzatii_jz3_v01.maker.output/D.buzzatii_jz3_v01_datastore/FE/93/scaffold1%7Csize657019//theVoid.scaffold1%7Csize657019/0/scaffold1%7Csize657019.0.te_proteins%2Efasta.repeatrunner.temp_dir/te_proteins%2Efasta.mpi.10.0.repeatrunner
#-------------------------------#
deleted:0 hits
doing blastx repeats
formating database...
#--------- command -------------#
Widget::formater:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/makeblastdb -dbtype prot -in /tmp/maker_dfhOnw/0/blastprep/te_proteins%2Efasta.mpi.10.1
#-------------------------------#
running  blast search.
#--------- command -------------#
Widget::blastx:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/blastx -db /tmp/maker_dfhOnw/te_proteins%2Efasta.mpi.10.1 -query /tmp/maker_dfhOnw/0/scaffold1%7Csize657019.0 -num_alignments 10000 -num_descriptions 10000 -evalue 1e-06 -dbsize 300 -searchsp 500000000 -num_threads 1 -seg yes -soft_masking true -lcase_masking -show_gis -out /home/nmoreyra/Data/MAKER_test/Dbuz-jz3/D.buzzatii_jz3_v01.maker.output/D.buzzatii_jz3_v01_datastore/FE/93/scaffold1%7Csize657019//theVoid.scaffold1%7Csize657019/0/scaffold1%7Csize657019.0.te_proteins%2Efasta.repeatrunner.temp_dir/te_proteins%2Efasta.mpi.10.1.repeatrunner
#-------------------------------#
deleted:0 hits
doing blastx repeats
formating database...
#--------- command -------------#
Widget::formater:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/makeblastdb -dbtype prot -in /tmp/maker_dfhOnw/0/blastprep/te_proteins%2Efasta.mpi.10.2
#-------------------------------#
running  blast search.
#--------- command -------------#
Widget::blastx:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/blastx -db /tmp/maker_dfhOnw/te_proteins%2Efasta.mpi.10.2 -query /tmp/maker_dfhOnw/0/scaffold1%7Csize657019.0 -num_alignments 10000 -num_descriptions 10000 -evalue 1e-06 -dbsize 300 -searchsp 500000000 -num_threads 1 -seg yes -soft_masking true -lcase_masking -show_gis -out /home/nmoreyra/Data/MAKER_test/Dbuz-jz3/D.buzzatii_jz3_v01.maker.output/D.buzzatii_jz3_v01_datastore/FE/93/scaffold1%7Csize657019//theVoid.scaffold1%7Csize657019/0/scaffold1%7Csize657019.0.te_proteins%2Efasta.repeatrunner.temp_dir/te_proteins%2Efasta.mpi.10.2.repeatrunner
#-------------------------------#
deleted:0 hits
doing blastx repeats
formating database...
#--------- command -------------#
Widget::formater:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/makeblastdb -dbtype prot -in /tmp/maker_dfhOnw/0/blastprep/te_proteins%2Efasta.mpi.10.3
#-------------------------------#
running  blast search.
#--------- command -------------#
Widget::blastx:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/blastx -db /tmp/maker_dfhOnw/te_proteins%2Efasta.mpi.10.3 -query /tmp/maker_dfhOnw/0/scaffold1%7Csize657019.0 -num_alignments 10000 -num_descriptions 10000 -evalue 1e-06 -dbsize 300 -searchsp 500000000 -num_threads 1 -seg yes -soft_masking true -lcase_masking -show_gis -out /home/nmoreyra/Data/MAKER_test/Dbuz-jz3/D.buzzatii_jz3_v01.maker.output/D.buzzatii_jz3_v01_datastore/FE/93/scaffold1%7Csize657019//theVoid.scaffold1%7Csize657019/0/scaffold1%7Csize657019.0.te_proteins%2Efasta.repeatrunner.temp_dir/te_proteins%2Efasta.mpi.10.3.repeatrunner
#-------------------------------#
deleted:0 hits
doing blastx repeats
formating database...
#--------- command -------------#
Widget::formater:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/makeblastdb -dbtype prot -in /tmp/maker_dfhOnw/0/blastprep/te_proteins%2Efasta.mpi.10.4
#-------------------------------#
running  blast search.
#--------- command -------------#
Widget::blastx:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/blastx -db /tmp/maker_dfhOnw/te_proteins%2Efasta.mpi.10.4 -query /tmp/maker_dfhOnw/0/scaffold1%7Csize657019.0 -num_alignments 10000 -num_descriptions 10000 -evalue 1e-06 -dbsize 300 -searchsp 500000000 -num_threads 1 -seg yes -soft_masking true -lcase_masking -show_gis -out /home/nmoreyra/Data/MAKER_test/Dbuz-jz3/D.buzzatii_jz3_v01.maker.output/D.buzzatii_jz3_v01_datastore/FE/93/scaffold1%7Csize657019//theVoid.scaffold1%7Csize657019/0/scaffold1%7Csize657019.0.te_proteins%2Efasta.repeatrunner.temp_dir/te_proteins%2Efasta.mpi.10.4.repeatrunner
#-------------------------------#
deleted:0 hits
doing blastx repeats
formating database...
#--------- command -------------#
Widget::formater:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/makeblastdb -dbtype prot -in /tmp/maker_dfhOnw/0/blastprep/te_proteins%2Efasta.mpi.10.5
#-------------------------------#
running  blast search.
#--------- command -------------#
Widget::blastx:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/blastx -db /tmp/maker_dfhOnw/te_proteins%2Efasta.mpi.10.5 -query /tmp/maker_dfhOnw/0/scaffold1%7Csize657019.0 -num_alignments 10000 -num_descriptions 10000 -evalue 1e-06 -dbsize 300 -searchsp 500000000 -num_threads 1 -seg yes -soft_masking true -lcase_masking -show_gis -out /home/nmoreyra/Data/MAKER_test/Dbuz-jz3/D.buzzatii_jz3_v01.maker.output/D.buzzatii_jz3_v01_datastore/FE/93/scaffold1%7Csize657019//theVoid.scaffold1%7Csize657019/0/scaffold1%7Csize657019.0.te_proteins%2Efasta.repeatrunner.temp_dir/te_proteins%2Efasta.mpi.10.5.repeatrunner
#-------------------------------#
deleted:0 hits
doing blastx repeats
formating database...
#--------- command -------------#
Widget::formater:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/makeblastdb -dbtype prot -in /tmp/maker_dfhOnw/0/blastprep/te_proteins%2Efasta.mpi.10.6
#-------------------------------#
running  blast search.
#--------- command -------------#
Widget::blastx:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/blastx -db /tmp/maker_dfhOnw/te_proteins%2Efasta.mpi.10.6 -query /tmp/maker_dfhOnw/0/scaffold1%7Csize657019.0 -num_alignments 10000 -num_descriptions 10000 -evalue 1e-06 -dbsize 300 -searchsp 500000000 -num_threads 1 -seg yes -soft_masking true -lcase_masking -show_gis -out /home/nmoreyra/Data/MAKER_test/Dbuz-jz3/D.buzzatii_jz3_v01.maker.output/D.buzzatii_jz3_v01_datastore/FE/93/scaffold1%7Csize657019//theVoid.scaffold1%7Csize657019/0/scaffold1%7Csize657019.0.te_proteins%2Efasta.repeatrunner.temp_dir/te_proteins%2Efasta.mpi.10.6.repeatrunner
#-------------------------------#
deleted:0 hits
doing blastx repeats
formating database...
#--------- command -------------#
Widget::formater:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/makeblastdb -dbtype prot -in /tmp/maker_dfhOnw/0/blastprep/te_proteins%2Efasta.mpi.10.7
#-------------------------------#
running  blast search.
#--------- command -------------#
Widget::blastx:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/blastx -db /tmp/maker_dfhOnw/te_proteins%2Efasta.mpi.10.7 -query /tmp/maker_dfhOnw/0/scaffold1%7Csize657019.0 -num_alignments 10000 -num_descriptions 10000 -evalue 1e-06 -dbsize 300 -searchsp 500000000 -num_threads 1 -seg yes -soft_masking true -lcase_masking -show_gis -out /home/nmoreyra/Data/MAKER_test/Dbuz-jz3/D.buzzatii_jz3_v01.maker.output/D.buzzatii_jz3_v01_datastore/FE/93/scaffold1%7Csize657019//theVoid.scaffold1%7Csize657019/0/scaffold1%7Csize657019.0.te_proteins%2Efasta.repeatrunner.temp_dir/te_proteins%2Efasta.mpi.10.7.repeatrunner
#-------------------------------#
deleted:0 hits
doing blastx repeats
formating database...
#--------- command -------------#
Widget::formater:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/makeblastdb -dbtype prot -in /tmp/maker_dfhOnw/0/blastprep/te_proteins%2Efasta.mpi.10.8
#-------------------------------#
running  blast search.
#--------- command -------------#
Widget::blastx:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/blastx -db /tmp/maker_dfhOnw/te_proteins%2Efasta.mpi.10.8 -query /tmp/maker_dfhOnw/0/scaffold1%7Csize657019.0 -num_alignments 10000 -num_descriptions 10000 -evalue 1e-06 -dbsize 300 -searchsp 500000000 -num_threads 1 -seg yes -soft_masking true -lcase_masking -show_gis -out /home/nmoreyra/Data/MAKER_test/Dbuz-jz3/D.buzzatii_jz3_v01.maker.output/D.buzzatii_jz3_v01_datastore/FE/93/scaffold1%7Csize657019//theVoid.scaffold1%7Csize657019/0/scaffold1%7Csize657019.0.te_proteins%2Efasta.repeatrunner.temp_dir/te_proteins%2Efasta.mpi.10.8.repeatrunner
#-------------------------------#
deleted:0 hits
doing blastx repeats
formating database...
#--------- command -------------#
Widget::formater:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/makeblastdb -dbtype prot -in /tmp/maker_dfhOnw/0/blastprep/te_proteins%2Efasta.mpi.10.9
#-------------------------------#
running  blast search.
#--------- command -------------#
Widget::blastx:
/home/nmoreyra/Software/miniconda3/envs/MAKER/bin/blastx -db /tmp/maker_dfhOnw/te_proteins%2Efasta.mpi.10.9 -query /tmp/maker_dfhOnw/0/scaffold1%7Csize657019.0 -num_alignments 10000 -num_descriptions 10000 -evalue 1e-06 -dbsize 300 -searchsp 500000000 -num_threads 1 -seg yes -soft_masking true -lcase_masking -show_gis -out /home/nmoreyra/Data/MAKER_test/Dbuz-jz3/D.buzzatii_jz3_v01.maker.output/D.buzzatii_jz3_v01_datastore/FE/93/scaffold1%7Csize657019//theVoid.scaffold1%7Csize657019/0/scaffold1%7Csize657019.0.te_proteins%2Efasta.repeatrunner.temp_dir/te_proteins%2Efasta.mpi.10.9.repeatrunner
#-------------------------------#
deleted:0 hits
collecting blastx repeatmasking
processing all repeats
doing repeat masking

------------- EXCEPTION: Bio::Root::Exception -------------
MSG: Did not specify a Hit End or Hit Begin
STACK: Error::throw
STACK: Bio::Root::Root::throw /home/nmoreyra/Software/miniconda3/envs/orthomcl/lib/perl5/site_perl/5.22.0/Bio/Root/Root.pm:449
STACK: Bio::Search::HSP::GenericHSP::_subject_seq_feature /home/nmoreyra/Software/miniconda3/envs/orthomcl/lib/perl5/site_perl/5.22.0/Bio/Search/HSP/GenericHSP.pm:1603
STACK: Bio::Search::HSP::GenericHSP::hit /home/nmoreyra/Software/miniconda3/envs/orthomcl/lib/perl5/site_perl/5.22.0/Bio/Search/HSP/GenericHSP.pm:987
STACK: repeat_mask_seq::separate_types /home/nmoreyra/Software/maker2/bin/../lib/repeat_mask_seq.pm:307
STACK: repeat_mask_seq::mask_chunk /home/nmoreyra/Software/maker2/bin/../lib/repeat_mask_seq.pm:191
STACK: Process::MpiChunk::_go /home/nmoreyra/Software/maker2/bin/../lib/Process/MpiChunk.pm:763
STACK: Process::MpiChunk::run /home/nmoreyra/Software/maker2/bin/../lib/Process/MpiChunk.pm:341
STACK: Process::MpiChunk::run_all /home/nmoreyra/Software/maker2/bin/../lib/Process/MpiChunk.pm:357
STACK: Process::MpiTiers::run_all /home/nmoreyra/Software/maker2/bin/../lib/Process/MpiTiers.pm:287
STACK: Process::MpiTiers::run_all /home/nmoreyra/Software/maker2/bin/../lib/Process/MpiTiers.pm:287
STACK: /home/nmoreyra/Software/maker2/bin/maker:683
-----------------------------------------------------------
--> rank=NA, hostname=andromeda
ERROR: Failed while doing repeat masking
ERROR: Chunk failed at level:0, tier_type:1
FAILED CONTIG:scaffold1|size657019

ERROR: Chunk failed at level:2, tier_type:0
FAILED CONTIG:scaffold1|size657019

examining contents of the fasta file and run log



--Next Contig--

#---------------------------------------------------------------------
Now starting the contig!!
SeqID: scaffold2|size426038
Length: 426038

@cheehowteo
Copy link

Thank you very much darencard for this nice post. I managed to run second round of MAKER with SNAP and Augustus parameters suggested in your post. However, when I was preparing datasets for third round of MAKER using results from the second round, I ended up with empty est2genome.gff and protein2genome.gff. I tried to run the fourth round of MAKER with these empty gffs, I ended up with empty genome.ann and genome.dna. I do not know what is wrong with my run since I followed the steps and repeat the step 4 and 5 of your post? Can you please kindly advise me on this?
Thank you,
Teo

@ttian627
Copy link

ttian627 commented Mar 8, 2021

you can try to change the "==" to "~", it will not empty at est2genome.gff and protein2genome.gff file.

@niconm89
Copy link

niconm89 commented Mar 8, 2021

you can try to change the "==" to "~", it will not empty at est2genome.gff and protein2genome.gff file.

Yes, that happened to me because the third column has a "protein_gff:" prefix and the same for ESTs.

@xiangboabc
Copy link

I used Marker to annotation maize genome. But the software was run for 5days and have not finished, why?

run pipeline: "maker -cpus 100 -base ky88_annotationCPU100"

Thank you

opt file:
#-----Genome (these are always required)
genome=/public/zhxiangbo/sweet_corn/Repeatmask/repeatkmast/ky88_ref_genome.fa.masked #genome sequence (fasta file or fasta embeded in GFF3 file)
organism_type=eukaryotic #eukaryotic or prokaryotic. Default is eukaryotic

#-----Re-annotation Using MAKER Derived GFF3
maker_gff= #MAKER derived GFF3 file
est_pass=0 #use ESTs in maker_gff: 1 = yes, 0 = no
altest_pass=0 #use alternate organism ESTs in maker_gff: 1 = yes, 0 = no
protein_pass=0 #use protein alignments in maker_gff: 1 = yes, 0 = no
rm_pass=0 #use repeats in maker_gff: 1 = yes, 0 = no
model_pass=0 #use gene models in maker_gff: 1 = yes, 0 = no
pred_pass=0 #use ab-initio predictions in maker_gff: 1 = yes, 0 = no
other_pass=0 #passthrough anyything else in maker_gff: 1 = yes, 0 = no

#-----EST Evidence (for best results provide a file for at least one)
est=/public/zhxiangbo/sweet_corn/RNA-seq/All_EST.fasta #set of ESTs or assembled mRNA-seq in fasta format
altest= #EST/cDNA sequence file in fasta format from an alternate organism
est_gff= #aligned ESTs or mRNA-seq from an external GFF3 file
altest_gff= #aligned ESTs from a closly relate species in GFF3 format

#-----Protein Homology Evidence (for best results provide a file for at least one)
protein=/public/zhxiangbo/common_file/protein_database/All_species_pretein.fasta #protein sequence file in fasta format (i.e. from mutiple organisms)
protein_gff= #aligned protein homology evidence from an external GFF3 file

#-----Repeat Masking (leave values blank to skip repeat masking)
model_org= #select a model organism for RepBase masking in RepeatMasker
rmlib= #provide an organism specific repeat library in fasta format for RepeatMasker
repeat_protein= #provide a fasta file of transposable element proteins for RepeatRunner
rm_gff= #pre-identified repeat elements from an external GFF3 file
prok_rm=0 #forces MAKER to repeatmask prokaryotes (no reason to change this), 1 = yes, 0 = no
softmask=1 #use soft-masking rather than hard-masking in BLAST (i.e. seg and dust filtering)

#-----Gene Prediction
snaphmm= #SNAP HMM file
gmhmm= #GeneMark HMM file
augustus_species= #Augustus gene prediction species model
fgenesh_par_file= #FGENESH parameter file
pred_gff= #ab-initio predictions from an external GFF3 file
model_gff= #annotated gene models from an external GFF3 file (annotation pass-through)
run_evm=0 #run EvidenceModeler, 1 = yes, 0 = no
est2genome=1 #infer gene predictions directly from ESTs, 1 = yes, 0 = no
protein2genome=1 #infer predictions from protein homology, 1 = yes, 0 = no
trna=0 #find tRNAs with tRNAscan, 1 = yes, 0 = no
snoscan_rrna= #rRNA file to have Snoscan find snoRNAs
snoscan_meth= #-O-methylation site fileto have Snoscan find snoRNAs
unmask=0 #also run ab-initio prediction programs on unmasked sequence, 1 = yes, 0 = no
allow_overlap= #allowed gene overlap fraction (value from 0 to 1, blank for default)

#-----Other Annotation Feature Types (features MAKER doesn't recognize)
other_gff= #extra features to pass-through to final MAKER generated GFF3 file

#-----External Application Behavior Options
alt_peptide=C #amino acid used to replace non-standard amino acids in BLAST databases
cpus=100 #max number of cpus to use in BLAST and RepeatMasker (not for MPI, leave 1 when using MPI)

#-----MAKER Behavior Options
max_dna_len=100000 #length for dividing up contigs into chunks (increases/decreases memory usage)
min_contig=1 #skip genome contigs below this length (under 10kb are often useless)

pred_flank=200 #flank for extending evidence clusters sent to gene predictors
pred_stats=0 #report AED and QI statistics for all predictions as well as models
AED_threshold=1 #Maximum Annotation Edit Distance allowed (bound by 0 and 1)
min_protein=0 #require at least this many amino acids in predicted proteins
alt_splice=0 #Take extra steps to try and find alternative splicing, 1 = yes, 0 = no
always_complete=0 #extra steps to force start and stop codons, 1 = yes, 0 = no
map_forward=0 #map names and attributes forward from old GFF3 genes, 1 = yes, 0 = no
keep_preds=0 #Concordance threshold to add unsupported gene prediction (bound by 0 and 1)

split_hit=10000 #length for the splitting of hits (expected max intron size for evidence alignments)
min_intron=20 #minimum intron length (used for alignment polishing)
single_exon=0 #consider single exon EST evidence when generating annotations, 1 = yes, 0 = no
single_length=250 #min length required for single exon ESTs if 'single_exon is enabled'
correct_est_fusion=0 #limits use of ESTs in annotation to avoid fusion genes

tries=2 #number of times to try a contig if there is a failure for some reason
clean_try=0 #remove all data from previous run before retrying, 1 = yes, 0 = no
clean_up=0 #removes theVoid directory with individual analysis files, 1 = yes, 0 = no
TMP= #specify a directory other than the system default temporary directory for temporary files

@xiangboabc
Copy link

I configure "mpicc2", but have some error when type "./Build"
Can you help me?

Configuring MAKER with MPI support
^Cmake: *** [pm_to_blib] Interrupt

A problem was encountered while attempting to compile and install your Inline
C code. The command that failed was:
"make > out.make 2>&1" with error code 0

The build directory was:
/public/zhxiangbo/software/maker/src/blib/build/Parallel/Application/MPI

To debug the problem, cd to the build directory, and inspect the output files.

Environment PATH = '/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin/:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin/:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin/:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/public/zhxiangbo/software/openmpi-4.1.1/bin/:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin/:/usr/local/Modules/bin:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin/:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin/:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin/:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/public/zhxiangbo/software/openmpi-4.1.1/bin/:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/openmpi-4.1.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/openmpi-4.1.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/openmpi-4.1.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/public/zhxiangbo/software/openmpi-4.1.1/bin/:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/openmpi-4.1.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/openmpi-4.1.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/openmpi-4.1.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/public/zhxiangbo/software/openmpi-4.1.1/bin/:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/openmpi-4.1.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/openmpi-4.1.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/openmpi-4.1.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/public/zhxiangbo/software/openmpi-4.1.1/bin/:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/gmap-2021-03-08/bin:/public/zhxiangbo/software/fasta-36.1.1/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin/:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin/:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/ab-blast-20200317-linux-x64:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/ab-blast-20200317-linux-x64:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin/:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/ab-blast-20200317-linux-x64:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin/:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/ab-blast-20200317-linux-x64:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1//bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas/:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/bin:/home/zhxiangbo/anaconda3/bin:/public/zhxiangbo/software/RepeatMasker:/public/zhxiangbo/software/eggnog-mapper-2.1.2:/public/zhxiangbo/software/eggnog-mapper-2.1.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4:/public/zhangxiangbo/software/anaconda3/bin:/public/zhangxiangbo/software/anaconda3/bin:/public/zhxiangbo/software/ParaFly-master/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/public/zhxiangbo/software/R-3.6.1/bin:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/public/zhxiangbo/software/kobas:/public/zhxiangbo/software/salmon/bin:/public/zhxiangbo/software/maker/bin:/home/zhxiangbo/anaconda2/condabin:/home/zhxiangbo/anaconda3/bin:/opt/curl-7.57.0/bin:/public/zhxiangbo/software/jdk-11.0.8/bin:/BiO/gridengine/bin:/BiO/gridengine/bin/lx-amd64:/usr/local/bin:/usr/bin:/usr/local/sbin:/usr/sbin:/home/gosadmin/gos-1.0/program/bin:/home/gosadmin/gos-1.0/program/sbin:/home/gosadmin/gos-1.0/tools/base_tools/analytics_engine/spark-2.1.1-bin-hadoop2.7/bin:/home/gosadmin/gos-1.0/program/sbin/gos:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/ab-blast-20200317-linux-x64:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/gatk-4.1.4.1:/home/zhxiangbo/.local/bin:/home/zhxiangbo/bin:/public/zhxiangbo/software/STAR-2.7.7a/source/:/public/zhxiangbo/software/kobas/src:/public/zhxiangbo/gatk-4.1.4.1:/public/zhxiangbo/software/curl-7.47.1/bin:/public/zhxiangbo/software/samtools-1.9:/public/zhxiangbo/software/bedtools2/bin:/public/zhxiangbo/software:/public/zhxiangbo/software/TRF-master/build/src:/public/zhxiangbo/software/rmblast-2.11.0/bin:/public/zhxiangbo/software/cmake-3.9.2/bin:/home/zhxiangbo/anaconda2/bin/:/public/zhxiangbo/software/blast-2.2.21/bin:/public/zhxiangbo/software/RAPSearch2.24_64bits/bin:/public/zhxiangbo/software/genemark_hmm_euk_linux_64/ehmm:/public/zhxiangbo/software/EVidenceModeler-1.1.1:/public/zhxiangbo/software/tRNAscan-SE-master/bin'
at /public/zhxiangbo/software/maker/src/../perl/lib/Parallel/Application/MPI.pm line 236.
...propagated at /home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/lib/site_perl/5.33.4/Inline/C.pm line 888.
at /public/zhxiangbo/software/maker/src/../perl/lib/Parallel/Application/MPI.pm line 256.
Parallel::Application::MPI::_bind("/public/zhxiangbo/software/mpich2-1.5-install/bin/mpicc", "/public/zhxiangbo/software/mpich2-1.5-install/include", "blib", "") called at /public/zhxiangbo/software/maker/src/inc/lib/MAKER/Build.pm line 279
MAKER::Build::ACTION_build(MAKER::Build=HASH(0x36eebb0)) called at /home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/lib/site_perl/5.33.4/Module/Build/Base.pm line 2020
Module::Build::Base::_call_action(MAKER::Build=HASH(0x36eebb0), "build") called at /home/zhxiangbo/perl5/perlbrew/perls/perl-5.33.4/lib/site_perl/5.33.4/Module/Build/Base.pm line 2008
Module::Build::Base::dispatch(MAKER::Build=HASH(0x36eebb0)) called at ./Build line 63

@darencard
Copy link
Author

Questions about installing Maker and runtime errors fall under the purview of the Maker developers/maintainers, so I would reach out to them with these types of issues. They have a pretty active user group that you can post to for help, though make sure your question has not already been addressed.

@dongzhang0725
Copy link

Recently I am annotating a cestode genome, but encountered two major problems:

  1. RepeatMasker error, 3 cases: A. when I set model_org as simple or null, and set the result of RepeatModeler to rmlib, it can run successfully; B. when I set model_org as all, I get "RepeatMasker error"; C. when I specify the GFF file generated by RepeatMasker in rm_gff parameter, and set model_org as null, I get "Issuing rollback() due to DESTROY without explicit disconnect() of DBD::SQLite::db handle dbname=path/to//MAKER1.maker.output/MAKER1.db at /usr/local/bin/../lib/Error.pm line 184". Do you know what happened to my RepeatMasker?

  2. GeneMark error: when I specify "gmhmm.mod" file to "gmhmm" parameter, I get "ERROR: Genemark failed \n ERROR: Failed while preparing ab-inits \n ERROR: Chunk failed at level:0, tier_type:2 \n FAILED CONTIG:ctg000560". I can't find any file that can guide me to debug, I can find the related folder for the contig ctg000560 (theVoid.ctg000560), but I don't know what command can I use to debug. Could you plese help me for this?

Could you plese help me with this?
Thank you for your kind help in advance.

@Olivier144
Copy link

Hi Daren,

I have a first round of genome annotation from Maker.
I am trying to train Augustus by following your pipeline.
I have tried to tweak the awk command to perform the following task, but unfortunately

I would like to select CDs, keep genes with an AED 0.25, keep the longest isoform per mRNA, select Complete genes,
filter those genes by distance from neighbouring genes, and then remove redundancy and output the results in a fasta format.

Could you assist, kindly?

@Juke34
Copy link

Juke34 commented Aug 28, 2023

Hi @Olivier144, we have a Nextflow pipeline hat make the steps you are looking for, you can find it here: https://github.com/NBISweden/pipelines-nextflow/tree/master. The workflow to use is Abinitio Training, the different steps are described here (https://github.com/NBISweden/pipelines-nextflow/blob/master/subworkflows/abinitio_training/README.md).

Sign up for free to join this conversation on GitHub. Already have an account? Sign in to comment