IQ-Tree on XSEDE1.6.10Efficient phylogenomic software by maximum likelihood, run on XSEDEL.-T. Nguyen, H.A. Schmidt, A. von Haeseler, and B.Q. MinhL.-T. Nguyen, H.A. Schmidt, A. von Haeseler, and B.Q. Minh (2015) IQ-TREE: A fast and effective stochastic algorithm for estimating maximum likelihood phylogenies. Mol. Biol. Evol., 32:268-274.
DOI: 10.1093/molbev/msu300Phylogeny / Alignmentiqtree_xsedeiqtree_invoke2perl$which_iqtree eq "2"perl"iqtree_1.6.2_comet "0iqtree_invoke6perl$which_iqtree eq "6"perl"iqtree_1.6.6_comet "0iqtree_invoke7perl$which_iqtree eq "7"perl"iqtree_1.6.7_comet "0iqtree_invoke9perl$which_iqtree eq "9"perl"iqtree_1.6.9_comet "0iqtree_invoke10perl$which_iqtree eq "10"perl"iqtree_1.6.10_comet "0number_nodes12scheduler.confperl$specify_runtype == 1 && !$specify_autocores && $specify_numparts < 13 perl
"nodes=1\\n" .
"node_exclusive=0\\n" .
"threads_per_process=12\\n"
number_nodes1b2scheduler.confperl$specify_runtype == 1 && $specify_autocores perl
"nodes=1\\n" .
"node_exclusive=0\\n" .
"threads_per_process=24\\n"
number_nodes1d2scheduler.confperl$specify_runtype == 1 && !$specify_autocores && $specify_numparts > 12 perl
"nodes=1\\n" .
"node_exclusive=1\\n" .
"threads_per_process=24\\n"
number_nodes22scheduler.confperl$specify_runtype == 2 && $specify_numparts < 13 && $specify_numparts > 1perl
"nodes=1\\n" .
"node_exclusive=0\\n" .
"threads_per_process=12\\n"
number_nodes2b2scheduler.confperl$specify_runtype == 2 && $specify_numparts == 1 && $specify_mem < 60perl
"nodes=1\\n" .
"node_exclusive=0\\n" .
"threads_per_process=12\\n"
number_nodes2c2scheduler.confperl$specify_runtype == 2 && $specify_numparts == 1 && $specify_mem > 60perl
"nodes=1\\n" .
"node_exclusive=1\\n" .
"threads_per_process=24\\n"
number_nodes2d2scheduler.confperl$specify_runtype == 2 && $specify_numparts > 12 perl
"nodes=1\\n" .
"node_exclusive=1\\n" .
"threads_per_process=24\\n"
infileInput Alignmentinfile.txtperl"-s infile.txt"1runtime1scheduler.confMaximum Hours to Run (up to 168 hours)0.5The maximum hours to run must be less than 168perl$runtime > 168.0The maximum hours to run must be greater than 0.05perl$runtime < 0.05perl"runhours=$value\\n"The job will run on 12 processors as configured. If it runs for the entire configured time, it will consume 12 x $runtime cpu hoursperl$specify_runtype == 1 The job will run on 24 processors as configured. If it runs for the entire configured time, it will consume 24 x $runtime cpu hoursperl$specify_runtype == 2 && $specify_numparts > 12The job will run on 24 processors as configured. If it runs for the entire configured time, it will consume 24 x $runtime cpu hoursperl$specify_runtype == 2 && $specify_numparts == 1 && $specify_mem > 60The job will run on 12 processors as configured. If it runs for the entire configured time, it will consume 12 x $runtime cpu hoursperl$specify_runtype == 2 && $specify_numparts < 13 && !defined $specify_memThe job will run on 12 processors as configured. If it runs for the entire configured time, it will consume 12 x $runtime cpu hoursperl$specify_runtype == 2 && $specify_numparts == 1 && defined $specify_mem && $specify_mem < 60Estimate the maximum time your job will need to run. We recommend testing initially with a < 0.5hr test run because Jobs set for 0.5 h or less depedendably run immediately in the "debug" queue.
Once you are sure the configuration is correct, you then increase the time. The reason is that jobs > 0.5 h are submitted to the "normal" queue, where jobs configured for 1 or a few hours times may
run sooner than jobs configured for the full 168 hours.
which_iqtreeWhich version do you want to run26791010specify_numpartsHow many partitions does your data set havePlease specify the number of partitionsperl!defined $specify_numpartsThe number of partitions must be greater than zeroperl$specify_numparts < 1Please specify the number of partitionsperl!defined $specify_numpartsspecify_memMemory required (in GB)perl$specify_runtype == 2 && $specify_numparts == 1The run will not complete if -mem is greater than 120 GB, please contact usperl$specify_mem > 120specify_twelvecoresperl$specify_runtype == 1 && !$specify_autocoresperl"-nt 12"3specify_autocoresAutomatically select number of threadsperl$specify_runtype == 1perl($value) ? "-nt AUTO":""3specify_cores3perl$specify_runtype == 2perl"-nt AUTO"3specify_cores4perl$specify_runtype == 2 && defined $specify_mem && !defined $partition_fileperl"-mem $specify_mem$specify_g"4specify_gperl$specify_runtype == 2 && defined $specify_mem Gspecify_runtypeSelect the kind of run you need12Please specify whether the run is for Tree inference or Model Selectionperl!defined $value 3sequence_typeSpecify your sequence type (-st)perl!$mixed_sequenceperl($value ne "CODON" && $value ne "NT2AA") ? "-st $value":""DNAAABINMORPHCODONNT2AADNA1codon_typeSpecify your Codon typeperl$sequence_type eq "CODON"perl"-st $value"CODON1CODON2CODON3CODON4CODON5CODON6CODON9CODON10CODON11CODON12CODON13CODON14CODON16CODON21CODON22CODON23CODON24CODON25CODON13nt2aa_typeSpecify your translation tableperl$sequence_type eq "NT2AA"perl"-st $value"NT2AA1NT2AA2NT2AA3NT2AA4NT2AA5NT2AA6NT2AA9NT2AA10NT2AA11NT2AA12NT2AA13NT2AA14NT2AA16NT2AA21NT2AA22NT2AA23NT2AA24NT2AA25NT2AA13partition_typePlease specify your partition type-q-spp-spperl(defined $value) ? "$partition_type partition.txt":""Please select a partition fileperldefined $partition_type && !defined $partition_file Sorry, a bug in this version will prevent the use of -sp with a partiton file, please use the -spp optionperl$partition_type eq "-sp" && $use_bnni && $which_iqtree <= 9 partition_filePlease select your partition fileperldefined $partition_typepartition.txtmixed_sequenceI want to mix data types in a partitioned analysisperldefined $partition_type0num_mixedsequencesHow many data types (files) in your partitioned analysisperl$mixed_sequence2345datatype2_fileSelect the file with your second datatype (partition_datatype2.phy)perl$num_mixedsequences > 1 partition_datatype2.phydatatype3_fileSelect the file with your third datatype (partition_datatype3.phy)perl$num_mixedsequences > 2 partition_datatype3.phydatatype4_fileSelect the file with your fourth datatype (partition_datatype4.phy)perl$num_mixedsequences > 3 partition_datatype4.phydatatype5_fileSelect the file with your fifth datatype (partition_datatype5.phy)perl$num_mixedsequences > 4 partition_datatype5.phystarting_treeSpecify a starting (or other) tree file (-t)treefile.treperl(defined $value) ? "-t treefile.tre":""3use_njUse a NJ starting tree (-t BIONJ)perl!defined $starting_treeperl($value) ? "-t BIONJ":"" Sorry, you cannot choose both a random and a NJ starting treeperl$use_nj && $use_random3use_randomUse a Random starting tree (-t RANDOM) perl!defined $starting_treeperl($value) ? "-t RANDOM":""3specify_outgroupSpecify the outgroup (-o)perl(defined $value) ? "-o $value":""3specify_prefixSpecify the prefix for output files (-pre)perl(defined $value) ? "-pre $value":""output3specify_seedSpecify the seed (-seed)perl(defined $value) ? "-seed $value":""3specify_quartetsSpecify number of quartets (-lmap)perl(defined $value) ? "-lmap $value":""3model_selectionAutomatic Model Selection Parametersspecify_modelTest for the best model (-m TEST)perl$specify_runtype == 1TESTONLYTESTTESTNEWONLYTESTNEWTESTMERGEONLYTESTMERGETESTNEWMERGEONLYTESTNEWMERGEperl(defined $value) ? "-m $value":""3specify_rclusterSpecify the percentage for relaxed clustering algorithm (-rcluster)perl$specify_runtype == 1perl(defined $value) ? "-rcluster $value":""3specify_basemodelsSpecify names of the base models or program (-mset)perl$specify_runtype == 1perl(defined $value) ? "-mset $value":""3For -mset, specify the name of a program (raxml, phyml or mrbayes) to restrict to
only those models supported by the specified program. Alternatively, one can specify a
comma-separated list of base models. For example, -mset WAG,LG,JTT will restrict model
selection to WAG, LG, and JTT instead of all 18 AA models to save computations.
specify_aamodelsSpecify nuclear, mitochondrial, chloroplast or viral (-msub, protein)perl$sequence_type eq "AA" && $specify_runtype == 1 nuclearmitochondrialchloroplastviralperl(defined $value) ? "-msub $value":""3specify_freqtypesSpecify a comma-separated list of frequency types for model selection (-mfreq)perl$specify_runtype == 1perl(defined $value) ? "-mfreq $value":""3specify_ratehettypesSpecify a comma-separated list of rate heterogeneity types for model selection (-mrate)perl$specify_runtype == 1perl(defined $value) ? "-mrate $value":""3specify_mincatSpecify minimum number of categories for FreeRate model (-cmin)perl$specify_runtype == 1perl(defined $value) ? "-cmin $value":""3specify_maxcatperl$specify_runtype == 1Specify maximum number of categories for FreeRate model (-cmax)perl(defined $value) ? "-cmax $value":""3specify_meritSpecify either AIC, AICc or BIC for the optimality criterion (-merit)perl$specify_runtype == 1perl(defined $value) ? "-merit $value":""3specify_fulltreesearchTurn on full tree search for each model considered, to obtain more accurate result. (-mtree)perl$specify_runtype == 1perl($value) ? "-mtree":""3specify_addlmodelsSpecify a comma-separated list of mixture models to additionally consider for model selection. (-madd)perl$specify_runtype == 1perl(defined $value) ? "-madd $value":""3specify_substSpecify Substitution ModelsfreetextmodelSpecify any model using free text (-m)perl $specify_runtype == 2Sorry, you cant specify a DNA model and use the free text entryperldefined $freetextmodel && defined $specify_dnamodel3dnamodel_stringperl$sequence_type eq "DNA" && $specify_runtype == 2perl(defined $specify_dnamodel) ? "-m $specify_dnamodel$specify_modelfreq$specify_modelrate$asc_bias":""model_string2perl$specify_runtype == 2perl(defined $freetextmodel) ? "-m $freetextmodel":""specify_dnamodelSpecify a DNA model (-m )perl$sequence_type eq "DNA" && $specify_runtype == 2JC69F81K80HKYTN93TNeK81K81uTPM2TPM2uTPM3TPM3uTIMTIMeTIM2TIM2eTIM3TIM3eTVMTVMeSYMGTR3Sorry, you cant specify a DNA model and run a model test perldefined $specify_model && defined $valueaamodel_stringperl$sequence_type eq "AA" && $specify_runtype == 2perl(defined $specify_protmodel) ? "-m $specify_protmodel$specify_protmixture$specify_modelfreq$specify_modelrate":""specify_protmodelSpecify a Protein model (-m )perl($sequence_type eq "AA" || $sequence_type eq "NT2AA") && $specify_runtype == 2 BLOSUM62cpREVDayhoffDCMutFLUHIVbHIVwJTTJTTDCMutLGmtARTmtMAMmtREVmtZOAPoissonPMBrtREVVTWAGC10C20C30C40C50C60EX2EX3EHOUL2UL3EX_EHOLG4MLG4XCF4Sorry, you cant specify a protein model and use the free text entryperldefined $freetextmodel && defined $specify_protmodel3specify_protmixtureSpecify a Protein Profile mixtureperl($sequence_type eq "AA" || $sequence_type eq "NT2AA") && $specify_runtype == 2 && defined $specify_protmodel+C10+C20+C30+C40+C50+C60+EX2+EX3+EHO+UL2+UL3+EX_EHO+LG4M+LG4X+CF43guide_treeIf you want to use PMSF, specify a guide tree file (-ft)guidetree.treperl($sequence_type eq "AA" || $sequence_type eq "NT2AA") && $specify_runtype == 2perl(defined $value) ? "-ft guidetree.tre":""3binmodel_stringperl$sequence_type eq "BIN" && $specify_runtype == 2perl(defined $specify_binmodel) ? "-m $specify_binmodel$specify_modelfreq$specify_modelrate":""specify_binmodelSpecify a Binary/Morphological model (-m )perl($sequence_type eq "BIN" || $sequence_type eq "MORPH") && $specify_runtype == 2JC2GTR2MKORDEREDSorry, you cant specify a BIN model and use the free text entryperldefined $freetextmodel && defined $specify_binmodel3codonmodel_stringperl$sequence_type eq "CODON" && $specify_runtype == 2perl(defined $specify_codonmodel) ? "-m $specify_codonmodel$specify_modelfreq$specify_modelrate":""specify_codonmodelSpecify a Codon model (-m )perl$sequence_type eq "CODON" && $specify_runtype == 2MGMGKMG1KTSMG1KTVMG2KGYGY1KTSGY1KTVGY2KKOSI07ECMrestSCHN05Sorry, you cant specify a CODON model and use the free text entryperldefined $freetextmodel && defined $specify_codonmodel3specify_modelfreqSpecify model frequencyperl$specify_runtype == 2+F+FO+FQ+F1x4+F3x43specify_modelrateSpecify rate heterogeneityperl$specify_runtype == 2+I+G+I+G+R+I+R3asc_biasCorrect for Ascertainment bias (+ASC)perl$specify_runtype == 2+ASC2This is useful for binary/morphological datasets that only contain variable sites (the identical morphological features are usually not
included in the alignments, hence you need to correct for this, see, e.g., http://sysbio.oxfordjournals.org/content/50/6/913.short).For DNA data this option might be useful when
you analyze alignments of SNPs that also don't contain constant sites. Note that, for mathematical and numerical reasons you can
not apply an ascertainment bias correction to datasets or partitions that contain constant sites.gamma_shapeSpecify the Gamma shape parameter (-a)perl$specify_runtype == 2perl(defined $value ) ? "-a $value":""median_approximationPerform the median approximation for Gamma rate heterogeneity (-gmedian)perl$specify_runtype == 2perl($value ) ? "-gmedian":""
Perform the median approximation for Gamma rate heterogeneity instead of the default mean approximation (Yang, 1994)
invariable_sitesSpecify the proportion of invariable sites (-i)perl$specify_runtype == 2perl(defined $value ) ? "-i $value":""thorough_estimationPerform more thorough estimation for +I+G model parameters (--opt-gamma-inv)perl$specify_runtype == 2perl($value ) ? "--opt-gamma-inv":""tree_search_paramsTree Search Parametersnum_parstreesSpecify number of initial parsimony trees (-ninit)perl$specify_runtype == 2perl(defined $value ) ? "-ninit $value":""
Specify number of initial parsimony trees. DEFAULT: 100. Here the PLL library (Flouri et al., 2015) is used, which implements the randomized stepwise addition and parsimony subtree pruning and regafting (SPR).
num_topparstreesSpecify number of top initial parsimony trees (-ntop)perl$specify_runtype == 2perl(defined $value ) ? "-ntop $value":""
Specify number of top initial parsimony trees to optimize with ML nearest neighbor interchange (NNI) search to initialize the candidate set. DEFAULT: 20
num_besttreesNumber of trees in the candidate set to maintain (-nbest)perl$specify_runtype == 2perl(defined $value ) ? "-nbest $value":""
Specify number of trees in the candidate set to maintain during ML tree search. DEFAULT: 5
num_unsucctostopNumber of unsuccessful iterations to stop (-nstop)perl$specify_runtype == 2perl(defined $value ) ? "-nstop $value":""
Specify number of unsuccessful iterations to stop. DEFAULT: 100
num_tostopNumber of iterations to stop (-n)perl$specify_runtype == 2 && $bootstrap_type ne "b" perl(defined $value ) ? "-n $value":""Sorry, the -n parameter cannot be used with Ultrafast Bootstrappingperl(defined $value) && $bootstrap_type eq "bb"
Specify number of iterations to stop. This option overrides -nstop criterion. Use -n 0 to only estimate model parameters on an initial parsimony tree and ignore a full tree search to save time
specify_radiusSPR radius for the initial search (-sprrad)perl$specify_runtype == 2perl(defined $value ) ? "-sprrad $value":""
Specify SPR radius for the initial parsimony tree search. DEFAULT: 6
perturb_strengthPerturbation strength (between 0 and 1) (-pers)perl$specify_runtype == 2perl(defined $value ) ? "-pers $value":""
Specify perturbation strength (between 0 and 1) for randomized NNI. DEFAULT: 0.5
slower_NNITurn on more thorough and slower NNI search (-allnni)perl$specify_runtype == 2perl($value ) ? "-allnni":""
Turn on more thorough and slower NNI search. It means that IQ-TREE will consider all possible NNIs instead of only those in the vicinity of previously applied NNIs. DEFAULT: OFF
no_mlpairwiseAvoid computing ML pairwise distances and BIONJ tree (-djc)perl$specify_runtype == 2perl($value ) ? "-djc":""
Avoid computing ML pairwise distances and BIONJ tree.
constraint_fileSpecify a topological constraint tree file in NEWICK format (-g)perl$specify_runtype == 2constraintfile.txtperl(defined $value ) ? "-g constraintfile.txt":""
Specify a topological constraint tree file in NEWICK format. The constraint tree can be a multifurcating tree and need not to include all taxa.
ultrafast_search_paramsBootstrap Search Parametersbootstrap_typeBootstrap Typebbbbobcbbuse_bnniUse bnni to reduce overestimating support (-bnni)perl$bootstrap_type eq "bb"perl($value) ? "-bnni" : ""1num_bootrepsSpecify number of bootstrap replicates (>=1000)perldefined $bootstrap_typeperl(defined $value ) ? "-$bootstrap_type $value":""The value of bootstraps must be greater than or equal to 1,000perl$num_bootreps < 1000-b: Specify number of bootstrap replicates (recommended >=100). This will perform both bootstrap and analysis on original alignment and provide a consensus tree. -bc Like -b but omit analysis on original alignment.
-bo Like -b but only perform bootstrap analysis (no analysis on original alignment and no consensus tree).
write_boottreesTurn on writing bootstrap trees to .ufboot file (-wbt)perldefined $bootstrap_typeperl($value) ? "-wbt":""0
Turn on writing bootstrap trees to .ufboot file. DEFAULT: OFF
write_boottrees1Turn on writing bootstrap trees with branch lengths (-wbtl)perldefined $bootstrap_typeperl($value) ? "-wbtl":""0
Turn on writing bootstrap trees with branch lengths (-wbt1) DEFAULT: OFF
max_itersSpecify maximum number of iterations to stop. (-nm)perldefined $bootstrap_typeperl(defined $value ) ? "-nm $value":""
Specify maximum number of iterations to stop. DEFAULT: 1000
cc_ufbootMinimum correlation coefficient for UFBoot convergence criterion (-bcor)perldefined $bootstrap_typeperl(defined $value ) ? "-bcor $value":""
Specify minimum correlation coefficient for UFBoot convergence criterion. DEFAULT: 0.99
iter_intervalIteration interval checking for UFBoot convergence (-nstep)perldefined $bootstrap_typeperl(defined $value ) ? "-nstep $value":""Step size must be a multiple of 2perldefined $iter_interval && ((($iter_interval) % 2) != 0)Step size must be at least 10perldefined $iter_interval && $iter_interval < 10
Specify iteration interval checking for UFBoot convergence. DEFAULT: every 100 iterations
specify_tiebreakerSPR radius for the initial search (-beps)perldefined $bootstrap_typeperl(defined $value ) ? "-beps $value":""
Specify a small epsilon to break tie in RELL evaluation for bootstrap trees. DEFAULT: 0.5
part_resampleResampling strategies for partitioned analysis (-bspec)GENEGENESITEperl(defined $value ) ? "-bspec $value":""
Specify the resampling strategies for partitioned analysis. By default, IQ-TREE resamples alignment sites within partitions.
With -bspec GENE IQ-TREE will resample partitions.
With -bspec GENESITE IQ-TREE will resample partitions and then resample sites within resampled partitions (Gadagkar et al., 2005).
single_branchtSingle Branch Testssh_testSH-Like Test (-alrt)perl$bootstrap_type ne "b" && $bootstrap_type ne "bo" && $bootstrap_type ne "bc"perl($value) ? "-alrt $num_replicates":""abayes_testApproximate Bayes test (-abayes)perl$bootstrap_type ne "b" && $bootstrap_type ne "bo" && $bootstrap_type ne "bc"perl($value) ? "-abayes $num_replicates":""lbp_testFast local bootstrap probability (-lbp)perl$bootstrap_type ne "b" && $bootstrap_type ne "bo" && $bootstrap_type ne "bc"perl($value) ? "-lbp $num_replicates":""num_replicatesSpecify number of replicates (1000 or less)perl$sh_test || $abayes_test || $lbp_test The value of bootstraps must be less than or equal to 1,000perldefined $num_replicates && $num_replicates > 1000-b: Specify number of bootstrap replicates (recommended >=100). This will perform both bootstrap and analysis on original alignment and provide a consensus tree. -bc Like -b but omit analysis on original alignment.
-bo Like -b but only perform bootstrap analysis (no analysis on original alignment and no consensus tree).
tree_topologyTree Topology Testsspecify_treefileSpecify a file containing a set of trees (-z)treefile1.treperl(defined $value) ? "-z treefile1.tre":""num_rellSpecify the number of RELL replicates (-zb)perl(defined $value) ? "-zb $value":""Sorry, the number of RELL replicates cannot be less than 1,000perldefined $num_rell && $num_rell < 1000-zb Specify the number of RELL (Kishino et al., 1990) replicates (>=1000) to perform several tree topology tests for all trees passed via -z. The tests include bootstrap proportion (BP), KH test (Kishino and Hasegawa, 1989), SH test (Shimodaira and Hasegawa, 1999) and expected likelihood weights (ELW) (Strimmer and Rambaut, 2002).weighted_testsPerform the weighted-KH and weighted-SH tests (-zw)perldefined $num_rellperl($value) ? "-zw":""unbiased_testPerform the approximately unbiased (AU) testperldefined $num_rellperl($value) ? "-au":""fixed_usertreeSpecify a fixed user tree to estimate model parameters (-te)fixed_usertree.treperl($value) ? "-te fixed_usertree.tre":""-te Specify a fixed user tree to estimate model parameters. Thus it behaves like -n 0 but uses a user-defined tree instead of parsimony tree.
consensus_treeConsesnsus Treestree_file1Specify a file containing a set of treestreefile1.treperl(defined $value) ? "-t treefile1.tre":""compute_consensustreeCompute consensus tree of the trees passed via -t (-con)perldefined $tree_file1perl($value) ? "-con":""-con Compute consensus tree of the trees passed via -t. Resulting consensus tree is written to .contree file.compute_consensusnetworkCompute consensus network of the trees passed via -t (-net)perldefined $tree_file1perl($value) ? "-net":""min_thresholdSpecify a minimum threshold between 0 and 1 (-minsup)perldefined $tree_file1perl($value) ? "-minsup":""burnin_valueSpecify a burn-in (-bi)perldefined $tree_file1perl(defined $value) ? "-bi ($value)":""target_treefileSpecify an input “target” tree file (-sup)targetfile.treperl(defined $value) ? "-sup targetfile.tre":""-sup Specify an input “target” tree file. That means, support values are first extracted from the trees passed via -t, and then mapped onto the target tree. Resulting tree with assigned support values is written to .suptree file. This option is useful to map and compare support values from different approaches onto a single tree.
nodetarget_treefileSpecify name of a node in -sup target tree (-suptag)perl(defined $value) ? "-suptag $value":""
-suptag Specify name of a node in -sup target tree. The corresponding node of .suptree will then be assigned with IDs of trees where this node appears. Special option -suptag ALL will assign such IDs for all nodes of the target tree.
robinsons_fouldsdistComputing Robinson's Foulds distancestree_file2Specify a second set of treestreefile2.treperl(defined $value) ? "-rf treefile2.tre":""compute_rfdistances_allCompute all-to-all RF distances between all trees passed via -t (-rf_all)perldefined $tree_file1perl($value) ? "-rf_all":""compute_rfdistances_adjCompute RF distances between adjacent trees passed via -t (-rf_adj)perldefined $tree_file1perl($value) ? "-rf_adj":""generate_randomtreesGenerate Random Treesnum_taxaSpecify number of taxa for the tree (-r)perl(defined $value) ? "-r $value":""choose_randomtypeSpecify model for the trees-r-ru-rcat-rbal-rcsgspecify_brlengthsperl(defined $value) ? "-rcat $value":""misc_optionsMiscellaneous Optionswrite_locally_optimalTurn on writing all locally optimal trees (-wt)perl($value) ? "-wt":""fix_brlengthsTurn on fixing branch lengths of tree passed via -t or -te (-fixbr)perldefined $tree_file1 || defined $fixed_usertreeperl($value) ? "-fixbr":"" -fixbr Turn on fixing branch lengths of tree passed via -t or -te. This is useful to evaluate the log-likelihood of an input tree with fixed tolopogy and branch lengths.per_sitefileWrite per-site rates to .rate file (-wsr)perl$specify_runtype == 2perl($value ) ? "-wsr":""per_sitewslfileWrite site log-liklihoods to .sitelh file (-wsl)perl$specify_runtype == 2perl($value ) ? "-wsl":""per_sitewslrfileWrite site log-likelihoods per rate category (-wslr)perl$specify_runtype == 2perl($value ) ? "-wslr":""per_sitewslmfile Write site log-likelihoods per mixture class (-wslm)perl$specify_runtype == 2perl($value ) ? "-wslm":""per_sitewspmfileWrite site probabilities per mixture class (-wspm)perl$specify_runtype == 2perl($value ) ? "-wspm":""per_sitewsprfile Write site probabilities per rate category (-wspr)perl$specify_runtype == 2perl($value ) ? "-wspr":""per_sitewspmrfile Write site probabilities per rate category (-wspmr)perl$specify_runtype == 2perl($value ) ? "-wspmr":""per_sitewplfile Write partition log-likelihoods to .partlh file (-wpl)perl$specify_runtype == 2perl($value ) ? "-wpl":""write_sitelikelihoodsWrite log-likelihoods in TREE-PUZZLE format (-wsl)perl($value) ? "-wsl":""Turn on writing site log-likelihoods to .sitelh file in TREE-PUZZLE format. Such file can then be passed on to CONSEL for further tree tests. DEFAULT: OFF write_loglikelihoodsWrite log-likelihoods per rate category (-wslg)perl($value) ? "-wslg":""Turn on writing site log-likelihoods per rate category. DEFAULT: OFF list_csintegersSpecify a list of comma-separated integer numbers (-fconst)integerfile.csvperl(defined $value) ? "-const integerfile.csv":""Specify a list of comma-separated integer numbers. The number of entries should be equal to the number of states in the model (e.g. 4 for DNA and 20 for protein). IQ-TREE will then add a number of constant sites accordingly. For example, -fconst 10,20,15,40 will add 10 constant sites of all A, 20 constant sites of all C, 15 constant sites of all G and 40 constant sites of all T into the alignment.results*