Uses of Class
org.forester.phylogeny.Phylogeny
Packages that use Phylogeny
Package
Description
-
Uses of Phylogeny in org.biojava.nbio.phylo
Methods in org.biojava.nbio.phylo that return PhylogenyModifier and TypeMethodDescriptionstatic Phylogeny
TreeConstructor.distanceTree
(BasicSymmetricalDistanceMatrix distM, TreeConstructorType constructor) Methods in org.biojava.nbio.phylo with parameters of type PhylogenyModifier and TypeMethodDescriptionstatic double
DistanceTreeEvaluator.evaluate
(Phylogeny tree, DistanceMatrix matrix) Evaluate the goodness of fit of a given tree to the original distance matrix.static String
ForesterWrapper.getNewickString
(Phylogeny phylo, boolean writeDistances) Convert a Phylogenetic tree to its Newick representation, so that it can be exported to an external application. -
Uses of Phylogeny in org.biojava.nbio.structure.align.multiple.util
Methods in org.biojava.nbio.structure.align.multiple.util that return PhylogenyModifier and TypeMethodDescriptionstatic Phylogeny
MultipleAlignmentTools.getHSDMTree
(MultipleAlignment msta) Calculate a phylogenetic tree of the MultipleAlignment using dissimilarity scores (DS), based in SDM Substitution Matrix (ideal for distantly related proteins, structure-derived) and the Neighbor Joining algorithm from forester.static Phylogeny
MultipleAlignmentTools.getKimuraTree
(MultipleAlignment msta) Calculate a phylogenetic tree of the MultipleAlignment using Kimura distances and the Neighbor Joining algorithm from forester.static Phylogeny
MultipleAlignmentTools.getStructuralTree
(MultipleAlignment msta) Calculate a phylogenetic tree of the MultipleAlignment using RMSD distances and the Neighbor Joining algorithm from forester. -
Uses of Phylogeny in org.forester.analysis
Methods in org.forester.analysis with parameters of type PhylogenyModifier and TypeMethodDescriptionstatic void
AncestralTaxonomyInference.inferTaxonomyFromDescendents
(Phylogeny phy) Constructors in org.forester.analysis with parameters of type PhylogenyModifierConstructorDescriptionTaxonomyDataManager
(MainFrameApplication mf, TreePanel treepanel, Phylogeny phy) TaxonomyDataManager
(MainFrameApplication mf, TreePanel treepanel, Phylogeny phy, boolean delete, boolean allow_simple_name) -
Uses of Phylogeny in org.forester.application
Methods in org.forester.application with parameters of type PhylogenyModifier and TypeMethodDescriptionstatic final void
support_transfer.moveBranchLengthsToBootstrap
(Phylogeny p) Moves the values in the branch length field to the bootstrap field, for each PhylogenyNode of this Phylogeny.static final void
support_transfer.transferSupportValues
(Phylogeny from, Phylogeny to) Modifies Phylogeny to with the support values from Phylogeny from. -
Uses of Phylogeny in org.forester.archaeopteryx
Methods in org.forester.archaeopteryx that return PhylogenyModifier and TypeMethodDescriptionfinal Phylogeny
TreePanel.getPhylogeny()
Get a pointer to the phylogenystatic final Phylogeny[]
AptxUtil.readPhylogeniesFromUrl
(URL url, boolean phyloxml_validate_against_xsd, boolean replace_underscores, boolean internal_numbers_are_confidences, NHXParser.TAXONOMY_EXTRACTION taxonomy_extraction, boolean midpoint_reroot) Methods in org.forester.archaeopteryx with parameters of type PhylogenyModifier and TypeMethodDescriptionvoid
MainPanel.addPhylogenyInNewTab
(Phylogeny phy, Configuration config, String default_name, String full_path) static MainFrame
Archaeopteryx.createApplication
(Phylogeny phylogeny) static MainFrame
Archaeopteryx.createApplication
(Phylogeny[] phylogenies) static MainFrame
Archaeopteryx.createApplication
(Phylogeny[] phylogenies, String config_file_name, String title) static MainFrame
Archaeopteryx.createApplication
(Phylogeny phylogeny, Configuration config, String title) static MainFrameApplication
MainFrameApplication.createInstance
(Phylogeny[] phys, Configuration config) static MainFrame
MainFrameApplication.createInstance
(Phylogeny[] phys, Configuration config, String title, File current_dir) static final boolean
AptxUtil.isHasAtLeastNodeWithEvent
(Phylogeny phy) static final boolean
AptxUtil.isHasAtLeastOneBranchLengthLargerThanZero
(Phylogeny phy) Returns true if at least one branch has a length larger than zero.static final boolean
AptxUtil.isHasAtLeastOneBranchWithSupportSD
(Phylogeny phy) static final boolean
AptxUtil.isHasAtLeastOneBranchWithSupportValues
(Phylogeny phy) static final boolean
AptxUtil.isHasAtLeastOneNodeWithScientificName
(Phylogeny phy) static final boolean
AptxUtil.isHasAtLeastOneNodeWithSequenceAnnotation
(Phylogeny phy) final void
Set a phylogeny tree.static void
AptxUtil.writePhylogenyToGraphicsFile
(Phylogeny phy, File outfile, int width, int height, AptxUtil.GraphicsExportType type, Configuration config) -
Uses of Phylogeny in org.forester.archaeopteryx.tools
Constructors in org.forester.archaeopteryx.tools with parameters of type PhylogenyModifierConstructorDescriptionAncestralTaxonomyInferrer
(MainFrame mf, TreePanel treepanel, Phylogeny phy) SequenceDataRetriver
(MainFrameApplication mf, TreePanel treepanel, Phylogeny phy) -
Uses of Phylogeny in org.forester.archaeopteryx.webservices
Methods in org.forester.archaeopteryx.webservices with parameters of type PhylogenyModifier and TypeMethodDescriptionstatic void
WebserviceUtil.processInstructions
(PhylogeniesWebserviceClient client, Phylogeny phylogeny) -
Uses of Phylogeny in org.forester.development
Methods in org.forester.development that return PhylogenyModifier and TypeMethodDescriptionstatic Phylogeny
DevelopmentTools.createBalancedPhylogeny
(int levels, int children_per_node) Creates a completely balanced rooted phylogeny with a given number of levels and children per node.Methods in org.forester.development with parameters of type PhylogenyModifier and TypeMethodDescriptionstatic void
DevelopmentTools.intervalNumberSpecies
(Phylogeny t, int i) Sets the species name of the external Nodes of Phylogeny t to 1, 1+i, 2, 2+i, 3, 3+i, ....static void
DevelopmentTools.numberSpeciesInDescOrder
(Phylogeny t) Sets the species namea of the external Nodes of Phylogeny t to descending integers, ending with 1.static void
DevelopmentTools.numberSpeciesInOrder
(Phylogeny t) Sets the species namea of the external Nodes of Phylogeny t to ascending integers, starting with 1.static void
DevelopmentTools.randomizeSpecies
(int min, int max, Phylogeny t) Sets the species names of the external Nodes of Phylogeny t to a random positive integer number between (and including) min and max. -
Uses of Phylogeny in org.forester.evoinference.distance
Methods in org.forester.evoinference.distance that return PhylogenyModifier and TypeMethodDescriptionfinal Phylogeny
NeighborJoining.execute
(BasicSymmetricalDistanceMatrix distance) final Phylogeny
NeighborJoiningF.execute
(BasicSymmetricalDistanceMatrix distance) final Phylogeny
NeighborJoiningR.execute
(BasicSymmetricalDistanceMatrix distance) Methods in org.forester.evoinference.distance that return types with arguments of type PhylogenyModifier and TypeMethodDescriptionNeighborJoining.execute
(List<BasicSymmetricalDistanceMatrix> distances_list) NeighborJoiningF.execute
(List<BasicSymmetricalDistanceMatrix> distances_list) NeighborJoiningR.execute
(List<BasicSymmetricalDistanceMatrix> distances_list) -
Uses of Phylogeny in org.forester.evoinference.parsimony
Methods in org.forester.evoinference.parsimony with parameters of type PhylogenyModifier and TypeMethodDescriptionvoid
DolloParsimony.execute
(Phylogeny p, CharacterStateMatrix<CharacterStateMatrix.BinaryStates> external_node_states_matrix) void
FitchParsimony.execute
(Phylogeny p, CharacterStateMatrix<STATE_TYPE> external_node_states_matrix) void
FitchParsimony.execute
(Phylogeny p, CharacterStateMatrix<STATE_TYPE> external_node_states_matrix, boolean verbose) void
SankoffParsimony.execute
(Phylogeny p, CharacterStateMatrix<STATE_TYPE> external_node_states_matrix) -
Uses of Phylogeny in org.forester.io.parsers
Methods in org.forester.io.parsers that return Phylogeny -
Uses of Phylogeny in org.forester.io.parsers.nexus
Methods in org.forester.io.parsers.nexus that return Phylogeny -
Uses of Phylogeny in org.forester.io.parsers.nhx
Methods in org.forester.io.parsers.nhx that return Phylogeny -
Uses of Phylogeny in org.forester.io.parsers.phyloxml
Methods in org.forester.io.parsers.phyloxml that return PhylogenyMethods in org.forester.io.parsers.phyloxml with parameters of type Phylogeny -
Uses of Phylogeny in org.forester.io.parsers.phyloxml.data
Methods in org.forester.io.parsers.phyloxml.data with parameters of type PhylogenyModifier and TypeMethodDescriptionstatic PhylogenyDataPhyloXmlParser
SequenceRelationParser.getInstance
(Phylogeny phylogeny) -
Uses of Phylogeny in org.forester.io.parsers.tol
Methods in org.forester.io.parsers.tol that return Phylogeny -
Uses of Phylogeny in org.forester.io.parsers.util
Methods in org.forester.io.parsers.util that return PhylogenyModifier and TypeMethodDescriptionstatic final Phylogeny[]
ParserUtils.readPhylogenies
(File file) static final Phylogeny[]
ParserUtils.readPhylogenies
(String file_name) -
Uses of Phylogeny in org.forester.io.writers
Methods in org.forester.io.writers with parameters of type PhylogenyModifier and TypeMethodDescriptionvoid
PhylogenyWriter.toNewHampshire
(Phylogeny[] trees, boolean write_distance_to_parent, File out_file, String separator) PhylogenyWriter.toNewHampshire
(Phylogeny tree, boolean nh_write_distance_to_parent) void
PhylogenyWriter.toNewHampshire
(Phylogeny tree, boolean write_distance_to_parent, File out_file) PhylogenyWriter.toNewHampshire
(Phylogeny tree, boolean nh_write_distance_to_parent, PhylogenyNode.NH_CONVERSION_SUPPORT_VALUE_STYLE svs) void
PhylogenyWriter.toNewHampshire
(Phylogeny tree, boolean write_distance_to_parent, PhylogenyNode.NH_CONVERSION_SUPPORT_VALUE_STYLE svs, File out_file) PhylogenyWriter.toNewHampshireX
(Phylogeny tree) void
PhylogenyWriter.toNewHampshireX
(Phylogeny[] trees, File out_file, String separator) void
PhylogenyWriter.toNewHampshireX
(Phylogeny tree, File out_file) void
PhylogenyWriter.toNexus
(File out_file, Phylogeny tree, PhylogenyNode.NH_CONVERSION_SUPPORT_VALUE_STYLE svs) PhylogenyWriter.toNexus
(Phylogeny tree, PhylogenyNode.NH_CONVERSION_SUPPORT_VALUE_STYLE svs) void
PhylogenyWriter.toPhyloXML
(File out_file, Phylogeny tree, int phyloxml_level) void
PhylogenyWriter.toPhyloXML
(Writer writer, Phylogeny[] trees, int phyloxml_level, String separator) void
PhylogenyWriter.toPhyloXML
(Writer writer, Phylogeny tree, int phyloxml_level) void
PhylogenyWriter.toPhyloXML
(Phylogeny[] trees, int phyloxml_level, File out_file, String separator) PhylogenyWriter.toPhyloXML
(Phylogeny tree, int phyloxml_level) void
PhylogenyWriter.toPhyloXML
(Phylogeny phy, int phyloxml_level, File out_file) static void
PhylogenyWriter.writeNexusTaxaBlock
(Writer writer, Phylogeny tree) Method parameters in org.forester.io.writers with type arguments of type PhylogenyModifier and TypeMethodDescriptionvoid
PhylogenyWriter.toNewHampshire
(List<Phylogeny> trees, boolean write_distance_to_parent, File out_file, String separator) void
PhylogenyWriter.toNewHampshireX
(List<Phylogeny> trees, File out_file, String separator) void
PhylogenyWriter.toPhyloXML
(File out_file, List<Phylogeny> trees, int phyloxml_level, String separator) void
PhylogenyWriter.toPhyloXML
(Writer writer, List<Phylogeny> trees, int phyloxml_level, String separator) static void
PhylogenyWriter.writeNexusTreesBlock
(Writer writer, List<Phylogeny> trees, PhylogenyNode.NH_CONVERSION_SUPPORT_VALUE_STYLE svs) -
Uses of Phylogeny in org.forester.msa_compactor
Methods in org.forester.msa_compactor that return PhylogenyMethods in org.forester.msa_compactor with parameters of type Phylogeny -
Uses of Phylogeny in org.forester.pccx
Methods in org.forester.pccx with parameters of type PhylogenyModifier and TypeMethodDescriptionvoid
BranchCountingBasedScoringMethod.calculateScoreForExternalNode
(SortedMap<PhylogenyNode, Double> external_node_scores, Phylogeny phylogeny, PhylogenyNode external_node, CoverageCalculationOptions options) void
ScoringMethodForExternalNode.calculateScoreForExternalNode
(SortedMap<PhylogenyNode, Double> external_node_scores, Phylogeny phylogeny, PhylogenyNode external_node, CoverageCalculationOptions options) This calculates the coverage score for one external node.double
BranchCountingBasedScoringMethod.getNormalizationFactor
(Phylogeny phylogeny) double
BranchLengthBasedScoringMethod.getNormalizationFactor
(Phylogeny phylogeny) double
LogBranchLengthBasedScoringMethod.getNormalizationFactor
(Phylogeny phylogeny) double
ScoringMethodForExternalNode.getNormalizationFactor
(Phylogeny phylogeny) This calculates a normalization factor, so that a normalized score of 1.0 means complete coverage.Method parameters in org.forester.pccx with type arguments of type PhylogenyModifier and TypeMethodDescriptionCoverageCalculationMethod.calculateCoverage
(List<Phylogeny> phylogenies, List<String> names, CoverageCalculationOptions options, boolean annotate_phylogenies) CoverageCalculator.calculateCoverage
(List<Phylogeny> phylogenies, List<String> names, boolean annotate_phylogenies) ExternalNodeBasedCoverageMethod.calculateCoverage
(List<Phylogeny> phylogenies, List<String> names, CoverageCalculationOptions options, boolean annotate_phylogenies) BasicExternalNodeBasedCoverageExtender.find
(List<Phylogeny> phylogenies, List<String> already_covered, int number_names_to_find, CoverageCalculationOptions options, PrintStream out) CoverageExtender.find
(List<Phylogeny> phylogenies, List<String> already_covered, int number_names_to_find, CoverageCalculationOptions options, PrintStream out) -
Uses of Phylogeny in org.forester.phylogeny
Methods in org.forester.phylogeny that return PhylogenyModifier and TypeMethodDescriptionPhylogeny.copy()
Returns a deep copy of this Phylogeny.Phylogeny.copy
(PhylogenyNode source) Returns a deep copy of this Phylogeny.Phylogeny.copyShallow()
Returns a shallow copy of this Phylogeny.Phylogeny.copyShallow
(PhylogenyNode source) static final Phylogeny
Phylogeny.createInstanceFromNhxString
(String nhx) static final Phylogeny[]
PhylogenyMethods.readPhylogenies
(PhylogenyParser parser, File file) static final Phylogeny[]
PhylogenyMethods.readPhylogenies
(PhylogenyParser parser, List<File> files) Methods in org.forester.phylogeny with parameters of type PhylogenyModifier and TypeMethodDescriptionstatic void
PhylogenyMethods.addMolecularSeqsToTree
(Phylogeny phy, Msa msa) static DescriptiveStatistics
PhylogenyMethods.calculateBranchLengthStatistics
(Phylogeny phy) static List<DescriptiveStatistics>
PhylogenyMethods.calculateConfidenceStatistics
(Phylogeny phy) static int
PhylogenyMethods.calculateMaxDepth
(Phylogeny phy) static double
PhylogenyMethods.calculateMaxDistanceToRoot
(Phylogeny phy) static PhylogenyNode
PhylogenyMethods.calculateNodeWithMaxDistanceToRoot
(Phylogeny phy) static DescriptiveStatistics
PhylogenyMethods.calculateNumberOfDescendantsPerNodeStatistics
(Phylogeny phy) static int
PhylogenyMethods.countNumberOfOneDescendantNodes
(Phylogeny phy) static int
PhylogenyMethods.countNumberOfPolytomies
(Phylogeny phy) static final HashMap<String,
PhylogenyNode> PhylogenyMethods.createNameToExtNodeMap
(Phylogeny phy) static void
PhylogenyMethods.deleteExternalNodesNegativeSelection
(String[] node_names_to_delete, Phylogeny p) static void
PhylogenyMethods.deleteExternalNodesNegativeSelection
(Set<Long> to_delete, Phylogeny phy) PhylogenyMethods.deleteExternalNodesPositiveSelection
(String[] node_names_to_keep, Phylogeny p) static void
PhylogenyMethods.deleteExternalNodesPositiveSelectionT
(List<Taxonomy> species_to_keep, Phylogeny phy) static final void
PhylogenyMethods.deleteInternalNodesWithOnlyOneDescendent
(Phylogeny phy) static final void
PhylogenyMethods.deleteNonOrthologousExternalNodes
(Phylogeny phy, PhylogenyNode n) static final List<List<PhylogenyNode>>
PhylogenyMethods.divideIntoSubTrees
(Phylogeny phy, double min_distance_to_root) static boolean
PhylogenyMethods.extractFastaInformation
(Phylogeny phy) static double
PhylogenyMethods.getMaximumConfidenceValue
(Phylogeny phy) Returns the largest confidence value found on phy.static int
PhylogenyMethods.getMinimumDescendentsPerInternalNodes
(Phylogeny phy) static final boolean
PhylogenyMethods.isInternalNamesLookLikeConfidences
(Phylogeny phy) static void
PhylogenyMethods.midpointRoot
(Phylogeny phylogeny) static void
PhylogenyMethods.normalizeBootstrapValues
(Phylogeny phylogeny, double max_bootstrap_value, double max_normalized_value) static List<PhylogenyNode>
PhylogenyMethods.obtainAllNodesAsList
(Phylogeny phy) static void
PhylogenyMethods.postorderBranchColorAveragingExternalNodeBased
(Phylogeny p) static final void
PhylogenyMethods.preOrderReId
(Phylogeny phy) static void
PhylogenyMethods.removeNode
(PhylogenyNode remove_me, Phylogeny phylogeny) static List<PhylogenyNode>
PhylogenyMethods.searchData
(String query, Phylogeny phy, boolean case_sensitive, boolean partial, boolean regex, boolean search_domains, double domains_confidence_threshold) static List<PhylogenyNode>
PhylogenyMethods.searchDataLogicalAnd
(String[] queries, Phylogeny phy, boolean case_sensitive, boolean partial, boolean search_domains, double domains_confidence_threshold) static void
PhylogenyMethods.setAllIndicatorsToZero
(Phylogeny phy) static List<PhylogenyNode>
PhylogenyMethods.taxonomyBasedDeletionOfExternalNodes
(Phylogeny reference, Phylogeny to_be_stripped) Removes from Phylogeny to_be_stripped all external Nodes which are associated with a species NOT found in Phylogeny reference.static final void
PhylogenyMethods.transferInternalNamesToBootstrapSupport
(Phylogeny phy) static final void
PhylogenyMethods.transferInternalNodeNamesToConfidence
(Phylogeny phy, String confidence_type) static final void
PhylogenyMethods.transferNodeNameToField
(Phylogeny phy, PhylogenyMethods.PhylogenyNodeField field, boolean external_only) -
Uses of Phylogeny in org.forester.phylogeny.factories
Methods in org.forester.phylogeny.factories that return PhylogenyModifier and TypeMethodDescriptionThis must create a Phylogeny from source (e.g. -
Uses of Phylogeny in org.forester.phylogeny.iterators
Constructors in org.forester.phylogeny.iterators with parameters of type PhylogenyModifierConstructorDescriptionExternalForwardIterator
(Phylogeny phylogeny) Constructor for ExternalForwardIterator.LevelOrderTreeIterator
(Phylogeny phylogeny) Creates a new LevelOrderTreeIterator for iterating over all the nodes of Phylogeny phylogeny -
Uses of Phylogeny in org.forester.rio
Methods in org.forester.rio that return PhylogenyModifier and TypeMethodDescriptionfinal Phylogeny[]
RIO.getAnalyzedGeneTrees()
final Phylogeny
final Phylogeny
RIO.getSpeciesTree()
Methods in org.forester.rio with parameters of type PhylogenyModifier and TypeMethodDescriptionstatic final IntMatrix
RIO.calculateOrthologTable
(Phylogeny[] analyzed_gene_trees, boolean sort) static final RIO
RIO.executeAnalysis
(File gene_trees_file, Phylogeny species_tree, SDIutil.ALGORITHM algorithm, RIO.REROOTING rerooting, String outgroup, boolean produce_log, boolean verbose, boolean transfer_taxonomy) static final RIO
RIO.executeAnalysis
(File gene_trees_file, Phylogeny species_tree, SDIutil.ALGORITHM algorithm, RIO.REROOTING rerooting, String outgroup, int first, int last, boolean produce_log, boolean verbose, boolean transfer_taxonomy) static final RIO
RIO.executeAnalysis
(IteratingPhylogenyParser p, Phylogeny species_tree, SDIutil.ALGORITHM algorithm, RIO.REROOTING rerooting, String outgroup, boolean produce_log, boolean verbose, boolean transfer_taxonomy) static final RIO
RIO.executeAnalysis
(IteratingPhylogenyParser p, Phylogeny species_tree, SDIutil.ALGORITHM algorithm, RIO.REROOTING rerooting, String outgroup, int first, int last, boolean produce_log, boolean verbose, boolean transfer_taxonomy) static final RIO
RIO.executeAnalysis
(Phylogeny[] gene_trees, Phylogeny species_tree) static final RIO
RIO.executeAnalysis
(Phylogeny[] gene_trees, Phylogeny species_tree, SDIutil.ALGORITHM algorithm, RIO.REROOTING rerooting, String outgroup, boolean produce_log, boolean verbose, boolean transfer_taxonomy) static final RIO
RIO.executeAnalysis
(Phylogeny[] gene_trees, Phylogeny species_tree, SDIutil.ALGORITHM algorithm, RIO.REROOTING rerooting, String outgroup, int first, int last, boolean produce_log, boolean verbose, boolean transfer_taxonomy) -
Uses of Phylogeny in org.forester.sdi
Methods in org.forester.sdi that return PhylogenyModifier and TypeMethodDescriptionSDI.getGeneTree()
Returns the gene tree.GSDIR.getMinDuplicationsSumGeneTree()
SDI.getSpeciesTree()
Returns the species tree.SDIR.infer
(Phylogeny gene_tree, Phylogeny species_tree, boolean minimize_mapping_cost, boolean minimize_sum_of_dup, boolean minimize_height, boolean return_trees, int max_trees_to_return) Infers gene duplications on a possibly unrooted gene Phylogeny gene_tree.static final Phylogeny
SDIutil.parseSpeciesTree
(Phylogeny gene_tree, File species_tree_file, boolean replace_undescores_in_nhx_trees, boolean ignore_quotes_in_nhx_trees, NHXParser.TAXONOMY_EXTRACTION taxonomy_extraction_in_nhx_trees) Methods in org.forester.sdi with parameters of type PhylogenyModifier and TypeMethodDescriptionstatic final SDIutil.TaxonomyComparisonBase
SDIutil.determineTaxonomyComparisonBase
(Phylogeny gene_tree) static List<PhylogenyBranch>
SDIR.getBranchesInPreorder
(Phylogeny t) SDIR.infer
(Phylogeny gene_tree, Phylogeny species_tree, boolean minimize_mapping_cost, boolean minimize_sum_of_dup, boolean minimize_height, boolean return_trees, int max_trees_to_return) Infers gene duplications on a possibly unrooted gene Phylogeny gene_tree.static final Phylogeny
SDIutil.parseSpeciesTree
(Phylogeny gene_tree, File species_tree_file, boolean replace_undescores_in_nhx_trees, boolean ignore_quotes_in_nhx_trees, NHXParser.TAXONOMY_EXTRACTION taxonomy_extraction_in_nhx_trees) Method parameters in org.forester.sdi with type arguments of type PhylogenyConstructors in org.forester.sdi with parameters of type PhylogenyModifierConstructorDescriptionGSDI
(Phylogeny gene_tree, Phylogeny species_tree, boolean most_parsimonious_duplication_model, boolean strip_gene_tree, boolean strip_species_tree) GSDI
(Phylogeny gene_tree, Phylogeny species_tree, boolean most_parsimonious_duplication_model, boolean strip_gene_tree, boolean strip_species_tree, boolean transfer_taxonomy) GSDIR
(Phylogeny gene_tree, Phylogeny species_tree, boolean strip_gene_tree, boolean strip_species_tree, boolean transfer_taxonomy) Constructor which sets the gene tree and the species tree to be compared. -
Uses of Phylogeny in org.forester.surfacing
Methods in org.forester.surfacing that return PhylogenyModifier and TypeMethodDescriptionstatic Phylogeny
SurfacingUtil.createNjTreeBasedOnMatrixToFile
(File nj_tree_outfile, DistanceMatrix distance) static Phylogeny[]
SurfacingUtil.obtainAndPreProcessIntrees
(File[] intree_files, int number_of_genomes, String[][] input_file_properties) static Phylogeny
SurfacingUtil.obtainFirstIntree
(File intree_file) Methods in org.forester.surfacing with parameters of type PhylogenyModifier and TypeMethodDescriptionstatic DomainParsimonyCalculator
DomainParsimonyCalculator.createInstance
(Phylogeny phylogeny) static DomainParsimonyCalculator
DomainParsimonyCalculator.createInstance
(Phylogeny phylogeny, List<GenomeWideCombinableDomains> gwcd_list) static DomainParsimonyCalculator
DomainParsimonyCalculator.createInstance
(Phylogeny phylogeny, List<GenomeWideCombinableDomains> gwcd_list, Map<String, Set<String>> domain_id_to_secondary_features_map) SurfacingUtil.createTaxCodeToIdMap
(Phylogeny phy) static void
SurfacingUtil.executeParsimonyAnalysis
(long random_number_seed_for_fitch_parsimony, boolean radomize_fitch_parsimony, String outfile_name, DomainParsimonyCalculator domain_parsimony, Phylogeny phylogeny, Map<String, List<GoId>> domain_id_to_go_ids_map, Map<GoId, GoTerm> go_id_to_term_map, GoNameSpace go_namespace_limit, String parameters_str, Map<String, Set<String>>[] domain_id_to_secondary_features_maps, SortedSet<String> positive_filter, boolean output_binary_domain_combinations_for_graphs, List<BinaryDomainCombination> all_binary_domains_combination_gained_fitch, List<BinaryDomainCombination> all_binary_domains_combination_lost_fitch, BinaryDomainCombination.DomainCombinationType dc_type, Map<String, DescriptiveStatistics> protein_length_stats_by_dc, Map<String, DescriptiveStatistics> domain_number_stats_by_dc, Map<String, DescriptiveStatistics> domain_length_stats_by_domain, Map<String, Integer> tax_code_to_id_map, boolean write_to_nexus, boolean use_last_in_fitch_parsimony, boolean perform_dc_fich) static void
SurfacingUtil.executeParsimonyAnalysisForSecondaryFeatures
(String outfile_name, DomainParsimonyCalculator secondary_features_parsimony, Phylogeny phylogeny, String parameters_str, Map<Species, MappingResults> mapping_results_map, boolean use_last_in_fitch_parsimony) static int
SurfacingUtil.getNumberOfNodesLackingName
(Phylogeny p, StringBuilder names) static String
SurfacingUtil.obtainHexColorStringDependingOnTaxonomyGroup
(String tax_code, Phylogeny phy) static String
SurfacingUtil.obtainTaxonomyGroup
(String tax_code, Phylogeny species_tree) void
PairwiseGenomeComparator.performPairwiseComparisons
(StringBuilder html_desc, boolean sort_by_species_count_first, DomainSimilarityCalculator.Detailedness detailedness, boolean ignore_domains_without_combs_in_all_spec, boolean ignore_domains_specific_to_one_species, DomainSimilarity.DomainSimilaritySortField domain_similarity_sort_field, DomainSimilarity.PRINT_OPTION domain_similarity_print_option, DomainSimilarity.DomainSimilarityScoring scoring, Map<String, List<GoId>> domain_id_to_go_ids_map, Map<GoId, GoTerm> go_id_to_term_map, GoNameSpace go_namespace_limit, Species[] species, int number_of_genomes, List<GenomeWideCombinableDomains> list_of_genome_wide_combinable_domains, PairwiseDomainSimilarityCalculator pw_calc, String automated_pairwise_comparison_suffix, boolean verbose, String automated_pairwise_comparison_prefix, String command_line_prg_name, File out_dir, boolean write_pairwise_comparisons, Map<String, Integer> tax_code_to_id_map, boolean calc_similarity_scores, Phylogeny phy) static void
SurfacingUtil.preparePhylogeny
(Phylogeny p, DomainParsimonyCalculator domain_parsimony, String date_time, String method, String name, String parameters_str) static void
SurfacingUtil.preparePhylogenyForParsimonyAnalyses
(Phylogeny intree, String[][] input_file_properties) DomainSimilarity.toStringBuffer
(DomainSimilarity.PRINT_OPTION print_option, Map<String, Integer> tax_code_to_id_map, Phylogeny phy) static void
SurfacingUtil.writeAllDomainsChangedOnAllSubtrees
(Phylogeny p, boolean get_gains, String outdir, String suffix_for_filename) static void
SurfacingUtil.writeDomainSimilaritiesToFile
(StringBuilder html_desc, StringBuilder html_title, Writer simple_tab_writer, Writer single_writer, Map<Character, Writer> split_writers, SortedSet<DomainSimilarity> similarities, boolean treat_as_binary, List<Species> species_order, DomainSimilarity.PRINT_OPTION print_option, DomainSimilarity.DomainSimilarityScoring scoring, boolean verbose, Map<String, Integer> tax_code_to_id_map, Phylogeny phy, Set<String> pos_filter_doms) static void
SurfacingUtil.writePhylogenyToFile
(Phylogeny phylogeny, String filename) -
Uses of Phylogeny in org.forester.tools
Methods in org.forester.tools that return types with arguments of type PhylogenyModifier and TypeMethodDescriptionSupportCount.count
(Phylogeny phylogeny, Phylogeny[] evaluator_phylogenies, boolean strip_evaluator_phylogenies, double similarity_threshold, boolean verbose) This counts the support of topology phylogeny by the topologies in phylogenies.Methods in org.forester.tools with parameters of type PhylogenyModifier and TypeMethodDescriptionstatic double
SupportCount.compare
(Phylogeny phylogeny, Phylogeny evaluator_phylogeny, boolean strip_evaluator_phylogeny, boolean update_support_in_phylogeny, boolean re_root) static void
SupportCount.count
(Phylogeny phylogeny, Phylogeny[] evaluator_phylogenies, boolean strip_evaluator_phylogenies, boolean verbose) SupportCount.count
(Phylogeny phylogeny, Phylogeny[] evaluator_phylogenies, boolean strip_evaluator_phylogenies, double similarity_threshold, boolean verbose) This counts the support of topology phylogeny by the topologies in phylogenies.static String
PhylogenyDecorator.decorate
(Phylogeny phylogeny, Map<String, String> map, PhylogenyDecorator.FIELD field, boolean extract_bracketed_scientific_name, boolean extract_bracketed_tax_code, boolean picky, boolean cut_name_after_space, boolean trim_after_tilde, boolean verbose) static String
PhylogenyDecorator.decorate
(Phylogeny phylogeny, Map<String, String> map, PhylogenyDecorator.FIELD field, boolean extract_bracketed_scientific_name, boolean extract_bracketed_tax_code, boolean picky, Map<String, String> intermediate_map, boolean cut_name_after_space, boolean trim_after_tilde, boolean verbose) static void
static final void
ConfidenceAssessor.evaluate
(String confidence_type, Phylogeny[] evaluators, Phylogeny target, boolean strict, double value) static final void
ConfidenceAssessor.evaluate
(String confidence_type, Phylogeny[] evaluators, Phylogeny target, boolean strict, double value, int first, int last) Constructors in org.forester.tools with parameters of type PhylogenyModifierConstructorDescriptionTreeSplitMatrix
(Phylogeny evaluator, boolean strict, Set<PhylogenyNode> target_external_nodes) If strict is true, target nodes (all external nodes of the phylogeny for which support values are to be calculated) is not used for anything during construction.TreeSplitMatrix
(Phylogeny evaluator, boolean strict, Phylogeny target) -
Uses of Phylogeny in org.forester.ws.seqdb
Methods in org.forester.ws.seqdb with parameters of type PhylogenyModifier and TypeMethodDescriptionSequenceDbWsTools.obtainSeqInformation
(Phylogeny phy, boolean ext_nodes_only, boolean allow_to_set_taxonomic_data, int lines_to_return)