IQ-Tree (REST) on ACCESS 1.6.10 Efficient phylogenomic software by maximum likelihood, run on XSEDE L.-T. Nguyen, H.A. Schmidt, A. von Haeseler, and B.Q. Minh L.-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/msu300 Phylogeny / Alignment iqtree_xsede_1_01_01 iqtree_invoke2 perl $which_iqtree eq "2" perl "iqtree_1.6.2_comet " 0 iqtree_invoke6 perl $which_iqtree eq "6" perl "iqtree_1.6.6_comet " 0 iqtree_invoke7 perl $which_iqtree eq "7" perl "iqtree_1.6.7_comet " 0 iqtree_invoke9 perl $which_iqtree eq "9" perl "iqtree_1.6.9_comet " 0 iqtree_invoke10 perl $which_iqtree eq "10" perl "iqtree_1.6.10_comet " 0 number_nodes1 2 scheduler.conf perl $specify_runtype == 1 && !$specify_autocores && $specify_numparts < 13 perl "nodes=1\\n" . "node_exclusive=0\\n" . "threads_per_process=12\\n" number_nodes1b 2 scheduler.conf perl $specify_runtype == 1 && $specify_autocores perl "nodes=1\\n" . "node_exclusive=1\\n" . "threads_per_process=24\\n" number_nodes1d 2 scheduler.conf perl $specify_runtype == 1 && !$specify_autocores && $specify_numparts > 12 perl "nodes=1\\n" . "node_exclusive=1\\n" . "threads_per_process=24\\n" number_nodes2 2 scheduler.conf perl $specify_runtype == 2 && $specify_numparts < 13 && $specify_numparts > 1 perl "nodes=1\\n" . "node_exclusive=0\\n" . "threads_per_process=12\\n" number_nodes2b 2 scheduler.conf perl $specify_runtype == 2 && $specify_numparts == 1 && $specify_mem < 60 perl "nodes=1\\n" . "node_exclusive=0\\n" . "threads_per_process=12\\n" number_nodes2c 2 scheduler.conf perl $specify_runtype == 2 && $specify_numparts == 1 && $specify_mem > 60 perl "nodes=1\\n" . "node_exclusive=1\\n" . "threads_per_process=24\\n" number_nodes2d 2 scheduler.conf perl $specify_runtype == 2 && $specify_numparts > 12 perl "nodes=1\\n" . "node_exclusive=1\\n" . "threads_per_process=24\\n" infile Input Alignment infile.txt perl "-s infile.txt" 1 runtime 1 scheduler.conf Maximum Hours to Run (up to 168 hours) 0.5 The maximum hours to run must be less than 168 perl $runtime > 168.0 The maximum hours to run must be greater than 0.05 perl $runtime < 0.05 perl "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 hours perl $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 hours perl $specify_runtype == 2 && $specify_numparts > 12 The job will run on 24 processors as configured. If it runs for the entire configured time, it will consume 24 x $runtime cpu hours perl $specify_runtype == 2 && $specify_numparts == 1 && $specify_mem > 60 The job will run on 12 processors as configured. If it runs for the entire configured time, it will consume 12 x $runtime cpu hours perl $specify_runtype == 2 && $specify_numparts < 13 && !defined $specify_mem The job will run on 12 processors as configured. If it runs for the entire configured time, it will consume 12 x $runtime cpu hours perl $specify_runtype == 2 && $specify_numparts == 1 && defined $specify_mem && $specify_mem < 60 Estimate 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_iqtree Which version do you want to run 10 10 specify_numparts How many partitions does your data set have Please specify the number of partitions perl !defined $specify_numparts The number of partitions must be greater than zero perl $specify_numparts < 1 Please specify the number of partitions perl !defined $specify_numparts specify_mem Memory required (in GB) perl $specify_runtype == 2 && $specify_numparts == 1 The run will not complete if -mem is greater than 120 GB, please contact us perl $specify_mem > 120 specify_safe Safe likelihood kernel to avoid numerical underflow (-safe) perl ($value) ? "-safe":"" specify_twelvecores perl $specify_runtype == 1 && !$specify_autocores perl "-nt 12" 3 specify_autocores Automatically select number of threads perl $specify_runtype == 1 perl ($value) ? "-nt AUTO":"" 3 specify_cores3 perl $specify_runtype == 2 perl "-nt AUTO" 3 specify_cores4 perl $specify_runtype == 2 && defined $specify_mem && !defined $partition_file perl "-mem $specify_mem$specify_g" 4 specify_g perl $specify_runtype == 2 && defined $specify_mem G specify_runtype Select the kind of run you need 1 2 Please specify whether the run is for Tree inference or Model Selection perl !defined $value 3 sequence_type Specify your sequence type (-st) perl !$mixed_sequence perl ($value ne "CODON" && $value ne "NT2AA") ? "-st $value":"" DNA AA BIN MORPH CODON NT2AA DNA 1 codon_type Specify your Codon type perl $sequence_type eq "CODON" perl "-st $value" CODON1 CODON2 CODON3 CODON4 CODON5 CODON6 CODON9 CODON10 CODON11 CODON12 CODON13 CODON14 CODON16 CODON21 CODON22 CODON23 CODON24 CODON25 CODON1 3 nt2aa_type Specify your translation table perl $sequence_type eq "NT2AA" perl "-st $value" NT2AA1 NT2AA2 NT2AA3 NT2AA4 NT2AA5 NT2AA6 NT2AA9 NT2AA10 NT2AA11 NT2AA12 NT2AA13 NT2AA14 NT2AA16 NT2AA21 NT2AA22 NT2AA23 NT2AA24 NT2AA25 NT2AA1 3 partition_type Please specify your partition type perl $specify_numparts > 1 -q -spp -sp perl (defined $value) ? "$partition_type partition.txt":"" Please specify the partition type perl !defined $partition_type && $specify_numparts > 1 Please select a partition file perl defined $partition_type && !defined $partition_file Sorry, a bug in this version will prevent the use of -sp with a partition file, please use the -spp option perl $partition_type eq "-sp" && $use_bnni && $which_iqtree <= 9 partition_file Please select your partition file perl defined $partition_type partition.txt Please select your partition file perl $specify_numparts > 1 && !defined $partition_file mixed_sequence I want to mix data types in a partitioned analysis perl defined $partition_type 0 num_mixedsequences How many data types (files) in your partitioned analysis perl $mixed_sequence 2 3 4 5 datatype2_file Select the file with your second datatype (partition_datatype2.phy) perl $num_mixedsequences > 1 partition_datatype2.phy datatype3_file Select the file with your third datatype (partition_datatype3.phy) perl $num_mixedsequences > 2 partition_datatype3.phy datatype4_file Select the file with your fourth datatype (partition_datatype4.phy) perl $num_mixedsequences > 3 partition_datatype4.phy datatype5_file Select the file with your fifth datatype (partition_datatype5.phy) perl $num_mixedsequences > 4 partition_datatype5.phy starting_tree Specify a starting (or other) tree file (-t) treefile.tre perl (defined $value) ? "-t treefile.tre":"" 3 use_nj Use a NJ starting tree (-t BIONJ) perl !defined $starting_tree perl ($value) ? "-t BIONJ":"" Sorry, you cannot choose both a random and a NJ starting tree perl $use_nj && $use_random 3 use_random Use a Random starting tree (-t RANDOM) perl !defined $starting_tree perl ($value) ? "-t RANDOM":"" 3 specify_outgroup Specify the outgroup (-o) perl (defined $value) ? "-o $value":"" 3 specify_prefix Specify the prefix for output files (-pre) perl (defined $value) ? "-pre $value":"" output 3 specify_seed Specify the seed (-seed) perl (defined $value) ? "-seed $value":"" 3 specify_quartets Specify number of quartets (-lmap) perl (defined $value) ? "-lmap $value":"" 3 model_selection Automatic Model Selection Parameters specify_model Test for the best model (-m TEST) TESTONLY TEST TESTNEWONLY TESTNEW TESTMERGEONLY TESTMERGE TESTNEWMERGEONLY TESTNEWMERGE perl (defined $value) ? "-m $value":"" 3 specify_rcluster Specify the percentage for relaxed clustering algorithm (-rcluster) perl (defined $value) ? "-rcluster $value":"" 3 specify_basemodels Specify names of the base models or program (-mset) perl $specify_runtype == 1 perl (defined $value) ? "-mset $value":"" 3 For -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_aamodels Specify nuclear, mitochondrial, chloroplast or viral (-msub, protein) perl $sequence_type eq "AA" && $specify_runtype == 1 nuclear mitochondrial chloroplast viral perl (defined $value) ? "-msub $value":"" 3 specify_freqtypes Specify a comma-separated list of frequency types for model selection (-mfreq) perl $specify_runtype == 1 perl (defined $value) ? "-mfreq $value":"" 3 specify_ratehettypes Specify a comma-separated list of rate heterogeneity types for model selection (-mrate) perl $specify_runtype == 1 perl (defined $value) ? "-mrate $value":"" 3 specify_mincat Specify minimum number of categories for FreeRate model (-cmin) perl $specify_runtype == 1 perl (defined $value) ? "-cmin $value":"" 3 specify_maxcat perl $specify_runtype == 1 Specify maximum number of categories for FreeRate model (-cmax) perl (defined $value) ? "-cmax $value":"" 3 specify_merit Specify either AIC, AICc or BIC for the optimality criterion (-merit) perl $specify_runtype == 1 perl (defined $value) ? "-merit $value":"" 3 specify_fulltreesearch Turn on full tree search for each model considered, to obtain more accurate result. (-mtree) perl $specify_runtype == 1 perl ($value) ? "-mtree":"" 3 specify_addlmodels Specify a comma-separated list of mixture models to additionally consider for model selection. (-madd) perl $specify_runtype == 1 perl (defined $value) ? "-madd $value":"" 3 specify_subst Specify Substitution Models freetextmodel Specify any model using free text (-m) perl $specify_runtype == 2 Sorry, you cant specify a DNA model and use the free text entry perl defined $freetextmodel && defined $specify_dnamodel 3 dnamodel_string perl $sequence_type eq "DNA" && $specify_runtype == 2 perl (defined $specify_dnamodel) ? "-m $specify_dnamodel$specify_modelfreq$specify_modelrate$asc_bias":"" model_string2 perl $specify_runtype == 2 perl (defined $freetextmodel) ? "-m $freetextmodel":"" specify_dnamodel Specify a DNA model (-m ) perl $sequence_type eq "DNA" && $specify_runtype == 2 JC69 F81 K80 HKY TN93 TNe K81 K81u TPM2 TPM2u TPM3 TPM3u TIM TIMe TIM2 TIM2e TIM3 TIM3e TVM TVMe SYM GTR 3 Sorry, you cant specify a DNA model and run a model test perl defined $specify_model && defined $value aamodel_string perl $sequence_type eq "AA" && $specify_runtype == 2 perl (defined $specify_protmodel) ? "-m $specify_protmodel$specify_protmixture$specify_modelfreq$specify_modelrate":"" specify_protmodel Specify a Protein model (-m ) perl ($sequence_type eq "AA" || $sequence_type eq "NT2AA") && $specify_runtype == 2 BLOSUM62 cpREV Dayhoff DCMut FLU HIVb HIVw JTT JTTDCMut LG mtART mtMAM mtREV mtZOA Poisson PMB rtREV VT WAG C10 C20 C30 C40 C50 C60 EX2 EX3 EHO UL2 UL3 EX_EHO LG4M LG4X CF4 Sorry, you cant specify a protein model and use the free text entry perl defined $freetextmodel && defined $specify_protmodel 3 specify_protmixture Specify a Protein Profile mixture perl ($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 +CF4 3 guide_tree If you want to use PMSF, specify a guide tree file (-ft) guidetree.tre perl ($sequence_type eq "AA" || $sequence_type eq "NT2AA") && $specify_runtype == 2 perl (defined $value) ? "-ft guidetree.tre":"" 3 binmodel_string perl $sequence_type eq "BIN" && $specify_runtype == 2 perl (defined $specify_binmodel) ? "-m $specify_binmodel$specify_modelfreq$specify_modelrate":"" specify_binmodel Specify a Binary/Morphological model (-m ) perl ($sequence_type eq "BIN" || $sequence_type eq "MORPH") && $specify_runtype == 2 JC2 GTR2 MK ORDERED Sorry, you cant specify a BIN model and use the free text entry perl defined $freetextmodel && defined $specify_binmodel 3 codonmodel_string perl $sequence_type eq "CODON" && $specify_runtype == 2 perl (defined $specify_codonmodel) ? "-m $specify_codonmodel$specify_modelfreq$specify_modelrate":"" specify_codonmodel Specify a Codon model (-m ) perl $sequence_type eq "CODON" && $specify_runtype == 2 MG MGK MG1KTS MG1KTV MG2K GY GY1KTS GY1KTV GY2K KOSI07 ECMrest SCHN05 Sorry, you cant specify a CODON model and use the free text entry perl defined $freetextmodel && defined $specify_codonmodel 3 specify_modelfreq Specify model frequency perl $specify_runtype == 2 +F +FO +FQ +F1x4 +F3x4 3 specify_modelrate Specify rate heterogeneity perl $specify_runtype == 2 +I +G +I+G +R +I+R 3 asc_bias Correct for Ascertainment bias (+ASC) perl $specify_runtype == 2 +ASC 2 This 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_shape Specify the Gamma shape parameter (-a) perl $specify_runtype == 2 perl (defined $value ) ? "-a $value":"" The gamma shape parameter must be greater than 0 perl defined $gamma_shape && $gamma_shape <= 0 median_approximation Perform the median approximation for Gamma rate heterogeneity (-gmedian) perl $specify_runtype == 2 perl ($value ) ? "-gmedian":"" Perform the median approximation for Gamma rate heterogeneity instead of the default mean approximation (Yang, 1994) invariable_sites Specify the proportion of invariable sites (-i) perl $specify_runtype == 2 perl (defined $value ) ? "-i $value":"" thorough_estimation Perform more thorough estimation for +I+G model parameters (--opt-gamma-inv) perl $specify_runtype == 2 perl ($value ) ? "--opt-gamma-inv":"" tree_search_params Tree Search Parameters num_parstrees Specify number of initial parsimony trees (-ninit) perl $specify_runtype == 2 perl (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_topparstrees Specify number of top initial parsimony trees (-ntop) perl $specify_runtype == 2 perl (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_besttrees Number of trees in the candidate set to maintain (-nbest) perl $specify_runtype == 2 perl (defined $value ) ? "-nbest $value":"" Specify number of trees in the candidate set to maintain during ML tree search. DEFAULT: 5 num_unsucctostop Number of unsuccessful iterations to stop (-nstop) perl $specify_runtype == 2 perl (defined $value ) ? "-nstop $value":"" Specify number of unsuccessful iterations to stop. DEFAULT: 100 num_tostop Number 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 Bootstrapping perl (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_radius SPR radius for the initial search (-sprrad) perl $specify_runtype == 2 perl (defined $value ) ? "-sprrad $value":"" Specify SPR radius for the initial parsimony tree search. DEFAULT: 6 perturb_strength Perturbation strength (between 0 and 1) (-pers) perl $specify_runtype == 2 perl (defined $value ) ? "-pers $value":"" Specify perturbation strength (between 0 and 1) for randomized NNI. DEFAULT: 0.5 slower_NNI Turn on more thorough and slower NNI search (-allnni) perl $specify_runtype == 2 perl ($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_mlpairwise Avoid computing ML pairwise distances and BIONJ tree (-djc) perl $specify_runtype == 2 perl ($value ) ? "-djc":"" Avoid computing ML pairwise distances and BIONJ tree. constraint_file Specify a topological constraint tree file in NEWICK format (-g) perl $specify_runtype == 2 constraintfile.txt perl (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_params Bootstrap Search Parameters bootstrap_type Bootstrap Type bb b bo bc perl (defined $value ) ? "-$value $num_bootreps":"" use_bnni Use bnni to reduce overestimating support (-bnni) perl $bootstrap_type eq "bb" perl ($value) ? "-bnni" : "" 1 num_bootreps Specify number of bootstrap replicates (>=1000 for ultrafast) perl defined $bootstrap_type Please enter a number of bootstraps perl defined $bootstrap_type && !defined $num_bootreps For ultrafast, the value of bootstraps must be greater than or equal to 1,000 perl $bootstrap_type eq "bb" && $num_bootreps < 1000 -b: Specify number of bootstrap replicates (recommended >=100; for ultrafast (-bb) >=1000). 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_boottrees Turn on writing bootstrap trees to .ufboot file (-wbt) perl defined $bootstrap_type perl ($value) ? "-wbt":"" 0 Turn on writing bootstrap trees to .ufboot file. DEFAULT: OFF write_boottrees1 Turn on writing bootstrap trees with branch lengths (-wbtl) perl defined $bootstrap_type perl ($value) ? "-wbtl":"" 0 Turn on writing bootstrap trees with branch lengths (-wbt1) DEFAULT: OFF max_iters Specify maximum number of iterations to stop. (-nm) perl defined $bootstrap_type perl (defined $value ) ? "-nm $value":"" Specify maximum number of iterations to stop. DEFAULT: 1000 cc_ufboot Minimum correlation coefficient for UFBoot convergence criterion (-bcor) perl defined $bootstrap_type perl (defined $value ) ? "-bcor $value":"" Specify minimum correlation coefficient for UFBoot convergence criterion. DEFAULT: 0.99 iter_interval Iteration interval checking for UFBoot convergence (-nstep) perl defined $bootstrap_type perl (defined $value ) ? "-nstep $value":"" Step size must be a multiple of 2 perl defined $iter_interval && ((($iter_interval) % 2) != 0) Step size must be at least 10 perl defined $iter_interval && $iter_interval < 10 Specify iteration interval checking for UFBoot convergence. DEFAULT: every 100 iterations specify_tiebreaker SPR radius for the initial search (-beps) perl defined $bootstrap_type perl (defined $value ) ? "-beps $value":"" Specify a small epsilon to break tie in RELL evaluation for bootstrap trees. DEFAULT: 0.5 part_resample Resampling strategies for partitioned analysis (-bspec) GENE GENESITE perl (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_brancht Single Branch Tests sh_test SH-Like Test (-alrt) perl $bootstrap_type ne "b" && $bootstrap_type ne "bo" && $bootstrap_type ne "bc" perl ($value) ? "-alrt $num_replicates":"" parametrical_test Run the parametricaLRT test (-alrt 0) perl $bootstrap_type ne "b" && $bootstrap_type ne "bo" && $bootstrap_type ne "bc" perl ($value) ? "-alrt 0":"" abayes_test Approximate Bayes test (-abayes) perl $bootstrap_type ne "b" && $bootstrap_type ne "bo" && $bootstrap_type ne "bc" perl ($value) ? "-abayes":"" lbp_test Fast local bootstrap probability (-lbp) perl $bootstrap_type ne "b" && $bootstrap_type ne "bo" && $bootstrap_type ne "bc" perl ($value) ? "-lbp $num_replicates":"" num_replicates Specify number of replicates (1000 or more) perl $sh_test || $lbp_test The value of replicates must be greater than or equal to 1,000 perl defined $num_replicates && $num_replicates < 1000 && $lbp_test The value of replicates must be greater than or equal to 1,000 for the SH- test perl defined $num_replicates && $sh_test && $num_replicates < 1000 Please enter a value for number of replicates perl !defined $num_replicates && ($sh_test || $lbp_test) tree_topology Tree Topology Tests specify_treefile Specify a file containing a set of trees (-z) treefile1.tre perl (defined $value) ? "-z treefile1.tre":"" num_rell Specify the number of RELL replicates (-zb) perl (defined $value) ? "-zb $value":"" Sorry, the number of RELL replicates cannot be less than 1,000 perl defined $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_tests Perform the weighted-KH and weighted-SH tests (-zw) perl defined $num_rell perl ($value) ? "-zw":"" unbiased_test Perform the approximately unbiased (AU) test perl defined $num_rell perl ($value) ? "-au":"" fixed_usertree Specify a fixed user tree to estimate model parameters (-te) fixed_usertree.tre perl ($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_tree Consesnsus Trees tree_file1 Specify a file containing a set of trees treefile1.tre perl (defined $value) ? "-t treefile1.tre":"" compute_consensustree Compute consensus tree of the trees passed via -t (-con) perl defined $tree_file1 perl ($value) ? "-con":"" -con Compute consensus tree of the trees passed via -t. Resulting consensus tree is written to .contree file. compute_consensusnetwork Compute consensus network of the trees passed via -t (-net) perl defined $tree_file1 perl ($value) ? "-net":"" min_threshold Specify a minimum threshold between 0 and 1 (-minsup) perl defined $tree_file1 perl ($value) ? "-minsup":"" burnin_value Specify a burn-in (-bi) perl defined $tree_file1 perl (defined $value) ? "-bi ($value)":"" target_treefile Specify an input “target” tree file (-sup) targetfile.tre perl (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_treefile Specify 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_fouldsdist Computing Robinson's Foulds distances tree_file2 Specify a second set of trees treefile2.tre perl (defined $value) ? "-rf treefile2.tre":"" compute_rfdistances_all Compute all-to-all RF distances between all trees passed via -t (-rf_all) perl defined $tree_file1 perl ($value) ? "-rf_all":"" compute_rfdistances_adj Compute RF distances between adjacent trees passed via -t (-rf_adj) perl defined $tree_file1 perl ($value) ? "-rf_adj":"" generate_randomtrees Generate Random Trees num_taxa Specify number of taxa for the tree (-r) perl (defined $value) ? "-r $value":"" choose_randomtype Specify model for the trees -r -ru -rcat -rbal -rcsg specify_brlengths perl (defined $value) ? "-rcat $value":"" misc_options Miscellaneous Options write_locally_optimal Turn on writing all locally optimal trees (-wt) perl ($value) ? "-wt":"" fix_brlengths Turn on fixing branch lengths of tree passed via -t or -te (-fixbr) perl defined $tree_file1 || defined $fixed_usertree perl ($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_sitefile Write per-site rates to .rate file (-wsr) perl $specify_runtype == 2 perl ($value ) ? "-wsr":"" per_sitewslfile Write site log-liklihoods to .sitelh file (-wsl) perl $specify_runtype == 2 perl ($value ) ? "-wsl":"" per_sitewslrfile Write site log-likelihoods per rate category (-wslr) perl $specify_runtype == 2 perl ($value ) ? "-wslr":"" per_sitewslmfile Write site log-likelihoods per mixture class (-wslm) perl $specify_runtype == 2 perl ($value ) ? "-wslm":"" per_sitewspmfile Write site probabilities per mixture class (-wspm) perl $specify_runtype == 2 perl ($value ) ? "-wspm":"" per_sitewsprfile Write site probabilities per rate category (-wspr) perl $specify_runtype == 2 perl ($value ) ? "-wspr":"" per_sitewspmrfile Write site probabilities per rate category (-wspmr) perl $specify_runtype == 2 perl ($value ) ? "-wspmr":"" per_sitewplfile Write partition log-likelihoods to .partlh file (-wpl) perl $specify_runtype == 2 perl ($value ) ? "-wpl":"" write_sitelikelihoods Write 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_loglikelihoods Write log-likelihoods per rate category (-wslg) perl ($value) ? "-wslg":"" Turn on writing site log-likelihoods per rate category. DEFAULT: OFF list_csintegers Specify a list of comma-separated integer numbers (-fconst) integerfile.csv perl (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. restart perl ($value) ? "-redo" : "" 4 results *